diff --git a/.DS_Store b/.DS_Store index a1a5a0d..dbfc581 100644 Binary files a/.DS_Store and b/.DS_Store differ diff --git a/README.md b/README.md index 7665e4f..5b72e52 100644 --- a/README.md +++ b/README.md @@ -20,19 +20,23 @@ cd pdbbind/java javac -cp cdk-2.3-SNAPSHOT.jar Surface_for_single.java cd ../.. -# compile cpp -cd octree/external && git clone --recursive https://github.com/wang-ps/octree-ext.git -cd .. && mkdir build && cd build -cmake .. && cmake --build . --config Release -export PATH=`pwd`:$PATH - -# set-up TF enviroment +# set-up TF enviroment and compile cpp conda create -n OctSurf_env tensorflow-gpu==1.14.0 conda activate OctSurf_env conda install -c conda-forge yacs tqdm +pip install sklearn +pip install matplotlib +pip install seaborn pip install -U openbabel -cmake .. -DUSE_CUDA=ON && make -cd ../../tensorflow/libs + +cd octree/external && git clone --recursive https://github.com/wang-ps/octree-ext.git +cd .. && mkdir build && cd build +cmake .. -DUSE_CUDA=ON && cmake --build . --config Release +export PATH=`pwd`:$PATH +cd python +export PATH=`pwd`:$PATH + +cd ../../../tensorflow/libs python build.py cd ../../ ``` @@ -41,11 +45,12 @@ cd ../../ ```angular2 cd pdbbind/data_folder/refined-set/1a1e bash ../octree_for_single.sh -cd ../../../.. +cd octree_folder +ls -lh +cd ../../../../ -# visualization -pip install vtk -cd visualize +# parse by python +cd python python octree_parse.py cd ../ ``` diff --git a/octree/.DS_Store b/octree/.DS_Store index 9d96ca8..018aff8 100644 Binary files a/octree/.DS_Store and b/octree/.DS_Store differ diff --git a/octree/CMakeLists.txt b/octree/CMakeLists.txt index ba6d98e..ca498e9 100644 --- a/octree/CMakeLists.txt +++ b/octree/CMakeLists.txt @@ -8,11 +8,14 @@ option(USE_PYTHON "Build the python interface with pybind11" ON) option(USE_GLOG "Use glog" OFF) option(USE_OPENMP "Use OpenMP for speed up" OFF) option(USE_RPLY "Use the library rply in the project octree" OFF) +option(KEY64 "Use 64-bit key for deeper octrees" OFF) +option(ABI "Open CXX11_ABI compatibility" OFF) set(VCPKG "" CACHE PATH "The VCPKG path, containing glog and gtest") # set languanges if(USE_CUDA) + message(STATUS "octree: USE_CUDA") project(Octree LANGUAGES CUDA CXX C) add_definitions(-DUSE_CUDA) set(CMAKE_CUDA_STANDARD 11) @@ -25,30 +28,48 @@ endif() set_property(GLOBAL PROPERTY USE_FOLDERS ON) # # c++11 Support -set(CMAKE_CXX_STANDARD 11) -set(CMAKE_POSITION_INDEPENDENT_CODE ON) +set (CMAKE_CXX_STANDARD 11) +set (CMAKE_POSITION_INDEPENDENT_CODE ON) +if(ABI) + set(CMAKE_CXX_FLAGS "${CMAKE_CXX_FLAGS} -D_GLIBCXX_USE_CXX11_ABI=0") +endif() -# add target_link_libraries -if(USE_MINIBALL) +# add libraries +if(USE_MINIBALL) + message(STATUS "octree: USE_MINIBALL") add_definitions(-DUSE_MINIBALL) set(miniball_path "${PROJECT_SOURCE_DIR}/external/octree-ext/miniball") include_directories(${miniball_path}) endif() if(USE_RPLY) + message(STATUS "octree: USE_RPLY") add_definitions(-DUSE_RPLY) - file(GLOB src_rply - "${PROJECT_SOURCE_DIR}/external/octree-ext/rply-1.1.4/*.h" - "${PROJECT_SOURCE_DIR}/external/octree-ext/rply-1.1.4/*.c") - include_directories("${PROJECT_SOURCE_DIR}/external/octree-ext/rply-1.1.4") - add_library(rply ${src_rply}) +endif() +file(GLOB src_rply + "${PROJECT_SOURCE_DIR}/external/octree-ext/rply-1.1.4/*.h" + "${PROJECT_SOURCE_DIR}/external/octree-ext/rply-1.1.4/*.c") +include_directories("${PROJECT_SOURCE_DIR}/external/octree-ext/rply-1.1.4") +add_library(rply ${src_rply}) +set_target_properties(rply PROPERTIES FOLDER "ext") + +if(KEY64) + message(STATUS "octree: KEY64") + add_definitions(-DKEY64) endif() if(USE_GLOG) + message(STATUS "octree: USE_GLOG") add_definitions(-DUSE_GLOG) + set(glog_path "${PROJECT_SOURCE_DIR}/external/octree-ext/glog") + set(WITH_GFLAGS OFF CACHE BOOL "Disable WITH_GFLAGS") + set(BUILD_TESTING OFF CACHE BOOL "Disable BUILD_TESTING") + add_subdirectory(${glog_path}) + set_target_properties(glog PROPERTIES FOLDER "ext") endif() if(USE_WINDOWS_IO) + message(STATUS "octree: USE_WINDOWS_IO") add_definitions(-DUSE_WINDOWS_IO) endif() @@ -100,6 +121,9 @@ target_compile_features(octree_lib PUBLIC cxx_std_11) if(USE_RPLY) target_link_libraries(octree_lib rply) endif(USE_RPLY) +if(USE_GLOG) + target_link_libraries(octree_lib glog::glog) +endif(USE_GLOG) # add tools file(GLOB_RECURSE srcs "${PROJECT_SOURCE_DIR}/tools/*.cpp") @@ -116,5 +140,16 @@ endforeach(source) # add the python interface if(USE_PYTHON) + message(STATUS "octree: USE_PYTHON") add_subdirectory(python) -endif() \ No newline at end of file +endif() + +# add gtest +set(gtest_path "${PROJECT_SOURCE_DIR}/external/octree-ext/googletest") +set(gtest_force_shared_crt ON CACHE BOOL "" FORCE) +add_subdirectory(${gtest_path} EXCLUDE_FROM_ALL) +set_target_properties(gtest gtest_main PROPERTIES FOLDER "ext") + +# add the test +add_executable(octree_test ${src_test}) +target_link_libraries(octree_test octree_lib gtest gtest_main) \ No newline at end of file diff --git a/octree/octree/contour.cpp b/octree/octree/contour.cpp index c277c72..ffa449f 100644 --- a/octree/octree/contour.cpp +++ b/octree/octree/contour.cpp @@ -1,19 +1,19 @@ #include "contour.h" -#include "marching_cube.h" +#include "marching_cube.h" void Contour::marching_cube(vector& V, vector& F) { // subdivide const int depth = octree_->info().depth(); - vector nodes_subdivided; + vector nodes_subdivided; for (int d = octree_->info().full_layer(); d < depth; ++d) { // Check subdividion of octree nodes int nnum = octree_->info().node_num(d); - vector nodes_need_subdivide; + vector nodes_need_subdivide; for (int i = 0; i < nnum; ++i) { // Only check the leaf nodes if (octree_->children_cpu(d)[i] < 0) { - uint32 keyi = octree_->key_cpu(d)[i]; + uintk keyi = octree_->key_cpu(d)[i]; if (check_subdividion(keyi, d)) { nodes_need_subdivide.push_back(keyi); } @@ -22,7 +22,7 @@ void Contour::marching_cube(vector& V, vector& F) { // check the subdivided nodes in the last iteration for (int i = 0; i < nodes_subdivided.size(); ++i) { - uint32 keyi = nodes_subdivided[i]; + uintk keyi = nodes_subdivided[i]; if (check_subdividion(keyi, d)) { nodes_need_subdivide.push_back(keyi); } @@ -37,11 +37,13 @@ void Contour::marching_cube(vector& V, vector& F) { } // marching cube - V.clear(); F.clear(); - nodes_subdivided.insert(nodes_subdivided.end(), - octree_->key_cpu(depth), octree_->key_cpu(depth) + octree_->info().node_num(depth)); + V.clear(); + F.clear(); + nodes_subdivided.insert( + nodes_subdivided.end(), octree_->key_cpu(depth), + octree_->key_cpu(depth) + octree_->info().node_num(depth)); for (int i = 0; i < nodes_subdivided.size(); ++i) { - uint32 weight_case = 0; + uintk weight_case = 0; float corner_val[8], pt[3]; octree_->key2xyz(pt, nodes_subdivided[i], depth); for (int j = 0; j < 8; ++j) { @@ -60,39 +62,43 @@ void Contour::marching_cube(vector& V, vector& F) { } // translate and scale points - const float* bbmin = octree_->info().bbmin(); - const float scale = octree_->info().bbox_max_width() / float(1 << depth); - for (int i = 0; i < V.size() / 3; ++i) { - for (int c = 0; c < 3; ++c) { - V[i * 3 + c] = V[i * 3 + c] * scale + bbmin[c]; + if (rescale_) { + const float* bbmin = octree_->info().bbmin(); + const float scale = octree_->info().bbox_max_width() / float(1 << depth); + for (int i = 0; i < V.size() / 3; ++i) { + for (int c = 0; c < 3; ++c) { + V[i * 3 + c] = V[i * 3 + c] * scale + bbmin[c]; + } } } } pair Contour::fval(int x, int y, int z) { const int depth = octree_->info().depth(); - int key = (x << 2 * depth) | (y << depth) | z; + int key = (x << 2 * depth) | (y << depth) | z; // qq: TODO: uintk auto it = fval_map_.find(key); if (it == fval_map_.end()) { auto v = value_.fval(x, y, z); - fval_map_[key] = v; // insert new element + fval_map_[key] = v; // insert new element return v; } else { return it->second; } } -bool Contour::check_subdividion(const uint32 node_key, const int depth) { +bool Contour::check_subdividion(const uintk node_key, const int depth) { // get cooridinates - uint32 xyz[3] = { 0 }; + uintk xyz[3] = {0}; octree_->key2xyz(xyz, node_key, depth); int depth_ = octree_->info().depth(); const int scale = 1 << (depth_ - depth); - for (int c = 0; c < 3; ++c) { xyz[c] *= scale; } + for (int c = 0; c < 3; ++c) { + xyz[c] *= scale; + } // check 8 cornors - const uint32 mask[8] = { 1, 2, 4, 8, 16, 32, 64, 128 }; - uint32 cube_case = 0, weight_case = 0; + const uintk mask[8] = {1, 2, 4, 8, 16, 32, 64, 128}; + uintk cube_case = 0, weight_case = 0; for (int i = 0; i < 8; ++i) { int x = xyz[0] + MarchingCube::corner_[i][0] * scale; int y = xyz[1] + MarchingCube::corner_[i][2] * scale; @@ -106,20 +112,17 @@ bool Contour::check_subdividion(const uint32 node_key, const int depth) { // check 6 faces const int coord[6][3] = { - {xyz[0], xyz[1], xyz[2]}, {xyz[0] + scale, xyz[1], xyz[2]}, - {xyz[0], xyz[1], xyz[2]}, {xyz[0], xyz[1] + scale, xyz[2]}, - {xyz[0], xyz[1], xyz[2]}, {xyz[0], xyz[1], xyz[2] + scale} - }; - const int axis1[6][3] = { - {0, 1, 0}, {0, 1, 0}, {1, 0, 0}, {1, 0, 0}, {1, 0, 0}, {1, 0, 0} - }; - const int axis2[6][3] = { - {0, 0, 1}, {0, 0, 1}, {0, 0, 1}, {0, 0, 1}, {0, 1, 0}, {0, 1, 0} - }; + {xyz[0], xyz[1], xyz[2]}, {xyz[0] + scale, xyz[1], xyz[2]}, + {xyz[0], xyz[1], xyz[2]}, {xyz[0], xyz[1] + scale, xyz[2]}, + {xyz[0], xyz[1], xyz[2]}, {xyz[0], xyz[1], xyz[2] + scale}}; + const int axis1[6][3] = {{0, 1, 0}, {0, 1, 0}, {1, 0, 0}, + {1, 0, 0}, {1, 0, 0}, {1, 0, 0}}; + const int axis2[6][3] = {{0, 0, 1}, {0, 0, 1}, {0, 0, 1}, + {0, 0, 1}, {0, 1, 0}, {0, 1, 0}}; for (int i = 0; i < 6; ++i) { for (int m = 0; m < scale; ++m) { for (int n = 0; n < scale; ++n) { - uint32 face_case = 0, wt_case = 0; + uintk face_case = 0, wt_case = 0; for (int k = 0; k < 4; ++k) { int m1 = (k & 1) ? m + 1 : m; int n1 = (k & 2) ? n + 1 : n; @@ -130,7 +133,6 @@ bool Contour::check_subdividion(const uint32 node_key, const int depth) { auto fvalue = fval(x, y, z); // pair if (fvalue.first < 0) face_case |= mask[k]; if (fvalue.second != 0) wt_case |= mask[k]; - } if (face_case != 0 && face_case != 15 && wt_case == 15) return true; } @@ -140,22 +142,22 @@ bool Contour::check_subdividion(const uint32 node_key, const int depth) { return false; } -void Contour::subdivide(uint32* key_output, const uint32 key_input) const { - // !!! caveat: depth should be smaller than 8 - typedef unsigned char ubyte; +void Contour::subdivide(uintk* key_output, const uintk key_input) const { + typedef typename KeyTrait::uints uints; + if (octree_->info().is_key2xyz()) { - const ubyte* pt = reinterpret_cast(&key_input); - ubyte x = pt[0] << 1; - ubyte y = pt[1] << 1; - ubyte z = pt[2] << 1; + const uints* pt = reinterpret_cast(&key_input); + uints x = pt[0] << 1; + uints y = pt[1] << 1; + uints z = pt[2] << 1; for (int i = 0; i < 8; ++i) { - ubyte* xyz = reinterpret_cast(key_output + i); + uints* xyz = reinterpret_cast(key_output + i); xyz[0] = (i & 1) ? x + 1 : x; xyz[1] = (i & 2) ? y + 1 : y; xyz[2] = (i & 4) ? z + 1 : z; } } else { - uint32 key_in = key_input << 3; + uintk key_in = key_input << 3; for (int i = 0; i < 8; ++i) { key_output[i] = key_in | i; } diff --git a/octree/octree/contour.h b/octree/octree/contour.h index 3723cbf..bfe954d 100644 --- a/octree/octree/contour.h +++ b/octree/octree/contour.h @@ -1,23 +1,25 @@ #ifndef _OCTREE_CONTOUR_ #define _OCTREE_CONTOUR_ -#include -#include #include +#include +#include #include "octree_parser.h" #include "octree_value.h" +#include "types.h" using std::pair; -using std::vector; using std::unordered_map; - +using std::vector; class Contour { public: - Contour(const OctreeParser* oct = nullptr): value_(oct) { + Contour(const OctreeParser* oct = nullptr, bool rescale = true) + : value_(oct), rescale_(rescale) { set_octree(oct); } + void set_octree(const OctreeParser* oct) { octree_ = oct; fval_map_.clear(); @@ -26,16 +28,15 @@ class Contour { void marching_cube(vector& V, vector& F); protected: - typedef unsigned int uint32; pair fval(int x, int y, int z); - bool check_subdividion(const uint32 node_key, const int depth); - void subdivide(uint32* key_output, const uint32 key_input) const; + bool check_subdividion(const uintk node_key, const int depth); + void subdivide(uintk* key_output, const uintk key_input) const; protected: OctreeValue value_; const OctreeParser* octree_; unordered_map > fval_map_; - + bool rescale_; }; #endif \ No newline at end of file diff --git a/octree/octree/marching_cube.cpp b/octree/octree/marching_cube.cpp index 9992f95..80ee935 100644 --- a/octree/octree/marching_cube.cpp +++ b/octree/octree/marching_cube.cpp @@ -38,7 +38,7 @@ unsigned int MarchingCube::compute_cube_case() const { return cube_case; } -void MarchingCube::contouring(vector& vtx, vector& face) const { +void MarchingCube::contouring(vector& vtx, vector& face) { // compute cube cases unsigned int cube_case = compute_cube_case(); @@ -72,6 +72,13 @@ void MarchingCube::contouring(vector& vtx, vector& face) const { } } +void MarchingCube::compute(const vector& fval, float iso_val, + const vector& left_btm, int vid) { + vtx_.clear(); + face_.clear(); + set(fval.data(), iso_val, left_btm.data(), vid); + contouring(vtx_, face_); +} void intersect_cube(vector& V, const float* pt, const float* pt_base, const float* normal) { diff --git a/octree/octree/marching_cube.h b/octree/octree/marching_cube.h index 4a09807..7062691 100644 --- a/octree/octree/marching_cube.h +++ b/octree/octree/marching_cube.h @@ -10,13 +10,19 @@ class MarchingCube { MarchingCube() : fval_(nullptr), iso_value_(0), left_btm_(nullptr), vtx_id_(0) {} MarchingCube(const float* fval, float iso_val, const float* left_btm, int vid); void set(const float* fval, float iso_val, const float* left_btm, int vid); - void contouring(vector& vtx, vector& face) const; + void contouring(vector& vtx, vector& face); + void compute(const vector& fval, float iso_val, + const vector& left_btm, int vid); unsigned int compute_cube_case() const; private: inline int btwhere(int x) const; inline void interpolation(float* pt, const float* pt1, const float* pt2, - const float f1, const float f2) const; + const float f1, const float f2) const; + + public: + vector vtx_; + vector face_; protected: const float* fval_; diff --git a/octree/octree/math_functions.cpp b/octree/octree/math_functions.cpp index 7a4f45c..0cf4823 100644 --- a/octree/octree/math_functions.cpp +++ b/octree/octree/math_functions.cpp @@ -31,7 +31,7 @@ void bounding_sphere(float& radius, float* center, const float* pt, const int np // if so, just calculate the bounding box float bbmin[3] = { 0.0f, 0.0f, 0.0f }; float bbmax[3] = { 0.0f, 0.0f, 0.0f }; - bouding_box(bbmin, bbmax, pt, npt); + bounding_box(bbmin, bbmax, pt, npt); for (int j = 0; j < dim; ++j) { center[j] = (bbmax[j] + bbmin[j]) / 2.0f; @@ -110,7 +110,7 @@ void bounding_sphere(float& radius, float* center, const float* pt, const int np #endif -void bouding_box(float* bbmin, float* bbmax, const float* pt, const int npt) { +void bounding_box(float* bbmin, float* bbmax, const float* pt, const int npt) { const int dim = 3; if (npt < 1) return; for (int i = 0; i < 3; ++i) { diff --git a/octree/octree/math_functions.h b/octree/octree/math_functions.h index 743760a..2ba4336 100644 --- a/octree/octree/math_functions.h +++ b/octree/octree/math_functions.h @@ -8,7 +8,7 @@ using std::vector; const float ESP = 1.0e-30f; void bounding_sphere(float& radius, float* center, const float* pt, const int npt); -void bouding_box(float* bbmin, float* bbmax, const float* pt, const int npt); +void bounding_box(float* bbmin, float* bbmax, const float* pt, const int npt); // !!! The matrix in this header is in column-major storage order !!! diff --git a/octree/octree/merge_octrees.cpp b/octree/octree/merge_octrees.cpp index 01c50f6..a2b9636 100644 --- a/octree/octree/merge_octrees.cpp +++ b/octree/octree/merge_octrees.cpp @@ -1,8 +1,10 @@ #include "merge_octrees.h" -#include "octree_nn.h" + #include "logs.h" +#include "octree_nn.h" +#include "types.h" -void merge_octrees(vector& octree_out, const vector octrees_in) { +void merge_octrees(vector& octree_out, const vector octrees_in) { MergeOctrees mo; mo.init(octrees_in); mo.check_input(); @@ -12,7 +14,6 @@ void merge_octrees(vector& octree_out, const vector octrees_ mo.merge_octree(); } - void MergeOctrees::init(const vector& octrees) { batch_size_ = octrees.size(); octree_parsers_.resize(batch_size_); @@ -23,7 +24,6 @@ void MergeOctrees::init(const vector& octrees) { full_layer_ = octree_parsers_[0].info().full_layer(); } - void MergeOctrees::check_input() { string err_msg; bool valid = octree_parsers_[0].info().check_format(err_msg); @@ -32,7 +32,7 @@ void MergeOctrees::check_input() { valid = octree_parsers_[i].info().check_format(err_msg); CHECK(valid) << err_msg; CHECK(octree_parsers_[0].info().is_consistent(octree_parsers_[i].info())) - << "The formats of input octrees are not consistent, check the database"; + << "The formats of input octrees are not consistent"; } } @@ -95,37 +95,38 @@ void MergeOctrees::set_batch_info() { info_batch_.set_batch_size(batch_size_); // add the neighbor property const int kNeighChannel = 8; - info_batch_.set_property(OctreeInfo::kNeigh, kNeighChannel, -1); + info_batch_.set_property(OctreeInfo::kNeigh, kNeighChannel, -1); // qq: kNeighChannel is channel, -1 is location, means the for every octants // update nodenumber - info_batch_.set_nnum(nnum_batch_.data()); + info_batch_.set_nnum(nnum_batch_.data()); // qq: cumulative node number of the batch, info_batch_.set_nempty(nnum_nempty_batch_.data()); - info_batch_.set_nnum_cum(); - info_batch_.set_ptr_dis(); - //bool valid = info_batch.check_format(err_msg); - //CHECK(valid) << err_msg; + info_batch_.set_nnum_cum(); // qq: default capacity is 0. set nnum_cum_ from d=0 to depth +2 + info_batch_.set_ptr_dis(); // qq: check + // bool valid = info_batch.check_format(err_msg); + // CHECK(valid) << err_msg; } void MergeOctrees::set_batch_parser(vector& octree_out) { - int sz = info_batch_.sizeof_octree(); + int64_t sz = info_batch_.sizeof_octree(); // qq: TODO: long sz octree_out.resize(sz); octbatch_parser_.set_cpu(octree_out.data(), &info_batch_); } void MergeOctrees::merge_octree() { - //omp_set_num_threads(8); + typedef typename KeyTrait::uints uints; + + // omp_set_num_threads(8); //#pragma omp parallel for for (int i = 0; i < batch_size_; ++i) { // copy key - // the channel and location of key is 1 and -1 (todo: !!! channel 2 for deeper key) + // the channel and location of key is 1 and -1 for (int d = 0; d < depth_ + 1; ++d) { if (!info_batch_.has_property(OctreeInfo::kKey)) break; int p = i * (depth_ + 1) + d; - uint32* des = octbatch_parser_.mutable_key_cpu(d) + nnum_cum_layer_[p]; - const uint32* src = octree_parsers_[i].key_cpu(d); + uintk* des = octbatch_parser_.mutable_key_cpu(d) + nnum_cum_layer_[p]; + const uintk* src = octree_parsers_[i].key_cpu(d); for (int j = 0; j < nnum_[p]; ++j) { des[j] = src[j]; - // !!! todo: deal with octree depth > 8 - unsigned char* ptr = reinterpret_cast(des + j); + uints* ptr = reinterpret_cast(des + j); ptr[3] = i; } } @@ -150,7 +151,8 @@ void MergeOctrees::merge_octree() { if (!info_batch_.has_property(OctreeInfo::kFeature)) break; int p = i * (depth_ + 1) + d; for (int c = 0; c < feature_channel; c++) { - float* des = octbatch_parser_.mutable_feature_cpu(d) + c * nnum_batch_[d] + nnum_cum_layer_[p]; + float* des = octbatch_parser_.mutable_feature_cpu(d) + // qq: here ~240 million with bs=1. + c * nnum_batch_[d] + nnum_cum_layer_[p]; const float* src = octree_parsers_[i].feature_cpu(d) + c * nnum_[p]; for (int j = 0; j < nnum_[p]; ++j) { des[j] = src[j]; } } @@ -188,9 +190,9 @@ void MergeOctrees::merge_octree() { calc_neigh_cpu(octbatch_parser_.mutable_neighbor_cpu(d), d, batch_size_); } else { calc_neigh_cpu(octbatch_parser_.mutable_neighbor_cpu(d), - octbatch_parser_.neighbor_cpu(d - 1), - octbatch_parser_.children_cpu(d - 1), - octbatch_parser_.info().node_num(d - 1)); + octbatch_parser_.neighbor_cpu(d - 1), + octbatch_parser_.children_cpu(d - 1), + octbatch_parser_.info().node_num(d - 1)); } } } diff --git a/octree/octree/merge_octrees.h b/octree/octree/merge_octrees.h index b5a1367..9b899f5 100644 --- a/octree/octree/merge_octrees.h +++ b/octree/octree/merge_octrees.h @@ -1,18 +1,14 @@ #ifndef _OCTREE_MERGE_OCTREES_ #define _OCTREE_MERGE_OCTREES_ -#include #include #include "octree_parser.h" using std::vector; -using std::string; -typedef uint32_t uint32; void merge_octrees(vector& octree_out, const vector octrees_in); - // A simple implementation of index matrix class Index { public: @@ -24,20 +20,15 @@ class Index { data_.assign(row_ * col_, 0); } - int operator()(int c, int r) const { - return data_[row_ * c + r]; - } + int operator()(int c, int r) const { return data_[row_ * c + r]; } - int& operator()(int c, int r) { - return data_[row_ * c + r]; - } + int& operator()(int c, int r) { return data_[row_ * c + r]; } protected: int row_, col_; vector data_; }; - class MergeOctrees { public: void init(const vector& octrees); @@ -66,5 +57,4 @@ class MergeOctrees { OctreeParser octbatch_parser_; }; - -#endif // _OCTREE_MERGE_OCTREES_ +#endif // _OCTREE_MERGE_OCTREES_ diff --git a/octree/octree/octree.cpp b/octree/octree/octree.cpp index c516c28..33a8a26 100644 --- a/octree/octree/octree.cpp +++ b/octree/octree/octree.cpp @@ -10,6 +10,7 @@ #include #include #include +#include #include "math_functions.h" #include "octree_nn.h" @@ -26,17 +27,28 @@ void Octree::set_octree(vector& data) { this->set_cpu(buffer_.data()); } -void Octree::set_octree(const char* data, const int sz) { +void Octree::set_octree(const char* data, const int64_t sz) { // qq: TODO: with batches, sz can exceed int range + resize_octree(sz); + memcpy(buffer_.data(), data, sz); + this->set_cpu(buffer_.data()); +} +void Octree::set_octree(const char* data, const int sz) { // qq: TODO: with batches, sz can exceed int range resize_octree(sz); memcpy(buffer_.data(), data, sz); this->set_cpu(buffer_.data()); } -void Octree::resize_octree(const int sz) { + +void Octree::resize_octree(const int64_t sz) { // qq: TODO: with batches, sz can exceed int range + buffer_.resize(sz); + this->set_cpu(buffer_.data()); +} +void Octree::resize_octree(const int sz) { // qq: TODO: with batches, sz can exceed int range buffer_.resize(sz); this->set_cpu(buffer_.data()); } + bool Octree::read_octree(const string& filename) { std::ifstream infile(filename, std::ios::binary); if (!infile) return false; @@ -80,9 +92,9 @@ void Octree::build(const OctreeInfo& octree_info, const Points& point_cloud) { // preprocess, get key and sort vector pts_scaled; normalize_pts(pts_scaled, point_cloud); - vector node_keys, sorted_idx; + vector node_keys, sorted_idx; sort_keys(node_keys, sorted_idx, pts_scaled); - vector unique_idx; + vector unique_idx; unique_key(node_keys, unique_idx); // build octree structure @@ -160,7 +172,7 @@ void Octree::normalize_pts(vector& pts_scaled, const Points& point_cloud) pts_scaled.resize(3 * npt); // normalize the points into the range [0, 1 << depth_) using bbox_width - #pragma omp parallel for + //#pragma omp parallel for for (int i = 0; i < npt; i++) { int i3 = i * 3; for (int j = 0; j < 3; j++) { @@ -169,26 +181,24 @@ void Octree::normalize_pts(vector& pts_scaled, const Points& point_cloud) } } -void Octree::sort_keys(vector& sorted_keys, vector& sorted_idx, +void Octree::sort_keys(vector& sorted_keys, vector& sorted_idx, const vector& pts_scaled) { - - // compute the code int depth_ = oct_info_.depth(); int npt = pts_scaled.size() / 3; - vector code(npt); - #pragma omp parallel for + vector> code; + code.reserve(npt); + + //#pragma omp parallel for for (int i = 0; i < npt; i++) { // compute key - uint32 pt[3], key; + uintk pt[3], key; for (int j = 0; j < 3; ++j) { - pt[j] = static_cast(pts_scaled[3 * i + j]); + pt[j] = static_cast(pts_scaled[3 * i + j]); } compute_key(key, pt, depth_); // generate code - uint32* ptr = reinterpret_cast(&code[i]); - ptr[0] = i; - ptr[1] = key; + code.push_back(std::make_pair(key, i)); } // sort all the code @@ -197,15 +207,14 @@ void Octree::sort_keys(vector& sorted_keys, vector& sorted_idx, // unpack the code sorted_keys.resize(npt); sorted_idx.resize(npt); - #pragma omp parallel for + //#pragma omp parallel for for (int i = 0; i < npt; i++) { - uint32* ptr = reinterpret_cast(&code[i]); - sorted_idx[i] = ptr[0]; - sorted_keys[i] = ptr[1]; + sorted_keys[i] = code[i].first; + sorted_idx[i] = code[i].second; } } -void Octree::build_structure(vector& node_keys) { +void Octree::build_structure(vector& node_keys) { const int depth_ = oct_info_.depth(); const int full_layer_ = oct_info_.full_layer(); children_.resize(depth_ + 1); @@ -214,7 +223,7 @@ void Octree::build_structure(vector& node_keys) { // layer 0 to full_layer_: the octree is full in these layers for (int curr_depth = 0; curr_depth <= full_layer_; curr_depth++) { vector& children = children_[curr_depth]; - vector& keys = keys_[curr_depth]; + vector& keys = keys_[curr_depth]; int n = 1 << 3 * curr_depth; keys.resize(n, -1); children.resize(n, -1); @@ -230,21 +239,21 @@ void Octree::build_structure(vector& node_keys) { for (int curr_depth = depth_; curr_depth > full_layer_; --curr_depth) { // compute parent key, i.e. keys of layer (curr_depth -1) int n = node_keys.size(); - vector parent_keys(n); + vector parent_keys(n); #pragma omp parallel for for (int i = 0; i < n; i++) { parent_keys[i] = node_keys[i] >> 3; } // compute unique parent key - vector parent_pidx; + vector parent_pidx; unique_key(parent_keys, parent_pidx); // augment children keys and create nodes int np = parent_keys.size(); int nch = np << 3; vector& children = children_[curr_depth]; - vector& keys = keys_[curr_depth]; + vector& keys = keys_[curr_depth]; children.resize(nch, -1); keys.resize(nch, 0); @@ -254,18 +263,18 @@ void Octree::build_structure(vector& node_keys) { } // compute base address for each node - vector addr(nch); + vector addr(nch); for (int i = 0; i < np; i++) { - for (uint32 j = parent_pidx[i]; j < parent_pidx[i + 1]; j++) { + for (uintk j = parent_pidx[i]; j < parent_pidx[i + 1]; j++) { addr[j] = i << 3; } } // set children pointer and parent pointer - #pragma omp parallel for + //#pragma omp parallel for for (int i = 0; i < n; i++) { // address - uint32 k = (node_keys[i] & 7u) | addr[i]; + uintk k = (node_keys[i] & 7u) | addr[i]; // set children pointer for layer curr_depth children[k] = i; @@ -279,7 +288,7 @@ void Octree::build_structure(vector& node_keys) { // Now the node_keys are the key for full_layer if (depth_ > full_layer_) { for (int i = 0; i < node_keys.size(); i++) { - uint32 j = node_keys[i]; + uintk j = node_keys[i]; children_[full_layer_][j] = i; } } @@ -313,7 +322,7 @@ void Octree::calc_node_num() { // compute the average signal for the last octree layer void Octree::calc_signal(const Points& point_cloud, const vector& pts_scaled, - const vector& sorted_idx, const vector& unique_idx) { + const vector& sorted_idx, const vector& unique_idx) { int depth = oct_info_.depth(); const float* normals = point_cloud.ptr(PointsInfo::kNormal); const float* features = point_cloud.ptr(PointsInfo::kFeature); @@ -331,7 +340,7 @@ void Octree::calc_signal(const Points& point_cloud, const vector& pts_sca if (node_type(t) == kLeaf) continue; vector avg_normal(channel, 0.0f); - for (uint32 j = unique_idx[t]; j < unique_idx[t + 1]; j++) { + for (uintk j = unique_idx[t]; j < unique_idx[t + 1]; j++) { int h = sorted_idx[j]; for (int c = 0; c < channel; ++c) { avg_normal[c] += normals[channel * h + c]; @@ -362,7 +371,7 @@ void Octree::calc_signal(const Points& point_cloud, const vector& pts_sca if (node_type(t) == kLeaf) continue; vector avg_feature(channel, 0.0f); - for (uint32 j = unique_idx[t]; j < unique_idx[t + 1]; j++) { + for (uintk j = unique_idx[t]; j < unique_idx[t + 1]; j++) { int h = sorted_idx[j]; for (int c = 0; c < channel; ++c) { avg_feature[c] += features[channel * h + c]; @@ -389,7 +398,7 @@ void Octree::calc_signal(const Points& point_cloud, const vector& pts_sca int valid_num = 0; vector avg_label(max_label_, 0); - for (uint32 j = unique_idx[t]; j < unique_idx[t + 1]; j++) { + for (uintk j = unique_idx[t]; j < unique_idx[t + 1]; j++) { int h = sorted_idx[j]; int l = static_cast(labels[h]); if (l < 0) { continue; } // invalid labels @@ -417,7 +426,7 @@ void Octree::calc_signal(const Points& point_cloud, const vector& pts_sca if (node_type(t) == kLeaf) continue; float avg_pt[3] = { 0.0f, 0.0f, 0.0f }; - for (uint32 j = unique_idx[t]; j < unique_idx[t + 1]; j++) { + for (uintk j = unique_idx[t]; j < unique_idx[t + 1]; j++) { int h = sorted_idx[j]; for (int c = 0; c < 3; ++c) { avg_pt[c] += pts_scaled[3 * h + c]; @@ -483,7 +492,7 @@ void Octree::calc_signal(const bool calc_normal_err, const bool calc_dist_err) { const vector& dnum_d = dnum_[d]; const vector& didx_d = didx_[d]; const vector& children_d = children_[d]; - const vector& key_d = keys_[d]; + const vector& key_d = keys_[d]; const float scale = static_cast(1 << (depth - d)); vector& normal_d = avg_normals_[d]; @@ -583,7 +592,7 @@ void Octree::calc_signal(const bool calc_normal_err, const bool calc_dist_err) { } } - uint32 ptu_base[3]; + uintk ptu_base[3]; compute_pt(ptu_base, key_d[i], d); float pt_base[3] = { ptu_base[0], ptu_base[1], ptu_base[2] }; if (has_dis) { @@ -632,7 +641,7 @@ void Octree::calc_signal(const bool calc_normal_err, const bool calc_dist_err) { for (int c = 0; c < 3; ++c) { dis += (pt_depth[c * nnum_depth + j] - pt_avg1[c]) * n_avg[c]; } - dis = abs(dis); + dis = fabsf(dis); if (dis > distance_max1) distance_max1 = dis; } @@ -761,10 +770,10 @@ void Octree::extrapolate_signal() { dis /= count; if (dis > 3.0f) dis = 3.0f; if (dis < -3.0f) dis = -3.0f; - if (abs(dis) < 1.0f) { + if (fabsf(dis) < 1.0f) { //bool has_intersection = false; // make the voxel has no intersection with the current voxel - unsigned int cube_cases = 0; + uint32 cube_cases = 0; for (int k = 0; k < 8; ++k) { float fval = dis; for (int j = 0; j < 3; ++j) { @@ -788,7 +797,7 @@ void Octree::extrapolate_signal() { for (int j = 0; j < nnum_d; ++j) { if (node_type(children_d[j]) == kLeaf) continue; key2xyz(ptj, keys_[d][j], d); - float dd = abs(pti[0] - ptj[0]) + abs(pti[1] - ptj[1]) + abs(pti[2] - ptj[2]); + float dd = fabsf(pti[0] - ptj[0]) + fabsf(pti[1] - ptj[1]) + fabsf(pti[2] - ptj[2]); if (dd < dis_min) { dis_min = dd; j_min = j; @@ -809,6 +818,7 @@ void Octree::extrapolate_signal() { } bool Octree::save_legacy(std::string& filename) { + typedef typename KeyTrait::uints uints; int depth_ = oct_info_.depth(); int full_layer_ = oct_info_.full_layer(); @@ -831,18 +841,18 @@ bool Octree::save_legacy(std::string& filename) { std::vector key(total_node_num), children(total_node_num); int idx = 0; for (int d = 0; d <= depth_; ++d) { - vector& keys = keys_[d]; + vector& keys = keys_[d]; for (int i = 0; i < keys.size(); ++i) { // calc point - uint32 k = keys[i], pt[3]; + uintk k = keys[i], pt[3]; compute_pt(pt, k, d); // compress - unsigned char* ptr = reinterpret_cast(&key[idx]); - ptr[0] = static_cast(pt[0]); - ptr[1] = static_cast(pt[1]); - ptr[2] = static_cast(pt[2]); - ptr[3] = static_cast(d); + uints* ptr = reinterpret_cast(&key[idx]); + ptr[0] = static_cast(pt[0]); + ptr[1] = static_cast(pt[1]); + ptr[2] = static_cast(pt[2]); + ptr[3] = static_cast(d); // children children[idx] = children_[d][i]; @@ -889,7 +899,7 @@ bool Octree::save_legacy(std::string& filename) { // } //} -void Octree::unique_key(vector& keys, vector& idx) { +void Octree::unique_key(vector& keys, vector& idx) { idx.clear(); idx.push_back(0); @@ -907,7 +917,7 @@ void Octree::unique_key(vector& keys, vector& idx) { void Octree::serialize() { - const int sz = oct_info_.sizeof_octree(); + const int64_t sz = oct_info_.sizeof_octree(); // qq: TODO: need update to long or uintk buffer_.resize(sz, 0); this->set_cpu(buffer_.data(), &oct_info_); //info_ = reinterpret_cast(buffer_.data()); @@ -934,11 +944,11 @@ void Octree::serialize() { } while(0) \ if (oct_info_.is_key2xyz()) { - vector > xyz; + vector > xyz; key_to_xyz(xyz); - SERIALIZE_PROPERTY(uint32, OctreeInfo::kKey, xyz); + SERIALIZE_PROPERTY(uintk, OctreeInfo::kKey, xyz); } else { - SERIALIZE_PROPERTY(uint32, OctreeInfo::kKey, keys_); + SERIALIZE_PROPERTY(uintk, OctreeInfo::kKey, keys_); } SERIALIZE_PROPERTY(int, OctreeInfo::kChild, children_); SERIALIZE_PROPERTY(float, OctreeInfo::kFeature, features); @@ -947,7 +957,7 @@ void Octree::serialize() { } template -void Octree::serialize(Dtype* des, const vector >& src, const int location) { +void Octree::serialize(Dtype* des, const vector >& src, const int location) { // qq: location to long ? if (location == -1) { for (int d = 0; d <= oct_info_.depth(); ++d) { des = std::copy(src[d].begin(), src[d].end(), des); @@ -1082,7 +1092,7 @@ void Octree::trim_octree() { int nnum_d = oct_info_.node_num(d); const vector& drop_d = drop[d]; - vector key; + vector key; for (int i = 0; i < nnum_d; ++i) { if (drop_d[i] == kDrop) continue; key.push_back(keys_[d][i]); @@ -1136,28 +1146,22 @@ void Octree::trim_octree() { serialize(); } -void Octree::key_to_xyz(vector >& xyz) { +void Octree::key_to_xyz(vector >& xyz) { + typedef typename KeyTrait::uints uints; const int depth = oct_info_.depth(); const int channel = oct_info_.channel(OctreeInfo::kKey); + //assert(channel == 1); xyz.resize(depth + 1); for (int d = 0; d <= depth; ++d) { int nnum = oct_info_.node_num(d); xyz[d].resize(nnum * channel, 0); - uint32* xyz_d = xyz[d].data(); + uintk* xyz_d = xyz[d].data(); for (int i = 0; i < nnum; ++i) { - uint32 pt[3] = { 0, 0, 0 }; + uintk pt[3] = { 0, 0, 0 }; compute_pt(pt, keys_[d][i], d); - - if (channel == 1) { - unsigned char* ptr = reinterpret_cast(xyz_d + i); - for (int c = 0; c < 3; ++c) { - ptr[c] = static_cast(pt[c]); - } - } else { - unsigned short* ptr = reinterpret_cast(xyz_d + 2 * i); - for (int c = 0; c < 3; ++c) { - ptr[c] = static_cast(pt[c]); - } + uints* ptr = reinterpret_cast(xyz_d + i); + for (int c = 0; c < 3; ++c) { + ptr[c] = static_cast(pt[c]); } } } @@ -1175,8 +1179,8 @@ void Octree::calc_split_label() { if (node_type(children_[d][i]) == kLeaf) { split_labels_[d][i] = 0; // empty node if (adaptive) { - float t = abs(avg_normals_[d][i]) + abs(avg_normals_[d][nnum_d + i]) + - abs(avg_normals_[d][2 * nnum_d + i]); + float t = fabsf(avg_normals_[d][i]) + fabsf(avg_normals_[d][nnum_d + i]) + + fabsf(avg_normals_[d][2 * nnum_d + i]); // todo: t != 0 && has_intersection if (t != 0) split_labels_[d][i] = 2; // surface-well-approximated } @@ -1203,7 +1207,7 @@ void Octree::octree2pts(Points& point_cloud, int depth_start, int depth_end, bool rescale) const { const int depth = info_->depth(); const float* bbmin = info_->bbmin(); - const float kMul = rescale ? info_->bbox_max_width() / float(1 << depth) : 1.0f; + const float kMul = info_->bbox_max_width() / float(1 << depth); valid_depth_range(depth_start, depth_end); vector pts, normals, labels; @@ -1219,13 +1223,16 @@ void Octree::octree2pts(Points& point_cloud, int depth_start, int depth_end, float n[3], pt[3]; node_normal(n, i, d); - float len = abs(n[0]) + abs(n[1]) + abs(n[2]); + float len = fabsf(n[0]) + fabsf(n[1]) + fabsf(n[2]); if (len == 0 && d != depth) continue; // for adaptive octree node_pos(pt, i, d); for (int c = 0; c < 3; ++c) { + if (rescale) { // !!! note the scale and bbmin + pt[c] = pt[c] * scale + bbmin[c]; + } normals.push_back(n[c]); - pts.push_back(pt[c] * scale + bbmin[c]); // !!! note the scale and bbmin + pts.push_back(pt[c]); } if (label_d != nullptr) labels.push_back(label_d[i]); } @@ -1235,7 +1242,7 @@ void Octree::octree2pts(Points& point_cloud, int depth_start, int depth_end, } void Octree::octree2mesh(vector& V, vector& F, int depth_start, - int depth_end) const { + int depth_end, bool rescale) const { const int depth = info_->depth(); const float* bbmin = info_->bbmin(); const float kMul = info_->bbox_max_width() / float(1 << depth); @@ -1253,7 +1260,7 @@ void Octree::octree2mesh(vector& V, vector& F, int depth_start, float n[3], pt[3], pt_ref[3]; node_normal(n, i, d); - float len = abs(n[0]) + abs(n[1]) + abs(n[2]); + float len = fabsf(n[0]) + fabsf(n[1]) + fabsf(n[2]); if (len == 0) continue; node_pos(pt, i, d, pt_ref); @@ -1279,7 +1286,10 @@ void Octree::octree2mesh(vector& V, vector& F, int depth_start, nv = vtx.size() / 3; for (int i = 0; i < nv; ++i) { for (int c = 0; c < 3; ++c) { - float vl = vtx[i * 3 + c] * scale + bbmin[c]; + float vl = vtx[i * 3 + c]; + if (rescale) { // !!! note the scale and bbmin + vl = vl * scale + bbmin[c]; + } V.push_back(vl); } } @@ -1287,122 +1297,5 @@ void Octree::octree2mesh(vector& V, vector& F, int depth_start, } -//// only work for adaptive octree -//void Octree::extrapolate_signal() { -// const int depth = info().depth(); -// const int full_layer = info().full_layer(); -// const float imul = 2.0f / sqrtf(3.0f); -// const int channel_label = info().channel(OctreeInfo::kLabel); -// const int channel_normal = 3; -// const bool has_dis = info().has_displace(); -// const bool has_label = channel_label; -// -// for (int d = depth; d >= full_layer; --d) { -// const int nnum_d = info().node_num(d); -// const int* child_d = children_cpu(d); -// const uint32* keys_d = key_cpu(d); -// float* normal_d = mutable_feature_cpu(d); -// //float* label_d = mutable_label(d); // !!!todo: label -// float* displacement_d = normal_d + 3 * nnum_d; -// -// // For adaptive octree, there is kNonEmptyLeaf, -// // but the original child_d contains only kLeaf and kInternelNode, -// // So we use children_d to mark the kNonEmptyLeaf -// vector children_d(child_d, child_d + nnum_d); -// for (int i = 0; i < nnum_d; ++i) { -// if (d == depth) break; -// if (node_type(children_d[i]) == kLeaf) { -// float n[3] = { 0 }; -// node_normal(n, i, d); -// float len = abs(n[0]) + abs(n[1]) + abs(n[2]); -// if (len != 0) { children_d[i] = -2; } -// } -// } -// -// for (int i = 0; i < nnum_d; ++i) { -// if (node_type(children_d[i]) != kLeaf) continue; -// int id = i % 8; -// int i_base = i - id; -// -// float count = ESP; // the non-empty node number -// for (int j = i_base; j < i_base + 8; ++j) { -// if (node_type(children_d[j]) != kLeaf) count += 1.0f; -// } -// -// vector n_avg(channel_normal, 0.0f); -// for (int j = i_base; j < i_base + 8; ++j) { -// if (node_type(children_d[j]) == kLeaf) continue; -// for (int c = 0; c < channel_normal; ++c) { -// n_avg[c] += normal_d[c * nnum_d + j]; -// } -// } -// -// float ilen = 1.0f / (norm2(n_avg) + ESP); -// for (int c = 0; c < channel_normal; ++c) { -// n_avg[c] *= ilen; -// normal_d[c * nnum_d + i] = n_avg[c]; // output -// } -// -// if (has_dis && count > 0.5f) { -// float xyzs[8][3] = { -// {0, 0, 0}, {0, 0, 1.0f}, {0, 1.0f, 0}, {0, 1.0f, 1.0f}, -// {1.0f, 0, 0}, {1.0f, 0, 1.0f}, {1.0f, 1.0f, 0}, {1.0f, 1.0f, 1.0f}, -// }; -// float dis = 0; -// for (int j = i_base; j < i_base + 8; ++j) { -// if (node_type(children_d[j]) == kLeaf) continue; -// dis += displacement_d[j]; -// for (int c = 0; c < channel_normal; ++c) { -// dis += normal_d[c * nnum_d + j] * (xyzs[j % 8][c] - xyzs[id][c]) * imul; -// } -// } -// dis /= count; -// if (dis > 3.0f) dis = 3.0f; -// if (dis < -3.0f) dis = -3.0f; -// if (abs(dis) < 1.0f) { -// // make the voxel has no intersection with the current voxel -// uint32 cube_cases = 0; -// for (int k = 0; k < 8; ++k) { -// float fval = dis; -// for (int j = 0; j < 3; ++j) { -// fval += (0.5 - MarchingCube::corner_[k][j]) * n_avg[j] * imul; -// } -// if (fval < 0) cube_cases |= (1 << k); -// } -// if (cube_cases != 255 && cube_cases != 0) { -// dis = dis < 0 ? -1.0f : 1.0f; -// } -// } -// -// displacement_d[i] = dis; -// } -// -// if (has_dis && count < 0.5f) { -// // find the closest point -// int j_min = -1; -// float pti[3], ptj[3], dis_min = 1.0e30f; -// key2xyz(pti, keys_d[i], d); -// for (int j = 0; j < nnum_d; ++j) { -// if (node_type(children_d[j]) == kLeaf) continue; -// key2xyz(ptj, keys_d[j], d); -// float dis = abs(pti[0] - ptj[0]) + abs(pti[1] - ptj[1]) + abs(pti[2] - ptj[2]); -// if (dis < dis_min) { -// dis_min = dis; -// j_min = j; -// } -// } -// // calc the displacement -// float dis = displacement_d[j_min]; -// key2xyz(ptj, keys_d[j_min], d); -// for (int c = 0; c < channel_normal; ++c) { -// dis += normal_d[c * nnum_d + j_min] * (ptj[c] - pti[c]) * imul; -// } -// if (dis > 0.0f) dis = 2.0f; -// if (dis < 0.0f) dis = -2.0f; -// displacement_d[i] = dis; -// } -// } -// } -//} diff --git a/octree/octree/octree.h b/octree/octree/octree.h index bbc1808..cafd664 100644 --- a/octree/octree/octree.h +++ b/octree/octree/octree.h @@ -16,8 +16,10 @@ class Octree : public OctreeParser { Octree() {} void set_octree(const Octree& octree_in); // copy from octree_in void set_octree(vector& data); // swap data and buffer_ - void set_octree(const char* data, const int sz); - void resize_octree(const int sz); + void set_octree(const char* data, const int sz); // qq: TODO: int to long + void set_octree(const char* data, const int64_t sz); + void resize_octree(const int sz); // qq: TODO: int to long + void resize_octree(const int64_t sz); const vector& buffer() const { return buffer_; } bool read_octree(const string& filename); @@ -31,29 +33,31 @@ class Octree : public OctreeParser { void serialize(); bool save_legacy(string& filename); - void octree2pts(Points& point_cloud, int depth_start, int depth_end, bool rescale = true) const; - void octree2mesh(vector& V, vector& F, int depth_start, int depth_end) const; + void octree2pts(Points& point_cloud, int depth_start, int depth_end, + bool rescale = true) const; + void octree2mesh(vector& V, vector& F, int depth_start, + int depth_end, bool rescale = true) const; protected: void clear(int depth = 0); void normalize_pts(vector& pts_scaled, const Points& pts); - void sort_keys(vector& sorted_keys, vector& sorted_idx, + void sort_keys(vector& sorted_keys, vector& sorted_idx, const vector& pts_scaled); - void unique_key(vector& node_key, vector& pidx); + void unique_key(vector& node_key, vector& pidx); - void build_structure(vector& node_keys); + void build_structure(vector& node_keys); void calc_node_num(); // called after the function build_structure() void calc_signal(const Points& point_cloud, const vector& pts_scaled, - const vector& sorted_idx, const vector& unique_idx); + const vector& sorted_idx, const vector& unique_idx); void calc_signal(const bool calc_normal_err, const bool calc_dist_err); void extrapolate_signal(); - void key_to_xyz(vector >& xyz); + void key_to_xyz(vector>& xyz); void calc_split_label(); template - void serialize(Dtype* des, const vector >& src, const int location); + void serialize(Dtype* des, const vector >& src, const int location); // qq: TODO: int to long void covered_depth_nodes(); void valid_depth_range(int& depth_start, int& depth_end) const; @@ -61,12 +65,7 @@ class Octree : public OctreeParser { protected: // the octree is serialized into buffer_ vector buffer_; - - // Note: structure of arrays(SoA), instead of array of structures(AoS), is - // adopted. The reason is that the SoA is more friendly to GPU-based implementation. - // In the future, probably I will try to implement this class with CUDA accroding - // to this CPU-based code. - vector > keys_; + vector > keys_; vector > children_; vector > displacement_; diff --git a/octree/octree/octree_conv.cpp b/octree/octree/octree_conv.cpp index af48673..4df41d2 100644 --- a/octree/octree/octree_conv.cpp +++ b/octree/octree/octree_conv.cpp @@ -63,17 +63,17 @@ void OctreeBaseConv::reshape() { // reshape workspce workspace_depth_ = curr_depth_; // the depth value used for octree2col if (is_deconvolution_layer() && stride_ == 2) workspace_depth_++; - workspace_h_ = btm_h; + workspace_h_ = btm_h; // qq: node num if (stride_ == 2) { if (is_deconvolution_layer()) { workspace_h_ = top_h >> 3; } else { workspace_h_ = btm_h >> 3; } } workspace_n_ = 1; - workspace_ha_ = workspace_h_; - int ideal_size = workspace_h_ * kernel_dim_; + workspace_ha_ = workspace_h_; // qq: node num + uint64 ideal_size = (uint64) workspace_h_ * (uint64) kernel_dim_; // qq: workspace_h_ here is node num at curr_depth. idea size 10 million * 24*27 if (ideal_size > MAX_SIZE && !is_1x1_) { - workspace_n_ = (ideal_size + MAX_SIZE - 1) / MAX_SIZE; - workspace_ha_ = (workspace_h_ + workspace_n_ - 1) / workspace_n_; + workspace_n_ = (ideal_size + MAX_SIZE - 1) / MAX_SIZE; // qq: thousands. + workspace_ha_ = (workspace_h_ + workspace_n_ - 1) / workspace_n_; // qq: million/thousand } workspace_shape_ = vector { kernel_dim_, workspace_ha_}; diff --git a/octree/octree/octree_conv.h b/octree/octree/octree_conv.h index de4b20f..5ab884e 100644 --- a/octree/octree/octree_conv.h +++ b/octree/octree/octree_conv.h @@ -76,10 +76,10 @@ class OctreeBaseConv { const int* ni_cpu_ptr_; // hold cpu data from NeighHelper::get_ni(kernel_size_) const int* ni_gpu_ptr_; // hold gpu data from NeighHelper::get_ni(kernel_size_) + uint64 MAX_SIZE; + GEMMEngine* engine_cpu_; GEMMEngine* engine_gpu_; - - int MAX_SIZE; }; } // namespace octree diff --git a/octree/octree/octree_info.cpp b/octree/octree/octree_info.cpp index e53462f..66f8db3 100644 --- a/octree/octree/octree_info.cpp +++ b/octree/octree/octree_info.cpp @@ -1,9 +1,14 @@ #include "octree_info.h" #include "points.h" +#include "types.h" #include +#ifdef KEY64 +const char OctreeInfo::kMagicStr[16] = "_OCTREE_2.0_"; +#else const char OctreeInfo::kMagicStr[16] = "_OCTREE_1.0_"; +#endif void OctreeInfo::initialize(int depth, int full_depth, bool node_displacement, bool node_feature, bool split_label, bool adaptive, int adaptive_depth, @@ -59,7 +64,7 @@ void OctreeInfo::initialize(int depth, int full_depth, bool node_displacement, set_location(OctreeInfo::kLabel, location); } - // init bounding box + // init bounding box bbmin_[0] = bbmin_[1] = bbmin_[2] = -1.0f; bbmax_[0] = bbmax_[1] = bbmax_[2] = 1.0f; @@ -74,14 +79,16 @@ void OctreeInfo::reset() { bool OctreeInfo::check_format(string& msg) const { msg.clear(); + const int max_depth = strcmp(kMagicStr, "_OCTREE_2.0_") ? 8 : 16; if (strcmp(kMagicStr, magic_str_) != 0) { - msg += "The version of octree format is not " + string(kMagicStr) + ".\n"; + msg += "The version of the provided octree format is " + + string(magic_str_) + ", not " + string(kMagicStr) + ".\n"; } if (batch_size_ < 0) { msg += "The batch_size_ should be larger than 0.\n"; } - if (depth_ < 1 || depth_ > 10) { - msg += "The depth_ should be in range [1, 8].\n"; + if (depth_ < 1 || depth_ > max_depth) { + msg += "The depth_ should be in [1, " + std::to_string(max_depth) + "].\n"; } if (full_layer_ < 0 || full_layer_ > depth_) { msg += "The full_layer_ should be in range [1, depth_].\n"; @@ -89,7 +96,7 @@ bool OctreeInfo::check_format(string& msg) const { if (is_adaptive_ && (adp_layer_ < full_layer_ || adp_layer_ > depth_)) { msg += "The adp_layer_ should be in range [full_layer_, depth_].\n"; } - const int channel_max[] = { 2, 1, 8, 1 << 30, 1, 1 }; + const int channel_max[] = { 2, 1, 8, 1 << 30, 1, 1 }; // qq: question, what does this do? kKey 2, kChild 1, kNeigh 8, kFeature 1<<30, kLabel 1, kSplit 1. Why child 1 and kneigh 8? for (int i = 0; i < kPTypeNum; ++i) { string str = std::to_string(i); if (channels_[i] < 0 && channels_[i] > channel_max[i]) { @@ -127,19 +134,33 @@ int OctreeInfo::channel(PropType ptype) const { return channels_[i]; } +int OctreeInfo::size_of(PropType ptype) const { + int sz = 0; + if (ptype == kChild || ptype == kNeigh) { // qq: question what is kNeigh exactly? + sz = sizeof(int); + } else if (ptype == kFeature || ptype == kLabel || ptype == kSplit) { + sz = sizeof(float); + } else if (ptype == kKey) { + sz = sizeof(uintk); + } else { + // pass + } + return sz; +} + int OctreeInfo::locations(PropType ptype) const { if (!has_property(ptype)) return 0; int i = property_index(ptype); return locations_[i]; } -int OctreeInfo::ptr_dis(PropType ptype, const int depth) const { +int64_t OctreeInfo::ptr_dis(PropType ptype, const int depth) const { if (!has_property(ptype)) return -1; int i = property_index(ptype); - int dis = ptr_dis_[i]; + int64_t dis = ptr_dis_[i]; //int dis = ptr_dis_[i]; if (locations(ptype) == -1) { - // !!! Note: sizeof(int) - dis += nnum_cum_[depth] * channel(ptype) * sizeof(int); + dis += (int64_t) nnum_cum_[depth] * channel(ptype) * size_of(ptype); // qq: TODO: dis should be long + if (dis==0){std::cout << "Warning in OctreeInfo: ptr_dis\n";} } else { // ignore the input parameter depth } @@ -233,7 +254,9 @@ void OctreeInfo::set_location(PropType ptype, int lc) { void OctreeInfo::set_ptr_dis() { // the accumulated pointer displacement - ptr_dis_[0] = sizeof(OctreeInfo); + // !!! ALERT !!! Make ptr_dis_[0] be equal to 8*n, otherwise there will be + // the memory alignment issue for CUDA when the we use 64 bit key. + ptr_dis_[0] = (sizeof(OctreeInfo) + 7) / 8 * 8; for (int i = 1; i <= kPTypeNum; ++i) { // note the " <= " is used here PropType ptype = static_cast(1 << (i - 1)); int lc = locations(ptype); @@ -241,8 +264,7 @@ void OctreeInfo::set_ptr_dis() { // If the property do not exist, lc is equal to 0, then num = 8, both of them // are meaningless. Their values are wiped out by channels_[i - 1] (= 0). // So the value of ptr_dis_[i] is still correct. - // !!! Note: sizeof(int) - ptr_dis_[i] = ptr_dis_[i - 1] + sizeof(int) * num * channels_[i - 1]; + ptr_dis_[i] = ptr_dis_[i - 1] + (int64_t) size_of(ptype) * num * channels_[i - 1]; // qq: TODO: here the size_of could be 4, num could be ~10 million, channels_ could be 24. int up to 2 billion. } } diff --git a/octree/octree/octree_info.h b/octree/octree/octree_info.h index de91d56..b3e7895 100644 --- a/octree/octree/octree_info.h +++ b/octree/octree/octree_info.h @@ -1,7 +1,9 @@ #ifndef _OCTREE_OCTREE_INFO_ #define _OCTREE_OCTREE_INFO_ +#include #include +#include class Points; using std::string; @@ -44,8 +46,9 @@ class OctreeInfo { int total_nnum_capacity() const { return nnum_cum_[depth_ + 2]; } int content_flags() const { return content_flags_; } int channel(PropType ptype) const; - int locations(PropType ptype) const; - int ptr_dis(PropType ptype, const int depth) const; + int size_of(PropType ptype) const; + int locations(PropType ptype) const; // qq: -1 or d, or 0 + int64_t ptr_dis(PropType ptype, const int depth) const; //int ptr_dis(PropType ptype, const int depth) const; // qq: TODO: long float bbox_max_width() const; bool is_key2xyz() const { return key2xyz_; } bool extrapolate() const { return extrapolate_; } @@ -54,7 +57,8 @@ class OctreeInfo { const float* bbmax() const { return bbmax_; } // todo: modify sizeof_octinfo() according to magic_str_ for back-compatibility int sizeof_octinfo() const { return sizeof(OctreeInfo); } - int sizeof_octree() const { return ptr_dis_[kPTypeNum]; } + int64_t sizeof_octree() const { return ptr_dis_[kPTypeNum]; } // qq: TODO: long + void set_magic_str(const char* str) { strcpy(magic_str_, str); } void set_content_flags(int cf); void set_batch_size(int b); void set_depth(int d); @@ -107,11 +111,7 @@ class OctreeInfo { char reserved_[254]; // reserved for future usage: 2018/12/12 private: - int ptr_dis_[16]; + int64_t ptr_dis_[16]; //int ptr_dis_[16]; // qq: what is this used for? // qq: TODO: long }; #endif // _OCTREE_OCTREE_INFO_t - -// bytes need for info: 16*1 + 4*4 + 1(4) + 4*2 + 1*2(2) + 16*4*3 + 4 + 16*4*2 + 3*4*2 + 2 + 254*1 + 16*4 + public: 1 + 4 -// static are omitted -// memory allignment of class in cpp \ No newline at end of file diff --git a/octree/octree/octree_nn.cpp b/octree/octree/octree_nn.cpp index 1235636..d6bf3ec 100644 --- a/octree/octree/octree_nn.cpp +++ b/octree/octree/octree_nn.cpp @@ -119,18 +119,6 @@ vector& NeighHelper::get_ni(const vector& kernel_size) { } -template -void memset_cpu(const int N, const Dtype alpha, Dtype* Y) { - if (alpha == 0) { - memset(Y, 0, sizeof(Dtype) * N); - return; - } - for (int i = 0; i < N; ++i) { - Y[i] = alpha; - } -} - - int num_elements(const vector& vec) { int count = vec.empty() ? 0 : 1; for (auto v : vec) { count *= v; } @@ -152,9 +140,21 @@ void resize_with_last_val(vector& vec, const int size) { } +template +void memset_cpu(const int N, const Dtype alpha, Dtype* Y) { + if (alpha == 0) { + memset(Y, 0, sizeof(Dtype) * N); // qq: does memset work with larger value? + return; + } + for (int i = 0; i < N; ++i) { + Y[i] = alpha; + } +} + + template void memcpy_cpu(const int N, const Dtype* X, Dtype* Y) { - if (X != Y) { + if (X != Y && N > 0) { memcpy(Y, X, sizeof(Dtype) * N); } } @@ -245,7 +245,7 @@ void octree_max_pool_cpu(Dtype* top_data, int top_h, int* mask, const Dtype* btm_data, int btm_h, int channel) { for (int c = 0; c < channel; ++c) { for (int h = 0; h < top_h; ++h) { - int hb = 8 * h; + int hb = 8 * h; // qq: TODO: long: do not have to, just involve num_nodes top_data[h] = btm_data[hb]; mask[h] = hb; for (int idx = hb + 1; idx < hb + 8; ++idx) { @@ -266,7 +266,7 @@ void octree_max_pool_cpu(Dtype* top_data, int top_h, int* mask, template void octree_max_unpool_cpu(const Dtype* top_data, int top_h, const int* mask, Dtype* btm_data, int btm_h, int channel) { - memset_cpu(btm_h * channel, Dtype(0), btm_data); + memset_cpu(btm_h * channel, Dtype(0), btm_data); // qq: TODO: long for (int c = 0; c < channel; ++c) { for (int h = 0; h < top_h; ++h) { @@ -296,25 +296,25 @@ void octree_mask_pool_cpu(Dtype* top_data, int top_h, const int* mask, } -void calc_neigh_cpu(int* neigh_split, const int* neigh, +void calc_neigh_cpu(int* neigh_split, const int* neigh, // qq: here neigh_split is for current level d, neigh, children, node_num are for d-1. const int* children, const int node_num) { const int* parent = NeighHelper::Get().get_parent_array().data(); const int* dis = NeighHelper::Get().get_dis_array().data(); //#pragma omp parallel for - for (int i = 0; i < node_num; ++i) { + for (int i = 0; i < node_num; ++i) { // qq: for every node in d-1, int l0 = children[i]; - if (l0 == -1) continue; - const int* ngh0 = neigh + (i >> 3 << 6); + if (l0 == -1) continue; // qq: if -1, means no child, empty + const int* ngh0 = neigh + (i >> 3 << 6); // qq: the children's index in level d const int* pi0 = parent + (i % 8) * 64; - int* ngh1 = neigh_split + (l0 << 6); + int* ngh1 = neigh_split + (l0 << 6); // qq: l0 could be 10 million, << 6 is times 64. might be too large when we have large batch size. for (int j = 0; j < 64; ++j) { ngh1[j] = -1; int k = ngh0[pi0[j]]; if (k != -1) { int l1 = children[k]; if (l1 != -1) { - ngh1[j] = (l1 << 3) + dis[j]; + ngh1[j] = (l1 << 3) + dis[j]; // qq: l1<<3 could 80 million with bs=1. dis is small. } } } @@ -322,32 +322,32 @@ void calc_neigh_cpu(int* neigh_split, const int* neigh, } void calc_neigh_cpu(int* neigh, const int depth, const int batch_size) { - uint32 node_num = 1 << 3 * depth; - const uint32 bound = 1 << depth; - for (uint32 n = 0; n < batch_size; ++n) { - for (uint32 i = 0; i < node_num; i += 8) { + uintk node_num = 1 << 3 * depth; + const uintk bound = 1 << depth; + for (uintk n = 0; n < batch_size; ++n) { + for (uintk i = 0; i < node_num; i += 8) { // key to xyz - uint32 x0 = 0, y0 = 0, z0 = 0; - for (uint32 d = 0; d < depth; d++) { + uintk x0 = 0, y0 = 0, z0 = 0; + for (uintk d = 0; d < depth; d++) { x0 |= (i & (1 << (3 * d + 2))) >> (2 * d + 2); y0 |= (i & (1 << (3 * d + 1))) >> (2 * d + 1); z0 |= (i & (1 << (3 * d + 0))) >> (2 * d + 0); } - for (uint32 x = 0; x < 4; ++x) { - for (uint32 y = 0; y < 4; ++y) { - for (uint32 z = 0; z < 4; ++z) { - uint32 x1 = x0 + x - 1; - uint32 y1 = y0 + y - 1; - uint32 z1 = z0 + z - 1; + for (uintk x = 0; x < 4; ++x) { + for (uintk y = 0; y < 4; ++y) { + for (uintk z = 0; z < 4; ++z) { + uintk x1 = x0 + x - 1; + uintk y1 = y0 + y - 1; + uintk z1 = z0 + z - 1; int v = -1; if ((x1 & bound) == 0 && (y1 & bound) == 0 && (z1 & bound) == 0) { - uint32 key1 = 0; + uintk key1 = 0; for (int d = 0; d < depth; d++) { - uint32 mask = 1u << d; + uintk mask = 1u << d; key1 |= ((x1 & mask) << (2 * d + 2)) | ((y1 & mask) << (2 * d + 1)) | ((z1 & mask) << (2 * d)); @@ -355,7 +355,7 @@ void calc_neigh_cpu(int* neigh, const int depth, const int batch_size) { v = key1 + n * node_num; } - uint32 xyz = (x << 4) | (y << 2) | z; + uintk xyz = (x << 4) | (y << 2) | z; neigh[xyz + i * 8 + n * node_num * 8] = v; } } @@ -365,15 +365,16 @@ void calc_neigh_cpu(int* neigh, const int depth, const int batch_size) { } -void generate_key_cpu(uint32* key_child, const uint32* key, const int* child, +template +void generate_key_cpu(Dtype* key_child, const Dtype* key, const int* child, const int node_num) { - typedef unsigned char ubyte; + typedef typename KeyTrait::uints T; for (int i = 0; i < node_num; ++i) { int label = child[i]; - if (label == -1) continue; - const ubyte* k0 = (const ubyte*)(key + i); - for (ubyte j = 0; j < 8; ++j) { - ubyte* k1 = (ubyte*)(key_child + 8 * label + j); + if (label < 0) continue; // empty + const T* k0 = reinterpret_cast(key + i); + for (T j = 0; j < 8; ++j) { + T* k1 = reinterpret_cast(key_child + 8 * label + j); k1[0] = (k0[0] << 1) | ((j & 4) >> 2); k1[1] = (k0[1] << 1) | ((j & 2) >> 1); k1[2] = (k0[2] << 1) | (j & 1); @@ -382,12 +383,14 @@ void generate_key_cpu(uint32* key_child, const uint32* key, const int* child, } } -void generate_key_cpu(uint32* key, const int depth, const int batch_size) { +template +void generate_key_cpu(Dtype* key, const int depth, const int batch_size) { + typedef typename KeyTrait::uints T; int node_num = 1 << 3 * depth; for (int n = 0; n < batch_size; ++n) { for (int k = 0; k < node_num; ++k) { - unsigned xyz = 0; - unsigned char* ptr = (unsigned char*)(&xyz); + Dtype xyz = 0; + T* ptr = reinterpret_cast(&xyz); for (int d = 0; d < depth; d++) { ptr[0] |= (k & (1 << (3 * d + 2))) >> (2 * d + 2); ptr[1] |= (k & (1 << (3 * d + 1))) >> (2 * d + 1); @@ -428,8 +431,9 @@ void bilinear_neigh_cpu(int* bidx, const int* neigh, const int* child, } } -void bilinear_xyz_cpu(uint32* xyz0, float* fracs, const int d0, const uint32* xyz1, +void bilinear_xyz_cpu(uintk* xyz0, float* fracs, const int d0, const uintk* xyz1, const int d1, const int num) { + typedef typename KeyTrait::uints uints; const float scale = static_cast(1 << (d1 - d0)); const int mask[8][3] = { // bilinear mask: {0, 0, 0}, {0, 0, 1}, {0, 1, 0}, {1, 0, 0}, // 27, 9, 9, 9 @@ -440,7 +444,7 @@ void bilinear_xyz_cpu(uint32* xyz0, float* fracs, const int d0, const uint32* xy float pt[3] = { 0.0f }; float* frac = fracs + 3 * i; int bnd[2][3] = { 0 }; - const unsigned char* ptr1 = (const unsigned char*)(xyz1 + i); + const uints* ptr1 = (const uints*)(xyz1 + i); for (int c = 0; c < 3; ++c) { pt[c] = (static_cast(ptr1[c]) + 0.5f) / scale - 0.5f; @@ -457,9 +461,9 @@ void bilinear_xyz_cpu(uint32* xyz0, float* fracs, const int d0, const uint32* xy } for (int j = 0; j < 8; ++j) { - unsigned char* ptr0 = (unsigned char*)(xyz0 + i * 8 + j); + uints* ptr0 = (uints*)(xyz0 + i * 8 + j); for (int c = 0; c < 3; ++c) { - ptr0[c] = static_cast(bnd[mask[j][c]][c]); + ptr0[c] = static_cast(bnd[mask[j][c]][c]); } ptr0[3] = ptr1[3]; } @@ -467,8 +471,16 @@ void bilinear_xyz_cpu(uint32* xyz0, float* fracs, const int d0, const uint32* xy } -void search_key_cpu(int* idx, const uint32* key, const int n_key, - const uint32* query, const int n_query) { +template +void sequence_cpu(Dtype* ptr, const int num) { + for (int i = 0; i < num; ++i) { + ptr[i] = static_cast(i); + } +} + +template +void search_key_cpu(int* idx, const Dtype* key, const int n_key, + const Dtype* query, const int n_query) { for (int i = 0; i < n_query; ++i) { int j = std::lower_bound(key, key + n_key, query[i]) - key; idx[i] = (j >= n_key || key[j] != query[i]) ? -1 : j; @@ -476,23 +488,26 @@ void search_key_cpu(int* idx, const uint32* key, const int n_key, } -void compute_key(uint32& key, const uint32* pt, const int depth) { +template +void compute_key(Dtype& key, const Dtype* pt, const int depth) { key = 0; for (int i = 0; i < depth; i++) { - uint32 mask = 1u << i; + Dtype mask = 1u << i; for (int j = 0; j < 3; j++) { key |= (pt[j] & mask) << (2 * i + 2 - j); } } } -void compute_pt(uint32* pt, const uint32& key, const int depth) { + +template +void compute_pt(Dtype* pt, const Dtype& key, const int depth) { for (int i = 0; i < 3; pt[i++] = 0u); for (int i = 0; i < depth; i++) { for (int j = 0; j < 3; j++) { // bit mask - uint32 mask = 1u << (3 * i + 2 - j); + Dtype mask = 1u << (3 * i + 2 - j); // put the bit to position i pt[j] |= (key & mask) >> (2 * i + 2 - j); } @@ -500,14 +515,16 @@ void compute_pt(uint32* pt, const uint32& key, const int depth) { } -// NOTE: !!! currently the depth should be less than 8 -void xyz2key_cpu(uint32* key, const uint32* xyz, const int num, const int depth) { +template +void xyz2key_cpu(Dtype* key, const Dtype* xyz, const int num, const int depth) { + typedef typename KeyTrait::uints T; + for (int i = 0; i < num; ++i) { - uint32 pt[3] = { 0, 0, 0 }, key_out = 0; - const unsigned char* ptr = reinterpret_cast(xyz + i); - unsigned char* ptr_out = (unsigned char*)(&key_out); + Dtype pt[3] = { 0, 0, 0 }, key_out = 0; + const T* ptr = reinterpret_cast(xyz + i); + T* ptr_out = reinterpret_cast(&key_out); for (int j = 0; j < 3; ++j) { - pt[j] = static_cast(ptr[j]); + pt[j] = static_cast(ptr[j]); } compute_key(key_out, pt, depth); ptr_out[3] = ptr[3]; @@ -515,32 +532,38 @@ void xyz2key_cpu(uint32* key, const uint32* xyz, const int num, const int depth) } } +template +void key2xyz_cpu(Dtype* xyz, const Dtype* key, const int num, const int depth) { + typedef typename KeyTrait::uints T; -void key2xyz_cpu(uint32* xyz, const uint32* key, const int num, const int depth) { for (int i = 0; i < num; ++i) { - uint32 pt[3] = { 0 }; + Dtype pt[3] = { 0 }; compute_pt(pt, key[i], depth); xyz[i] = key[i]; - unsigned char* ptr = reinterpret_cast(xyz + i); + T* ptr = reinterpret_cast(xyz + i); for (int j = 0; j < 3; ++j) { - ptr[j] = static_cast(pt[j]); + ptr[j] = static_cast(pt[j]); } } } -void key2idx_cpu(int* idx, const uint32* key, const int num) { +template +void key2idx_cpu(int* idx, const Dtype* key, const int num) { + typedef typename KeyTrait::uints T; for (int i = 0; i < num; ++i) { - const unsigned char* ptr = reinterpret_cast(key + i); + const T* ptr = reinterpret_cast(key + i); idx[i] = static_cast(ptr[3]); } } -void xyz2coord_cpu(float* pt, const uint32* xyz, const int num, const int channel) { +template +void xyz2coord_cpu(float* pt, const Dtype* xyz, const int num, const int channel) { + typedef typename KeyTrait::uints T; for (int i = 0; i < num; ++i) { - const unsigned char* ptr = reinterpret_cast(xyz + i); + const T* ptr = reinterpret_cast(xyz + i); for (int c = 0; c < channel; ++c) { pt[c * num + i] = static_cast(ptr[c]); } @@ -548,22 +571,24 @@ void xyz2coord_cpu(float* pt, const uint32* xyz, const int num, const int channe } -void coord2xyz_cpu(uint32* xyz, const float* pt, const int num, const int channel) { +template +void coord2xyz_cpu(Dtype* xyz, const float* pt, const int num, const int channel) { + typedef typename KeyTrait::uints T; for (int i = 0; i < num; ++i) { - unsigned char* ptr = reinterpret_cast(xyz + i); + T* ptr = reinterpret_cast(xyz + i); for (int c = 0; c < channel; ++c) { - ptr[c] = static_cast(pt[c * num + i]); + ptr[c] = static_cast(pt[c * num + i]); } } } -template -void key2xyz(Dtype* xyz, const uint32 key, const int depth) { - uint32 pt[3]; +template +void key2xyz(Dtype1* xyz, const Dtype2 key, const int depth) { + Dtype2 pt[3]; compute_pt(pt, key, depth); for (int c = 0; c < 3; ++c) { - xyz[c] = static_cast(pt[c]); + xyz[c] = static_cast(pt[c]); } } @@ -578,6 +603,8 @@ template void memcpy_cpu(const int N, const int* X, int* Y); template void memcpy_cpu(const int N, const unsigned* X, unsigned* Y); template void memcpy_cpu(const int N, const float* X, float* Y); template void memcpy_cpu(const int N, const double* X, double* Y); +template void sequence_cpu(int* ptr, const int num); +template void sequence_cpu(uintk* ptr, const int num); template void pad_forward_cpu(float* Y, const int Hy, const int Cy, const float* X, const int Hx, const int* label, const float dval); template void pad_forward_cpu(double* Y, const int Hy, const int Cy, @@ -616,6 +643,22 @@ template void octree_mask_pool_cpu(float* top_data, int top_h, const int* mask, const float* btm_data, int bottom_h, int channel); template void octree_mask_pool_cpu(double* top_data, int top_h, const int* mask, const double* btm_data, int bottom_h, int channel); -template void key2xyz(float* xyz, const uint32 key, const int d); -template void key2xyz(unsigned* xyz, const uint32 key, const int d); -template void key2xyz(int* xyz, const uint32 key, const int d); \ No newline at end of file +template void key2xyz(float* xyz, const uintk key, const int d); +template void key2xyz(uintk* xyz, const uintk key, const int d); +template void key2xyz(int* xyz, const uintk key, const int d); +template void generate_key_cpu(uintk* key, const int depth, const int batch_size); +template void generate_key_cpu(uintk* key_child, const uintk* key, + const int* child, const int node_num); +template void compute_key(uintk& key, const uintk* pt, const int depth); +template void compute_pt(uintk* pt, const uintk& key, const int depth); +template void search_key_cpu(int* idx, const uintk* key, const int n_key, + const uintk* query, const int n_query); +template void xyz2key_cpu(uintk* key, const uintk* xyz, const int num, + const int depth); +template void key2xyz_cpu(uintk* xyz, const uintk* key, const int num, + const int depth); +template void key2idx_cpu(int* idx, const uintk* key, const int num); +template void xyz2coord_cpu(float* pt, const uintk* xyz, const int num, + const int channel); +template void coord2xyz_cpu(uintk* xyz, const float* pt, const int num, + const int channel); \ No newline at end of file diff --git a/octree/octree/octree_nn.cu b/octree/octree/octree_nn.cu index cbd72ea..943014d 100644 --- a/octree/octree/octree_nn.cu +++ b/octree/octree/octree_nn.cu @@ -272,7 +272,7 @@ __global__ void calc_neigh_kernel(int* neigh_split, const int* neigh, void calc_neigh_gpu(int* neigh_split, const int* neigh, const int* children, const int node_num, const int* parent, const int* dis) { - int n = node_num << 6; // node_num: the non_empty node number of parent layer + int n = node_num << 6; // node_num: the non_empty node number of parent layer // qq: 2 million * 2^6 < 2billion. calc_neigh_kernel <<< CudaGetBlocks(n), kCudaThreadsNum >>> ( neigh_split, neigh, children, parent, dis, n); } @@ -323,7 +323,7 @@ __global__ void calc_full_neigh_kernel(int* neigh, const int depth, } void calc_neigh_gpu(int* neigh, const int depth, const int batch_size) { - int thread_num = batch_size * (1 << 3 * depth + 3); + int thread_num = batch_size * (1 << 3 * depth + 3); // qq: TODO: long? calc_full_neigh_kernel <<< CudaGetBlocks(thread_num), kCudaThreadsNum >>> ( neigh, depth, batch_size, thread_num); CUDA_POST_KERNEL_CHECK; @@ -382,7 +382,7 @@ __global__ void gen_full_key_kernel(Dtype* key, const int depth, template void generate_key_gpu(Dtype* key, const int depth, const int batch_size) { - int thread_num = batch_size * (1 << 3 * depth); + int thread_num = batch_size * (1 << 3 * depth); // qq: TODO: 1 << 3 * depth is much more than int gen_full_key_kernel <<< CudaGetBlocks(thread_num), kCudaThreadsNum >>> ( key, depth, batch_size, thread_num); CUDA_POST_KERNEL_CHECK; diff --git a/octree/octree/octree_nn.h b/octree/octree/octree_nn.h index 545edec..9ac22de 100644 --- a/octree/octree/octree_nn.h +++ b/octree/octree/octree_nn.h @@ -1,15 +1,15 @@ #ifndef _OCTREE_OCTREE_NN_ #define _OCTREE_OCTREE_NN_ -#include #include #include #include +#include "types.h" + using std::string; using std::vector; using std::unordered_map; -typedef uint32_t uint32; // A singleton class to hold global & common stuff for octree neighbor @@ -49,8 +49,8 @@ class NeighHelper { // !!! TODO: support gpu stream for gpu functions !!! -int num_elements(const vector& vec); -void resize_with_last_val(vector& vec, const int size); +int num_elements(const vector& shape); +void resize_with_last_val(vector& shape, const int size); template void memset_cpu(const int N, const Dtype alpha, Dtype *X); @@ -125,13 +125,17 @@ void calc_neigh_gpu(int* neigh_child, const int* neigh, const int* children, void calc_neigh_cpu(int* neigh, const int depth, const int batch_size); void calc_neigh_gpu(int* neigh, const int depth, const int batch_size); - -void generate_key_gpu(uint32* key_child, const uint32* key, const int* child, +// !!! The generated key is in the format of zipped (x,y,z,id) +template +void generate_key_gpu(Dtype* key_child, const Dtype* key, const int* child, const int node_num); -void generate_key_cpu(uint32* key_child, const uint32* key, const int* child, +template +void generate_key_cpu(Dtype* key_child, const Dtype* key, const int* child, const int node_num); -void generate_key_gpu(uint32* key, const int depth, const int batch_size); -void generate_key_cpu(uint32* key, const int depth, const int batch_size); +template +void generate_key_gpu(Dtype* key, const int depth, const int batch_size); +template +void generate_key_cpu(Dtype* key, const int depth, const int batch_size); template @@ -146,21 +150,25 @@ void bilinear_neigh_cpu(int* bidx, const int* neigh, const int* child, const int node_num, const int* table); void bilinear_neigh_gpu(int* bidx, const int* neigh, const int* child, const int node_num, const int* table); -void bilinear_xyz_cpu(uint32* xyz0, float* dis, const int d0, const uint32* xyz1, +void bilinear_xyz_cpu(uintk* xyz0, float* dis, const int d0, const uintk* xyz1, const int d1, const int num); -void bilinear_xyz_gpu(uint32* xyz0, float* dis, const int d0, const uint32* xyz1, +void bilinear_xyz_gpu(uintk* xyz0, float* dis, const int d0, const uintk* xyz1, const int d1, const int num); +template +void sequence_cpu(Dtype* ptr, const int num); template void sequence_gpu(Dtype* ptr, const int num); // TODO: The performance can be improved via descent along the octree -void search_key_cpu(int* idx, const uint32* key, const int n_key, - const uint32* query, const int n_query); -void search_key_gpu(int* idx, const uint32* key, const int n_key, - const uint32* query, const int n_query); +template +void search_key_cpu(int* idx, const Dtype* key, const int n_key, + const Dtype* query, const int n_query); +template +void search_key_gpu(int* idx, const Dtype* key, const int n_key, + const Dtype* query, const int n_query); template @@ -191,24 +199,35 @@ void octree_mask_gpu(float* out_data, const float* in_data, const int* label, // !!! Caveat: for the following two functions, pt and depth // must be consistent, i.e pt must be in the range [0, 2^depth]^3 -void compute_key(uint32& key, const uint32* pt, const int depth); -void compute_pt(uint32* pt, const uint32& key, const int depth); +template +void compute_key(Dtype& key, const Dtype* pt, const int depth); +template +void compute_pt(Dtype* pt, const Dtype& key, const int depth); -void xyz2key_cpu(uint32* key, const uint32* xyz, const int num, const int depth); -void xyz2key_gpu(uint32* key, const uint32* xyz, const int num, const int depth); -void key2xyz_cpu(uint32* xyz, const uint32* key, const int num, const int depth); -void key2xyz_gpu(uint32* xyz, const uint32* key, const int num, const int depth); +template +void xyz2key_cpu(Dtype* key, const Dtype* xyz, const int num, const int depth); +template +void xyz2key_gpu(Dtype* key, const Dtype* xyz, const int num, const int depth); +template +void key2xyz_cpu(Dtype* xyz, const Dtype* key, const int num, const int depth); +template +void key2xyz_gpu(Dtype* xyz, const Dtype* key, const int num, const int depth); -void key2idx_cpu(int* idx, const uint32* key, const int num); -void key2idx_gpu(int* idx, const uint32* key, const int num); +template +void key2idx_cpu(int* idx, const Dtype* key, const int num); +template +void key2idx_gpu(int* idx, const Dtype* key, const int num); -void xyz2coord_cpu(float* pt, const uint32* xyz, const int num, const int channel); -void xyz2coord_gpu(float* pt, const uint32* xyz, const int num, const int channel); -void coord2xyz_cpu(uint32* xyz, const float* pt, const int num, const int channel); -void coord2xyz_gpu(uint32* xyz, const float* pt, const int num, const int channel); +template +void xyz2coord_cpu(float* pt, const Dtype* xyz, const int num, const int channel); +template +void xyz2coord_gpu(float* pt, const Dtype* xyz, const int num, const int channel); +template +void coord2xyz_cpu(Dtype* xyz, const float* pt, const int num, const int channel); +template +void coord2xyz_gpu(Dtype* xyz, const float* pt, const int num, const int channel); -//int content_flag(string str); -template -void key2xyz(Dtype* xyz, const uint32 key, const int depth); +template +void key2xyz(Dtype1* xyz, const Dtype2 key, const int depth); #endif // _OCTREE_OCTREE_NN_ diff --git a/octree/octree/octree_parser.cpp b/octree/octree/octree_parser.cpp index 58b8782..8189151 100644 --- a/octree/octree/octree_parser.cpp +++ b/octree/octree/octree_parser.cpp @@ -36,8 +36,8 @@ const char* OctreeParser::ptr_cpu(const PropType ptype, const int depth) const { return p; } -const uint32* OctreeParser::key_cpu(const int depth) const { - return reinterpret_cast(ptr_cpu(OctreeInfo::kKey, depth)); +const uintk* OctreeParser::key_cpu(const int depth) const { + return reinterpret_cast(ptr_cpu(OctreeInfo::kKey, depth)); } const int* OctreeParser::children_cpu(const int depth) const { @@ -65,8 +65,8 @@ char* OctreeParser::mutable_ptr_cpu(const OctreeInfo::PropType ptype, const int return const_cast(ptr_cpu(ptype, depth)); } -uint32* OctreeParser::mutable_key_cpu(const int depth) { - return reinterpret_cast(mutable_ptr_cpu(OctreeInfo::kKey, depth)); +uintk* OctreeParser::mutable_key_cpu(const int depth) { + return reinterpret_cast(mutable_ptr_cpu(OctreeInfo::kKey, depth)); } int* OctreeParser::mutable_children_cpu(const int depth) { @@ -92,7 +92,7 @@ float* OctreeParser::mutable_split_cpu(const int depth) { ////////////////////////////////////// void OctreeParser::node_pos(float* xyz, int id, int depth, float* xyz_base) const { - const uint32* keyi = key_cpu(depth) + id; + const uintk* keyi = key_cpu(depth) + id; key2xyz(xyz, *keyi, depth); if (xyz_base != nullptr) { @@ -141,22 +141,21 @@ float OctreeParser::node_dis(int id, int depth) const { } template -void OctreeParser::key2xyz(Dtype* xyz, const uint32& key, const int depth) const { +void OctreeParser::key2xyz(Dtype* xyz, const uintk& key, const int depth) const { if (info_->is_key2xyz()) { - //!!! Caveat: the octree depth should be less than 8 - const unsigned char* pt = reinterpret_cast(&key); + typedef typename KeyTrait::uints uints; + const uints* pt = reinterpret_cast(&key); for (int c = 0; c < 3; ++c) { xyz[c] = static_cast(pt[c]); } - } - else { - uint32 pt[3]; + } else { + uintk pt[3]; compute_pt(pt, key, depth); for (int c = 0; c < 3; ++c) { xyz[c] = static_cast(pt[c]); } } } -template void OctreeParser::key2xyz(float* xyz, const unsigned& k, const int d) const; -template void OctreeParser::key2xyz(unsigned* xyz, const unsigned& k, const int d) const; -template void OctreeParser::key2xyz(int* xyz, const unsigned& k, const int d) const; +template void OctreeParser::key2xyz(float* xyz, const uintk& k, const int d) const; +template void OctreeParser::key2xyz(uintk* xyz, const uintk& k, const int d) const; +template void OctreeParser::key2xyz(int* xyz, const uintk& k, const int d) const; diff --git a/octree/octree/octree_parser.cu b/octree/octree/octree_parser.cu index c8e4572..e5809d6 100644 --- a/octree/octree/octree_parser.cu +++ b/octree/octree/octree_parser.cu @@ -29,7 +29,7 @@ void OctreeParser::set_gpu(void* ptr, OctreeInfo* octinfo) { const char* OctreeParser::ptr_gpu(const PropType ptype, const int depth) const { CHECK(d_metadata_ != nullptr); const char* p = nullptr; - int dis = info_->ptr_dis(ptype, depth); + int dis = info_->ptr_dis(ptype, depth); // qq: TODO: long if (-1 != dis) { p = d_metadata_ + dis; } diff --git a/octree/octree/octree_parser.h b/octree/octree/octree_parser.h index 54c9ed1..017a980 100644 --- a/octree/octree/octree_parser.h +++ b/octree/octree/octree_parser.h @@ -3,7 +3,8 @@ #include #include -#include + +#include "types.h" #include "octree_info.h" using std::vector; @@ -11,8 +12,6 @@ using std::string; class OctreeParser { public: - typedef uint32_t uint32; - typedef uint64_t uint64; typedef OctreeInfo::PropType PropType; enum NodeType {kNonEmptyLeaf = -2, kLeaf = -1, kInternelNode = 0 }; @@ -32,7 +31,7 @@ class OctreeParser { const char* ptr_raw_cpu() const { return h_metadata_; } const char* ptr_cpu(const PropType ptype, const int depth) const; - const uint32* key_cpu(const int depth) const; + const uintk* key_cpu(const int depth) const; const int* children_cpu(const int depth) const; const int* neighbor_cpu(const int depth) const; const float* feature_cpu(const int depth) const; @@ -41,7 +40,7 @@ class OctreeParser { const char* ptr_raw_gpu() const { return d_metadata_; } const char* ptr_gpu(const PropType ptype, const int depth) const; - const uint32* key_gpu(const int depth) const; + const uintk* key_gpu(const int depth) const; const int* children_gpu(const int depth) const; const int* neighbor_gpu(const int depth) const; const float* feature_gpu(const int depth) const; @@ -49,7 +48,7 @@ class OctreeParser { const float* split_gpu(const int depth) const; char* mutable_ptr_cpu(const PropType ptype, const int depth); - uint32* mutable_key_cpu(const int depth); + uintk* mutable_key_cpu(const int depth); int* mutable_children_cpu(const int depth); int* mutable_neighbor_cpu(const int depth); float* mutable_feature_cpu(const int depth); @@ -57,7 +56,7 @@ class OctreeParser { float* mutable_split_cpu(const int depth); char* mutable_ptr_gpu(const PropType ptype, const int depth); - uint32* mutable_key_gpu(const int depth); + uintk* mutable_key_gpu(const int depth); int* mutable_children_gpu(const int depth); int* mutable_neighbor_gpu(const int depth); float* mutable_feature_gpu(const int depth); @@ -69,7 +68,7 @@ class OctreeParser { void node_normal(float* n, int id, int depth) const; float node_dis(int id, int depth) const; template - void key2xyz(Dtype* xyz, const uint32& key, const int depth) const; + void key2xyz(Dtype* xyz, const uintk& key, const int depth) const; protected: // original pointer diff --git a/octree/octree/octree_samples.cpp b/octree/octree/octree_samples.cpp index 4e74506..a92dd04 100644 --- a/octree/octree/octree_samples.cpp +++ b/octree/octree/octree_samples.cpp @@ -1,4 +1,5 @@ #include "octree_samples.h" +#include "transform_octree.h" namespace octree { @@ -2138,18 +2139,31 @@ static const unsigned char octree_6[] = { 0000, 0000, 0000, 0000, 0000, 0000, 0x80, 0x3f, 0000, 0000, 0000, 0000, 0x00 }; -const struct embedded_file { +class embedded_file { + public: + embedded_file(const char* nm, const unsigned char* d, size_t sz) + : name(nm), data(d), size(sz) { +#ifdef KEY64 + vector octree_in(d, d + sz); + upgrade_key64(octree_64, octree_in); + data = (unsigned char *)octree_64.data(); + size = octree_64.size(); +#endif // KEY64 + } const char *name; const unsigned char *data; size_t size; -} embedded_octrees[] = { + vector octree_64; +}; + +embedded_file embedded_octrees[] = { { "octree_1", octree_1, sizeof(octree_1) - 1 }, { "octree_2", octree_2, sizeof(octree_2) - 1 }, { "octree_3", octree_3, sizeof(octree_3) - 1 }, { "octree_4", octree_4, sizeof(octree_4) - 1 }, { "octree_5", octree_5, sizeof(octree_5) - 1 }, - { "octree_6", octree_6, sizeof(octree_6) - 1 }, - { nullptr, nullptr, 0 } + { "octree_6", octree_6, sizeof(octree_6) - 1 } + //{ nullptr, nullptr, 0 } }; const unsigned char* get_one_octree(const char *name, size_t *size) { diff --git a/octree/octree/octree_value.cpp b/octree/octree/octree_value.cpp index 17012a1..7318226 100644 --- a/octree/octree/octree_value.cpp +++ b/octree/octree/octree_value.cpp @@ -2,6 +2,7 @@ #include "math_functions.h" #include +#include pair OctreeValue::fval(const float x, const float y, const float z) const { int oct_depth = octree_->info().depth(); @@ -36,7 +37,7 @@ pair OctreeValue::fval(const float x, const float y, const float z // This node has no children if (depth_child >= adp_depth) { octree_->node_normal(nm, i, depth_child); - float len = abs(nm[0]) + abs(nm[1]) + abs(nm[2]); + float len = fabsf(nm[0]) + fabsf(nm[1]) + fabsf(nm[2]); if (len != 0) { // This node has plane information phi += w * basis(pos_in, pos_child, nm); diff --git a/octree/octree/points.cpp b/octree/octree/points.cpp index f027ae2..ae87959 100644 --- a/octree/octree/points.cpp +++ b/octree/octree/points.cpp @@ -36,25 +36,6 @@ bool Points::write_points(const string& filename) const { return true; } -//bool Points::write_ply(const string & filename) const { -// std::ofstream outfile(filename, std::ios::binary); -// if (!outfile) return false; -// -// // write header -// int n = info_->pt_num(); -// outfile << "ply\nformat ascii 1.0\nelement vertex " << n -// << "\nproperty float x\nproperty float y\nproperty float z\n" -// << "property float nx\nproperty float ny\nproperty float nz\n" -// << "element face 0\nproperty list uchar int vertex_indices\n" -// << "end_header" << std::endl; -// -// // wirte contents -// const float* pts = ptr(PointsInfo::kPoint); -// const float* normals = ptr(PointsInfo::kNormal); -// if (normals == nullptr) { -// outfile.close(); -// return false; -// } bool Points::write_ply(const string & filename) const { std::ofstream outfile(filename, std::ios::binary); diff --git a/octree/octree/points.h b/octree/octree/points.h index 98d87ff..ebf4c98 100644 --- a/octree/octree/points.h +++ b/octree/octree/points.h @@ -18,6 +18,8 @@ class Points: public PointsParser { const vector& features = vector(), const vector& labels = vector()); void set_points(vector& data); // swap data and buffer_ + + const vector& get_buffer() const { return buffer_; } bool read_points(const string& filename); bool write_points(const string& filename) const; diff --git a/octree/octree/points_parser.cpp b/octree/octree/points_parser.cpp index d26a05e..ad68ca2 100644 --- a/octree/octree/points_parser.cpp +++ b/octree/octree/points_parser.cpp @@ -84,6 +84,8 @@ void PointsParser::scale(const float* s) { } } + if (s[0] == s[1] && s[0] == s[2]) { return; } // uniform scale + if (this->info().has_property(PointsInfo::kNormal)) { float* nm = this->mutable_normal(); for (int i = 0; i < npt; ++i) { @@ -216,3 +218,36 @@ void PointsParser::normalize() { this->translate(trans); this->uniform_scale(1 / (radius + 1.0e-10f)); } + +void PointsParser::orient_normal(const string axis) { + if (!this->info().has_property(PointsInfo::kNormal)) { + return; // directly return if there is no normal + } + + int npt = info_->pt_num(); + float* normal = this->mutable_normal(); + if (axis == "x" || axis == "y" || axis == "z") { + int j = 0; + if (axis == "y") j = 1; + if (axis == "z") j = 2; + for (int i = 0; i < npt; ++i) { + int ix3 = i * 3; + if (normal[ix3 + j] < 0) { + for (int c = 0; c < 3; ++c) { + normal[ix3 + c] = -normal[ix3 + c]; + } + } + } + } else if (axis == "xyz") { + for (int i = 0; i < npt; ++i) { + int ix3 = i * 3; + for (int c = 0; c < 3; ++c) { + if (normal[ix3 + c] < 0) { + normal[ix3 + c] = -normal[ix3 + c]; + } + } + } + } else { + // do nothing + } +} diff --git a/octree/octree/points_parser.h b/octree/octree/points_parser.h index 3c9e64c..9410edb 100644 --- a/octree/octree/points_parser.h +++ b/octree/octree/points_parser.h @@ -42,6 +42,7 @@ class PointsParser { void clip(const float* bbmin, const float* bbmax); void add_noise(const float std_pt, const float std_nm); void normalize(); // translate and scale the points to unit sphere + void orient_normal(const string axis); protected: diff --git a/octree/octree/transform_octree.cpp b/octree/octree/transform_octree.cpp index 9c8ec17..66fcc4f 100644 --- a/octree/octree/transform_octree.cpp +++ b/octree/octree/transform_octree.cpp @@ -1,13 +1,14 @@ #include "transform_octree.h" -#include "math_functions.h" + +#include +#include #include #include -#include -#include -void ScanOctree::set_scale(float scale) { - scale_ = scale; -} +#include "math_functions.h" +#include "types.h" + +void ScanOctree::set_scale(float scale) { scale_ = scale; } void ScanOctree::set_axis(const float* axis, int n) { if (n == 3) { @@ -25,7 +26,7 @@ void ScanOctree::scan(vector& octree_out, const OctreeParser& octree_in, // drop_flags: 1 - drop; 0 - keep, iff the node is visible and non-empty int depth = octree_in.info().depth(); int num = octree_in.info().node_num(depth); - vector > drop_flags(depth + 1); + vector> drop_flags(depth + 1); drop_flags[depth].resize(num, 1); const int axis_channel = 3; @@ -54,7 +55,6 @@ void ScanOctree::scan(vector& octree_out, const OctreeParser& octree_in, trim_octree(octree_out, octree_in, drop_flags); } - void ScanOctree::bbox_xy(int depth) { for (int i = 0; i < 3; ++i) { bbmin_[i] = std::numeric_limits::max(); @@ -62,7 +62,7 @@ void ScanOctree::bbox_xy(int depth) { } for (int i = 0; i < 8; ++i) { - float pt[3] = { i / 4, (i / 2) % 2, i % 2 }; + float pt[3] = {i / 4, (i / 2) % 2, i % 2}; float x = dot_prod(pt, x_); if (x < bbmin_[0]) bbmin_[0] = x; if (x > bbmax_[0]) bbmax_[0] = x; @@ -73,7 +73,7 @@ void ScanOctree::bbox_xy(int depth) { float z = dot_prod(pt, z_); if (z < bbmin_[2]) bbmin_[2] = z; - if (z > bbmax_[2])bbmax_[2] = z; + if (z > bbmax_[2]) bbmax_[2] = z; } float width = -1; @@ -86,7 +86,7 @@ void ScanOctree::bbox_xy(int depth) { if (dis > width) width = dis; } - width_ = static_cast(width * scale_) + 2; // slightly larger + width_ = static_cast(width * scale_) + 2; // slightly larger } void ScanOctree::reset_buffer() { @@ -94,21 +94,22 @@ void ScanOctree::reset_buffer() { z_buffer_.assign(width_ * width_, std::numeric_limits::max()); } -void ScanOctree::z_buffer(vector& drop_flags, const OctreeParser& octree_in) { +void ScanOctree::z_buffer(vector& drop_flags, + const OctreeParser& octree_in) { // reset the buffer reset_buffer(); const int depth = octree_in.info().depth(); const int num = octree_in.info().node_num(depth); - const unsigned int* key = octree_in.key_cpu(depth); + const uintk* key = octree_in.key_cpu(depth); const int* children = octree_in.children_cpu(depth); for (int i = 0; i < num; ++i) { - if (children[i] < 0) continue; // empty node + if (children[i] < 0) continue; // empty node float normal[3]; octree_in.node_normal(normal, i, depth); - if (dot_prod(normal, z_) >= 0) continue; // invisible node + if (dot_prod(normal, z_) >= 0) continue; // invisible node float pt[3]; octree_in.key2xyz(pt, key[i], depth); @@ -143,7 +144,7 @@ void ScanOctree::generate_flags(vector>& drop_flags, const int* child_d = octree_in.children_cpu(d); for (int i = 0; i < num; ++i) { int j = child_d[i]; - if (j < 0) continue; // empty node + if (j < 0) continue; // empty node int drop = 1; for (int k = j * 8; k < j * 8 + 8; ++k) { @@ -159,7 +160,8 @@ void ScanOctree::generate_flags(vector>& drop_flags, } void ScanOctree::trim_octree(vector& octree_buffer, - const OctreeParser& octree_in, vector>& drop_flags) { + const OctreeParser& octree_in, + vector>& drop_flags) { // calculate the node number for the octree_out int depth = octree_in.info().depth(); int depth_full = octree_in.info().full_layer(); @@ -207,9 +209,9 @@ void ScanOctree::trim_octree(vector& octree_buffer, // copy children and key // !!! Caveat: currently channel_key is 1, and channel_child is 1 const int* child_in = octree_in.children_cpu(d - 1); - const unsigned int* key_in = octree_in.key_cpu(d); + const uintk* key_in = octree_in.key_cpu(d); int* child_out = octree_out.mutable_children_cpu(d); - unsigned int* key_out = octree_out.mutable_key_cpu(d); + uintk* key_out = octree_out.mutable_key_cpu(d); for (int i = 0, j = 0, id = 0; i < num; ++i) { // the node is dropped or empty if (drop[i] == 1) continue; @@ -230,7 +232,7 @@ void ScanOctree::trim_octree(vector& octree_buffer, if (location_feature == -1 || d == depth) { int nnum_in = octree_in.info().node_num(d); int nnum_out = octree_out.info().node_num(d); - const float * feature_in = octree_in.feature_cpu(d); + const float* feature_in = octree_in.feature_cpu(d); float* feature_out = octree_out.mutable_feature_cpu(d); for (int i = 0, j = 0; i < num; ++i) { // the node is dropped or empty @@ -239,8 +241,8 @@ void ScanOctree::trim_octree(vector& octree_buffer, for (int k = 8 * t; k < 8 * t + 8; ++k) { for (int c = 0; c < channel_feature; ++c) { - feature_out[c * nnum_out + j] = drop_d[k] == 0 ? - feature_in[c * nnum_in + k] : 0; + feature_out[c * nnum_out + j] = + drop_d[k] == 0 ? feature_in[c * nnum_in + k] : 0; } j++; } @@ -249,7 +251,7 @@ void ScanOctree::trim_octree(vector& octree_buffer, // copy label if ((location_label == -1 || d == depth) && channel_label != 0) { - const float * label_in = octree_in.label_cpu(d); + const float* label_in = octree_in.label_cpu(d); float* label_out = octree_out.mutable_label_cpu(d); for (int i = 0, j = 0; i < num; ++i) { // the node is dropped or empty @@ -265,7 +267,7 @@ void ScanOctree::trim_octree(vector& octree_buffer, // copy split if ((location_split == -1 || d == depth) && channel_split != 0) { - const float * split_in = octree_in.split_cpu(d); + const float* split_in = octree_in.split_cpu(d); float* split_out = octree_out.mutable_split_cpu(d); for (int i = 0, j = 0; i < num; ++i) { // the node is dropped or empty @@ -281,15 +283,13 @@ void ScanOctree::trim_octree(vector& octree_buffer, } } - - void octree_dropout(vector& octree_output, const string& octree_input, const int depth_dropout, const float threshold) { // generate the drop flag OctreeParser parser_in; parser_in.set_cpu(octree_input.c_str()); int depth = parser_in.info().depth(); - vector > drop(depth + 1); + vector> drop(depth + 1); // generate random flag for the level depth_dropout int nnum_d = parser_in.info().node_num(depth_dropout); drop[depth_dropout].resize(nnum_d, 0); @@ -305,7 +305,7 @@ void octree_dropout(vector& octree_output, const string& octree_input, drop[d].resize(nnum_d); for (int i = 0; i < nnum_dp; ++i) { int t = children_dp[i]; - if (t < 0) continue; // continue if it has no children + if (t < 0) continue; // continue if it has no children // assign the drop flag of a parent node to its children for (int j = 0; j < 8; ++j) { drop[d][t * 8 + j] = drop[d - 1][i]; @@ -338,23 +338,26 @@ void octree_dropout(vector& octree_output, const string& octree_input, // from level 0 to depth_output int num = parser_in.info().node_num_cum(depth_dropout + 1); int channel_key = parser_in.info().channel(OctreeInfo::kKey); - //CHECK_EQ(channel_key, 1) << "Currently the channel must be 1"; + // CHECK_EQ(channel_key, 1) << "Currently the channel must be 1"; std::copy_n(parser_in.key_cpu(0), num * channel_key, parser_out.mutable_key_cpu(0)); std::copy_n(parser_in.children_cpu(0), num, parser_out.mutable_children_cpu(0)); int channel_feature = parser_in.info().channel(OctreeInfo::kFeature); int location_feature = parser_in.info().locations(OctreeInfo::kFeature); if (location_feature == -1) { - std::copy_n(parser_in.feature_cpu(0), num * channel_feature, parser_out.mutable_feature_cpu(0)); + std::copy_n(parser_in.feature_cpu(0), num * channel_feature, + parser_out.mutable_feature_cpu(0)); } int channel_label = parser_in.info().channel(OctreeInfo::kLabel); int location_label = parser_in.info().locations(OctreeInfo::kLabel); if (location_label == -1) { - std::copy_n(parser_in.label_cpu(0), num * channel_label, parser_out.mutable_label_cpu(0)); + std::copy_n(parser_in.label_cpu(0), num * channel_label, + parser_out.mutable_label_cpu(0)); } int channel_split = parser_in.info().channel(OctreeInfo::kSplit); int location_split = parser_in.info().locations(OctreeInfo::kSplit); if (location_split == -1) { - std::copy_n(parser_in.split_cpu(0), num * channel_split, parser_out.mutable_split_cpu(0)); + std::copy_n(parser_in.split_cpu(0), num * channel_split, + parser_out.mutable_split_cpu(0)); } // from level depth_output+1 to depth @@ -362,9 +365,9 @@ void octree_dropout(vector& octree_output, const string& octree_input, for (int d = depth_dropout + 1; d <= depth; ++d) { int nnum_d = parser_in.info().node_num(d), id = 0; const int* child_src = parser_in.children_cpu(d); - const unsigned int* key_src = parser_in.key_cpu(d); + const uintk* key_src = parser_in.key_cpu(d); int* child_des = parser_out.mutable_children_cpu(d); - unsigned int* key_des = parser_out.mutable_key_cpu(d); + uintk* key_des = parser_out.mutable_key_cpu(d); for (int i = 0, j = 0; i < nnum_d; ++i) { if (drop[d][i] == 0) { key_des[j] = key_src[i]; @@ -377,7 +380,7 @@ void octree_dropout(vector& octree_output, const string& octree_input, if (location_feature == -1 || d == depth) { int nnum_src = parser_out.info().node_num(d); - const float * feature_src = parser_in.feature_cpu(d); + const float* feature_src = parser_in.feature_cpu(d); float* feature_des = parser_out.mutable_feature_cpu(d); for (int i = 0, j = 0; i < nnum_d; ++i) { if (drop[d][i] == 0) { @@ -390,7 +393,7 @@ void octree_dropout(vector& octree_output, const string& octree_input, } if ((location_label == -1 || d == depth) && channel_label != 0) { - const float * label_src = parser_in.label_cpu(d); + const float* label_src = parser_in.label_cpu(d); float* label_des = parser_out.mutable_label_cpu(d); for (int i = 0, j = 0; i < nnum_d; ++i) { if (drop[d][i] == 0) { @@ -401,7 +404,7 @@ void octree_dropout(vector& octree_output, const string& octree_input, } if ((location_split == -1 || d == depth) && channel_split != 0) { - const float * split_src = parser_in.split_cpu(d); + const float* split_src = parser_in.split_cpu(d); float* split_des = parser_out.mutable_split_cpu(d); for (int i = 0, j = 0; i < nnum_d; ++i) { if (drop[d][i] == 0) { @@ -417,12 +420,78 @@ void octree_dropout(vector& octree_output, const string& octree_input, const int* child_src = parser_in.children_cpu(depth_dropout); int* child_des = parser_out.mutable_children_cpu(depth_dropout); for (int i = 0; i < node_num[depth_dropout]; ++i) { - child_des[i] = (drop[depth_dropout][i] == 1 || child_src[i] < 0) ? - child_src[i] : id++; + child_des[i] = + (drop[depth_dropout][i] == 1 || child_src[i] < 0) ? child_src[i] : id++; } for (int d = 0; d < depth_dropout; ++d) { node_num_nempty[d] = parser_in.info().node_num_nempty(d); } - node_num_nempty[depth_dropout] = id; // !!! important + node_num_nempty[depth_dropout] = id; // !!! important parser_out.mutable_info().set_nempty(node_num_nempty.data()); } + +void upgrade_key64(vector& octree_out, const vector& octree_in) { + typedef typename KeyTrait::uints uints_in; + typedef typename KeyTrait::uints uints_out; + + OctreeParser parser_in, parser_out; + parser_in.set_cpu(octree_in.data()); + + + // modify the OctreeInfo, update the magic_str and ptr_dis + OctreeInfo oct_info = parser_in.info(); + oct_info.set_magic_str(OctreeInfo::kMagicStr); + oct_info.set_ptr_dis(); + + // set OctreeInfo to the output + octree_out.resize(oct_info.sizeof_octree()); + parser_out.set_cpu(octree_out.data(), &oct_info); + + // copy key + int num = oct_info.total_nnum(); + uintk* key_out = parser_out.mutable_key_cpu(0); + const uint32* key_in = reinterpret_cast(parser_in.key_cpu(0)); + for (int i = 0; i < num; ++i) { + if (oct_info.is_key2xyz()) { + uints_out* ptr_out = reinterpret_cast(key_out + i); + const uints_in* ptr_in = reinterpret_cast(key_in + i); + for (int j = 0; j < 4; ++j) { + ptr_out[j] = static_cast(ptr_in[j]); + } + } else { + key_out[i] = static_cast(key_in[i]); + } + } + + // copy children + std::copy_n(parser_in.children_cpu(0), num, parser_out.mutable_children_cpu(0)); + + // copy data + int depth = oct_info.depth(); + int feature_channel = oct_info.channel(OctreeInfo::kFeature); + int feature_location = oct_info.locations(OctreeInfo::kFeature); + int depth_start = feature_location == depth ? depth : 0; + for (int d = depth_start; d < depth + 1; ++d) { + if (!oct_info.has_property(OctreeInfo::kFeature)) break; + int n = oct_info.node_num(d) * feature_channel; + std::copy_n(parser_in.feature_cpu(d), n, parser_out.mutable_feature_cpu(d)); + } + + // copy label + int label_location = oct_info.locations(OctreeInfo::kLabel); + depth_start = label_location == depth ? depth : 0; + for (int d = depth_start; d < depth + 1; ++d) { + if (!oct_info.has_property(OctreeInfo::kLabel)) break; + int n = oct_info.node_num(d); + std::copy_n(parser_in.label_cpu(d), n, parser_out.mutable_label_cpu(d)); + } + + // copy split label + int split_location = oct_info.locations(OctreeInfo::kSplit); + depth_start = split_location == depth ? depth : 0; + for (int d = depth_start; d < depth + 1; ++d) { + if (!oct_info.has_property(OctreeInfo::kSplit)) break; + int n = oct_info.node_num(d); + std::copy_n(parser_in.split_cpu(d), n, parser_out.mutable_split_cpu(d)); + } +} diff --git a/octree/octree/transform_octree.h b/octree/octree/transform_octree.h index fb0ebe5..369c261 100644 --- a/octree/octree/transform_octree.h +++ b/octree/octree/transform_octree.h @@ -32,4 +32,6 @@ class ScanOctree { void octree_dropout(vector& octree_output, const string& octree_input, const int depth_dropout, const float threshold); +void upgrade_key64(vector& octree_out, const vector& octree_in); + #endif // _OCTREE_TRANSFORM_OCTREES_ diff --git a/octree/octree/types.h b/octree/octree/types.h new file mode 100644 index 0000000..2a33ff9 --- /dev/null +++ b/octree/octree/types.h @@ -0,0 +1,27 @@ +#ifndef _OCTREE_TYPES_ +#define _OCTREE_TYPES_ + +// #include + +// typedef uint8_t uint8; +// typedef uint16_t uint16; +// typedef uint32_t uint32; +// typedef uint64_t uint64; + +// these definations are from tensorflow +typedef unsigned char uint8; +typedef unsigned short uint16; +typedef unsigned int uint32; +typedef unsigned long long uint64; + +template struct KeyTrait {}; +template<> struct KeyTrait { typedef uint8 uints; }; +template<> struct KeyTrait { typedef uint16 uints; }; + +#ifdef KEY64 +typedef uint64 uintk; +#else +typedef uint32 uintk; +#endif // KEY64 + +#endif // _OCTREE_TYPES_ diff --git a/octree/python/pyoctree.cpp b/octree/python/pyoctree.cpp index dfc4481..e284cf2 100644 --- a/octree/python/pyoctree.cpp +++ b/octree/python/pyoctree.cpp @@ -6,6 +6,7 @@ #include #include +#include // qq add for octree #include @@ -42,51 +43,65 @@ PYBIND11_MODULE(pyoctree, m) { }); - // points interface using vectorf = vector; using vectorfc = const vector; auto Points_set_points = (bool(Points::*)(vectorfc&, vectorfc&, vectorfc&, vectorfc&))&Points::set_points; - auto Points_set_points_buffer = (void(Points::*)(vector&))&Points::set_points; + auto Mcube_compute = (void(MarchingCube::*)(vectorfc&, float, vectorfc&, + int))&MarchingCube::compute; + + // points interface py::class_(m, "Points") .def(py::init<>()) .def("read_points", &Points::read_points) .def("write_points", &Points::write_points) .def("write_ply", &Points::write_ply) .def("normalize", &Points::normalize) + .def("orient_normal", &Points::orient_normal) .def("set_points", Points_set_points) - .def("set_points_buffer", Points_set_points_buffer) +// .def("set_points_buffer", Points_set_points_buffer) .def("pts_num", [](const Points& pts) { return pts.info().pt_num(); }) // todo: fix the functions points(), normals(), labels(), // It is inefficient, since there is a memory-copy here - .def("points", [](const Points& pts) { + .def("points", [](const Points & pts) { const float* ptr = pts.points(); int num = pts.info().pt_num(); return vectorf(ptr, ptr + num * 3); }) - .def("normals", [](const Points& pts) { + .def("normals", [](const Points & pts) { const float* ptr = pts.normal(); int num = pts.info().pt_num(); return vectorf(ptr, ptr + num * 3); }) - .def("features", [](const Points& pts) { + .def("features", [](const Points & pts) { const float* ptr = pts.feature(); int num = pts.info().pt_num(); const int ch = pts.info().channel(PointsInfo::kFeature); return vectorf(ptr, ptr + num * ch); }) - .def("labels", [](const Points& pts) { + .def("labels", [](const Points & pts) { const float* ptr = pts.label(); int num = pts.info().pt_num(); return vectorf(ptr, ptr + num); }) - .def("buffer", [](const Points& pts) { + .def("buffer", [](const Points & pts) { const char* ptr = pts.data(); return py::bytes(std::string(ptr, pts.info().sizeof_points())); }); + // marching cube + py::class_(m, "MCube") + .def(py::init<>()) + .def("compute", Mcube_compute) + .def("get_vtx", [](const MarchingCube & mcube) { + return mcube.vtx_; + }) + .def("get_face", [](const MarchingCube & mcube) { + return mcube.face_; + }); + // qq: try octree interface using vectoru = vector; using vectori = vector; @@ -109,7 +124,7 @@ PYBIND11_MODULE(pyoctree, m) { }) .def("keys", [](const Octree& octree, int depth) { // int depth = octree.info().depth(); - const uint32_t* ptr = octree.key_cpu(depth); + const uintk* ptr = octree.key_cpu(depth); int num = octree.info().node_num(depth); return vectoru(ptr, ptr + num); }) diff --git a/octree/test/test_octree.cpp b/octree/test/test_octree.cpp index 14c33d3..5c6bf41 100644 --- a/octree/test/test_octree.cpp +++ b/octree/test/test_octree.cpp @@ -114,7 +114,7 @@ TEST_F(OctreeTest, TestOctreeBuild) { EXPECT_EQ(info.node_num_cum(depth + 1), nnum_cum[depth + 1]); // test the key - const unsigned int keys[] = { + const uintk keys[] = { 0, 0, 1, 2, 3, 4, 5, 6, 7, 0, 1, 2, 3, 4, 5, 6, 7, 48, 49, 50, 51, 52, 53, 54, 55, 0, 1, 2, 3, 4, 5, 6, 7, 384, 385, 386, 387, 388, 389, 390, 391, @@ -123,7 +123,7 @@ TEST_F(OctreeTest, TestOctreeBuild) { }; for (int d = 0, j = 0; d <= depth; ++d) { const int nnum_d = info.node_num(d); - const unsigned int* key_d = octree_.key_cpu(d); + const uintk* key_d = octree_.key_cpu(d); for (int i = 0; i < nnum_d; ++i, j++) { EXPECT_EQ(key_d[i], keys[j]); } @@ -220,7 +220,7 @@ TEST_F(OctreeTest, TestOctreeTrim) { EXPECT_EQ(info.node_num_cum(depth + 1), nnum_cum[depth + 1]); // test the key - const unsigned int keys[] = { + const uintk keys[] = { 0, 0, 1, 2, 3, 4, 5, 6, 7, 0, 1, 2, 3, 4, 5, 6, 7, 48, 49, 50, 51, 52, 53, 54, 55, 0, 1, 2, 3, 4, 5, 6, 7, 384, 385, 386, 387, 388, 389, 390, 391, @@ -229,7 +229,7 @@ TEST_F(OctreeTest, TestOctreeTrim) { }; for (int d = 0, j = 0; d <= depth; ++d) { const int nnum_d = info.node_num(d); - const unsigned int* key_d = octree_.key_cpu(d); + const uintk* key_d = octree_.key_cpu(d); for (int i = 0; i < nnum_d; ++i, j++) { EXPECT_EQ(key_d[i], keys[j]); } diff --git a/octree/test/test_octree_nn.cpp b/octree/test/test_octree_nn.cpp index 02760c4..277491f 100644 --- a/octree/test/test_octree_nn.cpp +++ b/octree/test/test_octree_nn.cpp @@ -1,7 +1,9 @@ #include +#include #include #include #include +#include TEST(VecResizeTest, TestVecResize) { @@ -18,7 +20,6 @@ TEST(VecResizeTest, TestVecResize) { ASSERT_EQ(vec2, gt2); } - TEST(BiliearNeigh, TestBiliearNeigh) { const char* octree1 = (const char*) octree::get_one_octree("octree_1"); vector buffer; @@ -36,12 +37,13 @@ TEST(BiliearNeigh, TestBiliearNeigh) { child0, nnum0, NeighHelper::get_bilinear_array().data()); // check + typedef typename KeyTrait::uints uints; const int weights[8] = { 27, 9, 9, 9, 3, 3, 3, 1 }; - const unsigned* key0 = parser.key_cpu(depth); - const unsigned* key1 = parser.key_cpu(depth + 1); + const uintk* key0 = parser.key_cpu(depth); + const uintk* key1 = parser.key_cpu(depth + 1); ASSERT_TRUE(parser.info().is_key2xyz()); - auto key_to_xyz = [](float * xyz, const unsigned * key) { - const unsigned char* ptr = (const unsigned char*)key; + auto key_to_xyz = [](float * xyz, const uintk * key) { + const uints* ptr = (const uints*)key; for (int i = 0; i < 3; ++i) { xyz[i] = (float)ptr[i] + 0.5f; } }; for (int i = 0; i < nnum1; ++i) { @@ -58,7 +60,7 @@ TEST(BiliearNeigh, TestBiliearNeigh) { int weight = 1; for (int c = 0; c < 3; ++c) { - float dis = fabs(xyz0[c] - xyz1[c]); + float dis = fabsf(xyz0[c] - xyz1[c]); ASSERT_LT(dis, 1.0f); weight *= (int)((1 - dis) * 4); } @@ -67,7 +69,7 @@ TEST(BiliearNeigh, TestBiliearNeigh) { } // check - vector xyz10(nnum1 * 8), key10(nnum1 * 8), key_octree(nnum0); + vector xyz10(nnum1 * 8), key10(nnum1 * 8), key_octree(nnum0); vector fracs(nnum1 * 3); bilinear_xyz_cpu(xyz10.data(), fracs.data(), depth, parser.key_cpu(depth + 1), depth + 1, nnum1); @@ -81,13 +83,14 @@ TEST(BiliearNeigh, TestBiliearNeigh) { } } - TEST(Coord2xyzTest, TestCoord2xyz) { + typedef typename KeyTrait::uints uints; + float coord[] = {1.1, 2.2, 3.3, 4.4, 5.5, 6.6, 7.7, 8.8 }; - unsigned char xyz[] = { 1, 3, 5, 7, 2, 4, 6, 8 }; - unsigned int rst[2] = { 0 }; + uints xyz[] = { 1, 3, 5, 7, 2, 4, 6, 8 }; + uintk rst[2] = { 0 }; coord2xyz_cpu(rst, coord, 2, 4); - unsigned char* ptr = (unsigned char*)rst; + uints* ptr = (uints*)rst; for (int i = 0; i < 8; ++i) { ASSERT_EQ(ptr[i], xyz[i]); } diff --git a/octree/test/test_util.cpp b/octree/test/test_util.cpp index 8cde2e9..e3a0a0a 100644 --- a/octree/test/test_util.cpp +++ b/octree/test/test_util.cpp @@ -1,5 +1,6 @@ #include #include "math_functions.h" +#include #include #include diff --git a/octree/tools/.DS_Store b/octree/tools/.DS_Store deleted file mode 100644 index 6347f9d..0000000 Binary files a/octree/tools/.DS_Store and /dev/null differ diff --git a/octree/tools/adaptive_octree.cpp b/octree/tools/adaptive_octree.cpp deleted file mode 100644 index 68c6250..0000000 --- a/octree/tools/adaptive_octree.cpp +++ /dev/null @@ -1,507 +0,0 @@ -// todo: optimize the coding - -#include -#include -#include -#include -#include -#include - -#include "filenames.h" -#include "octree.h" -#include "marching_cube.h" - -using namespace std; - -int depth_start = 4; -int signal_channel = 4; -int segmentation = 0; -int split_label = 0; - -//float threshold = 0.002f; // about 2.6 degree -float threshold = 0.1f; // about 5.7 degree -float threshold_distance = 0.866; // sqrtf(3.0f) * 0.5f; -//float threshold = 0.02f; // about 8.1 degree -//float threshold = 0.05f; // about 12.8 degree -//float threshold = 0.2f; // about 12.8 degree - - -void covered_depth_nodes(vector>& dnum_, vector>& didx_, - const int* children_, const int* node_num_, const int* node_num_accu_, const int depth_) { - // init - didx_.resize(depth_ + 1); - dnum_.resize(depth_ + 1); - - //layer-depth_ - int nnum = node_num_[depth_]; - dnum_[depth_].resize(nnum, 1); - didx_[depth_].resize(nnum); - for (int i = 0; i < nnum; ++i) { - didx_[depth_][i] = i; - } - - // layer-(depth_-1) - nnum = node_num_[depth_ - 1]; - dnum_[depth_ - 1].resize(nnum, 0); - didx_[depth_ - 1].resize(nnum, -1); - const int* children_d = children_ + node_num_accu_[depth_ - 1]; - for (int i = 0; i < nnum; ++i) { - int t = children_d[i]; - if (t != -1) { - dnum_[depth_ - 1][i] = 8; - didx_[depth_ - 1][i] = t * 8; - } - } - - // layer-(depth-2) to layer-0 - for (int d = depth_ - 2; d >= 0; --d) { - nnum = node_num_[d]; - dnum_[d].resize(nnum, 0); - didx_[d].resize(nnum, -1); - const int* children_d = children_ + node_num_accu_[d]; - for (int i = 0; i < nnum; ++i) { - int t = children_d[i]; - if (t != -1) { - t *= 8; - for (int j = 0; j < 8; ++j) { - dnum_[d][i] += dnum_[d + 1][t + j]; - } - for (int j = 0; j < 8; ++j) { - if (didx_[d + 1][t + j] != -1) { - didx_[d][i] = didx_[d + 1][t + j]; - break; - } - } - } - } - } -} - - -void adaptive_octree(vector& octree_output, const vector& octree_input, - const int depth_output) { - /// const - const float mul = sqrtf(3.0f) / 2.0f; - const float imul = 2.0f / sqrtf(3.0f); - //const int signal_channel = 4; - - /// parse the octree file - Octree octree_in; - octree_in.set_octree(octree_input.data(), octree_input.size()); - bool is_key2xyz = octree_in.info().is_key2xyz(); // !!! must be true - int depth = octree_in.info().depth(); - int full_layer = octree_in.info().full_layer(); - int total_node_num = octree_in.info().total_nnum(); - int final_node_num = octree_in.info().node_num(depth); - vector nnum_vec(depth + 1, 0), nnum_accu_vec(depth + 2, 0); - for (int d = 0; d < depth + 1; ++d) { - nnum_vec[d] = octree_in.info().node_num(d); - nnum_accu_vec[d] = octree_in.info().node_num_cum(d); - } - nnum_accu_vec[depth + 1] = octree_in.info().node_num_cum(depth + 1); - const int* node_num = nnum_vec.data(); - const int* node_num_accu = nnum_accu_vec.data(); - const unsigned int* key = octree_in.key_cpu(0); - const int* children = octree_in.children_cpu(0); - const float* data = octree_in.feature_cpu(0); - const float* normal_ptr = data; // !!! channel x n - const float* dis_ptr = normal_ptr + 3 * final_node_num; - const float* label_ptr = octree_in.label_cpu(0); - - /// precompute the nodes in the depth layer covered by each octree node - vector> dnum_, didx_; - covered_depth_nodes(dnum_, didx_, children, node_num, node_num_accu, depth); - - /// precompute the points in the finest level - vector pt_depth; // !!! n x channel - if (signal_channel == 4) { - pt_depth.resize(3 * final_node_num); - const unsigned int* key_depth = key + node_num_accu[depth]; - for (int i = 0; i < final_node_num; ++i) { - const unsigned char* pt = reinterpret_cast(key_depth + i); - for (int c = 0; c < 3; ++c) { - float nc = normal_ptr[c * final_node_num + i]; - pt_depth[i * 3 + c] = static_cast(pt[c]) + 0.5f + dis_ptr[i] * nc * mul; - } - } - } - - /// the average normal & displacement and normal variation - vector > normal_avg(depth + 1), normal_err(depth + 1), distance_err(depth + 1); - vector > label_avg(depth + 1); - int nlabel = 0; - if (segmentation != 0) { - nlabel = *std::max_element(label_ptr, label_ptr + final_node_num) + 1; - } - - // initialization - for (int d = 0; d <= depth; ++d) { - normal_avg[d].resize(signal_channel * node_num[d], 0.0f); - normal_err[d].resize(node_num[d], 5.0f); // !!! initialized as 5.0f - distance_err[d].resize(node_num[d], 5.0e10f); - if (segmentation != 0) { - label_avg[d].resize(node_num[d], -1); - } - } - - // for the depth layer - memcpy(normal_avg[depth].data(), normal_ptr, normal_avg[depth].size() * sizeof(float)); - if (segmentation != 0) { - memcpy(label_avg[depth].data(), label_ptr, label_avg[depth].size() * sizeof(float)); - } - - // for the other layers - for (int d = depth - 1; d > full_layer; --d) { - vector& dnum = dnum_[d]; - vector& didx = didx_[d]; - const unsigned int* key_d = key + node_num_accu[d]; - const int* children_d = children + node_num_accu[d]; - const int* children_depth = children + node_num_accu[depth]; - const float scale = static_cast(1 << (depth - d)); - - int nnum = node_num[d]; - vector& normal_d = normal_avg[d]; - vector& normal_err_d = normal_err[d]; - vector& distance_err_d = distance_err[d]; - - vector& label_d = label_avg[d]; - for (int i = 0; i < nnum; ++i) { - if (children_d[i] == -1) continue; - - // average the normal and projection point - float count = 0.0f; - float pt_avg[3] = { 0.0f, 0.0f, 0.0f }, dis_avg = 0.0f; - float n_avg[3] = { 0.0f, 0.0f, 0.0f }; - vector l_avg(nlabel, 0); - for (int j = didx[i]; j < didx[i] + dnum[i]; ++j) { - if (children_depth[j] == -1) continue; - count += 1.0f; - for (int c = 0; c < 3; ++c) { - float nc = normal_ptr[c * final_node_num + j]; - n_avg[c] += nc; - if (signal_channel == 4) { - pt_avg[c] += pt_depth[3 * j + c]; - } - } - if (segmentation != 0) { - l_avg[label_ptr[j]] += 1; - } - } - - - float len = 1.0e-30f; - for (int c = 0; c < 3; ++c) len += n_avg[c] * n_avg[c]; - len = sqrtf(len); - - float pt_base[3]; - const unsigned char* pt = reinterpret_cast(key_d + i); - for (int c = 0; c < 3; ++c) { - n_avg[c] /= len; - if (signal_channel == 4) { - pt_avg[c] /= count * scale; // !!! note the scale - pt_base[c] = static_cast(pt[c]); - float fract_part = pt_avg[c] - pt_base[c]; - dis_avg += (fract_part - 0.5f) * n_avg[c]; - } - } - - // === version 1 - // the normal error - float nm_err = 0.0f; - for (int j = didx[i]; j < didx[i] + dnum[i]; ++j) { - if (children_depth[j] == -1) continue; - for (int c = 0; c < 3; ++c) { - float tmp = normal_ptr[c * final_node_num + j] - n_avg[c]; - nm_err += tmp * tmp; - } - } - nm_err /= count; - - // output - normal_d[i] = n_avg[0]; - normal_d[1 * nnum + i] = n_avg[1]; - normal_d[2 * nnum + i] = n_avg[2]; - if (signal_channel == 4) { - normal_d[3 * nnum + i] = dis_avg * imul; // IMPORTANT: RESCALE - } - normal_err_d[i] = nm_err; - if (segmentation != 0) { - label_d[i] = 0; - for (int j = 1, v = 0; j < nlabel; ++j) { - if (l_avg[j] > v) { - v = l_avg[j]; - label_d[i] = j; - } - } - } - - // === version 2 - if (signal_channel != 4) { - distance_err_d[i] = 0; - continue; - } - // the error from the original geometry to the averaged geometry - float distance_max1 = -1; - // !!! note the scale - float pt_avg1[3] = { pt_avg[0] * scale, pt_avg[1] * scale, pt_avg[2] * scale }; - for (int j = didx[i]; j < didx[i] + dnum[i]; ++j) { - if (children_depth[j] == -1) continue; - float dis = 0.0f; - for (int c = 0; c < 3; ++c) { - dis += (pt_depth[3 * j + c] - pt_avg1[c]) * n_avg[c]; - } - dis = abs(dis); - if (dis > distance_max1) distance_max1 = dis; - } - - // the error from the averaged geometry to the original geometry - float distance_max2 = -1; - vector vtx; - intersect_cube(vtx, pt_avg, pt_base, n_avg); - if (vtx.empty()) distance_max2 = 5.0e10f; // !!! the degenerated case, ||n_avg|| == 0 - for (auto& v : vtx) v *= scale; // !!! note the scale - for (int k = 0; k < vtx.size() / 3; ++k) { - - // min - float distance_min = 1.0e30f; - for (int j = didx[i]; j < didx[i] + dnum[i]; ++j) { - if (children_depth[j] == -1) continue; - float dis = 0.0f; - for (int c = 0; c < 3; ++c) { - float ptc = pt_depth[3 * j + c] - vtx[3 * k + c]; - dis += ptc * ptc; - } - dis = sqrtf(dis); - if (dis < distance_min) distance_min = dis; - } - - // max - if (distance_min > distance_max2) distance_max2 = distance_min; - } - - distance_err_d[i] = std::max(distance_max2, distance_max1); - } - } - - /// trim the octree according to normal_var - vector > data_output(depth + 1), label_output(depth + 1); - vector > key_output(depth + 1); - vector > children_output(depth + 1), drop(depth + 1); - for (int d = 0; d <= depth; ++d) { - drop[d].resize(node_num[d], 0); // 1 means dropping the sub-tree - } - for (int d = depth_output; d <= depth; ++d) { - int nnum_d = node_num[d]; - int nnum_dp = node_num[d - 1]; - vector& normal_err_d = normal_err[d]; - vector& dist_err_d = distance_err[d]; - const unsigned int* key_d = key + node_num_accu[d]; - const int* children_d = children + node_num_accu[d]; - const int* children_dp = children + node_num_accu[d - 1]; - vector& drop_d = drop[d]; - vector& drop_dp = drop[d - 1]; - - // generate the drop flag - bool all_drop = true; - for (int i = 0; i < nnum_dp; ++i) { - int t = children_dp[i]; - if (t == -1) continue; - for (int j = 0; j < 8; ++j) { - int idx = t * 8 + j; - drop_d[idx] = drop_dp[i] == 1 || - (normal_err_d[idx] < threshold && dist_err_d[idx] < threshold_distance); - //drop_d[idx] = drop_dp[i] == 1 ||dist_err_d[idx] < thredhold_distance; - if (all_drop && children_d[idx] != -1) { - all_drop = drop_d[idx] == 1; - } - } - } - - // make sure that there is at least one octree node in each layer - if (all_drop) { - int max_idx = 0; - float max_var = -1.0f; - for (int i = 0; i < nnum_dp; ++i) { - int t = children_dp[i]; - if (t == -1 || drop_dp[i] == 1) continue; - for (int j = 0; j < 8; ++j) { - int idx = t * 8 + j; - if (children_d[idx] != -1 && normal_err_d[idx] > max_var) { - max_var = normal_err_d[idx]; - max_idx = idx; - } - } - } - drop_d[max_idx] = 0; - } - - for (int i = 0, id = 0; i < nnum_dp; ++i) { - int t = children_dp[i]; - if (t == -1) continue; - for (int j = 0; j < 8; ++j) { - int idx = t * 8 + j; - if (drop_dp[i] == 0) { - key_output[d].push_back(key_d[idx]); - - int ch = (drop_d[idx] == 0 && children_d[idx] != -1) ? id++ : -1; - children_output[d].push_back(ch); - - for (int c = 0; c < signal_channel; ++c) { - data_output[d].push_back(normal_avg[d][c * nnum_d + idx]); - } - - if (segmentation != 0) { - label_output[d].push_back(label_avg[d][idx]); - } - } - } - } - - // transpose data - int num = key_output[d].size(); - vector data_buffer(num * signal_channel); - for (int i = 0; i < num; ++i) { - for (int c = 0; c < signal_channel; ++c) { - data_buffer[c * num + i] = data_output[d][i * signal_channel + c]; - } - } - data_output[d].swap(data_buffer); - } - - /// output - OctreeInfo info_out = octree_in.info(); - info_out.set_adaptive(true); - info_out.set_threshold_dist(threshold_distance); - info_out.set_threshold_normal(threshold); - if (split_label) { - info_out.set_property(OctreeInfo::kSplit, 1, -1); - } else { - info_out.set_property(OctreeInfo::kSplit, 0, 0); - } - info_out.set_property(OctreeInfo::kFeature, signal_channel, -1); - if (segmentation) info_out.set_property(OctreeInfo::kLabel, 1, -1); - //vector nnum_nempty_vec(depth + 1); - for (int d = 0; d <= depth; ++d) { - nnum_vec[d] = d <= depth_output ? octree_in.info().node_num(d) : key_output[d].size(); - } - info_out.set_nnum(nnum_vec.data()); - info_out.set_nnum_cum(); - info_out.set_ptr_dis(); - - // copy OctreeInfo - Octree octree_out; - octree_out.resize_octree(info_out.sizeof_octree()); - octree_out.mutable_info() = info_out; - copy(key, key + node_num_accu[depth_output], octree_out.mutable_key_cpu(0)); - for (int d = depth_output; d <= depth; ++d) { - copy(key_output[d].begin(), key_output[d].end(), octree_out.mutable_key_cpu(d)); - } - copy(children, children + node_num_accu[depth_output], octree_out.mutable_children_cpu(0)); - for (int d = depth_output; d <= depth; ++d) { - copy(children_output[d].begin(), children_output[d].end(), octree_out.mutable_children_cpu(d)); - } - for (int d = 0; d <= depth; ++d) { - vector& normal_tmp = d < depth_output ? normal_avg[d] : data_output[d]; - copy(normal_tmp.begin(), normal_tmp.end(), octree_out.mutable_feature_cpu(d)); - } - if (segmentation != 0) { - for (int d = 0; d <= depth; ++d) { - vector& label_tmp = d < depth_output ? label_avg[d] : label_output[d]; - copy(label_tmp.begin(), label_tmp.end(), octree_out.mutable_label_cpu(d)); - } - } - // update nnum_nempty - for (int d = 0; d <= depth; ++d) { - // find the last element which is not equal to -1 - int nnum_nempty = 0; - const int* children_d = octree_out.children_cpu(d); - for (int i = octree_out.info().node_num(d) - 1; i >= 0; i--) { - if (children_d[i] != -1) { - nnum_nempty = children_d[i] + 1; - break; - } - } - nnum_vec[d] = nnum_nempty; - } - octree_out.mutable_info().set_nempty(nnum_vec.data()); - - if (split_label != 0) { - // generate split label according to the children_ - vector > split_output(depth + 1); - for (int d = 0; d <= depth; ++d) { - int nnum_d = octree_out.info().node_num(d); - vector& split_d = split_output[d]; - split_d.resize(nnum_d, 1); // initialize as 1 - const int* children_d = d < depth_output ? - children + node_num_accu[d] : children_output[d].data(); - vector& data_d = data_output[d]; - for (int i = 0; i < nnum_d; ++i) { - if (children_d[i] == -1) { - split_d[i] = 0; - if (d >= depth_output) { - float t = abs(data_d[i]) + abs(data_d[nnum_d + i]) + abs(data_d[nnum_d * 2 + i]); - if (t != 0) split_d[i] = 2; - } - } - } - } - for (int d = 0; d <= depth; ++d) { - copy(split_output[d].begin(), split_output[d].end(), octree_out.mutable_split_cpu(d)); - } - } - - octree_output = octree_out.buffer(); -} - - -void adaptive_octree(const string& filename, const string& filename_output) { - // read octree - ifstream infile(filename, ios::binary); - infile.seekg(0, infile.end); - int len = infile.tellg(); - infile.seekg(0, infile.beg); - vector octree(len, 0); - infile.read(octree.data(), len); - infile.close(); - - vector octree_output; - adaptive_octree(octree_output, octree, depth_start); - - // save octree - ofstream outfile(filename_output, ios::binary); - outfile.write(octree_output.data(), octree_output.size()); - outfile.close(); -} - - -int main(int argc, char* argv[]) { - if (argc < 3) { - cout << "Usage: AdaptiveOctree.exe " - << "[depth] [signal_channel] [segmentation] [split_label]" << endl; - return 0; - } - - string input_file_path(argv[1]); - string output_file_path(argv[2]); - mkdir(output_file_path.c_str()); - if (argc > 3) depth_start = atoi(argv[3]); - if (argc > 4) signal_channel = atoi(argv[4]); - if (argc > 5) segmentation = atoi(argv[5]); - if (argc > 6) split_label = atoi(argv[6]); - - vector all_files; - get_all_filenames(all_files, input_file_path + "\\*.octree"); - - //#pragma omp parallel for - for (int i = 0; i < all_files.size(); ++i) { - string filename = extract_filename(all_files[i]); - string filename_ouput = output_file_path + filename + "_output.octree"; - - adaptive_octree(all_files[i], filename_ouput); - - cout << filename + " done!\n"; - } - - return 0; - -} diff --git a/octree/tools/bbox.cpp b/octree/tools/bbox.cpp index 83a8425..d5a86e7 100644 --- a/octree/tools/bbox.cpp +++ b/octree/tools/bbox.cpp @@ -35,7 +35,7 @@ int main(int argc, char* argv[]) { if (FLAGS_type == "box") { float bbmin[3], bbmax[3]; - bouding_box(bbmin, bbmax, pt, npt); + bounding_box(bbmin, bbmax, pt, npt); cout << bbmin[0] << ", " << bbmin[1] << ", " << bbmin[2] << ", " << bbmax[0] << ", " << bbmax[1] << ", " << bbmax[2] << endl; } else { diff --git a/octree/tools/build_octree.cpp b/octree/tools/build_octree.cpp index 7c2543c..08c8f86 100644 --- a/octree/tools/build_octree.cpp +++ b/octree/tools/build_octree.cpp @@ -21,7 +21,7 @@ DEFINE_string(axis, kOptional, "y", "The upright axis of the input model"); DEFINE_int(depth, kOptional, 6, "The maximum depth of the octree"); DEFINE_int(full_depth, kOptional, 2, "The full layer of the octree"); DEFINE_int(rot_num, kOptional, 12, "Number of poses rotated along the upright axis"); -DEFINE_float(offset, kOptional, 0.55f, "The offset value for handing thin shapes"); +DEFINE_float(offset, kOptional, 0.0f, "The offset value for handing thin shapes"); DEFINE_bool(node_dis, kOptional, false, "Output per-node displacement"); DEFINE_bool(node_feature, kOptional, false, "Compute per node feature"); DEFINE_bool(split_label, kOptional, false, "Compute per node splitting label"); @@ -61,7 +61,7 @@ class OctreeBuilder { cout << "Points number: " << npt < +#include #include #include #include @@ -16,6 +16,7 @@ DEFINE_string(filenames, kRequired, "", "The input filenames"); DEFINE_string(output_path, kOptional, ".", "The output path"); DEFINE_int(depth_start, kOptional, 0, "The starting depth"); DEFINE_int(depth_end, kOptional, 10, "The ending depth"); +DEFINE_bool(rescale, kOptional, true, "Scale the mesh according to the bbox"); DEFINE_bool(pu, kOptional, false, "Partition of Unity"); DEFINE_bool(verbose, kOptional, true, "Output logs"); @@ -59,10 +60,10 @@ int main(int argc, char* argv[]) { // convert vector V; vector F; if (!FLAGS_pu) { - octree.octree2mesh(V, F, FLAGS_depth_start, FLAGS_depth_end); + octree.octree2mesh(V, F, FLAGS_depth_start, FLAGS_depth_end, FLAGS_rescale); } else { clock_t t = clock(); - Contour contour(&octree); + Contour contour(&octree, FLAGS_rescale); contour.marching_cube(V, F); t = clock() - t; cout << "time : " << t << endl; diff --git a/octree/tools/octree2points.cpp b/octree/tools/octree2points.cpp index faacf42..0d23b33 100644 --- a/octree/tools/octree2points.cpp +++ b/octree/tools/octree2points.cpp @@ -1,4 +1,4 @@ -#include +#include #include #include @@ -14,14 +14,14 @@ DEFINE_string(output_path, kOptional, ".", "The output path"); DEFINE_string(suffix, kOptional, "points", "The output file suffix"); DEFINE_int(depth_start, kOptional, 0, "The starting depth"); DEFINE_int(depth_end, kOptional, 10, "The ending depth"); -DEFINE_int(rescale, kOptional, true, "The ending depth"); +DEFINE_bool(rescale, kOptional, true, "Scale the points according to the bbox"); DEFINE_bool(verbose, kOptional, true, "Output logs"); int main(int argc, char* argv[]) { bool succ = cflags::ParseCmd(argc, argv); if (!succ) { - cflags::PrintHelpInfo("\nUsage: octree2points.exe"); + cflags::PrintHelpInfo("\nUsage: octree2points"); return 0; } diff --git a/octree/tools/octree2pts_suncg.cpp b/octree/tools/octree2pts_suncg.cpp index 284529d..6d43611 100644 --- a/octree/tools/octree2pts_suncg.cpp +++ b/octree/tools/octree2pts_suncg.cpp @@ -1,4 +1,4 @@ -#include +#include #include #include #include @@ -22,7 +22,7 @@ void octree2pts(vector& pts, vector& labels, const Octree& octree) { const int* child = octree.children_cpu(depth); const float* label = octree.label_cpu(depth); const float* normal = octree.feature_cpu(depth); - const unsigned int* key = octree.key_cpu(depth); + const uintk* key = octree.key_cpu(depth); pts.clear(); labels.clear(); for (int i = 0; i < num; ++i) { diff --git a/octree/tools/octree_prune.cpp b/octree/tools/octree_prune.cpp index 9779d65..1663699 100644 --- a/octree/tools/octree_prune.cpp +++ b/octree/tools/octree_prune.cpp @@ -1,4 +1,4 @@ -#include +#include #include #include #include @@ -10,6 +10,7 @@ #include "octree.h" #include "contour.h" #include "cmd_flags.h" +#include "types.h" using namespace std; using cflags::Require; @@ -68,11 +69,11 @@ void prune_octree(Octree& octree_out, const Octree& octree_in) { int id = 0, j = 0; int* child_out = octree_out.mutable_children_cpu(d); const int* child_in = octree_in.children_cpu(d); - unsigned int* key_out = octree_out.mutable_key_cpu(d); + uintk* key_out = octree_out.mutable_key_cpu(d); float* split_out = octree_out.mutable_split_cpu(d); for (int i = 0; i < octree_in.info().node_num(d); ++i) { - unsigned int key = i, pt[3]; + uintk key = i, pt[3]; octree_in.key2xyz(pt, key, d); if (pt[0] < bnd0[d][0] && pt[1] < bnd0[d][1] && pt[2] < bnd0[d][2]) { @@ -104,8 +105,8 @@ void prune_octree(Octree& octree_out, const Octree& octree_in) { int* child_out = octree_out.mutable_children_cpu(d); std::copy_n(child_in, num, child_out); - const unsigned int* key_in = octree_in.key_cpu(d); - unsigned int* key_out = octree_out.mutable_key_cpu(d); + const uintk* key_in = octree_in.key_cpu(d); + uintk* key_out = octree_out.mutable_key_cpu(d); std::copy_n(key_in, num, key_out); if (location_feature == -1 || d == depth) { diff --git a/octree/tools/points_noise.cpp b/octree/tools/points_noise.cpp index 9ded8af..9490ad0 100644 --- a/octree/tools/points_noise.cpp +++ b/octree/tools/points_noise.cpp @@ -1,23 +1,25 @@ -#include -#include +#include #include -#include #include -#include +#include +#include #include "cmd_flags.h" -#include "points.h" #include "filenames.h" +#include "math_functions.h" +#include "points.h" - -using std::vector; -using std::string; +using cflags::Require; using std::cout; using std::endl; -using cflags::Require; +using std::string; +using std::vector; DEFINE_string(filenames, kRequired, "", "The input filenames"); DEFINE_string(output_path, kOptional, ".", "The output path"); +DEFINE_float(ratio, kOptional, 0.1f, "The ratio of perturbed points"); +DEFINE_float(dp, kOptional, 1.0f, "The deviation of point noise"); +DEFINE_float(dn, kOptional, 0.1f, "The deviation of normal noise"); DEFINE_bool(verbose, kOptional, true, "Output logs"); class GaussianRand { @@ -63,22 +65,27 @@ class BernoulliRand { }; - -void add_noise(Points& pts) { - BernoulliRand bernoulli(0.1f); - GaussianRand pt_noise(3.0f), normal_noise(0.1f); +void add_noise(Points& pts, GaussianRand& pt_noise, GaussianRand& normal_noise, + BernoulliRand& bernoulli) { + // bounding sphere of the points + float radius = 0, center[3] = { 0 }; + int npts = pts.info().pt_num(); + bounding_sphere(radius, center, pts.points(), npts); + radius = radius / 100.0f; // add pt noise - int npts = pts.info().pt_num(); vector noise(npts); pt_noise(noise.data(), npts); - vector mask(npts); - bernoulli(mask.data(), npts); + for (int i = 0; i < npts; ++i) { + noise[i] *= radius; // rescale the noise according to the radius + } + //vector mask(npts); + //bernoulli(mask.data(), npts); - float* ptr_pts = pts.mutable_ptr(PointsInfo::kPoint); - float* ptr_normal = pts.mutable_ptr(PointsInfo::kNormal); + float* ptr_pts = pts.mutable_points(); + float* ptr_normal = pts.mutable_normal(); for (int i = 0; i < npts; ++i) { - if (mask[i] == 0) continue; + //if (mask[i] == 0) continue; for (int c = 0; c < 3; ++c) { ptr_pts[i * 3 + c] += noise[i] * ptr_normal[i * 3 + c]; } @@ -105,32 +112,36 @@ void add_noise(Points& pts) { int main(int argc, char* argv[]) { bool succ = cflags::ParseCmd(argc, argv); if (!succ) { - cflags::PrintHelpInfo("\nUsage: simplify_points"); + cflags::PrintHelpInfo("\nUsage: points_noise"); return 0; } // file path string file_path = FLAGS_filenames; string output_path = FLAGS_output_path; - if (output_path != ".") mkdir(output_path); - else output_path = extract_path(file_path); + if (output_path != ".") { mkdir(output_path); } + else { output_path = extract_path(file_path); } output_path += "/"; vector all_files; get_all_filenames(all_files, file_path); + // declare the random number generator as global variables + BernoulliRand bernoulli(FLAGS_ratio); + GaussianRand pt_noise(FLAGS_dp), normal_noise(FLAGS_dn); + for (int i = 0; i < all_files.size(); i++) { Points pts; pts.read_points(all_files[i]); - add_noise(pts); + add_noise(pts, pt_noise, normal_noise, bernoulli); string filename = extract_filename(all_files[i]); if (FLAGS_verbose) cout << "Processing: " << filename << std::endl; - filename = output_path + filename + "_noise.points"; + filename = output_path + filename + ".points"; pts.write_points(filename); } cout << "Done: " << FLAGS_filenames << endl; return 0; -} \ No newline at end of file +} diff --git a/octree/tools/qq_octree_rotate.cpp b/octree/tools/qq_octree_rotate.cpp deleted file mode 100644 index 6868d30..0000000 --- a/octree/tools/qq_octree_rotate.cpp +++ /dev/null @@ -1,213 +0,0 @@ -// QQ add for xyz rotation - -#include -#include -#include -#include - -#include "cmd_flags.h" -#include "octree.h" -#include "filenames.h" -#include "math_functions.h" - -using std::vector; -using std::string; -using std::cout; -using std::endl; -using cflags::Require; -const float kPI = 3.14159265f; - -DEFINE_string(filenames, kRequired, "", "The input filenames"); -DEFINE_string(output_path, kOptional, ".", "The output path"); -DEFINE_string(axis, kOptional, "y", "The upright axis of the input model"); -DEFINE_int(depth, kOptional, 6, "The maximum depth of the octree"); -DEFINE_int(full_depth, kOptional, 2, "The full layer of the octree"); -DEFINE_int(rot_num, kOptional, 24, "Number of poses rotated along the upright axis"); -DEFINE_float(offset, kOptional, 0.0f, "The offset value for handing thin shapes"); -DEFINE_bool(node_dis, kOptional, false, "Output per-node displacement"); -DEFINE_bool(node_feature, kOptional, false, "Compute per node feature"); -DEFINE_bool(split_label, kOptional, false, "Compute per node splitting label"); -DEFINE_bool(adaptive, kOptional, false, "Build adaptive octree"); -DEFINE_int(adp_depth, kOptional, 4, "The starting depth of adaptive octree"); -DEFINE_float(th_distance, kOptional, 2.0f, "The threshold for simplifying octree"); -DEFINE_float(th_normal, kOptional, 0.1f, "The threshold for simplifying octree"); -DEFINE_bool(key2xyz, kOptional, false, "Convert the key to xyz when serialization"); -DEFINE_bool(extrapolate, kOptional, false, "Exptrpolate the node feature"); -DEFINE_bool(save_pts, kOptional, false, "Save the average points as signal"); -DEFINE_bool(verbose, kOptional, true, "Output logs"); - - -// OctreeBuilder shows a basic example for building an octree with a point cloud -class OctreeBuilder { - public: - bool set_point_cloud(string filename) { - // load point cloud - bool succ = point_cloud_.read_points(filename); - if (!succ) { - cout << "Can not load " << filename << endl; - return false; - } - string msg; - succ = point_cloud_.info().check_format(msg); - if (!succ) { - cout << filename << endl << msg << endl; - return false; - } - - // deal with empty points - int npt = point_cloud_.info().pt_num(); - if (npt == 0) { - cout << "This is an empty points!" << endl; - return false; - } - cout << "Points number: " << npt < 1.0e-10f) { - float offset = FLAGS_offset * 2.0f * radius_ / float(1 << FLAGS_depth); - point_cloud_.displace(offset); - radius_ += offset; - } - - return true; - } - - void set_octree_info() { - octree_info_.initialize(FLAGS_depth, FLAGS_full_depth, FLAGS_node_dis, - FLAGS_node_feature, FLAGS_split_label, FLAGS_adaptive, FLAGS_adp_depth, - FLAGS_th_distance, FLAGS_th_normal, FLAGS_key2xyz, FLAGS_extrapolate, - FLAGS_save_pts, point_cloud_); - - // the point cloud has been centralized, - // so initializing the bbmin & bbmax in the following way - float bbmin[] = { -radius_, -radius_, -radius_ }; - float bbmax[] = { radius_, radius_, radius_ }; - octree_info_.set_bbox(bbmin, bbmax); -// std::cout << octree_info_.depth() << std::endl; - } - - void build_octree() { - octree_.build(octree_info_, point_cloud_); -// std::cout << point_cloud_.info - } - - void save_octree(const string& output_filename) { - // Modify the bounding box before saving, because the center of - // the point cloud is translated to (0, 0, 0) when building the octree - octree_.mutable_info().set_bbox(radius_, center_); - octree_.write_octree(output_filename); - } - - public: - Points point_cloud_; - float radius_, center_[3]; - OctreeInfo octree_info_; - Octree octree_; -}; - - -int main(int argc, char* argv[]) { - bool succ = cflags::ParseCmd(argc, argv); - if (!succ) { - cflags::PrintHelpInfo("\nUsage: Octree.exe"); - return 0; - } - - // file path - string file_path = FLAGS_filenames; - string output_path = FLAGS_output_path; - if (output_path != ".") mkdir(output_path); - else output_path = extract_path(file_path); - output_path += "/"; - - vector all_files; - get_all_filenames(all_files, file_path); - - #pragma omp parallel for - for (int i = 0; i < all_files.size(); i++) { - OctreeBuilder builder; - bool succ = builder.set_point_cloud(all_files[i]); - - string filename = extract_filename(all_files[i]); - if (!succ) { - if (FLAGS_verbose) cout << "Warning: " + filename + " is invalid!\n"; - continue; - } - builder.set_octree_info(); - - // data augmentation -// float angle = 2.0f * kPI / float(FLAGS_rot_num); - float deg_90 = kPI * 1.0f/2; - float deg_180 = kPI; -// float axis[] = { 0.0f, 0.0f, 0.0f }; -// if (FLAGS_axis == "x") axis[0] = 1.0f; -// else if (FLAGS_axis == "y") axis[1] = 1.0f; -// else axis[2] = 1.0f; - - float x_axis[] = { 1.0f, 0.0f, 0.0f }; - float y_axis[] = { 0.0f, 1.0f, 0.0f }; - float z_axis[] = { 0.0f, 0.0f, 1.0f }; - - - if (FLAGS_verbose) cout << "Processing: " + filename + "\n"; - // QQ: get 24 augmentations - int idx = 0; - for (int v = 0; v < 4; ++v){ - builder.point_cloud_.rotate(deg_90, x_axis); - - for (int t= 0; t < 4; ++t){ - builder.point_cloud_.rotate(deg_90, z_axis); - - // output filename - char file_suffix[64]; - sprintf(file_suffix, "_%d_%d_%03d.octree", FLAGS_depth, FLAGS_full_depth, idx); - idx++; - - // build - builder.build_octree(); - builder.save_octree(output_path + filename + file_suffix); - } - } - - builder.point_cloud_.rotate(deg_90, y_axis); - - for (int t= 0; t < 4; ++t){ - builder.point_cloud_.rotate(deg_90, z_axis); - - // output filename - char file_suffix[64]; - sprintf(file_suffix, "_%d_%d_%03d.octree", FLAGS_depth, FLAGS_full_depth, idx); - idx++; - - // build - builder.build_octree(); - builder.save_octree(output_path + filename + file_suffix); - } - - builder.point_cloud_.rotate(deg_180, y_axis); - - for (int t= 0; t < 4; ++t){ - builder.point_cloud_.rotate(deg_90, z_axis); - - // output filename - char file_suffix[64]; - sprintf(file_suffix, "_%d_%d_%03d.octree", FLAGS_depth, FLAGS_full_depth, idx); - idx++; - - // build - builder.build_octree(); - builder.save_octree(output_path + filename + file_suffix); - } - } - - if (FLAGS_verbose) cout << "Done: " << FLAGS_filenames << endl; - return 0; -} - diff --git a/octree/tools/qq_octree_rotate_angle.cpp b/octree/tools/qq_octree_rotate_angle.cpp deleted file mode 100644 index d8b10a7..0000000 --- a/octree/tools/qq_octree_rotate_angle.cpp +++ /dev/null @@ -1,187 +0,0 @@ -// Not working when multiple values in angle are non-zero. - -#include -#include -#include -#include - -#include "cmd_flags.h" -#include "octree.h" -#include "filenames.h" -#include "math_functions.h" - -using std::vector; -using std::string; -using std::cout; -using std::endl; -using cflags::Require; -const float kPI = 3.14159265f; - -DEFINE_string(filenames, kRequired, "", "The input filenames"); -DEFINE_string(output_path, kOptional, ".", "The output path"); -DEFINE_string(axis, kOptional, "y", "The upright axis of the input model"); -DEFINE_int(depth, kOptional, 6, "The maximum depth of the octree"); -DEFINE_int(full_depth, kOptional, 2, "The full layer of the octree"); -DEFINE_int(rot_num, kOptional, 12, "Number of poses rotated along the upright axis"); -DEFINE_float(offset, kOptional, 0.55f, "The offset value for handing thin shapes"); -DEFINE_bool(node_dis, kOptional, false, "Output per-node displacement"); -DEFINE_bool(node_feature, kOptional, false, "Compute per node feature"); -DEFINE_bool(split_label, kOptional, false, "Compute per node splitting label"); -DEFINE_bool(adaptive, kOptional, false, "Build adaptive octree"); -DEFINE_int(adp_depth, kOptional, 4, "The starting depth of adaptive octree"); -DEFINE_float(th_distance, kOptional, 2.0f, "The threshold for simplifying octree"); -DEFINE_float(th_normal, kOptional, 0.1f, "The threshold for simplifying octree"); -DEFINE_bool(key2xyz, kOptional, false, "Convert the key to xyz when serialization"); -DEFINE_bool(extrapolate, kOptional, false, "Exptrpolate the node feature"); -DEFINE_bool(save_pts, kOptional, false, "Save the average points as signal"); -DEFINE_bool(verbose, kOptional, true, "Output logs"); - - -// OctreeBuilder shows a basic example for building an octree with a point cloud -class OctreeBuilder { - public: - bool set_point_cloud(string filename) { - // load point cloud - bool succ = point_cloud_.read_points(filename); - if (!succ) { - cout << "Can not load " << filename << endl; - return false; - } - string msg; - succ = point_cloud_.info().check_format(msg); - if (!succ) { - cout << filename << endl << msg << endl; - return false; - } - - // deal with empty points - int npt = point_cloud_.info().pt_num(); - if (npt == 0) { - cout << "This is an empty points!" << endl; - return false; - } - cout << "Points number: " << npt < 1.0e-10f) { - float offset = FLAGS_offset * 2.0f * radius_ / float(1 << FLAGS_depth); - point_cloud_.displace(offset); - radius_ += offset; - } - - return true; - } - - void set_octree_info() { - octree_info_.initialize(FLAGS_depth, FLAGS_full_depth, FLAGS_node_dis, - FLAGS_node_feature, FLAGS_split_label, FLAGS_adaptive, FLAGS_adp_depth, - FLAGS_th_distance, FLAGS_th_normal, FLAGS_key2xyz, FLAGS_extrapolate, - FLAGS_save_pts, point_cloud_); - - // the point cloud has been centralized, - // so initializing the bbmin & bbmax in the following way - float bbmin[] = { -radius_, -radius_, -radius_ }; - float bbmax[] = { radius_, radius_, radius_ }; - octree_info_.set_bbox(bbmin, bbmax); -// std::cout << octree_info_.depth() << std::endl; - } - - void build_octree() { - octree_.build(octree_info_, point_cloud_); -// std::cout << point_cloud_.info - } - - void save_octree(const string& output_filename) { - // Modify the bounding box before saving, because the center of - // the point cloud is translated to (0, 0, 0) when building the octree - octree_.mutable_info().set_bbox(radius_, center_); - octree_.write_octree(output_filename); - } - - public: - Points point_cloud_; - float radius_, center_[3]; - OctreeInfo octree_info_; - Octree octree_; -}; - - -int main(int argc, char* argv[]) { - bool succ = cflags::ParseCmd(argc, argv); - if (!succ) { - cflags::PrintHelpInfo("\nUsage: Octree.exe"); - return 0; - } - - // file path - string file_path = FLAGS_filenames; - string output_path = FLAGS_output_path; - if (output_path != ".") mkdir(output_path); - else output_path = extract_path(file_path); - output_path += "/"; - - vector all_files; - get_all_filenames(all_files, file_path); - - #pragma omp parallel for - for (int i = 0; i < all_files.size(); i++) { - OctreeBuilder builder; - bool succ = builder.set_point_cloud(all_files[i]); - - string filename = extract_filename(all_files[i]); - if (!succ) { - if (FLAGS_verbose) cout << "Warning: " + filename + " is invalid!\n"; - continue; - } - builder.set_octree_info(); - - // data augmentation -// float angle = 2.0f * kPI / float(FLAGS_rot_num); - float angle[3] = { 0 }; - angle[0] = 1; - angle[1] = 1; - angle[2] = 1; - -// float axis[] = { 0.0f, 0.0f, 0.0f }; -// if (FLAGS_axis == "x") axis[0] = 1.0f; -// else if (FLAGS_axis == "y") axis[1] = 1.0f; -// else axis[2] = 1.0f; - - if (FLAGS_verbose) cout << "Processing: " + filename + "\n"; - for (int v = 0; v < FLAGS_rot_num; ++v) { - // output filename - char file_suffix[64]; - sprintf(file_suffix, "_%d_%d_%03d.octree", FLAGS_depth, FLAGS_full_depth, v); - - - // build - builder.build_octree(); - - // save octree - builder.save_octree(output_path + filename + file_suffix); - -// char file_suffix2[64]; -// sprintf(file_suffix2, "_%d_%d_%03d.ply", FLAGS_depth, FLAGS_full_depth, v); -// builder.point_cloud_.write_ply(output_path + filename + file_suffix2); - - // rotate point for the next iteration - builder.point_cloud_.rotate(angle); - - - - // message - //cout << "Processing: " << filename.substr(filename.rfind('\\') + 1) << endl; - } - } - - if (FLAGS_verbose) cout << "Done: " << FLAGS_filenames << endl; - return 0; -} - diff --git a/octree/tools/simplify_points.cpp b/octree/tools/simplify_points.cpp deleted file mode 100644 index 279ca99..0000000 --- a/octree/tools/simplify_points.cpp +++ /dev/null @@ -1,59 +0,0 @@ -#include -#include - -#include "cmd_flags.h" -#include "filenames.h" -#include "simplify_points.h" - -using std::string; -using cflags::Require; - -DEFINE_string(filenames, kRequired, "", "The input filenames"); -DEFINE_string(output_path, kOptional, ".", "The output path"); -DEFINE_int(dim, kOptional, 256, "The maximum resolution"); -DEFINE_float(offset, kOptional, 0.55f, "The offset value for handing thin shapes"); -DEFINE_bool(avg_points, kOptional, true, "Average points as output"); -DEFINE_bool(verbose, kOptional, true, "Output logs"); - - -// The points must have normals! Can not deal with labela and feature! (TODO) - -int main(int argc, char* argv[]) { - bool succ = cflags::ParseCmd(argc, argv); - if (!succ) { - cflags::PrintHelpInfo("\nUsage: simplify_points"); - return 0; - } - - // file path - string file_path = FLAGS_filenames; - string output_path = FLAGS_output_path; - if (output_path != ".") mkdir(output_path); - else output_path = extract_path(file_path); - output_path += "/"; - - vector all_files; -// get_all_filenames(all_files, file_path); - get_all_filenames_qq(all_files, file_path); - - //#pragma omp parallel for - SimplifyPoints simplify_pts(FLAGS_dim, FLAGS_avg_points, FLAGS_offset); - for (int i = 0; i < all_files.size(); i++) { - string error_msg = simplify_pts.set_point_cloud(output_path+all_files[i]); //qq revised: was set_point_cloud(all_files[i]) - if (!error_msg.empty()) { - std::cout << error_msg << std::endl; - continue; - } - - simplify_pts.simplify(); - string path = extract_path(output_path+all_files[i]); // qq add - string filename = extract_filename(all_files[i]); - if (FLAGS_verbose) { - std::cout << "Processing: " + filename + "\n"; - } - simplify_pts.write_point_cloud(path +"/" +filename + ".smp.points"); - } - - std::cout << "Done: " << FLAGS_filenames << std::endl; - return 0; -} \ No newline at end of file diff --git a/octree/tools/upgrade_octree.cpp b/octree/tools/upgrade_octree.cpp deleted file mode 100644 index 5456a94..0000000 --- a/octree/tools/upgrade_octree.cpp +++ /dev/null @@ -1,166 +0,0 @@ -#include -#include -#include -#include -#include - -#include "cmd_flags.h" -#include "octree.h" -#include "filenames.h" - -using std::vector; -using std::string; -using std::cout; -using cflags::Require; -const float kPI = 3.14159265f; - -DEFINE_string(filenames, kRequired, "", "The input filenames"); -DEFINE_string(output_path, kOptional, ".", "The output path"); -DEFINE_bool(node_dis, kOptional, false, "Output per-node displacement"); -DEFINE_bool(node_label, kOptional, false, "Whether has node label"); -DEFINE_bool(split_label, kOptional, false, "Compute per node splitting label"); -DEFINE_bool(adaptive, kOptional, false, "Build adaptive octree"); -DEFINE_int(adp_depth, kOptional, 4, "The starting depth of adaptive octree"); -DEFINE_bool(key2xyz, kOptional, true, "Convert the key to xyz when serialization"); -DEFINE_bool(verbose, kOptional, true, "Output logs"); - - -bool load_raw_data(vector& data, const string& filename) { - std::ifstream infile(filename, std::ios::binary); - if (!infile) return false; - - infile.seekg(0, infile.end); - int len = infile.tellg(); - infile.seekg(0, infile.beg); - - data.resize(len); - infile.read(data.data(), len); - return true; -} - -int main(int argc, char* argv[]) { - bool succ = cflags::ParseCmd(argc, argv); - if (!succ) { - cflags::PrintHelpInfo("\nUsage: update_octree.exe"); - return 0; - } - if (FLAGS_node_label && FLAGS_split_label) { - cout << "The node_label and split_label can not be true at the same time\n"; - return 0; - } - - // file path - string file_path = FLAGS_filenames; - string output_path = FLAGS_output_path; - if (output_path != ".") mkdir(output_path); - else output_path = extract_path(file_path); - output_path += "/"; - - vector all_files; - get_all_filenames(all_files, file_path); - - for (int i = 0; i < all_files.size(); i++) { - vector oct_input; - bool succ = load_raw_data(oct_input, all_files[i]); - if (!succ) continue; - - /// parse the octree - int* octi = (int*)oct_input.data(); - int total_node_num = octi[0]; - int final_node_num = octi[1]; - int depth = octi[2]; - int full_layer = octi[3]; - const int* node_num = octi + 4; - const int* node_num_cum = node_num + depth + 1; - const int* key = node_num_cum + depth + 2; - const int* children = key + total_node_num; - const int* data = children + total_node_num; - const float* normal_ptr = (const float*)data; - - vector nnum_nempty(depth + 1, 0); - for (int d = 0; d <= depth; ++d) { - // find the last element which is not equal to -1 - const int* children_d = children + node_num_cum[d]; - for (int i = node_num[d] - 1; i >= 0; i--) { - if (children_d[i] != -1) { - nnum_nempty[d] = children_d[i] + 1; - break; - } - } - } - - /// set octree info - OctreeInfo octree_info; - octree_info.set_batch_size(1); - octree_info.set_depth(depth); - octree_info.set_full_layer(full_layer); - octree_info.set_adaptive_layer(FLAGS_adp_depth); - octree_info.set_adaptive(FLAGS_adaptive); - octree_info.set_node_dis(FLAGS_node_dis); - octree_info.set_key2xyz(FLAGS_key2xyz); - octree_info.set_threshold_normal(0.0f); - octree_info.set_threshold_dist(0.0f); - - float width = static_cast(1 << depth); - float bbmin[] = {0.0f, 0.0f, 0.0f }; - float bbmax[] = {width, width, width }; - octree_info.set_bbox(bbmin, bbmax); - - // by default, the octree contains Key and Child - int channel = 1; - octree_info.set_property(OctreeInfo::kKey, channel, -1); - octree_info.set_property(OctreeInfo::kChild, channel, -1); - - // set feature - int data_channel = FLAGS_node_dis ? 4 : 3; - int location = FLAGS_adaptive ? -1 : depth; - octree_info.set_property(OctreeInfo::kFeature, data_channel, location); - - // set label - if (FLAGS_node_label) { - octree_info.set_property(OctreeInfo::kLabel, 1, depth); - } - - // set split label - octree_info.set_property(OctreeInfo::kSplit, 0, 0); - if (FLAGS_split_label) { - octree_info.set_property(OctreeInfo::kSplit, 1, -1); - } - - octree_info.set_nnum(node_num); - octree_info.set_nnum_cum(); - octree_info.set_nempty(nnum_nempty.data()); - octree_info.set_ptr_dis(); - - /// output octree - vector buffer(octree_info.sizeof_octree()); - memcpy(buffer.data(), &octree_info, sizeof(OctreeInfo)); - Octree oct_parser; - oct_parser.set_octree(buffer); - int total_nnum = octree_info.total_nnum(); - int nnum_depth = octree_info.node_num(depth); - memcpy(oct_parser.mutable_key_cpu(0), key, total_nnum * sizeof(int)); - memcpy(oct_parser.mutable_children_cpu(0), children, total_nnum * sizeof(int)); - int data_size = FLAGS_adaptive ? total_nnum : nnum_depth; - memcpy(oct_parser.mutable_feature_cpu(0), data, data_size * data_channel * sizeof(float)); - if (FLAGS_node_label) { - const int* ptr = data + data_size * data_channel; - float* des = oct_parser.mutable_label_cpu(0); - for (int i = 0; i < nnum_depth; ++i) { - des[i] = static_cast(ptr[i]); - } - } - if (FLAGS_split_label) { - const int* ptr = data + data_size * data_channel; - float* des = oct_parser.mutable_split_cpu(0); - for (int i = 0; i < total_nnum; ++i) { - des[i] = static_cast(ptr[i]); - } - } - string filename = extract_filename(all_files[i]); - oct_parser.write_octree(output_path + filename + ".upgrade.octree"); - } - - return 0; -} - diff --git a/octree/tools/upgrade_points.cpp b/octree/tools/upgrade_points.cpp deleted file mode 100644 index d8641d2..0000000 --- a/octree/tools/upgrade_points.cpp +++ /dev/null @@ -1,111 +0,0 @@ -#include -#include -#include -#include - -#include "filenames.h" -#include "points.h" -#include "cmd_flags.h" - -using namespace std; - -DEFINE_string(filenames, kRequired, "", "The input filenames"); -DEFINE_string(output_path, kOptional, ".", "The output path"); -DEFINE_bool(has_label, kOptional, false, "The file contains label"); -DEFINE_bool(verbose, kOptional, true, "Output logs"); - - -void load_pointcloud(vector& pt, vector& normal, - vector& seg, const string& filename) { - const int channel = 3; - std::ifstream infile(filename, std::ios::binary); - - infile.seekg(0, infile.end); - size_t len = infile.tellg(); - infile.seekg(0, infile.beg); - - int n; - infile.read((char*)(&n), sizeof(int)); - pt.resize(3 * n); - infile.read((char*)pt.data(), sizeof(float) * 3 * n); - normal.resize(channel * n); - infile.read((char*)normal.data(), sizeof(float) * channel * n); - - if (FLAGS_has_label && - 6 * n * sizeof(float) + (n + 1) * sizeof(int) == len) { - seg.resize(n); - infile.read((char*)seg.data(), sizeof(int)*n); - } - - infile.close(); -} - -void gen_test_pointcloud(vector& pt, vector& normal, - vector& label) { - const float pt_input[] = { 0.0f, 0.0f, 0.0f, 1.0f, 0.0f, 0.0f}; - const float nm_input[] = { 1.0f, 0.0f, 0.0f, -1.0f, 0.0f, 0.0f }; - const float lb_input[] = { 0.0f, 1.0f }; - - pt.assign(pt_input, pt_input + 6); - normal.assign(nm_input, nm_input + 6); - label.assign(lb_input, lb_input + 2); -} - -int main(int argc, char* argv[]) { - bool succ = cflags::ParseCmd(argc, argv); - if (!succ) { - cflags::PrintHelpInfo("\nUsage: upgrade_points.exe"); - return 0; - } - - // file path - string file_path = FLAGS_filenames; - string output_path = FLAGS_output_path; - if (output_path != ".") mkdir(output_path); - else output_path = extract_path(file_path); - output_path += "/"; - - vector all_files; - get_all_filenames(all_files, file_path); - //#pragma omp parallel for - for (int i = 0; i < all_files.size(); ++i) { - string filename = extract_filename(all_files[i]); - - /// from the old formate to this new format - vector pts, normals, labels; - vector seg; - load_pointcloud(pts, normals, seg, all_files[i]); - if (FLAGS_has_label && seg.size() == 0) { - cout << "Error in " << filename << endl; - continue; - } - labels.assign(seg.begin(), seg.end()); - - Points points; - points.set_points(pts, normals, vector(), labels); - - points.write_points(output_path + filename + ".upgrade.points"); - - if (FLAGS_verbose) cout << "Processing: " + filename + "\n"; - } - cout << "Done: " << FLAGS_filenames << endl; - //// generate testing points - //vector pts, normals, labels; - //gen_test_pointcloud(pts, normals, labels); - //Points points; - //points.set_points(pts, normals, vector(), labels); - //points.write_points("test.points"); - - ///// backward conversion: from this new formate to the old format - //points.load_points(filename + ".points"); - //ofstream outfile(filename + "_1.points", ofstream::binary); - //int n = points.info().pt_num(); - //outfile.write((char*)(&n), sizeof(int)); - //outfile.write((const char*)points.prop_ptr(PtsInfo::kPoint), - // n * sizeof(float) * points.info().channel(PtsInfo::kPoint)); - //outfile.write((const char*)points.prop_ptr(PtsInfo::kNormal), - // n * sizeof(float) * points.info().channel(PtsInfo::kNormal)); - //outfile.close(); - - return 0; -} diff --git a/pdbbind/.DS_Store b/pdbbind/.DS_Store deleted file mode 100644 index 1106d29..0000000 Binary files a/pdbbind/.DS_Store and /dev/null differ diff --git a/pdbbind/Elements.java b/pdbbind/Elements.java deleted file mode 100755 index 070bb3a..0000000 --- a/pdbbind/Elements.java +++ /dev/null @@ -1,509 +0,0 @@ -/* - * Copyright (C) 2006-2012 Egon Willighagen - * 2014 Mark B Vine (orcid:0000-0002-7794-0426) - * - * Contact: cdk-devel@lists.sourceforge.net - * - * This program is free software; you can redistribute it and/or - * modify it under the terms of the GNU Lesser General Public License - * as published by the Free Software Foundation; either version 2.1 - * of the License, or (at your option) any later version. - * All we ask is that proper credit is given for our work, which includes - * - but is not limited to - adding the above copyright notice to the beginning - * of your source code files, and to any copyright notice that you may distribute - * with programs based on this work. - * - * This program is distributed in the hope that it will be useful, - * but WITHOUT ANY WARRANTY; without even the implied warranty of - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - * GNU Lesser General Public License for more details. - * - * You should have received a copy of the GNU Lesser General Public License - * along with this program; if not, write to the Free Software - * Foundation, Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA. - */ -package org.openscience.cdk.config; - -import org.openscience.cdk.interfaces.IElement; - -import java.util.HashMap; -import java.util.Locale; -import java.util.Map; - -/** - * Enumeration of chemical elements. Data is taken from the Blue Obelisk Data - * Repository, version 3. This enumeration is auto-generated with utilities - * found in the 'cdk-build-utils' project. - * - * @author egonw - * @author john may - * @cdk.module core - * @cdk.githash - */ -public enum Elements { - Unknown(0, "", 0, 0, null, 0.00, null), - Hydrogen(1, "H", 1, 1, 0.37, 1.20, 2.20), - Helium(2, "He", 1, 18, 0.32, 1.40, null), - Lithium(3, "Li", 2, 1, 1.34, 2.20, 0.98), - Beryllium(4, "Be", 2, 2, 0.90, 1.90, 1.57), - Boron(5, "B", 2, 13, 0.82, 1.80, 2.04), - Carbon(6, "C", 2, 14, 0.77, 1.70, 2.55), - Nitrogen(7, "N", 2, 15, 0.75, 1.60, 3.04), - Oxygen(8, "O", 2, 16, 0.73, 1.55, 3.44), - Fluorine(9, "F", 2, 17, 0.71, 1.50, 3.98), - Neon(10, "Ne", 2, 18, 0.69, 1.54, null), - Sodium(11, "Na", 3, 1, 1.54, 2.40, 0.93), - Magnesium(12, "Mg", 3, 2, 1.30, 2.20, 1.31), - Aluminium(13, "Al", 3, 13, 1.18, 2.10, 1.61), - Silicon(14, "Si", 3, 14, 1.11, 2.10, 1.90), - Phosphorus(15, "P", 3, 15, 1.06, 1.95, 2.19), - Sulfur(16, "S", 3, 16, 1.02, 1.80, 2.58), - Chlorine(17, "Cl", 3, 17, 0.99, 1.80, 3.16), - Argon(18, "Ar", 3, 18, 0.97, 1.88, null), - Potassium(19, "K", 4, 1, 1.96, 2.80, 0.82), - Calcium(20, "Ca", 4, 2, 1.74, 2.40, 1.00), - Scandium(21, "Sc", 4, 3, 1.44, 2.30, 1.36), - Titanium(22, "Ti", 4, 4, 1.36, 2.15, 1.54), - Vanadium(23, "V", 4, 5, 1.25, 2.05, 1.63), - Chromium(24, "Cr", 4, 6, 1.27, 2.05, 1.66), - Manganese(25, "Mn", 4, 7, 1.39, 2.05, 1.55), - Iron(26, "Fe", 4, 8, 1.25, 2.05, 1.83), - Cobalt(27, "Co", 4, 9, 1.26, 2.0, 1.88), - Nickel(28, "Ni", 4, 10, 1.21, 2.0, 1.91), - Copper(29, "Cu", 4, 11, 1.38, 2.0, 1.90), - Zinc(30, "Zn", 4, 12, 1.31, 2.10, 1.65), - Gallium(31, "Ga", 4, 13, 1.26, 2.10, 1.81), - Germanium(32, "Ge", 4, 14, 1.22, 2.10, 2.01), - Arsenic(33, "As", 4, 15, 1.19, 2.05, 2.18), - Selenium(34, "Se", 4, 16, 1.16, 1.90, 2.55), - Bromine(35, "Br", 4, 17, 1.14, 1.90, 2.96), - Krypton(36, "Kr", 4, 18, 1.10, 2.02, 3.00), - Rubidium(37, "Rb", 5, 1, 2.11, 2.90, 0.82), - Strontium(38, "Sr", 5, 2, 1.92, 2.55, 0.95), - Yttrium(39, "Y", 5, 3, 1.62, 2.40, 1.22), - Zirconium(40, "Zr", 5, 4, 1.48, 2.30, 1.33), - Niobium(41, "Nb", 5, 5, 1.37, 2.15, 1.60), - Molybdenum(42, "Mo", 5, 6, 1.45, 2.10, 2.16), - Technetium(43, "Tc", 5, 7, 1.56, 2.05, 1.90), - Ruthenium(44, "Ru", 5, 8, 1.26, 2.05, 2.20), - Rhodium(45, "Rh", 5, 9, 1.35, 2.0, 2.28), - Palladium(46, "Pd", 5, 10, 1.31, 2.05, 2.20), - Silver(47, "Ag", 5, 11, 1.53, 2.10, 1.93), - Cadmium(48, "Cd", 5, 12, 1.48, 2.20, 1.69), - Indium(49, "In", 5, 13, 1.44, 2.20, 1.78), - Tin(50, "Sn", 5, 14, 1.41, 2.25, 1.96), - Antimony(51, "Sb", 5, 15, 1.38, 2.20, 2.05), - Tellurium(52, "Te", 5, 16, 1.35, 2.10, 2.10), - Iodine(53, "I", 5, 17, 1.33, 2.10, 2.66), - Xenon(54, "Xe", 5, 18, 1.30, 2.16, 2.60), - Caesium(55, "Cs", 6, 1, 2.25, 3.00, 0.79), - Barium(56, "Ba", 6, 2, 1.98, 2.70, 0.89), - Lanthanum(57, "La", 6, 3, 1.69, 2.50, 1.10), - Cerium(58, "Ce", 6, 0, null, 2.48, 1.12), - Praseodymium(59, "Pr", 6, 0, null, 2.47, 1.13), - Neodymium(60, "Nd", 6, 0, null, 2.45, 1.14), - Promethium(61, "Pm", 6, 0, null, 2.43, null), - Samarium(62, "Sm", 6, 0, null, 2.42, 1.17), - Europium(63, "Eu", 6, 0, 2.40, 2.40, null), - Gadolinium(64, "Gd", 6, 0, null, 2.38, 1.20), - Terbium(65, "Tb", 6, 0, null, 2.37, null), - Dysprosium(66, "Dy", 6, 0, null, 2.35, 1.22), - Holmium(67, "Ho", 6, 0, null, 2.33, 1.23), - Erbium(68, "Er", 6, 0, null, 2.32, 1.24), - Thulium(69, "Tm", 6, 0, null, 2.30, 1.25), - Ytterbium(70, "Yb", 6, 0, null, 2.28, null), - Lutetium(71, "Lu", 6, 0, 1.60, 2.27, 1.27), - Hafnium(72, "Hf", 6, 4, 1.50, 2.25, 1.30), - Tantalum(73, "Ta", 6, 5, 1.38, 2.20, 1.50), - Tungsten(74, "W", 6, 6, 1.46, 2.10, 2.36), - Rhenium(75, "Re", 6, 7, 1.59, 2.05, 1.90), - Osmium(76, "Os", 6, 8, 1.28, 2.0, 2.20), - Iridium(77, "Ir", 6, 9, 1.37, 2.0, 2.20), - Platinum(78, "Pt", 6, 10, 1.28, 2.05, 2.28), - Gold(79, "Au", 6, 11, 1.44, 2.10, 2.54), - Mercury(80, "Hg", 6, 12, 1.49, 2.05, 2.00), - Thallium(81, "Tl", 6, 13, 1.48, 2.20, 1.62), - Lead(82, "Pb", 6, 14, 1.47, 2.30, 2.33), - Bismuth(83, "Bi", 6, 15, 1.46, 2.30, 2.02), - Polonium(84, "Po", 6, 16, 1.46, null, 2.00), - Astatine(85, "At", 6, 17, null, null, 2.20), - Radon(86, "Rn", 6, 18, 1.45, null, null), - Francium(87, "Fr", 7, 1, null, null, 0.70), - Radium(88, "Ra", 7, 2, null, null, 0.90), - Actinium(89, "Ac", 7, 3, null, null, 1.10), - Thorium(90, "Th", 7, 0, null, 2.40, 1.30), - Protactinium(91, "Pa", 7, 0, null, null, 1.50), - Uranium(92, "U", 7, 0, null, 2.30, 1.38), - Neptunium(93, "Np", 7, 0, null, null, 1.36), - Plutonium(94, "Pu", 7, 0, null, null, 1.28), - Americium(95, "Am", 7, 0, null, null, 1.30), - Curium(96, "Cm", 7, 0, null, null, 1.30), - Berkelium(97, "Bk", 7, 0, null, null, 1.30), - Californium(98, "Cf", 7, 0, null, null, 1.30), - Einsteinium(99, "Es", 7, 0, null, null, 1.30), - Fermium(100, "Fm", 7, 0, null, null, 1.30), - Mendelevium(101, "Md", 7, 0, null, null, 1.30), - Nobelium(102, "No", 7, 0, null, null, 1.30), - Lawrencium(103, "Lr", 7, 0, null, null, null), - Rutherfordium(104, "Rf", 7, 4, null, null, null), - Dubnium(105, "Db", 7, 5, null, null, null), - Seaborgium(106, "Sg", 7, 6, null, null, null), - Bohrium(107, "Bh", 7, 7, null, null, null), - Hassium(108, "Hs", 7, 8, null, null, null), - Meitnerium(109, "Mt", 7, 9, null, null, null), - Darmstadtium(110, "Ds", 7, 10, null, null, null), - Roentgenium(111, "Rg", 7, 11, null, null, null), - Copernicium(112, "Cn", 7, 12, null, null, null), - @Deprecated - Ununtrium(113, "Uut", 7, 13, null, null, null), - Nihonium(113, "Nh", 7, 13, null, null, null), - Flerovium(114, "Fl", 7, 14, null, null, null), - @Deprecated - Ununpentium(115, "Uup", 7, 15, null, null, null), - Moscovium(115, "Mc", 7, 15, null, null, null), - Livermorium(116, "Lv", 7, 16, null, null, null), - @Deprecated - Ununseptium(117, "Uus", 7, 17, null, null, null), - Tennessine(117, "Ts", 7, 17, null, null, null), - @Deprecated - Ununoctium(118, "Uuo", 7, 18, null, null, null), - Oganesson(118, "Og", 7, 18, null, null, null); - - /** - * Atomic number, periodic table period and group. - */ - private final int number, period, group; - - /** - * The symbol of the element. - */ - private final String symbol; - - /** - * Covalent radius (rcov), van der Waals radius - * (rw) and Pauling electronegativity. - */ - private final Double rCov, rW, electronegativity; - - /** - * An {@link IElement} instance of this element. - */ - private final IElement instance; - - /** - * Lookup elements by atomic number. - */ - static final Elements[] NUMER_MAP = new Elements[119]; - - /** - * Lookup elements by symbol / name. - */ - static final Map SYMBOL_MAP = new HashMap(400); - - static { - // index elements - for (final Elements e : values()) { - NUMER_MAP[e.number] = e; - SYMBOL_MAP.put(e.symbol.toLowerCase(Locale.ENGLISH), e); - SYMBOL_MAP.put(e.name().toLowerCase(Locale.ENGLISH), e); - } - - // recently named elements - SYMBOL_MAP.put("uub", Copernicium); // 2009 - SYMBOL_MAP.put("ununbium", Copernicium); - - SYMBOL_MAP.put("uuq", Flerovium); // 2012 - SYMBOL_MAP.put("ununquadium", Flerovium); - - SYMBOL_MAP.put("uuh", Livermorium); // 2012 - SYMBOL_MAP.put("ununhexium", Livermorium); - - // 2016 - SYMBOL_MAP.put("uut", Nihonium); - SYMBOL_MAP.put("uup", Moscovium); - SYMBOL_MAP.put("uus", Tennessine); - SYMBOL_MAP.put("uuo", Oganesson); - - // alternative spellings - SYMBOL_MAP.put("sulphur", Sulfur); - SYMBOL_MAP.put("cesium", Caesium); - SYMBOL_MAP.put("aluminum", Aluminium); - - } - - /** - * Internal constructor. - * - * @param number atomic number - * @param symbol symbol - * @param period periodic table period - * @param group periodic table group - * @param rCov covalent radius - * @param rW van der Waals radius - * @param electronegativity pauling electronegativity - */ - private Elements(int number, String symbol, int period, int group, Double rCov, Double rW, Double electronegativity) { - this.number = number; - this.period = period; - this.group = group; - this.symbol = symbol; - this.rCov = rCov; - this.rW = rW; - this.electronegativity = electronegativity; - this.instance = new NaturalElement(symbol, number); - } - - /** - * The atomic number of the element. An {@link #Unknown} element - * has an atomic number of '0'. - * - * @return 0 - 116 - */ - public int number() { - return number; - } - - /** - * The element symbol, C for carbon, N for nitrogen, Na for sodium, etc. An - * {@link #Unknown} element has no symbol. - * - * @return the symbol - */ - public String symbol() { - return symbol; - } - - /** - * Return the period in the periodic table this element belongs to. If - * the element is {@link #Unknown} it's period is 0. - * - * @return a period in the periodic table - */ - public int period() { - return period; - } - - /** - * Return the group in the periodic table this element belongs to. If - * the element does not belong to a group then it's group is '0'. - * - * @return a group in the periodic table - */ - public int group() { - return group; - } - - /** - * The covalent radius, rcov, is a measure of the - * size of an atom that forms part of one covalent bond. - * - * @return covalent radius - null if not available - * @see Covalent radius - */ - public Double covalentRadius() { - return rCov; - } - - /** - * The van der Waals radius, rw, of an atom is the - * radius of an imaginary hard sphere which can be used to model the - * atom. - * - * @return van der Waals radius - null if not available - * @see Van de Waals radius - */ - public Double vdwRadius() { - return rW; - } - - /** - * Electronegativity, symbol χ, is a chemical property that describes - * the tendency of an atom or a functional group to attract electrons - * (or electron density) towards itself. This method provides access to the - * Pauling electronegativity value for a chemical element. If no value is - * available 'null' is returned. - * - * @return Pauling electronegativity - null if not available - * @see Pauling Electronegativity - */ - public Double electronegativity() { - return electronegativity; - } - - /** - * Access an {@link IElement} instance of the chemical element. - * - * @return an instance - */ - public IElement toIElement() { - return instance; - } - - /** - * Obtain the element with the specified atomic number. If no element had - * the specified atomic number then {@link #Unknown} is returned. - * - *
-     *     // carbon
-     *     Elements e = Elements.ofNumber(6);
-     *
-     *     // oxygen
-     *     Elements e = Elements.ofNumber(8);
-     * 
- * - * @param number atomic number - * @return an element, or {@link #Unknown} - */ - public static Elements ofNumber(final int number) { - if (number < 0 || number > 118) return Unknown; - return NUMER_MAP[number]; - } - - /** - * Obtain the element with the specified symbol or name. If no element had - * the specified symbol or name then {@link #Unknown} is returned. The - * input is case-insensitive. - * - *
-     *     // carbon
-     *     Elements e = Elements.ofString("c");
-     *     Elements e = Elements.ofString("C");
-     *     Elements e = Elements.ofString("Carbon");
-     *     Elements e = Elements.ofString("carbon");
-     * 
- * - * @param str input string - * @return an element, or {@link #Unknown} - */ - public static Elements ofString(final String str) { - if (str == null) return Unknown; - Elements e = SYMBOL_MAP.get(str.toLowerCase(Locale.ENGLISH)); - if (e == null) return Unknown; - return e; - } - - /** These instances are for backards compatability. */ - public final static IElement DUMMY = Unknown.toIElement(); - public final static IElement HYDROGEN = Hydrogen.toIElement(); - public final static IElement HELIUM = Helium.toIElement(); - public final static IElement LITHIUM = Lithium.toIElement(); - public final static IElement BERYLLIUM = Beryllium.toIElement(); - public final static IElement BORON = Boron.toIElement(); - public final static IElement CARBON = Carbon.toIElement(); - public final static IElement NITROGEN = Nitrogen.toIElement(); - public final static IElement OXYGEN = Oxygen.toIElement(); - public final static IElement FLUORINE = Fluorine.toIElement(); - public final static IElement NEON = Neon.toIElement(); - public final static IElement SODIUM = Sodium.toIElement(); - public final static IElement MAGNESIUM = Magnesium.toIElement(); - public final static IElement ALUMINIUM = Aluminium.toIElement(); - public final static IElement SILICON = Silicon.toIElement(); - public final static IElement PHOSPHORUS = Phosphorus.toIElement(); - public final static IElement SULFUR = Sulfur.toIElement(); - public final static IElement CHLORINE = Chlorine.toIElement(); - public final static IElement ARGON = Argon.toIElement(); - public final static IElement POTASSIUM = Potassium.toIElement(); - public final static IElement CALCIUM = Calcium.toIElement(); - public final static IElement SCANDIUM = Scandium.toIElement(); - public final static IElement TITANIUM = Titanium.toIElement(); - public final static IElement VANADIUM = Vanadium.toIElement(); - public final static IElement CHROMIUM = Chromium.toIElement(); - public final static IElement MANGANESE = Manganese.toIElement(); - public final static IElement IRON = Iron.toIElement(); - public final static IElement COBALT = Cobalt.toIElement(); - public final static IElement NICKEL = Nickel.toIElement(); - public final static IElement COPPER = Copper.toIElement(); - public final static IElement ZINC = Zinc.toIElement(); - public final static IElement GALLIUM = Gallium.toIElement(); - public final static IElement GERMANIUM = Germanium.toIElement(); - public final static IElement ARSENIC = Arsenic.toIElement(); - public final static IElement SELENIUM = Selenium.toIElement(); - public final static IElement BROMINE = Bromine.toIElement(); - public final static IElement KRYPTON = Krypton.toIElement(); - public final static IElement RUBIDIUM = Rubidium.toIElement(); - public final static IElement STRONTIUM = Strontium.toIElement(); - public final static IElement YTTRIUM = Yttrium.toIElement(); - public final static IElement ZIRCONIUM = Zirconium.toIElement(); - public final static IElement NIOBIUM = Niobium.toIElement(); - public final static IElement MOLYBDENUM = Molybdenum.toIElement(); - public final static IElement TECHNETIUM = Technetium.toIElement(); - public final static IElement RUTHENIUM = Ruthenium.toIElement(); - public final static IElement RHODIUM = Rhodium.toIElement(); - public final static IElement PALLADIUM = Palladium.toIElement(); - public final static IElement SILVER = Silver.toIElement(); - public final static IElement CADMIUM = Cadmium.toIElement(); - public final static IElement INDIUM = Indium.toIElement(); - public final static IElement TIN = Tin.toIElement(); - public final static IElement ANTIMONY = Antimony.toIElement(); - public final static IElement TELLURIUM = Tellurium.toIElement(); - public final static IElement IODINE = Iodine.toIElement(); - public final static IElement XENON = Xenon.toIElement(); - public final static IElement CAESIUM = Caesium.toIElement(); - public final static IElement BARIUM = Barium.toIElement(); - public final static IElement LANTHANUM = Lanthanum.toIElement(); - public final static IElement CERIUM = Cerium.toIElement(); - public final static IElement PRASEODYMIUM = Praseodymium.toIElement(); - public final static IElement NEODYMIUM = Neodymium.toIElement(); - public final static IElement PROMETHIUM = Promethium.toIElement(); - public final static IElement SAMARIUM = Samarium.toIElement(); - public final static IElement EUROPIUM = Europium.toIElement(); - public final static IElement GADOLINIUM = Gadolinium.toIElement(); - public final static IElement TERBIUM = Terbium.toIElement(); - public final static IElement DYSPROSIUM = Dysprosium.toIElement(); - public final static IElement HOLMIUM = Holmium.toIElement(); - public final static IElement ERBIUM = Erbium.toIElement(); - public final static IElement THULIUM = Thulium.toIElement(); - public final static IElement YTTERBIUM = Ytterbium.toIElement(); - public final static IElement LUTETIUM = Lutetium.toIElement(); - public final static IElement HAFNIUM = Hafnium.toIElement(); - public final static IElement TANTALUM = Tantalum.toIElement(); - public final static IElement TUNGSTEN = Tungsten.toIElement(); - public final static IElement RHENIUM = Rhenium.toIElement(); - public final static IElement OSMIUM = Osmium.toIElement(); - public final static IElement IRIDIUM = Iridium.toIElement(); - public final static IElement PLATINUM = Platinum.toIElement(); - public final static IElement GOLD = Gold.toIElement(); - public final static IElement MERCURY = Mercury.toIElement(); - public final static IElement THALLIUM = Thallium.toIElement(); - public final static IElement LEAD = Lead.toIElement(); - public final static IElement BISMUTH = Bismuth.toIElement(); - public final static IElement POLONIUM = Polonium.toIElement(); - public final static IElement ASTATINE = Astatine.toIElement(); - public final static IElement RADON = Radon.toIElement(); - public final static IElement FRANCIUM = Francium.toIElement(); - public final static IElement RADIUM = Radium.toIElement(); - public final static IElement ACTINIUM = Actinium.toIElement(); - public final static IElement THORIUM = Thorium.toIElement(); - public final static IElement PROTACTINIUM = Protactinium.toIElement(); - public final static IElement URANIUM = Uranium.toIElement(); - public final static IElement NEPTUNIUM = Neptunium.toIElement(); - public final static IElement PLUTONIUM = Plutonium.toIElement(); - public final static IElement AMERICIUM = Americium.toIElement(); - public final static IElement CURIUM = Curium.toIElement(); - public final static IElement BERKELIUM = Berkelium.toIElement(); - public final static IElement CALIFORNIUM = Californium.toIElement(); - public final static IElement EINSTEINIUM = Einsteinium.toIElement(); - public final static IElement FERMIUM = Fermium.toIElement(); - public final static IElement MENDELEVIUM = Mendelevium.toIElement(); - public final static IElement NOBELIUM = Nobelium.toIElement(); - public final static IElement LAWRENCIUM = Lawrencium.toIElement(); - public final static IElement RUTHERFORDIUM = Rutherfordium.toIElement(); - public final static IElement DUBNIUM = Dubnium.toIElement(); - public final static IElement SEABORGIUM = Seaborgium.toIElement(); - public final static IElement BOHRIUM = Bohrium.toIElement(); - public final static IElement HASSIUM = Hassium.toIElement(); - public final static IElement MEITNERIUM = Meitnerium.toIElement(); - public final static IElement DARMSTADTIUM = Darmstadtium.toIElement(); - public final static IElement ROENTGENIUM = Roentgenium.toIElement(); - public final static IElement UNUNBIUM = Copernicium.toIElement(); - public final static IElement UNUNTRIUM = Ununtrium.toIElement(); - public final static IElement UNUNQUADIUM = Flerovium.toIElement(); - public final static IElement FLEROVIUM = Flerovium.toIElement(); - public final static IElement UNUNPENTIUM = Ununpentium.toIElement(); - public final static IElement UNUNHEXIUM = Livermorium.toIElement(); - public final static IElement LIVERMORIUM = Livermorium.toIElement(); - - // Incorrect spelling - @Deprecated - public final static IElement PLUTOMNIUM = PLUTONIUM; -} diff --git a/pdbbind/atomic_feature.py b/pdbbind/atomic_feature.py deleted file mode 100644 index ab32324..0000000 --- a/pdbbind/atomic_feature.py +++ /dev/null @@ -1,429 +0,0 @@ -# For OctSurfNet, get the atomic features for pocket and ligand. -# OpenBabel 3.0.0 also support van der waal surface for molecules. - -import pickle - -import numpy as np -# import pybel -# import openbabel -from openbabel import pybel -from openbabel import openbabel as ob - - -# from math import ceil, sin, cos, sqrt, pi -# from itertools import combinations -import os - - -def get_cdk_vdwr_dic(file = '/home/qil15006/2020Summer/OCNN_Jun26_2020/pdbbind/Elements.java'): #/home/qil15006/2020Summer/OCNN_Jun26_2020/pdbbind/Elements.java - """extract van der waal radius from cdk Element.java file""" - cdk_vdwr_dic = {} - with open(file, 'r') as f: - lines = f.readlines() - start = False - for line in lines: - if 'public enum Elements {' in line: - start = True - continue - if start: - if '@Deprecated' in line: - continue - contents = line.split('(') - contents = contents[1] - row = contents.split(',') - atomic_number = int(row[0]) - radius = row[-3] - if 'null' in radius: - # print(line) - pass - else: - cdk_vdwr_dic[atomic_number] = float(radius) - if 'Oganesson' in line: - break - else: - continue - return cdk_vdwr_dic -cdk_vdwr_dic = get_cdk_vdwr_dic() -# print(cdk_vdwr_dic) - -class Featurizer(): - """Calcaulates atomic features for molecules. Features can encode atom type, - native pybel properties or any property defined with SMARTS patterns - - Attributes - ---------- - FEATURE_NAMES: list of strings - Labels for features (in the same order as features) - NUM_ATOM_CLASSES: int - Number of atom codes - ATOM_CODES: dict - Dictionary mapping atomic numbers to codes - NAMED_PROPS: list of string - Names of atomic properties to retrieve from pybel.Atom object - CALLABLES: list of callables - Callables used to calculcate custom atomic properties - SMARTS: list of SMARTS strings - SMARTS patterns defining additional atomic properties - """ - - def __init__(self, atom_codes=None, atom_labels=None, - named_properties=None, save_molecule_codes=True, - custom_properties=None, smarts_properties=None, - smarts_labels=None): - - """Creates Featurizer with specified types of features. Elements of a - feature vector will be in a following order: atom type encoding - (defined by atom_codes), Pybel atomic properties (defined by - named_properties), molecule code (if present), custom atomic properties - (defined `custom_properties`), and additional properties defined with - SMARTS (defined with `smarts_properties`). - - Parameters - ---------- - atom_codes: dict, optional - Dictionary mapping atomic numbers to codes. It will be used for - one-hot encoging therefore if n different types are used, codes - shpuld be from 0 to n-1. Multiple atoms can have the same code, - e.g. you can use {6: 0, 7: 1, 8: 1} to encode carbons with [1, 0] - and nitrogens and oxygens with [0, 1] vectors. If not provided, - default encoding is used. - atom_labels: list of strings, optional - Labels for atoms codes. It should have the same length as the - number of used codes, e.g. for `atom_codes={6: 0, 7: 1, 8: 1}` you - should provide something like ['C', 'O or N']. If not specified - labels 'atom0', 'atom1' etc are used. If `atom_codes` is not - specified this argument is ignored. - named_properties: list of strings, optional - Names of atomic properties to retrieve from pybel.Atom object. If - not specified ['hyb', 'heavyvalence', 'heterovalence', - 'partialcharge'] is used. - save_molecule_codes: bool, optional (default True) - If set to True, there will be an additional feature to save - molecule code. It is usefeul when saving molecular complex in a - single array. - custom_properties: list of callables, optional - Custom functions to calculate atomic properties. Each element of - this list should be a callable that takes pybel.Atom object and - returns a float. If callable has `__name__` property it is used as - feature label. Otherwise labels 'func' etc are used, where i is - the index in `custom_properties` list. - smarts_properties: list of strings, optional - Additional atomic properties defined with SMARTS patterns. These - patterns should match a single atom. If not specified, deafult - patterns are used. - smarts_labels: list of strings, optional - Labels for properties defined with SMARTS. Should have the same - length as `smarts_properties`. If not specified labels 'smarts0', - 'smarts1' etc are used. If `smarts_properties` is not specified - this argument is ignored. - """ - - # Remember namse of all features in the correct order - self.FEATURE_NAMES = [] - - if atom_codes is not None: - if not isinstance(atom_codes, dict): - raise TypeError('Atom codes should be dict, got %s instead' - % type(atom_codes)) - codes = set(atom_codes.values()) - for i in range(len(codes)): - if i not in codes: - raise ValueError('Incorrect atom code %s' % i) - - self.NUM_ATOM_CLASSES = len(codes) - self.ATOM_CODES = atom_codes - if atom_labels is not None: - if len(atom_labels) != self.NUM_ATOM_CLASSES: - raise ValueError('Incorrect number of atom labels: ' - '%s instead of %s' - % (len(atom_labels), self.NUM_ATOM_CLASSES)) - else: - atom_labels = ['atom%s' % i for i in range(self.NUM_ATOM_CLASSES)] - self.FEATURE_NAMES += atom_labels - else: - self.ATOM_CODES = {} - - metals = ([3, 4, 11, 12, 13] + list(range(19, 32)) - + list(range(37, 51)) + list(range(55, 84)) - + list(range(87, 104))) - - # List of tuples (atomic_num, class_name) with atom types to encode. - atom_classes = [ - (1, 'H'), # QQ add: H also considered in surface. - (5, 'B'), - (6, 'C'), - (7, 'N'), - (8, 'O'), - (15, 'P'), - (16, 'S'), - (34, 'Se'), - ([9, 17, 35, 53], 'halogen'), - (metals, 'metal') - ] - - for code, (atom, name) in enumerate(atom_classes): - if type(atom) is list: - for a in atom: - self.ATOM_CODES[a] = code - else: - self.ATOM_CODES[atom] = code - self.FEATURE_NAMES.append(name) - - self.NUM_ATOM_CLASSES = len(atom_classes) - - if named_properties is not None: - if not isinstance(named_properties, (list, tuple, np.ndarray)): - raise TypeError('named_properties must be a list') - allowed_props = [prop for prop in dir(pybel.Atom) - if not prop.startswith('__')] - for prop_id, prop in enumerate(named_properties): - if prop not in allowed_props: - raise ValueError( - 'named_properties must be in pybel.Atom attributes,' - ' %s was given at position %s' % (prop_id, prop) - ) - self.NAMED_PROPS = named_properties - else: - # pybel.Atom properties to save - self.NAMED_PROPS = ['hyb', 'heavyvalence', 'heterovalence', - 'partialcharge', 'radius'] - self.FEATURE_NAMES += self.NAMED_PROPS - - if not isinstance(save_molecule_codes, bool): - raise TypeError('save_molecule_codes should be bool, got %s ' - 'instead' % type(save_molecule_codes)) - self.save_molecule_codes = save_molecule_codes - if save_molecule_codes: - # Remember if an atom belongs to the ligand or to the protein - self.FEATURE_NAMES.append('molcode') - - self.CALLABLES = [] - if custom_properties is not None: - for i, func in enumerate(custom_properties): - if not callable(func): - raise TypeError('custom_properties should be list of' - ' callables, got %s instead' % type(func)) - name = getattr(func, '__name__', '') - if name == '': - name = 'func%s' % i - self.CALLABLES.append(func) - self.FEATURE_NAMES.append(name) - - if smarts_properties is None: - # SMARTS definition for other properties - self.SMARTS = [ - '[#6+0!$(*~[#7,#8,F]),SH0+0v2,s+0,S^3,Cl+0,Br+0,I+0]', - '[a]', - '[!$([#1,#6,F,Cl,Br,I,o,s,nX3,#7v5,#15v5,#16v4,#16v6,*+1,*+2,*+3])]', - '[!$([#6,H0,-,-2,-3]),$([!H0;#7,#8,#9])]', - '[r]' - ] - smarts_labels = ['hydrophobic', 'aromatic', 'acceptor', 'donor', - 'ring'] - elif not isinstance(smarts_properties, (list, tuple, np.ndarray)): - raise TypeError('smarts_properties must be a list') - else: - self.SMARTS = smarts_properties - - if smarts_labels is not None: - if len(smarts_labels) != len(self.SMARTS): - raise ValueError('Incorrect number of SMARTS labels: %s' - ' instead of %s' - % (len(smarts_labels), len(self.SMARTS))) - else: - smarts_labels = ['smarts%s' % i for i in range(len(self.SMARTS))] - - # Compile patterns - self.compile_smarts() - self.FEATURE_NAMES += smarts_labels - - def compile_smarts(self): - self.__PATTERNS = [] - for smarts in self.SMARTS: - self.__PATTERNS.append(pybel.Smarts(smarts)) - - def encode_num(self, atomic_num): - """Encode atom type with a binary vector. If atom type is not included in - the `atom_classes`, its encoding is an all-zeros vector. - - Parameters - ---------- - atomic_num: int - Atomic number - - Returns - ------- - encoding: np.ndarray - Binary vector encoding atom type (one-hot or null). - """ - - if not isinstance(atomic_num, int): - raise TypeError('Atomic number must be int, %s was given' - % type(atomic_num)) - - encoding = np.zeros(self.NUM_ATOM_CLASSES) - try: - encoding[self.ATOM_CODES[atomic_num]] = 1.0 - except: - pass - return encoding - - def find_smarts(self, molecule): - """Find atoms that match SMARTS patterns. - - Parameters - ---------- - molecule: pybel.Molecule - - Returns - ------- - features: np.ndarray - NxM binary array, where N is the number of atoms in the `molecule` - and M is the number of patterns. `features[i, j]` == 1.0 if i'th - atom has j'th property - """ - - if not isinstance(molecule, pybel.Molecule): - raise TypeError('molecule must be pybel.Molecule object, %s was given' - % type(molecule)) - - features = np.zeros((len(molecule.atoms), len(self.__PATTERNS))) - - for (pattern_id, pattern) in enumerate(self.__PATTERNS): - atoms_with_prop = np.array(list(*zip(*pattern.findall(molecule))), - dtype=int) - 1 - features[atoms_with_prop, pattern_id] = 1.0 - return features - - def get_features(self, molecule, molcode=None): - """Get coordinates and features for all heavy atoms in the molecule. - - Parameters - ---------- - molecule: pybel.Molecule - molcode: float, optional - Molecule type. You can use it to encode whether an atom belongs to - the ligand (1.0) or to the protein (-1.0) etc. - - Returns - ------- - coords: np.ndarray, shape = (N, 3) - Coordinates of all heavy atoms in the `molecule`. - features: np.ndarray, shape = (N, F) - Features of all heavy atoms in the `molecule`: atom type - (one-hot encoding), pybel.Atom attributes, type of a molecule - (e.g protein/ligand distinction), and other properties defined with - SMARTS patterns - """ - - if not isinstance(molecule, pybel.Molecule): - raise TypeError('molecule must be pybel.Molecule object,' - ' %s was given' % type(molecule)) - if molcode is None: - if self.save_molecule_codes is True: - raise ValueError('save_molecule_codes is set to True,' - ' you must specify code for the molecule') - elif not isinstance(molcode, (float, int)): - raise TypeError('motlype must be float, %s was given' - % type(molcode)) - - coords = [] - features = [] - heavy_atoms = [] - - for i, atom in enumerate(molecule): - # ignore hydrogens and dummy atoms (they have atomicnum set to 0) - # if atom.atomicnum > 1: - # heavy_atoms.append(i) - # coords.append(atom.coords) - # - # features.append(np.concatenate(( - # self.encode_num(atom.atomicnum), - # [atom.__getattribute__(prop) for prop in self.NAMED_PROPS], - # [func(atom) for func in self.CALLABLES], - # ))) - - heavy_atoms.append(i) - coords.append(atom.coords) - - # ['hyb', 'heavyvalence', 'heterovalence', - # 'partialcharge'] - atom_attributes = [] - for prop in self.NAMED_PROPS: - if prop == 'hyb': - atom_attributes.append(atom.hyb) - if prop == 'heavyvalence': - atom_attributes.append(atom.heavydegree) - if prop == 'heterovalence': - atom_attributes.append(atom.heterodegree) - if prop == 'partialcharge': - atom_attributes.append(atom.partialcharge) - if prop == 'radius': - temp = atom.atomicnum - # temp2 = ob.GetVdwRad(temp) - # if abs(temp2 - 1.1) < 0.01: - # temp2 = 1.2 - temp2 = cdk_vdwr_dic[temp] - atom_attributes.append(temp2) - pass - - features.append(np.concatenate(( - self.encode_num(atom.atomicnum), - # [atom.__getattribute__(prop) for prop in self.NAMED_PROPS], - atom_attributes, - [func(atom) for func in self.CALLABLES], - ))) - - coords = np.array(coords, dtype=np.float32) - features = np.array(features, dtype=np.float32) - if self.save_molecule_codes: - features = np.hstack((features, - molcode * np.ones((len(features), 1)))) - - features = np.hstack([features, - self.find_smarts(molecule)[heavy_atoms]]) - - if np.isnan(features).any(): - raise RuntimeError('Got NaN when calculating features') - - return coords, features - -def write_feature_file(folder): - contents = folder.split('/') - id = contents[-1] - ligand_file = folder + '/{}_ligand.mol2'.format(id) - pocket_file = folder + '/{}_pocket.pdb'.format(id) - - ligand = next(pybel.readfile('mol2', ligand_file)) - featurizer = Featurizer() - ligand_coords, ligand_feature = featurizer.get_features(ligand, molcode=0) - with open('{}/{}_ligand_feature.txt'.format(folder,id), 'w') as f: - for i in range(ligand_feature.shape[0]): - # f.writelines('{} {}\n'.format(i+1, ligand_feature[i].tolist())) - f.writelines('{}'.format(i+1)) - for j in ligand_coords[i]: - f.writelines(' {}'.format(j)) - for j in ligand_feature[i]: - f.writelines(' {}'.format(j)) - f.writelines('\n') - - pocket = next(pybel.readfile('pdb', pocket_file)) - featurizer = Featurizer() - pocket_coords, pocket_feature = featurizer.get_features(pocket, molcode=1) - with open('{}/{}_pocket_feature.txt'.format(folder, id), 'w') as f: - for i in range(pocket_feature.shape[0]): - # f.writelines('{} {}\n'.format(i+1, pocket_feature[i].tolist())) - f.writelines('{}'.format(i+1)) - for j in pocket_coords[i]: - f.writelines(' {}'.format(j)) - for j in pocket_feature[i]: - f.writelines(' {}'.format(j)) - f.writelines('\n') - pass - -if __name__ == "__main__": - path = os.getcwd() - write_feature_file(path) - -# path = '../test_set/4oem' #'/media/data/data_share/pdbbind/v2018-other-PL/3oc0' #'/media/data/data_share/pdbbind/CASF-2016/coreset/3wtj'# #'../test_set/1a4r' -# write_feature_file(path) diff --git a/pdbbind/bash_scripts/data_prepare_points.sh b/pdbbind/bash_scripts/data_prepare_points.sh deleted file mode 100644 index 1da6fe6..0000000 --- a/pdbbind/bash_scripts/data_prepare_points.sh +++ /dev/null @@ -1,13 +0,0 @@ -for D in ./*/; -do - echo "${D}"; - cd "${D}"; - java -cp /home/qil15006/2020Summer/OCNN_Jun26_2020/pdbbind/java/cdk-2.3-SNAPSHOT.jar:/home/qil15006/2020Summer/OCNN_Jun26_2020/pdbbind/java Surface_for_single 6 ico pdbbind; - /home/qil15006/.conda/envs/tf-OCNN/bin/python /home/qil15006/2020Summer/OCNN_Jun26_2020/pdbbind/write_complex.py - /home/qil15006/.conda/envs/tf-OCNN/bin/python /home/qil15006/2020Summer/OCNN_Jun26_2020/pdbbind/atomic_feature.py - /home/qil15006/2020Summer/OCNN_Jun26_2020/octree/build/pdb_to_points --complex_id file_list.txt - # uncomment if need octree - #mkdir octree_folder - #/home/qil15006/2020Summer/OCNN_Jun26_2020/octree/build/qq_octree_rotate --depth 5 --filenames point_list.txt --output_path ./octree_folder - cd ..; -done \ No newline at end of file diff --git a/pdbbind/check_points_file.py b/pdbbind/check_points_file.py deleted file mode 100644 index fd903ff..0000000 --- a/pdbbind/check_points_file.py +++ /dev/null @@ -1,29 +0,0 @@ -import os - -cwd = os.getcwd() -folders = os.listdir(cwd) - -def check_name_points(filename): - if 'points.points' in filename: - return True - -count = 0 -for folder in folders: - current_folder = os.path.join(cwd, folder) - if os.path.isfile(current_folder): - continue - subfolders = os.listdir(current_folder) - find = False - for sub in subfolders: - if check_name_points(sub): - size = os.stat(os.path.join(current_folder, sub)).st_size - if size < 10000000: - print('File size too small: {}'.format(folder)) - find = True - break - if not find: - print('Not find points in: {}'.format(folder)) - count += 1 - -print('Total not found: {}'.format(count)) - diff --git a/pdbbind/chesk_make_grids.py b/pdbbind/chesk_make_grids.py deleted file mode 100644 index 73b6e01..0000000 --- a/pdbbind/chesk_make_grids.py +++ /dev/null @@ -1,23 +0,0 @@ -import numpy as np - -size = 64 -channel = 24 -a = np.zeros(size**3*channel) - - -j = 12 -x,y,z = 15,26,27 - - -idx = j * size **3 + x * size**2 + y * size + z -a[idx] = 1 - -b = a.reshape(channel, size, size, size) -b.nonzero() - -import tensorflow as tf -c = tf.convert_to_tensor(a) -c = tf.reshape(c, (channel, size, size, size)) -sess = tf.InteractiveSession() -c[j, x, y, z].eval() - diff --git a/pdbbind/data_download.sh b/pdbbind/data_download.sh deleted file mode 100644 index 5d271e0..0000000 --- a/pdbbind/data_download.sh +++ /dev/null @@ -1,28 +0,0 @@ -mkdir data_folder -cd data_folder - -wget "http://www.pdbbind.org.cn/download/pdbbind_v2018_refined.tar.gz" -wget "http://www.pdbbind.org.cn/download/pdbbind_v2018_other_PL.tar.gz" -wget "http://www.pdbbind-cn.org/download/CASF-2016.tar.gz" - -tar -xzvf pdbbind_v2018_refined.tar.gz -tar -xzvf pdbbind_v2018_other_PL.tar.gz -tar -xzvf CASF-2016.tar.gz - -cp ../bash_scripts/* v2018-other-PL -cp ../bash_scripts/* refined-set -cp ../bash_scripts/* CASF-2016/coreset - -cd v2018-other-PL -bash correct_mol2.sh -bash data_clean_index0.sh -#bash data_prepare_points.sh -# -cd ../refined-set -bash data_clean_index0.sh -#bash data_prepare_points.sh -# -cd ../CASF-2016/coreset -bash data_clean_index0.sh -#bash data_prepare_points.sh - diff --git a/pdbbind/generate_octree_list.py b/pdbbind/generate_octree_list.py deleted file mode 100644 index 23a615d..0000000 --- a/pdbbind/generate_octree_list.py +++ /dev/null @@ -1,383 +0,0 @@ -import re -import math -import numpy as np -import random -import os -import pandas as pd - - - -def filter(folders, feature_need_sdf): - results = [] - for folder in folders: - if len(folder) != 4: - continue - if folder in feature_need_sdf: - continue - if os.path.isfile(folder): - print(folder) - continue - results.append(folder) - return results - -def check_duplicate(folder1, folder2): - results = [] - for folder in folder1: - if folder in folder2: - # print('folder1 subfolder {} also in folder2'.format(folder)) - continue - results.append(folder) - for folder in folder2: - if folder in folder1: - # print('folder2 subfolder {} also in folder1'.format(folder)) - pass - return results - -# use to check if all the compelx show in PL_data include pdb and mol2 file. Answer is NO. -def check_dic_id(dic, general_folder, refine_folder, core_folder): - for key in dic: - if key not in general_folder and key not in refine_folder and key not in core_folder: - print(key) - - -def read_affinity(file_name, mode): - """ - read affinity data from pdbbind index file, refers to log Kd/Ki - Benefit is: in general set, there are some <,>,~ in Kd/Ki, directly use log Kd/Ki might be better. - """ - record_dic = {} - with open(file_name, 'r') as data_fid: - for line in data_fid: - if '#' in line or '===' in line or len(line) == 0: - continue - line = re.sub('\s+', ' ', line).strip() - contents = line.split(' ') - id = contents[0] - affinity = float(contents[3]) - if mode == 'reg': - record_dic[id] = affinity - else: - if affinity > 6 + math.log10(5): - record_dic[id] = 1 - elif affinity < 6 - math.log10(5): - record_dic[id] = 0 - else: - print('skip {}, affinity is {}.'.format(id, affinity)) - return record_dic - -# train/test/val split, with all pdbbind data. -def write_octree_list(general_dic, core_folders, refined_folders, depth = 8, mode = 'reg'): - # test only include core set - test_file_name = root_folder + 'octree_list_test_{}_{}.txt'.format(depth, mode) - test_affinity = [] - with open(test_file_name, 'w') as f: - for id in core_folders: - if id not in general_dic: - continue - for v in range(0, view_num): - path = 'CASF-2016/coreset/{0}/octree_folder/{1}_points_{2}_2_{3:03d}.octree'.format(id, id, depth, v) - line = '{} {}\n'.format(path, general_dic[id]) - f.write(line) - test_affinity.append(general_dic[id]) - - # validation is part of refined set - random.seed(2020) - val_id = random.sample(refined_folders, k=600) - val_file_name = root_folder + 'octree_list_val_{}_{}.txt'.format(depth, mode) - val_affinity = [] - with open(val_file_name, 'w') as f: - for id in refined_folders: - if id not in val_id: - continue - if id not in general_dic: - print('id {} not in general_dic'.format(id)) - continue - for v in range(0, view_num): - path = refined_set + '/{0}/octree_folder/{1}_points_{2}_2_{3:03d}.octree'.format(id, id, depth, v) - line = '{} {}\n'.format(path, general_dic[id]) - f.write(line) - val_affinity.append(general_dic[id]) - - train_file_name = root_folder + 'octree_list_train_{}_{}.txt'.format(depth, mode) - train_affinity = [] - with open(train_file_name, 'w') as f: - train_total = general_folders + refined_folders - for id in train_total: - if id in val_id: - continue - if id not in general_dic: - continue - for v in range(0, view_num): - if id in refined_folders: - path = refined_set + '/{0}/octree_folder/{1}_points_{2}_2_{3:03d}.octree'.format(id, id, depth, v) - else: - path = 'v2018-other-PL/{0}/octree_folder/{1}_points_{2}_2_{3:03d}.octree'.format(id, id, depth, v) - line = '{} {}\n'.format(path, general_dic[id]) - f.write(line) - train_affinity.append(general_dic[id]) - - train_affinity = np.array(train_affinity) - val_affinity = np.array(val_affinity) - test_affinity = np.array(test_affinity) - print('train_affinity size: {}, mean: {}, std: {}'.format(train_affinity.shape[0], np.mean(train_affinity), np.std(train_affinity))) - print('val_affinity size: {}, mean: {}, std: {}'.format(val_affinity.shape[0], np.mean(val_affinity), np.std(val_affinity))) - print('test_affinity size: {}, mean: {}, std: {}'.format(test_affinity.shape[0], np.mean(test_affinity), np.std(test_affinity))) - -def write_points_list(general_dic, core_folders, refined_folders, mode = 'reg', density = None): - # test only include core set - test_file_name = root_folder + 'points_list_test_{}.txt'.format(mode) - test_affinity = [] - with open(test_file_name, 'w') as f: - for id in core_folders: - if id not in general_dic: - continue - if density is None: - path = 'CASF-2016/coreset/{0}/{1}_points.points'.format(id, id) - else: - path = 'CASF-2016/coreset/{0}/{1}_points_{2}.points'.format(id, id, density) - # print(path) - line = '{} {}\n'.format(path, general_dic[id]) - f.write(line) - test_affinity.append(general_dic[id]) - - # validation is part of refined set - random.seed(2020) - # val_id = random.choices(refined_folders, k=1000) - val_id = random.sample(refined_folders, k=600) - val_file_name = root_folder + 'points_list_val_{}.txt'.format(mode) - val_affinity = [] - with open(val_file_name, 'w') as f: - for id in refined_folders: - if id not in val_id or id not in general_dic: - continue - if density is None: - path = refined_set + '/{0}/{1}_points.points'.format(id, id) - else: - path = refined_set + '/{0}/{1}_points_{2}.points'.format(id, id, density) - - line = '{} {}\n'.format(path, general_dic[id]) - f.write(line) - val_affinity.append(general_dic[id]) - - - - train_file_name = root_folder + 'points_list_train_{}.txt'.format(mode) - train_affinity = [] - with open(train_file_name, 'w') as f: - train_total = general_folders + refined_folders - for id in train_total: - if id in val_id: - continue - if id not in general_dic: - continue - if id in refined_folders: - if density is None: - path = refined_set + '/{0}/{1}_points.points'.format(id, id) - else: - path = refined_set + '/{0}/{1}_points_{2}.points'.format(id, id, density) - else: - if density is None: - path = 'v2018-other-PL/{0}/{1}_points.points'.format(id, id) - else: - path = 'v2018-other-PL/{0}/{1}_points_{2}.points'.format(id, id, density) - - # print(path) - line = '{} {}\n'.format(path, general_dic[id]) - f.write(line) - train_affinity.append(general_dic[id]) - - train_affinity = np.array(train_affinity) - val_affinity = np.array(val_affinity) - test_affinity = np.array(test_affinity) - print('train_affinity size: {}, mean: {}, std: {}'.format(train_affinity.shape[0], np.mean(train_affinity), np.std(train_affinity))) - print('val_affinity size: {}, mean: {}, std: {}'.format(val_affinity.shape[0], np.mean(val_affinity), np.std(val_affinity))) - print('test_affinity size: {}, mean: {}, std: {}'.format(test_affinity.shape[0], np.mean(test_affinity), np.std(test_affinity))) - - -def write_points_list_refine(general_dic, core_folders, refined_folders, mode='reg', density = None): - # test only include core set - test_file_name = root_folder + 'points_list_test_refine_{}.txt'.format(mode) - test_affinity = [] - with open(test_file_name, 'w') as f: - for id in core_folders: - if id not in general_dic: - continue - if density is None: - path = 'CASF-2016/coreset/{0}/{1}_points.points'.format(id, id) - else: - path = 'CASF-2016/coreset/{0}/{1}_points_{2}.points'.format(id, id, density) - line = '{} {}\n'.format(path, general_dic[id]) - f.write(line) - test_affinity.append(general_dic[id]) - - # validation is part of refined set - random.seed(2020) - # val_id = random.choices(refined_folders, k=1000) - val_id = random.sample(refined_folders, k=300) - val_file_name = root_folder + 'points_list_val_refine_{}.txt'.format(mode) - val_affinity = [] - with open(val_file_name, 'w') as f: - for id in refined_folders: - if id not in val_id or id not in general_dic: - continue - if density is None: - path = refined_set + '/{0}/{1}_points.points'.format(id, id) - else: - path = refined_set + '/{0}/{1}_points_{2}.points'.format(id, id, density) - - line = '{} {}\n'.format(path, general_dic[id]) - f.write(line) - val_affinity.append(general_dic[id]) - - train_file_name = root_folder + 'points_list_train_refine_{}.txt'.format(mode) - train_affinity = [] - with open(train_file_name, 'w') as f: - train_total = refined_folders - for id in train_total: - if id not in general_dic: - continue - if id in val_id: - continue - if id in refined_folders: - if density is None: - path = refined_set + '/{0}/{1}_points.points'.format(id, id) - else: - path = refined_set + '/{0}/{1}_points_{2}.points'.format(id, id, density) - line = '{} {}\n'.format(path, general_dic[id]) - f.write(line) - train_affinity.append(general_dic[id]) - - train_affinity = np.array(train_affinity) - val_affinity = np.array(val_affinity) - test_affinity = np.array(test_affinity) - print('train shape: ', train_affinity.shape) - print('val shape: ', val_affinity.shape) - print('test shape: ', test_affinity.shape) - print('train_affinity mean: {}, std: {}'.format(np.mean(train_affinity), np.std(train_affinity))) - print('val_affinity mean: {}, std: {}'.format(np.mean(val_affinity), np.std(val_affinity))) - print('test_affinity mean: {}, std: {}'.format(np.mean(test_affinity), np.std(test_affinity))) - - -def write_octree_list_refine(general_dic, core_folders, refined_folders, depth = 8, mode='reg'): - # test only include core set - test_file_name = root_folder + 'octree_list_core_{}_{}.txt'.format(depth, mode) - test_affinity = [] - with open(test_file_name, 'w') as f: - for id in core_folders: - if id not in general_dic: - continue - # for v in range(0, view_num): - for v in range(15, 16): - path = 'CASF-2016/coreset/{0}/octree_folder/{1}_points_{2}_2_{3:03d}.octree'.format(id, id, depth, v) - line = '{} {}\n'.format(path, general_dic[id]) - f.write(line) - test_affinity.append(general_dic[id]) - - train_file_name = root_folder + 'octree_list_refine_{}_{}.txt'.format(depth, mode) - train_affinity = [] - with open(train_file_name, 'w') as f: - train_total = refined_folders - for id in train_total: - if id not in general_dic: - continue - # for v in range(0, view_num): - for v in range(15, 16): - if id in refined_folders: - path = refined_set + '/{0}/octree_folder/{1}_points_{2}_2_{3:03d}.octree'.format(id, id, depth, v) - # else: - # path = 'v2018-other-PL/{0}/{1}_points_{2}_2_{3:03d}.octree'.format(id, id, depth, v) - line = '{} {}\n'.format(path, general_dic[id]) - f.write(line) - train_affinity.append(general_dic[id]) - - train_affinity = np.array(train_affinity) - test_affinity = np.array(test_affinity) - print('train shape: ', train_affinity.shape) - print('test shape: ', test_affinity.shape) - print('train_affinity mean: {}, std: {}'.format(np.mean(train_affinity), np.std(train_affinity))) - print('test_affinity mean: {}, std: {}'.format(np.mean(test_affinity), np.std(test_affinity))) - -def list_astex_complex(general_dic): - folder = '/media/data/data_share/qil15006/astex_diverse_set' - complexes = os.listdir(folder) - complexes = [item for item in complexes if len(item)==4 ] - - # filted_complexes = [] - # for complex in complexes: - # if complex in general_folders: - # print('Complex {} in general folder'.format(complex)) - # continue - # if complex in refined_folders: - # print('Complex {} in refine folder'.format(complex)) - # continue - # if complex in core_folders: - # print('Complex {} in core folder'.format(complex)) - # continue - # filted_complexes.append(complex) - # complexes = filted_complexes - # print(len(complexes)) - - pafnucy_affinity = pd.read_csv('./pdbbind/affinity_data.csv', names = ['pdbid', 'affinity']) - deepatom_affinity = pd.read_csv('./pdbbind/Supplement_INDEX_Benchmark.csv', header = None, names = ['pdbid', 'affinity']) - - affinity_dic = {} - for complex in complexes: - if complex in general_dic: - affinity_dic[complex] = general_dic[complex] - if complex in pafnucy_affinity['pdbid'].unique(): - affinity_dic[complex] = pafnucy_affinity.loc[pafnucy_affinity['pdbid'] == complex, 'affinity'] - if complex in deepatom_affinity['pdbid'].unique(): - affinity_dic[complex] = deepatom_affinity.loc[deepatom_affinity['pdbid'] == complex, 'affinity'] - - print(len(affinity_dic)) - - -if __name__ == "__main__": - root_folder = '/media/data/data_share/pdbbind/' - refined_set = 'refined_set_v2018' - - # root_folder = '/scratch/qil15006/pdbbind/' - # refined_set = 'refined-set' - mode = 'reg' - - general_file = root_folder + 'v2018-other-PL/index/INDEX_general_PL_data.2018' - view_num = 24 - general_folders = os.listdir(root_folder + 'v2018-other-PL') - refined_folders = os.listdir(root_folder + refined_set) - core_folders = os.listdir(root_folder + 'CASF-2016/coreset') - - feature_need_sdf = ['3qlb', '4oem', '4oel', '2fov', '2fou', '2foy'] - - - general_folders = filter(general_folders, feature_need_sdf) - refined_folders = filter(refined_folders, feature_need_sdf) - core_folders = filter(core_folders, feature_need_sdf) - - print(len(general_folders), len(refined_folders), len(core_folders)) - print('Check general and core') - general_folders = check_duplicate(general_folders, core_folders) - print('Check general and refine') - general_folders = check_duplicate(general_folders, refined_folders) - print('Check refine and core') - refined_folders = check_duplicate(refined_folders, core_folders) - print(len(general_folders), len(refined_folders), len(core_folders)) - - core_id_list = core_folders #get_core_id(core_path) - general_dic = read_affinity(general_file, mode = mode) - print(len(general_dic)) - - # check_dic_id(general_dic, general_folders, refined_folders, core_folders) - - # write_octree_list(general_dic, core_folders, refined_folders, depth = 5, mode = mode) - # write_octree_list_refine(general_dic, core_folders, refined_folders, depth=5, mode=mode) - write_points_list(general_dic, core_folders, refined_folders, mode=mode, density = 5) - # write_points_list_refine(general_dic, core_folders, refined_folders, mode=mode, density = 5) - - - -# print(np.mean(affinities)) -# print(np.std(affinities)) -# import matplotlib.pyplot as plt -# import numpy as np -# n, bins, patches = plt.hist(affinities, 30, facecolor='blue', alpha=0.5) -# plt.savefig('histagram.png') diff --git a/pdbbind/java/AdaptiveSurface.java b/pdbbind/java/AdaptiveSurface.java deleted file mode 100644 index ef09184..0000000 --- a/pdbbind/java/AdaptiveSurface.java +++ /dev/null @@ -1,320 +0,0 @@ -import java.io.BufferedWriter; -import java.io.File; -import java.io.FileInputStream; -import java.io.FileWriter; -import java.io.IOException; -import java.io.InputStream; -import java.util.ArrayList; -import java.util.Arrays; -import java.util.List; - -import javax.vecmath.Point3d; - -import org.openscience.cdk.ChemFile; -import org.openscience.cdk.geometry.surface.AdaptiveNumericalSurface; -import org.openscience.cdk.geometry.surface.NumericalSurface; -import org.openscience.cdk.geometry.surface.Point_Type; -import org.openscience.cdk.interfaces.IAtomContainer; -import org.openscience.cdk.interfaces.IChemObjectBuilder; -import org.openscience.cdk.io.Mol2Reader; -import org.openscience.cdk.io.PDBReader; -import org.openscience.cdk.io.iterator.IteratingSDFReader; -import org.openscience.cdk.silent.SilentChemObjectBuilder; -import org.openscience.cdk.io.MDLV2000Reader; -import org.openscience.cdk.tools.manipulator.ChemFileManipulator; - -public class AdaptiveSurface { - //public javax.vecmath.Point3d[] getAllSurfacePoints(); - - public static String get_id(String filename) { - String[] parts = filename.split("."); - String part1 = parts[0]; - String[] parts1 = part1.split("_"); - String id = parts1[0]; - return id; - } - - public static void handle_single_mol2(String filename, String path, String id, int tess_level, String tess_type, boolean append) { - //String id = get_id(filename); -// String[] parts1 = filename.split("_"); -// String id = parts1[0]; -// System.out.println("Test"); - //return id; - - try { - File file = new File(path + "/" + id + "/" + filename); - Mol2Reader reader = new Mol2Reader(new FileInputStream(file)); - ChemFile crambin = reader.read(new ChemFile()); - // ChemFile crambin = reader.read(new ChemFile()); generate warning: org.openscience.cdk.config.atomtypes.AtomTypeHandle WARN: Unrecognized hybridization in config file: tetrahedral - // refer to https://github.com/johnmay/cdk/blob/master/base/core/src/main/java/org/openscience/cdk/config/atomtypes/AtomTypeHandler.java - // Another warning: org.openscience.cdk.io.Mol2Reader WARN: Not reading molecule qualifiers - // refer to https://github.com/cdk/cdk/blob/master/storage/io/src/main/java/org/openscience/cdk/io/Mol2Reader.java - List containers= ChemFileManipulator.getAllAtomContainers(crambin); - String write_filename = path + "/" + id + "/" + id + "_cdk_ligand.xyz"; - String atom_filename = path + "/" + id + "/" + id + "_cdk_ligand.txt"; - //FileOutputStream outputStream = new FileOutputStream(write_filename); - BufferedWriter writer = new BufferedWriter(new FileWriter(write_filename, append)); - BufferedWriter writer1 = new BufferedWriter(new FileWriter(atom_filename, append)); - System.out.println("container size: " + containers.size()); - for (int i = 0; i< containers.size(); i++) { - IAtomContainer container = containers.get(i); - String description = container.toString(); - - AdaptiveNumericalSurface new_surface = new AdaptiveNumericalSurface(container, 0, tess_level, tess_type); -// System.out.println(container); -// System.out.println(description); -// System.out.println(new_surface); - try { - //new_surface.calculateSurface(); - //Point3d[] points= new_surface.getAllSurfacePoints(); - ArrayList point_types = new_surface.getAllPointswithAtomType(); - -// System.out.println(points); - - System.out.println(point_types.size()); - for (int j = 0; j < point_types.size(); j++) { - org.openscience.cdk.geometry.surface.Point_Type point_type = point_types.get(j); - Point3d coord = (point_type).getCoord(); - int atom = ((Point_Type) point_type).getAtom(); - String str = coord.x + " " + coord.y + " " + coord.z + "\n"; -// if (j == 1){System.out.println(str);} - writer.write(str); - writer1.write(atom + "\n"); - }} catch (Exception ex) {System.out.println(ex);} - } - /*IChemObject pdb_mol = reader.read();*/ - reader.close(); - - writer.close(); - writer1.close(); - System.out.println("Finished " + write_filename); - } catch (Exception ex) {System.out.println(ex);} - //return container; - } - - public static void handle_single_sdf(String filename, String path, String id, int tess_level, String tess_type, boolean append) { - //String id = get_id(filename); -// String[] parts1 = filename.split("_"); -// String id = parts1[0]; -// System.out.println("Test"); - //return id; - - try { -// File file = new File(path + "/" + id + "/" + filename); - final boolean noStopOnError = true; - final IChemObjectBuilder builder = SilentChemObjectBuilder.getInstance(); - String write_filename = path + "/" + id + "/" + id + "_cdk_ligand.xyz"; - String atom_filename = path + "/" + id + "/" + id + "_cdk_ligand.txt"; - //FileOutputStream outputStream = new FileOutputStream(write_filename); - BufferedWriter writer = new BufferedWriter(new FileWriter(write_filename, append)); - BufferedWriter writer1 = new BufferedWriter(new FileWriter(atom_filename, append)); - -// List containers = new ArrayList(); - - try (InputStream in = new FileInputStream(path + "/" + id + "/" + filename); // .mol also fine! - IteratingSDFReader sdfr = new IteratingSDFReader(in, builder, noStopOnError)) { - while (sdfr.hasNext()) { - IAtomContainer mol = sdfr.next(); -// containers.add(mol); - AdaptiveNumericalSurface new_surface = new AdaptiveNumericalSurface(mol, 0, tess_level, tess_type); - // process molecule here - ArrayList point_types = new_surface.getAllPointswithAtomType(); - System.out.println(point_types.size()); - for (int j = 0; j < point_types.size(); j++) { - org.openscience.cdk.geometry.surface.Point_Type point_type = point_types.get(j); - Point3d coord = (point_type).getCoord(); - int atom = ((Point_Type) point_type).getAtom(); - String str = coord.x + " " + coord.y + " " + coord.z + "\n"; - writer.write(str); - writer1.write(atom + "\n"); - } - } - } catch (IOException e) { - System.err.println("Error: " + e.getMessage()); - } - -// MDLV2000Reader reader = new MDLV2000Reader(new FileInputStream(file)); -// ChemFile crambin = reader.read(new ChemFile()); -// List containers= ChemFileManipulator.getAllAtomContainers(crambin); - writer.close(); - writer1.close(); - System.out.println("Finished " + write_filename); - } catch (Exception ex) {System.out.println(ex);} - //return container; - } - - public static void handle_single_pdb(String filename, String path, String id, int tess_level, String tess_type, String file_type) { - //String id = get_id(filename); -// System.out.println(filename); -// String[] parts = filename.split("_"); - //System.out.println(parts); -// String id = parts[0]; -// System.out.println(id); - - - try { - File file = new File(path + "/" + id + "/" + filename); - PDBReader reader = new PDBReader(new FileInputStream(file)); - //IAtomContainer container = reader.read(SilentChemObjectBuilder.getInstance().newInstance(IAtomContainer.class)); - ChemFile crambin = reader.read(new ChemFile()); - List containers= ChemFileManipulator.getAllAtomContainers(crambin); - String write_filename = path + "/" + id + "/" + id + "_cdk_"+ file_type + ".xyz"; - String atom_filename = path + "/" + id + "/" + id + "_cdk_"+ file_type + ".txt"; - //FileOutputStream outputStream = new FileOutputStream(write_filename); - BufferedWriter writer = new BufferedWriter(new FileWriter(write_filename)); - BufferedWriter writer1 = new BufferedWriter(new FileWriter(atom_filename)); - for (int i = 0; i< containers.size(); i++) { - IAtomContainer container = containers.get(i); -// String description = container.toString(); - - AdaptiveNumericalSurface new_surface = new AdaptiveNumericalSurface(container, 0, tess_level, tess_type); -// System.out.println(container); -// System.out.println(description); -// System.out.println(new_surface); - try { - ArrayList point_types = new_surface.getAllPointswithAtomType(); -// System.out.println(points); - System.out.println(point_types.size()); - for (int j = 0; j < point_types.size(); j++) { - org.openscience.cdk.geometry.surface.Point_Type point_type = point_types.get(j); - Point3d coord = (point_type).getCoord(); - int atom = ((Point_Type) point_type).getAtom(); - String str = coord.x + " " + coord.y + " " + coord.z + "\n"; -// if (j == 1){System.out.println(str);} - writer.write(str); - writer1.write(atom + "\n"); - }} catch (Exception ex) {System.out.println(ex);} - } - /*IChemObject pdb_mol = reader.read();*/ - reader.close(); - - writer.close(); - writer1.close(); - System.out.println("Finished " + write_filename); - } catch (Exception ex) {System.out.println(ex);} - //return container; - } - - public static void handle_single_complex(String filename, String path, String id, int tess_level, String tess_type, String file_type) { - // need revise: to separate ligand/protein. - try { - File file = new File(path + "/" + id + "/" + filename); - PDBReader reader = new PDBReader(new FileInputStream(file)); - ChemFile crambin = reader.read(new ChemFile()); - List containers= ChemFileManipulator.getAllAtomContainers(crambin); - String write_filename = path + "/" + id + "/" + id + "_cdk_"+ file_type + ".xyz"; - String atom_filename = path + "/" + id + "/" + id + "_cdk_"+ file_type + ".txt"; - BufferedWriter writer = new BufferedWriter(new FileWriter(write_filename)); - BufferedWriter writer1 = new BufferedWriter(new FileWriter(atom_filename)); - for (int i = 0; i< containers.size(); i++) { - IAtomContainer container = containers.get(i); - AdaptiveNumericalSurface new_surface = new AdaptiveNumericalSurface(container, 0, tess_level, tess_type); - try { - ArrayList point_types = new_surface.getAllPointswithAtomType(); - System.out.println(point_types.size()); - for (int j = 0; j < point_types.size(); j++) { - org.openscience.cdk.geometry.surface.Point_Type point_type = point_types.get(j); - Point3d coord = (point_type).getCoord(); - int atom = ((Point_Type) point_type).getAtom(); - String str = coord.x + " " + coord.y + " " + coord.z + "\n"; - writer.write(str); - writer1.write(atom + "\n"); - }} catch (Exception ex) {System.out.println(ex);} - } - reader.close(); - - writer.close(); - writer1.close(); - System.out.println("Finished " + write_filename); - } catch (Exception ex) {System.out.println(ex);} - } - - public static void handle_single_id(File complex_id, String path, int tess_level, String tess_type, Boolean protein_flag, String source) { - //File folder = new File("your/path"); - String id_string = complex_id.getName(); - File[] listOfFiles = complex_id.listFiles(); - - if (source.equals("pdbbind")) { - boolean append = false; - for (int i = 0; i < listOfFiles.length; i++) { - String file_name = listOfFiles[i].getName(); - - if (file_name.endsWith(".mol2")){ - System.out.println("Start work on: " + file_name); -// handle_single_mol2(file_name, path, id_string, tess_level, tess_type, append); - System.out.println("Finished: " + file_name); - append = false; - } -// else if (file_name.endsWith("_ligand.sdf")) { -// System.out.println("Start work on: " + file_name); -// handle_single_sdf(file_name, path, id_string, tess_level, tess_type, append); -// System.out.println("Finished: " + file_name); -// append = false; -// } - else if(file_name.endsWith("pocket.pdb")) { - System.out.println("Start work on: " + file_name); - handle_single_pdb(file_name, path, id_string, tess_level, tess_type, "pocket"); - System.out.println("Finished: " + file_name); - } - else if(protein_flag && file_name.endsWith("protein.pdb")) { - System.out.println("Start work on: " + file_name); - handle_single_pdb(file_name, path, id_string, tess_level-2, tess_type, "protein"); - System.out.println("Finished: " + file_name); - } - } // end for - - } // end if source - else if (source.equals("pdbbank")) { - boolean append = false; - for (int i = 0; i < listOfFiles.length; i++) { - String file_name = listOfFiles[i].getName(); - if(file_name.endsWith("_withHs.pdb")) { - handle_single_complex(file_name, path, id_string, tess_level-2, tess_type, "protein"); - } - }// end for - } - else { - System.out.println("This File Source is not supported: " + source); - } - - } - - public static void main(String[] args) { - String path = args[0]; - int tess_level = Integer.parseInt(args[1]); - String tess_type = args[2]; - Boolean protein_flag = Boolean.parseBoolean(args[3]); - String source = args[4]; - //System.out.println(path); - File folder = new File(path); - File[] listOfIDs = folder.listFiles(); - //System.out.println(listOfIDs); - try { - for (int i = 0; i < listOfIDs.length; i++) { - if (listOfIDs[i].isFile()) { - continue; - } - else if (listOfIDs[i].isDirectory()) { - File complex_id = listOfIDs[i]; - String id_string = complex_id.getName(); - System.out.println(id_string); - List already = Arrays.asList("1a1e", "1a4r", - "2pjt", "2phb", "1a4k", "3avj", "1x7a"); - List skip = Arrays.asList("4g17", "3v2w", - "2y80", "4prg", "2phb", "1a1e", "1a4r", - "2pjt", "1a4k"); - -// List already = Arrays.asList(); -// List skip = Arrays.asList(); - if(already.contains(id_string)|| skip.contains(id_string)) { - System.out.println("Skip " + id_string + "."); - continue; - } - handle_single_id(complex_id, path, tess_level, tess_type, protein_flag, source); - System.out.println("\n"); - } - } - } catch (Exception ex) {System.out.println(ex);} - System.out.println("All Finish"); - } -} diff --git a/pdbbind/java/Surface_for_single.class b/pdbbind/java/Surface_for_single.class deleted file mode 100644 index 7660871..0000000 Binary files a/pdbbind/java/Surface_for_single.class and /dev/null differ diff --git a/pdbbind/java/Surface_for_single.java b/pdbbind/java/Surface_for_single.java deleted file mode 100644 index c3906dc..0000000 --- a/pdbbind/java/Surface_for_single.java +++ /dev/null @@ -1,302 +0,0 @@ -import java.io.BufferedWriter; -import java.io.File; -import java.io.FileInputStream; -import java.io.FileWriter; -import java.io.IOException; -import java.io.InputStream; -import java.util.ArrayList; -import java.util.Arrays; -import java.util.List; -import java.nio.file.Path; -import java.nio.file.Paths; - - -import javax.vecmath.Point3d; - -import org.openscience.cdk.ChemFile; -import org.openscience.cdk.geometry.surface.AdaptiveNumericalSurface; -import org.openscience.cdk.geometry.surface.NumericalSurface; -import org.openscience.cdk.geometry.surface.Point_Type; -import org.openscience.cdk.interfaces.IAtomContainer; -import org.openscience.cdk.interfaces.IChemObjectBuilder; -import org.openscience.cdk.io.Mol2Reader; -import org.openscience.cdk.io.PDBReader; -import org.openscience.cdk.io.iterator.IteratingSDFReader; -import org.openscience.cdk.silent.SilentChemObjectBuilder; -import org.openscience.cdk.io.MDLV2000Reader; -import org.openscience.cdk.tools.manipulator.ChemFileManipulator; - -import java.io.BufferedWriter; -import java.io.File; -import java.io.FileInputStream; -import java.io.FileWriter; -import java.io.IOException; -import java.io.InputStream; -import java.util.ArrayList; -import java.util.Arrays; -import java.util.List; - -import javax.vecmath.Point3d; - -import org.openscience.cdk.ChemFile; -import org.openscience.cdk.geometry.surface.AdaptiveNumericalSurface; -import org.openscience.cdk.geometry.surface.NumericalSurface; -import org.openscience.cdk.geometry.surface.Point_Type; -import org.openscience.cdk.interfaces.IAtomContainer; -import org.openscience.cdk.interfaces.IChemObjectBuilder; -import org.openscience.cdk.io.Mol2Reader; -import org.openscience.cdk.io.PDBReader; -import org.openscience.cdk.io.iterator.IteratingSDFReader; -import org.openscience.cdk.silent.SilentChemObjectBuilder; -import org.openscience.cdk.io.MDLV2000Reader; -import org.openscience.cdk.tools.manipulator.ChemFileManipulator; - -public class Surface_for_single { - //public javax.vecmath.Point3d[] getAllSurfacePoints(); - - public static String get_id(String filename) { - String[] parts = filename.split("."); - String part1 = parts[0]; - String[] parts1 = part1.split("_"); - String id = parts1[0]; - return id; - } - - public static void handle_single_mol2(String filename, String path, String id, int tess_level, String tess_type, String file_type, boolean append) { - - try { - File file = new File(path + "/" + id + "/" + filename); - Mol2Reader reader = new Mol2Reader(new FileInputStream(file)); - ChemFile crambin = reader.read(new ChemFile()); - // ChemFile crambin = reader.read(new ChemFile()); generate warning: org.openscience.cdk.config.atomtypes.AtomTypeHandle WARN: Unrecognized hybridization in config file: tetrahedral - // refer to https://github.com/johnmay/cdk/blob/master/base/core/src/main/java/org/openscience/cdk/config/atomtypes/AtomTypeHandler.java - // Another warning: org.openscience.cdk.io.Mol2Reader WARN: Not reading molecule qualifiers - // refer to https://github.com/cdk/cdk/blob/master/storage/io/src/main/java/org/openscience/cdk/io/Mol2Reader.java - List containers= ChemFileManipulator.getAllAtomContainers(crambin); - String write_filename = path + "/" + id + "/" + id + "_cdk_"+ file_type + ".xyz"; - String atom_filename = path + "/" + id + "/" + id + "_cdk_"+ file_type + ".txt"; - //FileOutputStream outputStream = new FileOutputStream(write_filename); - BufferedWriter writer = new BufferedWriter(new FileWriter(write_filename, append)); - BufferedWriter writer1 = new BufferedWriter(new FileWriter(atom_filename, append)); - System.out.println("container size: " + containers.size()); - for (int i = 0; i< containers.size(); i++) { - IAtomContainer container = containers.get(i); -// String description = container.toString(); - -// AdaptiveNumericalSurface new_surface = new AdaptiveNumericalSurface(container, 0, tess_level, tess_type); - NumericalSurface new_surface = new NumericalSurface(container, 0, tess_level, tess_type); -// System.out.println(container); -// System.out.println(description); -// System.out.println(new_surface); - try { - //new_surface.calculateSurface(); - //Point3d[] points= new_surface.getAllSurfacePoints(); - ArrayList point_types = new_surface.getAllPointswithAtomType(); - -// System.out.println(points); - - System.out.println(point_types.size()); - for (int j = 0; j < point_types.size(); j++) { - org.openscience.cdk.geometry.surface.Point_Type point_type = point_types.get(j); - Point3d coord = (point_type).getCoord(); - int atom = ((Point_Type) point_type).getAtom(); - int atom_index = ((Point_Type) point_type).getIndex(); - String str = coord.x + " " + coord.y + " " + coord.z + "\n"; -// if (j == 1){System.out.println(str);} - writer.write(str); -// writer1.write(atom + "\n"); - writer1.write(atom + " " + atom_index + "\n"); - }} catch (Exception ex) {System.out.println("remind QQ Error: " + ex);} - } - /*IChemObject pdb_mol = reader.read();*/ - reader.close(); - - writer.close(); - writer1.close(); - System.out.println("Finished " + write_filename); - } catch (Exception ex) {System.out.println(ex);} - //return container; - } - - public static void handle_single_pdb(String filename, String path, String id, int tess_level, String tess_type, String file_type) { - //String id = get_id(filename); -// System.out.println(filename); -// String[] parts = filename.split("_"); - //System.out.println(parts); -// String id = parts[0]; -// System.out.println(id); - - - try { - File file = new File(path + "/" + id + "/" + filename); - PDBReader reader = new PDBReader(new FileInputStream(file)); - //IAtomContainer container = reader.read(SilentChemObjectBuilder.getInstance().newInstance(IAtomContainer.class)); - ChemFile crambin = reader.read(new ChemFile()); - List containers= ChemFileManipulator.getAllAtomContainers(crambin); - String write_filename = path + "/" + id + "/" + id + "_cdk_"+ file_type + ".xyz"; - String atom_filename = path + "/" + id + "/" + id + "_cdk_"+ file_type + ".txt"; - //FileOutputStream outputStream = new FileOutputStream(write_filename); - BufferedWriter writer = new BufferedWriter(new FileWriter(write_filename)); - BufferedWriter writer1 = new BufferedWriter(new FileWriter(atom_filename)); - for (int i = 0; i< containers.size(); i++) { - IAtomContainer container = containers.get(i); -// String description = container.toString(); - System.out.println(containers.size()); - -// AdaptiveNumericalSurface new_surface = new AdaptiveNumericalSurface(container, 0, tess_level, tess_type); - NumericalSurface new_surface = new NumericalSurface(container, 0, tess_level, tess_type); -// System.out.println(container); -// System.out.println(description); -// System.out.println(new_surface); - try { - ArrayList point_types = new_surface.getAllPointswithAtomType(); -// System.out.println(points); - System.out.println(point_types.size()); - for (int j = 0; j < point_types.size(); j++) { - org.openscience.cdk.geometry.surface.Point_Type point_type = point_types.get(j); - Point3d coord = (point_type).getCoord(); - int atom = ((Point_Type) point_type).getAtom(); - int atom_index = ((Point_Type) point_type).getIndex(); - String str = coord.x + " " + coord.y + " " + coord.z + "\n"; -// if (j == 1){System.out.println(str);} - writer.write(str); -// writer1.write(atom + "\n"); - writer1.write(atom + " " + atom_index + "\n"); - }} catch (Exception ex) {System.out.println(ex);} - } - /*IChemObject pdb_mol = reader.read();*/ - reader.close(); - - writer.close(); - writer1.close(); - System.out.println("Finished " + write_filename); - } catch (Exception ex) {System.out.println(ex);} - //return container; - } - - public static void handle_single_complex(String filename, String path, String id, int tess_level, String tess_type, String file_type) { - // need revise: to separate ligand/protein. - try { - File file = new File(path + "/" + id + "/" + filename); - PDBReader reader = new PDBReader(new FileInputStream(file)); - ChemFile crambin = reader.read(new ChemFile()); - List containers= ChemFileManipulator.getAllAtomContainers(crambin); - String write_filename = path + "/" + id + "/" + id + "_cdk_"+ file_type + ".xyz"; - String atom_filename = path + "/" + id + "/" + id + "_cdk_"+ file_type + ".txt"; - BufferedWriter writer = new BufferedWriter(new FileWriter(write_filename)); - BufferedWriter writer1 = new BufferedWriter(new FileWriter(atom_filename)); - for (int i = 0; i< containers.size(); i++) { - IAtomContainer container = containers.get(i); - AdaptiveNumericalSurface new_surface = new AdaptiveNumericalSurface(container, 0, tess_level, tess_type); - try { - ArrayList point_types = new_surface.getAllPointswithAtomType(); - System.out.println(point_types.size()); - for (int j = 0; j < point_types.size(); j++) { - org.openscience.cdk.geometry.surface.Point_Type point_type = point_types.get(j); - Point3d coord = (point_type).getCoord(); - int atom = ((Point_Type) point_type).getAtom(); - int atom_index = ((Point_Type) point_type).getIndex(); - String str = coord.x + " " + coord.y + " " + coord.z + "\n"; - writer.write(str); -// writer1.write(atom + "\n"); - writer1.write(atom + " " + atom_index + "\n"); - }} catch (Exception ex) {System.out.println(ex);} - } - reader.close(); - - writer.close(); - writer1.close(); - System.out.println("Finished " + write_filename); - } catch (Exception ex) {System.out.println(ex);} - } - - public static void handle_single_id(File complex_id, String path, int tess_level, String tess_type, Boolean protein_flag, String source) { - //File folder = new File("your/path"); - String id_string = complex_id.getName(); - File[] listOfFiles = complex_id.listFiles(); - - if (source.equals("pdbbind")) { - boolean append = false; - for (int i = 0; i < listOfFiles.length; i++) { - String file_name = listOfFiles[i].getName(); - - if (file_name.endsWith("ligand.mol2")){ - System.out.println("Start work on: " + file_name); - handle_single_mol2(file_name, path, id_string, tess_level, tess_type, "ligand", append); - System.out.println("Finished: " + file_name); - append = false; - } - else if(file_name.endsWith("pocket.pdb")) { - System.out.println("Start work on: " + file_name); - handle_single_pdb(file_name, path, id_string, tess_level, tess_type, "pocket"); - System.out.println("Finished: " + file_name); - } - else if(protein_flag && file_name.endsWith("protein.pdb")) { - System.out.println("Start work on: " + file_name); - handle_single_pdb(file_name, path, id_string, tess_level-2, tess_type, "protein"); - System.out.println("Finished: " + file_name); - } - } // end for - - } // end if source - else if (source.equals("pdbbank")) { - boolean append = false; - for (int i = 0; i < listOfFiles.length; i++) { - String file_name = listOfFiles[i].getName(); - if(file_name.endsWith("_withHs.pdb")) { - handle_single_complex(file_name, path, id_string, tess_level-2, tess_type, "protein"); - } - }// end for - } - else if (source.equals("astex")) { - boolean append = false; - for (int i = 0; i < listOfFiles.length; i++) { - String file_name = listOfFiles[i].getName(); - - if (file_name.endsWith("ligand.mol2")){ - System.out.println("Start work on: " + file_name); - handle_single_mol2(file_name, path, id_string, tess_level, tess_type, "ligand", append); - System.out.println("Finished: " + file_name); - append = false; - } - else if(file_name.endsWith("protein.mol2")) { - System.out.println("Start work on: " + file_name); - handle_single_mol2(file_name, path, id_string, tess_level, tess_type, "pocket", append); - System.out.println("Finished: " + file_name); - } - } // end for - - } - - else { - System.out.println("This File Source is not supported: " + source); - } - - } - public static void main(String[] args) { - - int tess_level = Integer.parseInt(args[0]); - String tess_type = args[1]; - String source = args[2]; - - Path currentRelativePath = Paths.get(""); - String s = currentRelativePath.toAbsolutePath().toString(); - String[] array = s.split("/"); - -// String complex_id = array[array.length-1]; - array = Arrays.copyOf(array, array.length - 1); - String dataset_path = String.join("/", array); - - File complex_file = new File(s); - - if (complex_file.isDirectory()) { - String id_string = complex_file.getName(); - handle_single_id(complex_file, dataset_path, tess_level, tess_type, false, source); - } - else { - System.out.println(s + "is not a folder"); - } - - } -} - diff --git a/pdbbind/java/Surface_from_Mol2.java b/pdbbind/java/Surface_from_Mol2.java deleted file mode 100644 index 9bdcf4a..0000000 --- a/pdbbind/java/Surface_from_Mol2.java +++ /dev/null @@ -1,177 +0,0 @@ -import java.io.BufferedWriter; -import java.io.File; -import java.io.FileInputStream; -import java.io.FileOutputStream; -import java.io.FileWriter; -import java.util.List; - -import javax.vecmath.Point3d; - -import org.openscience.cdk.geometry.surface.NumericalSurface; -import org.openscience.cdk.interfaces.IAtomContainer; -import org.openscience.cdk.io.*; -import org.openscience.cdk.silent.SilentChemObjectBuilder; -import org.openscience.cdk.tools.manipulator.ChemFileManipulator; -import org.apache.commons.io.FileUtils; -import org.openscience.cdk.*; - - -public class Surface_from_Mol2 { - - //public javax.vecmath.Point3d[] getAllSurfacePoints(); - - public static String get_id(String filename) { - String[] parts = filename.split("."); - String part1 = parts[0]; - String[] parts1 = part1.split("_"); - String id = parts1[0]; - return id; - } - - public static void handle_single_mol2(String filename, String path) { - //String id = get_id(filename); - String[] parts1 = filename.split("_"); - String id = parts1[0]; - System.out.println("Test"); - //return id; - - try { - File file = new File(path + "/" + id + "/" + filename); - Mol2Reader reader = new Mol2Reader(new FileInputStream(file)); - //IAtomContainer container = reader.read(SilentChemObjectBuilder.getInstance().newInstance(IAtomContainer.class)); - ChemFile crambin = reader.read(new ChemFile()); - - List containers= ChemFileManipulator.getAllAtomContainers(crambin); - String write_filename = path + "/" + id + "/" + id + "_cdk_ligand.xyz"; - //FileOutputStream outputStream = new FileOutputStream(write_filename); - BufferedWriter writer = new BufferedWriter(new FileWriter(write_filename)); - for (int i = 0; i< containers.size(); i++) { - IAtomContainer container = containers.get(i); - String description = container.toString(); - - NumericalSurface new_surface = new NumericalSurface(container, 0, 6); - System.out.println(container); - System.out.println(description); - System.out.println(new_surface); - // Next line is wrong. - try { - new_surface.calculateSurface(); - Point3d[] points= new_surface.getAllSurfacePoints(); -// System.out.println(points); - System.out.println(points.length); - for (int j = 0; j < points.length; j++) { - String str = points[j].x + " " + points[j].y + " " + points[j].z + "\n"; - if (j == 1){System.out.println(str);} - writer.write(str); - }} catch (Exception ex) {System.out.println(ex);} - } - /*IChemObject pdb_mol = reader.read();*/ - reader.close(); - - writer.close(); - System.out.println("Finished " + write_filename); - } catch (Exception ex) {System.out.println(ex);} - //return container; - } - - public static void handle_single_pdb(String filename, String path) { - //String id = get_id(filename); - System.out.println(filename); - String[] parts = filename.split("_"); - //System.out.println(parts); - String id = parts[0]; - System.out.println(id); - - try { - File file = new File(path + "/" + id + "/" + filename); - PDBReader reader = new PDBReader(new FileInputStream(file)); - //IAtomContainer container = reader.read(SilentChemObjectBuilder.getInstance().newInstance(IAtomContainer.class)); - ChemFile crambin = reader.read(new ChemFile()); - List containers= ChemFileManipulator.getAllAtomContainers(crambin); - String write_filename = path + "/" + id + "/" + id + "_cdk_pocket.xyz"; - //FileOutputStream outputStream = new FileOutputStream(write_filename); - BufferedWriter writer = new BufferedWriter(new FileWriter(write_filename)); -// writer.write("ply\n" + -// "format ascii 1.0\n" + -// "element vertex 107812\n" + -// "property float x\n" + -// "property float y\n" + -// "property float z\n" + -// "property float nx\n" + -// "property float ny\n" + -// "property float nz\n" + -// "element face 0\n" + -// "property list uchar int vertex_indices\n" + -// "end_header"); - for (int i = 0; i< containers.size(); i++) { - IAtomContainer container = containers.get(i); - String description = container.toString(); - - NumericalSurface new_surface = new NumericalSurface(container, 0, 6); - System.out.println(container); - System.out.println(description); - System.out.println(new_surface); - // Next line is wrong. - try { - new_surface.calculateSurface(); - Point3d[] points= new_surface.getAllSurfacePoints(); -// System.out.println(points); - System.out.println(points.length); - for (int j = 0; j < points.length; j++) { - String str = points[j].x + " " + points[j].y + " " + points[j].z + "\n"; - if (j == 1){System.out.println(str);} - writer.write(str); - }} catch (Exception ex) {System.out.println(ex);} - } - /*IChemObject pdb_mol = reader.read();*/ - reader.close(); - - writer.close(); - System.out.println("Finished " + write_filename); - } catch (Exception ex) {System.out.println(ex);} - //return container; - - } - - public static void handle_single_id(File complex_id, String path) { - //File folder = new File("your/path"); - File[] listOfFiles = complex_id.listFiles(); - for (int i = 0; i < listOfFiles.length; i++) { - String file_name = listOfFiles[i].getName(); - - if (file_name.endsWith(".mol2")){ - System.out.println("Start work on: " + file_name); - handle_single_mol2(file_name, path); - System.out.println("Finished: " + file_name); - - } - else if(file_name.endsWith("pocket.pdb")) { - System.out.println("Start work on: " + file_name); - handle_single_pdb(file_name, path); - System.out.println("Finished: " + file_name); - } - } - } - - public static void main(String[] args) { - String path = args[0]; - //System.out.println(path); - File folder = new File(path); - File[] listOfIDs = folder.listFiles(); - //System.out.println(listOfIDs); - try { - for (int i = 0; i < listOfIDs.length; i++) { - if (listOfIDs[i].isFile()) { - //System.out.println("File " + listOfFiles[i].getName()); - continue; - } - else if (listOfIDs[i].isDirectory()) { - File complex_id = listOfIDs[i]; - //String str = complex_id.getPath(); - //System.out.println(str); - handle_single_id(complex_id, path); - } - } - } catch (Exception ex) {System.out.println(ex);} - } -} diff --git a/pdbbind/java/Surface_with_Type.class b/pdbbind/java/Surface_with_Type.class deleted file mode 100644 index a4bdb7f..0000000 Binary files a/pdbbind/java/Surface_with_Type.class and /dev/null differ diff --git a/pdbbind/java/Surface_with_Type.java b/pdbbind/java/Surface_with_Type.java deleted file mode 100644 index 6d43b80..0000000 --- a/pdbbind/java/Surface_with_Type.java +++ /dev/null @@ -1,259 +0,0 @@ -// The updated version for Adaptive surface. -// Reduced the number of points that would be generated. -// Also generate txt file to describe the points. e.g. atom type, index. - - -import java.io.BufferedWriter; -import java.io.File; -import java.io.FileInputStream; -import java.io.FileWriter; -import java.util.ArrayList; -import java.util.Arrays; -import java.util.List; - -import javax.vecmath.Point3d; - -import org.openscience.cdk.ChemFile; -import org.openscience.cdk.geometry.surface.NumericalSurface; -import org.openscience.cdk.geometry.surface.Point_Type; -import org.openscience.cdk.interfaces.IAtomContainer; -import org.openscience.cdk.io.Mol2Reader; -import org.openscience.cdk.io.PDBReader; -import org.openscience.cdk.tools.manipulator.ChemFileManipulator; - -public class Surface_with_Type { - //public javax.vecmath.Point3d[] getAllSurfacePoints(); - - public static String get_id(String filename) { - String[] parts = filename.split("."); - String part1 = parts[0]; - String[] parts1 = part1.split("_"); - String id = parts1[0]; - return id; - } - - public static void handle_single_mol2(String filename, String path) { - //String id = get_id(filename); - String[] parts1 = filename.split("_"); - String id = parts1[0]; -// System.out.println("Test"); - //return id; - - try { - File file = new File(path + "/" + id + "/" + filename); - Mol2Reader reader = new Mol2Reader(new FileInputStream(file)); - //IAtomContainer container = reader.read(SilentChemObjectBuilder.getInstance().newInstance(IAtomContainer.class)); - ChemFile crambin = reader.read(new ChemFile()); - - List containers= ChemFileManipulator.getAllAtomContainers(crambin); - String write_filename = path + "/" + id + "/" + id + "_cdk_ligand.xyz"; - String atom_filename = path + "/" + id + "/" + id + "_cdk_ligand.txt"; - //FileOutputStream outputStream = new FileOutputStream(write_filename); - BufferedWriter writer = new BufferedWriter(new FileWriter(write_filename)); - BufferedWriter writer1 = new BufferedWriter(new FileWriter(atom_filename)); - for (int i = 0; i< containers.size(); i++) { - IAtomContainer container = containers.get(i); -// String description = container.toString(); - - NumericalSurface new_surface = new NumericalSurface(container, 0, 6); -// System.out.println(container); -// System.out.println(description); -// System.out.println(new_surface); - // Next line is wrong. - try { - //new_surface.calculateSurface(); - //Point3d[] points= new_surface.getAllSurfacePoints(); - ArrayList point_types = new_surface.getAllPointswithAtomType(); - -// System.out.println(points); - - System.out.println(point_types.size()); - for (int j = 0; j < point_types.size(); j++) { - org.openscience.cdk.geometry.surface.Point_Type point_type = point_types.get(j); - Point3d coord = (point_type).getCoord(); - int atom = ((Point_Type) point_type).getAtom(); - int atom_index = ((Point_Type) point_type).getIndex(); - String str = coord.x + " " + coord.y + " " + coord.z + "\n"; - if (j == 1){System.out.println(str);} - writer.write(str); - writer1.write(atom + " " + atom_index + "\n"); - }} catch (Exception ex) {System.out.println(ex);} - } - /*IChemObject pdb_mol = reader.read();*/ - reader.close(); - - writer.close(); - writer1.close(); - System.out.println("Finished " + write_filename); - } catch (Exception ex) {System.out.println(ex);} - //return container; - } - - public static void handle_single_pdb(String filename, String path) { - //String id = get_id(filename); -// System.out.println(filename); - String[] parts = filename.split("_"); - //System.out.println(parts); - String id = parts[0]; -// System.out.println(id); - - try { - File file = new File(path + "/" + id + "/" + filename); - PDBReader reader = new PDBReader(new FileInputStream(file)); - //IAtomContainer container = reader.read(SilentChemObjectBuilder.getInstance().newInstance(IAtomContainer.class)); - ChemFile crambin = reader.read(new ChemFile()); - List containers= ChemFileManipulator.getAllAtomContainers(crambin); - String write_filename = path + "/" + id + "/" + id + "_cdk_pocket.xyz"; - String atom_filename = path + "/" + id + "/" + id + "_cdk_pocket.txt"; - //FileOutputStream outputStream = new FileOutputStream(write_filename); - BufferedWriter writer = new BufferedWriter(new FileWriter(write_filename)); - BufferedWriter writer1 = new BufferedWriter(new FileWriter(atom_filename)); - for (int i = 0; i< containers.size(); i++) { - IAtomContainer container = containers.get(i); -// String description = container.toString(); - - NumericalSurface new_surface = new NumericalSurface(container, 0, 6); -// System.out.println(container); -// System.out.println(description); -// System.out.println(new_surface); - // Next line is wrong. - try { - ArrayList point_types = new_surface.getAllPointswithAtomType(); -// System.out.println(points); - System.out.println(point_types.size()); - for (int j = 0; j < point_types.size(); j++) { - org.openscience.cdk.geometry.surface.Point_Type point_type = point_types.get(j); - Point3d coord = (point_type).getCoord(); - int atom = ((Point_Type) point_type).getAtom(); - int index = ((Point_Type) point_type).getIndex(); - String str = coord.x + " " + coord.y + " " + coord.z + "\n"; - if (j == 1){System.out.println(str);} - writer.write(str); - writer1.write(atom + " " + index + "\n"); - }} catch (Exception ex) {System.out.println(ex);} - } - /*IChemObject pdb_mol = reader.read();*/ - reader.close(); - - writer.close(); - writer1.close(); - System.out.println("Finished " + write_filename); - } catch (Exception ex) {System.out.println(ex);} - //return container; - - } - - public static void handle_single_protein(String filename, String path) { - //String id = get_id(filename); -// System.out.println(filename); - String[] parts = filename.split("_"); - //System.out.println(parts); - String id = parts[0]; -// System.out.println(id); - - try { - File file = new File(path + "/" + id + "/" + filename); - PDBReader reader = new PDBReader(new FileInputStream(file)); - //IAtomContainer container = reader.read(SilentChemObjectBuilder.getInstance().newInstance(IAtomContainer.class)); - ChemFile crambin = reader.read(new ChemFile()); - List containers= ChemFileManipulator.getAllAtomContainers(crambin); - String write_filename = path + "/" + id + "/" + id + "_cdk_protein.xyz"; - String atom_filename = path + "/" + id + "/" + id + "_cdk_protein.txt"; - //FileOutputStream outputStream = new FileOutputStream(write_filename); - BufferedWriter writer = new BufferedWriter(new FileWriter(write_filename)); - BufferedWriter writer1 = new BufferedWriter(new FileWriter(atom_filename)); - for (int i = 0; i< containers.size(); i++) { - IAtomContainer container = containers.get(i); -// String description = container.toString(); - - NumericalSurface new_surface = new NumericalSurface(container, 0, 6); -// System.out.println(container); -// System.out.println(description); -// System.out.println(new_surface); - // Next line is wrong. - try { - ArrayList point_types = new_surface.getAllPointswithAtomType(); -// System.out.println(points); - System.out.println(point_types.size()); - for (int j = 0; j < point_types.size(); j++) { - org.openscience.cdk.geometry.surface.Point_Type point_type = point_types.get(j); - Point3d coord = (point_type).getCoord(); - int atom = ((Point_Type) point_type).getAtom(); - int index = ((Point_Type) point_type).getIndex(); - String str = coord.x + " " + coord.y + " " + coord.z + "\n"; - if (j == 1){System.out.println(str);} - writer.write(str); - writer1.write(atom + " " + index + "\n"); - }} catch (Exception ex) {System.out.println(ex);} - } - /*IChemObject pdb_mol = reader.read();*/ - reader.close(); - - writer.close(); - writer1.close(); - System.out.println("Finished " + write_filename); - } catch (Exception ex) {System.out.println(ex);} - //return container; - - } - - public static void handle_single_id(File complex_id, String path) { - //File folder = new File("your/path"); - File[] listOfFiles = complex_id.listFiles(); - for (int i = 0; i < listOfFiles.length; i++) { - String file_name = listOfFiles[i].getName(); - - if (file_name.endsWith(".mol2")){ - System.out.println("Start work on: " + file_name); - handle_single_mol2(file_name, path); - System.out.println("Finished: " + file_name); - - } - else if(file_name.endsWith("pocket.pdb")) { - System.out.println("Start work on: " + file_name); - handle_single_pdb(file_name, path); - System.out.println("Finished: " + file_name); - } -// else if(file_name.endsWith("protein.pdb")) { -// System.out.println("Start work on: " + file_name); -// handle_single_protein(file_name, path); -// System.out.println("Finished: " + file_name); -// } - - - } - } - - public static void main(String[] args) { - String path = args[0]; - //System.out.println(path); - File folder = new File(path); - File[] listOfIDs = folder.listFiles(); - //System.out.println(listOfIDs); - try { - for (int i = 0; i < listOfIDs.length; i++) { - if (listOfIDs[i].isFile()) { - continue; - } - else if (listOfIDs[i].isDirectory()) { - File complex_id = listOfIDs[i]; - String id_string = complex_id.getName(); - System.out.println(id_string); -// List already = Arrays.asList("1a1e", "1a4r", -// "2pjt", "2phb", "1a4k", "3avj", "1x7a", -// "4tvj", "4crf", "4PJT", "1i1e", "3huc"); -// List skip = Arrays.asList("4g17", "3v2w", -// "2y80", "4prg", "2hmu", "4m0f"); - List already = Arrays.asList(); - List skip = Arrays.asList(); - if(already.contains(id_string)|| skip.contains(id_string)) { - System.out.println("Skip " + id_string + "."); - continue; - } - handle_single_id(complex_id, path); - } - } - } catch (Exception ex) {System.out.println(ex);} - System.out.println("All Finish"); - } -} diff --git a/pdbbind/java/Tess_Val.java b/pdbbind/java/Tess_Val.java deleted file mode 100644 index b4640ae..0000000 --- a/pdbbind/java/Tess_Val.java +++ /dev/null @@ -1,18 +0,0 @@ -import java.util.Arrays; -import java.util.HashSet; -import java.util.Set; - -import javax.vecmath.Point3d; - -import org.openscience.cdk.geometry.surface.Tessellate; - -public class Tess_Val { - public static void main(String[] args) { - Tessellate tess = new Tessellate("ico", 4); - tess.doTessellate(); -// System.out.println(tess.getNumberOfTriangles()); - Point3d[] point_list = tess.getTessAsPoint3ds(); - Set point_set = new HashSet(Arrays.asList(point_list)); - System.out.println(point_set.size()); - } -} diff --git a/pdbbind/java/cdk-2.3-SNAPSHOT.jar b/pdbbind/java/cdk-2.3-SNAPSHOT.jar deleted file mode 100644 index 1c01c94..0000000 Binary files a/pdbbind/java/cdk-2.3-SNAPSHOT.jar and /dev/null differ diff --git a/pdbbind/write_complex.py b/pdbbind/write_complex.py deleted file mode 100644 index ff5dc06..0000000 --- a/pdbbind/write_complex.py +++ /dev/null @@ -1,19 +0,0 @@ -import os - -path = os.getcwd() -complex_id = path.split('/')[-1] - -# id_list_file = path + '/file_list.txt' -# with open(id_list_file, 'w') as fw: -# fw.write(complex_id) - - -# file_list is used to get .points from pdb points. -id_list_file = path + '/file_list.txt' -with open(id_list_file, 'w') as fw: - fw.write(complex_id) - -# point_list is used to get .octrees from .points -id_list_file = path + '/point_list.txt' -with open(id_list_file, 'w') as fw: - fw.write(path + '/' + complex_id + '_points.points') \ No newline at end of file diff --git a/tensorflow/.DS_Store b/tensorflow/.DS_Store index d6e1183..daa977a 100644 Binary files a/tensorflow/.DS_Store and b/tensorflow/.DS_Store differ diff --git a/tensorflow/data/cls_modelnet.py b/tensorflow/data/cls_modelnet.py deleted file mode 100644 index c8d6809..0000000 --- a/tensorflow/data/cls_modelnet.py +++ /dev/null @@ -1,236 +0,0 @@ -import os -import sys -import argparse - - -parser = argparse.ArgumentParser() -parser.add_argument('--run', type=str, required=True, - help='The command to run.') -parser.add_argument('--converter', type=str, required=False, - default='util/convert_tfrecords.py', - help='The path of the convert_tfrecords') -parser.add_argument('--scanner', type=str, required=False, - help='The path of the virtual_scanner') -parser.add_argument('--octree', type=str, required=False, default='octree', - help='The path of the octree') -parser.add_argument('--simplify_points', type=str, required=False, - default='simplify_points', - help='The path of the simplify_points') - - -abs_path = os.path.dirname(os.path.dirname(os.path.realpath(__file__))) -root_folder = os.path.join(abs_path, 'script/dataset/ModelNet40') - - -args = parser.parse_args() -octree = args.octree -converter = os.path.join(abs_path, args.converter) -virtual_scanner = args.scanner -simplify = args.simplify_points - - -def download_m40(): - # download via wget - if not os.path.exists(root_folder): - os.makedirs(root_folder) - url = 'http://modelnet.cs.princeton.edu/ModelNet40.zip' - cmd = 'wget %s -O %s/ModelNet40.zip' % (url, root_folder) - print(cmd) - os.system(cmd) - - # unzip - cmd = 'unzip %s/ModelNet40.zip -d %s' % (root_folder, root_folder) - print(cmd) - os.system(cmd) - - -def download_m40_points(): - # download via wget - if not os.path.exists(root_folder): - os.makedirs(root_folder) - url = 'https://www.dropbox.com/s/m233s9eza3acj2a/ModelNet40.points.zip?dl=0' - cmd = 'wget %s -O %s/ModelNet40.points.zip' % (url, root_folder) - print(cmd) - os.system(cmd) - - # unzip - cmd = 'unzip %s/ModelNet40.points.zip -d %s/ModelNet40.points' % ( - root_folder, root_folder) - print(cmd) - os.system(cmd) - - -def clean_off_file(filename): - # read the contents of the file - with open(filename) as fid: - file_str = fid.read() - # fix the file - if file_str[0:3] != 'OFF': - print('Error: not an OFF file: ' + filename) - elif file_str[0:4] != 'OFF\n': - print('Info: fix an OFF file: ' + filename) - new_str = file_str[0:3] + '\n' + file_str[3:] - with open(filename, 'w') as f_rewrite: - f_rewrite.write(new_str) - - -def m40_get_filelist(root_folder, train=True, suffix='off'): - filelist, category = [], [] - folders = sorted(os.listdir(root_folder)) - assert(len(folders) == 40) - for idx, folder in enumerate(folders): - subfolder = 'train' if train else 'test' - current_folder = os.path.join(root_folder, folder, subfolder) - filenames = sorted(os.listdir(current_folder)) - for filename in filenames: - if filename.endswith(suffix): - filelist.append(os.path.join(folder, subfolder, filename)) - category.append(idx) - return filelist, category - - -def m40_move_files(src_folder, des_folder, suffix): - folders = os.listdir(src_folder) - for folder in folders: - for subfolder in ['train', 'test']: - curr_src_folder = os.path.join(src_folder, folder, subfolder) - curr_des_folder = os.path.join(des_folder, folder, subfolder) - if not os.path.exists(curr_des_folder): - os.makedirs(curr_des_folder) - filenames = os.listdir(curr_src_folder) - for filename in filenames: - if filename.endswith('.points'): - os.rename(os.path.join(curr_src_folder, filename), - os.path.join(curr_des_folder, filename)) - - -def m40_convert_mesh_to_points(): - mesh_folder = os.path.join(root_folder, 'ModelNet40') - # Delete 3 files since the virtualscanner can not well deal with them - filelist = ['cone/train/cone_0117.off', - 'curtain/train/curtain_0066.off', - 'car/train/car_0021.off.off'] - for filename in filelist: - filename = os.path.join(mesh_folder, filename) - if os.path.exists(filename): - os.remove(filename) - - # clean the off files - train_list, _ = m40_get_filelist(mesh_folder, train=True, suffix='off') - test_list, _ = m40_get_filelist(mesh_folder, train=False, suffix='off') - filelist = train_list + test_list - for filename in filelist: - clean_off_file(os.path.join(mesh_folder, filename)) - - # run virtualscanner - folders = os.listdir(mesh_folder) - for folder in folders: - for subfolder in ['train', 'test']: - curr_folder = os.path.join(mesh_folder, folder, subfolder) - cmd = '%s %s 14' % (virtual_scanner, curr_folder) - print(cmd) - os.system(cmd) - - # move points - m40_move_files(mesh_folder, mesh_folder + '.points', 'points') - - -def m40_convert_points_to_octree(depth=5, adaptive=0, node_dis=0): - points_folder = os.path.join(root_folder, 'ModelNet40.points') - folders = os.listdir(points_folder) - for folder in folders: - for subfolder in ['train', 'test']: - curr_folder = os.path.join(points_folder, folder, subfolder) - # write filelist to disk - filenames = os.listdir(curr_folder) - filelist_name = os.path.join(curr_folder, 'list.txt') - with open(filelist_name, 'w') as fid: - for filename in filenames: - if filename.endswith('.points'): - fid.write(os.path.join(curr_folder, filename) + '\n') - # run octree - octree_folder = points_folder[:-6] + 'octree.%d' % depth - if adaptive == 1: - octree_folder = octree_folder + '.adaptive' - output_path = os.path.join(octree_folder, folder, subfolder) - if not os.path.exists(output_path): - os.makedirs(output_path) - cmd = '%s --filenames %s --output_path %s --depth %d --adaptive %d --node_dis %d --axis z' % \ - (octree, filelist_name, output_path, depth, adaptive, node_dis) - print(cmd) - os.system(cmd) - - -def m40_simplify_points(resolution=64): - # rename and backup the original folders - points_folder = os.path.join(root_folder, 'ModelNet40.points') - original_folder = points_folder + ".dense" - if os.path.exists(points_folder): - os.rename(points_folder, original_folder) - - folders = os.listdir(original_folder) - for folder in folders: - for subfolder in ['train', 'test']: - curr_folder = os.path.join(original_folder, folder, subfolder) - # write filelist to disk - filenames = os.listdir(curr_folder) - filelist_name = os.path.join(curr_folder, 'list.txt') - with open(filelist_name, 'w') as fid: - for filename in filenames: - if filename.endswith('.points'): - fid.write(os.path.join(curr_folder, filename) + '\n') - # run simplify_points - output_path = os.path.join(points_folder, folder, subfolder) - if not os.path.exists(output_path): - os.makedirs(output_path) - cmd = '%s --filenames %s --output_path %s --dim %d' % \ - (simplify, filelist_name, output_path, resolution) - print(cmd) - os.system(cmd) - os.remove(filelist_name) - - -def m40_generate_points_tfrecords(): - points_folder = os.path.join(root_folder, 'ModelNet40.points') - for folder in ['train', 'test']: - train = folder == 'train' - shuffle = '--shuffle true' if folder == 'train' else '' - filelist, idx = m40_get_filelist( - points_folder, train=train, suffix='points') - filename = os.path.join(root_folder, 'm40_%s_points_list.txt' % folder) - with open(filename, 'w') as fid: - for i in range(len(filelist)): - fid.write('%s %d\n' % (filelist[i], idx[i])) - tfrecords_name = os.path.join( - root_folder, 'm40_%s_points.tfrecords' % folder) - cmd = 'python %s %s --file_dir %s --list_file %s --records_name %s' % \ - (converter, shuffle, points_folder, filename, tfrecords_name) - print(cmd) - os.system(cmd) - - -def m40_generate_octree_tfrecords(depth=5): - # generate octree - m40_convert_points_to_octree(depth, adaptive=0, node_dis=0) - - # generate tfrecords - octree_folder = os.path.join(root_folder, 'ModelNet40.octree.%d' % depth) - for folder in ['train', 'test']: - train = folder == 'train' - shuffle = '--shuffle true' if folder == 'train' else '' - filelist, idx = m40_get_filelist( - octree_folder, train=train, suffix='octree') - filename = os.path.join(root_folder, 'm40_%s_octree_list.txt' % folder) - with open(filename, 'w') as fid: - for i in range(len(filelist)): - fid.write('%s %d\n' % (filelist[i], idx[i])) - tfname = os.path.join( - root_folder, 'm40_%d_2_12_%s_octree.tfrecords' % (depth, folder)) - cmd = 'python %s %s --file_dir %s --list_file %s --records_name %s' % \ - (converter, shuffle, octree_folder, filename, tfname) - print(cmd) - os.system(cmd) - - -if __name__ == '__main__': - eval('%s()' % args.run) diff --git a/tensorflow/data/completion.py b/tensorflow/data/completion.py deleted file mode 100644 index 61673bb..0000000 --- a/tensorflow/data/completion.py +++ /dev/null @@ -1,188 +0,0 @@ -import os -import sys -import argparse - - -parser = argparse.ArgumentParser() -parser.add_argument('--run', type=str, required=True) -parser.add_argument('--octree', type=str, required=False, - default='script/logs/completion/skip_connections_test') -args = parser.parse_args() - -abs_path = os.path.dirname(os.path.dirname(os.path.realpath(__file__))) -root_folder = os.path.join(abs_path, 'script/dataset/ocnn_completion') - -points2ply, ply2points, octree2pts = 'points2ply', 'ply2points', 'octree2points' -converter = os.path.join(abs_path, 'util/convert_tfrecords.py') - - -def download_point_clouds(): - # download via wget - if not os.path.exists(root_folder): - os.makedirs(root_folder) - url = 'https://www.dropbox.com/s/y5ljm2bs8649j3p/ocnn_completion.zip?dl=0' - cmd = 'wget %s -O %s.zip' % (url, root_folder) - print(cmd) - os.system(cmd) - - # unzip - cmd = 'unzip %s.zip -d %s' % (root_folder, root_folder) - print(cmd) - os.system(cmd) - - -def _convert_ply_to_points(prefix='shape'): - ply_folder = os.path.join(root_folder, prefix + '.ply') - points_folder = os.path.join(root_folder, prefix + '.points') - - folders = os.listdir(ply_folder) - for folder in folders: - curr_folder = os.path.join(ply_folder, folder) - - # write filelist to disk - filenames = os.listdir(curr_folder) - filelist_name = os.path.join(curr_folder, 'filelist.txt') - with open(filelist_name, 'w') as fid: - for filename in filenames: - if filename.endswith('.ply'): - fid.write(os.path.join(curr_folder, filename) + '\n') - - # run points2ply - output_path = os.path.join(points_folder, folder) - if not os.path.exists(output_path): - os.makedirs(output_path) - cmd = '%s --filenames %s --output_path %s --verbose 0' % \ - (ply2points, filelist_name, output_path) - print(cmd) - os.system(cmd) - os.remove(filelist_name) - - -def convert_ply_to_points(): - _convert_ply_to_points('shape') - _convert_ply_to_points('test.scans') - - -def _convert_points_to_ply(prefix='shape'): - ply_folder = os.path.join(root_folder, prefix + '.ply') - points_folder = os.path.join(root_folder, prefix + '.points') - - folders = os.listdir(points_folder) - for folder in folders: - curr_folder = os.path.join(points_folder, folder) - - # write filelist to disk - filenames = os.listdir(curr_folder) - filelist_name = os.path.join(curr_folder, 'filelist.txt') - with open(filelist_name, 'w') as fid: - for filename in filenames: - if filename.endswith('.points'): - fid.write(os.path.join(curr_folder, filename) + '\n') - - # run points2ply - output_path = os.path.join(ply_folder, folder) - if not os.path.exists(output_path): - os.makedirs(output_path) - cmd = '%s --filenames %s --output_path %s --verbose 0' % \ - (points2ply, filelist_name, output_path) - print(cmd) - os.system(cmd) - os.remove(filelist_name) - - -def convert_points_to_ply(): - _convert_points_to_ply('shape') - _convert_points_to_ply('test.scans') - - -def generate_points_tfrecords(): - # tfrecords for training - points_folder = os.path.join(root_folder, 'shape.points') - filelist = os.path.join(root_folder, 'filelist_train.txt') - records_name = os.path.join(root_folder, 'completion_train_points.tfrecords') - cmd = 'python %s --file_dir %s --list_file %s --records_name %s' % \ - (converter, points_folder, filelist, records_name) - print(cmd) - os.system(cmd) - - # tfrecords for testing - points_folder = os.path.join(root_folder, 'shape.points') - filelist = os.path.join(root_folder, 'filelist_test.txt') - records_name = os.path.join(root_folder, 'completion_test_points.tfrecords') - cmd = 'python %s --file_dir %s --list_file %s --records_name %s' % \ - (converter, points_folder, filelist, records_name) - print(cmd) - os.system(cmd) - - # tfrecords for testing scans - points_folder = os.path.join(root_folder, 'test.scans.points') - filelist = os.path.join(root_folder, 'filelist_test_scans.txt') - records_name = os.path.join(root_folder, 'completion_test_scans_points.tfrecords') - cmd = 'python %s --file_dir %s --list_file %s --records_name %s' % \ - (converter, points_folder, filelist, records_name) - print(cmd) - os.system(cmd) - - -def generate_dataset(): - download_point_clouds() - convert_ply_to_points() - generate_points_tfrecords() - - -def rename_output_octree(): - filelist = os.path.join(root_folder, 'filelist_test_scans.txt') - filenames = [] - with open(filelist, 'r') as fid: - for line in fid: - filename = line.split()[0] - filenames.append(filename[:-6] + 'octree') - - idx = 0 - folder_in = args.octree - octree_in = os.listdir(folder_in) - octree_in.sort() - folder_out = os.path.join(root_folder, 'output.octree') - for o in octree_in: - if o.endswith('output.octree'): - name_in = os.path.join(folder_in, o) - name_out = os.path.join(folder_out, filenames[idx]) - os.renames(name_in, name_out) - idx += 1 - assert (idx == 1200) - - -def _convert_octree_to_points(suffix='ply'): - octree_folder = os.path.join(root_folder, 'output.octree') - points_folder = os.path.join(root_folder, 'output.' + suffix) - - folders = os.listdir(octree_folder) - for folder in folders: - curr_folder = os.path.join(octree_folder, folder) - - # write filelist to disk - filenames = os.listdir(curr_folder) - filelist_name = os.path.join(curr_folder, 'filelist.txt') - with open(filelist_name, 'w') as fid: - for filename in filenames: - if filename.endswith('.octree'): - fid.write(os.path.join(curr_folder, filename) + '\n') - - # run octree2points - output_path = os.path.join(points_folder, folder) - if not os.path.exists(output_path): - os.makedirs(output_path) - cmd = '%s --filenames %s --output_path %s --verbose 0 --suffix %s' % \ - (octree2pts, filelist_name, output_path, suffix) - print(cmd) - os.system(cmd) - os.remove(filelist_name) - - -def convert_octree_to_points(): - _convert_octree_to_points('points') - _convert_octree_to_points('ply') - - -if __name__ == '__main__': - eval('%s()' % args.run) diff --git a/tensorflow/data/seg_shapenet.py b/tensorflow/data/seg_shapenet.py deleted file mode 100644 index e8f740d..0000000 --- a/tensorflow/data/seg_shapenet.py +++ /dev/null @@ -1,128 +0,0 @@ -import os -import json - -current_path = os.path.dirname(os.path.realpath(__file__)) -root_folder = os.path.join(current_path, '../script/dataset/shapenet_segmentation') -ply2points = 'ply2points' -convert_tfrecords = os.path.join(current_path, '../util/convert_tfrecords.py') -zip_name = 'shapenetcore_partanno_segmentation_benchmark_v0_normal' - -txt_folder = os.path.join(root_folder, zip_name) -ply_folder = os.path.join(root_folder, 'ply') -points_folder = os.path.join(root_folder, 'points') -dataset_folder = os.path.join(root_folder, 'datasets') - -categories= ['02691156', '02773838', '02954340', '02958343', - '03001627', '03261776', '03467517', '03624134', - '03636649', '03642806', '03790512', '03797390', - '03948459', '04099429', '04225987', '04379243'] -names = ['Aero', 'Bag', 'Cap', 'Car', - 'Chair', 'EarPhone', 'Guitar', 'Knife', - 'Lamp', 'Laptop', 'Motor', 'Mug', - 'Pistol', 'Rocket', 'Skate', 'Table'] -seg_num = [4, 2, 2, 4, 4, 3, 3, 2, 4, 2, 6, 2, 3, 3, 3, 3 ] -dis = [0, 4, 6, 8, 12, 16, 19, 22, 24, 28, 30, 36, 38, 41, 44, 47] - -def download_and_unzip(): - print('Downloading and unzipping ...') - if not os.path.exists(root_folder): os.makedirs(root_folder) - url = 'https://shapenet.cs.stanford.edu/media/%s.zip' % zip_name - os.system('wget %s -P %s' % (url, root_folder)) - os.system('unzip %s.zip -d %s' % (os.path.join(root_folder, zip_name), root_folder)) - -def txt_to_ply(): - print('Convert txt files to ply files ...') - header = 'ply\nformat ascii 1.0\nelement vertex %d\n' + \ - 'property float x\nproperty float y\nproperty float z\n' + \ - 'property float nx\nproperty float ny\nproperty float nz\n' + \ - 'property float label\nelement face 0\n' + \ - 'property list uchar int vertex_indices\nend_header' - for i, c in enumerate(categories): - src_folder = os.path.join(txt_folder, c) - des_folder = os.path.join(ply_folder, c) - if not os.path.exists(des_folder): os.makedirs(des_folder) - - filenames = os.listdir(src_folder) - for filename in filenames: - filename_txt = os.path.join(src_folder, filename) - filename_ply = os.path.join(des_folder, filename[:-4] + '.ply') - with open(filename_txt, 'r') as fid: - lines = [] - for line in fid: - if line == '\n': continue - nums = line.split() - nums[-1] = str(float(nums[-1]) - dis[i]) - lines.append(' '.join(nums)) - - ply_header = header % len(lines) - ply_content = '\n'.join([ply_header] + lines) - with open(filename_ply, 'w') as fid: - fid.write(ply_content) - -def ply_to_points(): - print('Convert ply files to points files ...') - for c in categories: - src_folder = os.path.join(ply_folder, c) - des_folder = os.path.join(points_folder, c) - list_folder = os.path.join(ply_folder, 'fileliet') - if not os.path.exists(des_folder): os.makedirs(des_folder) - if not os.path.exists(list_folder): os.makedirs(list_folder) - - list_filename = os.path.join(list_folder, c + '.txt') - filenames = [os.path.join(src_folder, filename) for filename in os.listdir(src_folder)] - with open(list_filename, 'w') as fid: - fid.write('\n'.join(filenames)) - - cmds = [ply2points, - '--filenames', list_filename, - '--output_path', des_folder, - '--verbose', '0'] - cmd = ' '.join(cmds) - # print(cmd + '\n') - os.system(cmd) - -def points_to_tfrecords(): - print('Convert points files to tfrecords files ...') - if not os.path.exists(dataset_folder): os.makedirs(dataset_folder) - list_folder = os.path.join(txt_folder, 'train_test_split') - train_list_name = os.path.join(list_folder, 'shuffled_train_file_list.json') - val_list_name = os.path.join(list_folder, 'shuffled_val_file_list.json') - test_list_name = os.path.join(list_folder, 'shuffled_test_file_list.json') - with open(train_list_name) as fid: train_list = json.load(fid) - with open(val_list_name) as fid: val_list = json.load(fid) - with open(test_list_name) as fid: test_list = json.load(fid) - for i, c in enumerate(categories): - filelist_name = os.path.join(list_folder, c + '_train_val.txt') - filelist = ['%s.points %d' % (line[11:], i) for line in train_list if c in line] + \ - ['%s.points %d' % (line[11:], i) for line in val_list if c in line] - with open(filelist_name, 'w') as fid: - fid.write('\n'.join(filelist)) - - dataset_name = os.path.join(dataset_folder, c + '_train_val.tfrecords') - cmds = ['python', convert_tfrecords, - '--file_dir', points_folder, - '--list_file', filelist_name, - '--records_name', dataset_name] - cmd = ' '.join(cmds) - print(cmd + '\n') - os.system(cmd) - - filelist_name = os.path.join(list_folder, c + '_test.txt') - filelist = ['%s.points %d' % (line[11:], i) for line in test_list if c in line] - with open(filelist_name, 'w') as fid: - fid.write('\n'.join(filelist)) - - dataset_name = os.path.join(dataset_folder, c + '_test.tfrecords') - cmds = ['python', convert_tfrecords, - '--file_dir', points_folder, - '--list_file', filelist_name, - '--records_name', dataset_name] - cmd = ' '.join(cmds) - print(cmd + '\n') - os.system(cmd) - -if __name__ == '__main__': - download_and_unzip() - txt_to_ply() - ply_to_points() - points_to_tfrecords() diff --git a/tensorflow/libs/.DS_Store b/tensorflow/libs/.DS_Store deleted file mode 100644 index 1ff9a70..0000000 Binary files a/tensorflow/libs/.DS_Store and /dev/null differ diff --git a/tensorflow/libs/Makefile b/tensorflow/libs/Makefile deleted file mode 100644 index de6d75d..0000000 --- a/tensorflow/libs/Makefile +++ /dev/null @@ -1,92 +0,0 @@ -TF_CFLAGS := -I/home/qil15006/.conda/envs/tf-OCNN/lib/python3.7/site-packages/tensorflow/include -D_GLIBCXX_USE_CXX11_ABI=1 -TF_LFLAGS := -L/home/qil15006/.conda/envs/tf-OCNN/lib/python3.7/site-packages/tensorflow -l:libtensorflow_framework.so.1 -OCT_CFLAGS := -I../../octree/octree -OCT_LFLAGS := -L../../octree/build -loctree_lib - -NVCC_FLAGS1 := -std=c++11 -O2 -c -NVCC_FLAGS2 := $(TF_CFLAGS) $(OCT_CFLAGS) -I /usr/local/cuda-10.1/include -x cu -Xcompiler -fPIC -D GOOGLE_CUDA=1 -I /usr/local -expt-relaxed-constexpr -DNDEBUG -CC_FLAGS1 := -std=c++11 -O2 -CC_FLAGS2 := $(TF_CFLAGS) $(OCT_CFLAGS) -I /usr/local/cuda-10.1/include -L /usr/local/cuda-10.1/lib64 -D GOOGLE_CUDA=1 $(TF_LFLAGS) $(OCT_LFLAGS) -fPIC -lcudart - -CC := g++ -NVCC := /usr/local/cuda-10.1/bin/nvcc - -cpu_objects := object/octree2col_op.cc.o object/octree_align_op.cc.o object/octree_batch_op.cc.o object/octree_bilinear_op.cc.o object/octree_conv_op.cc.o object/octree_gather_op.cc.o object/octree_grow_op.cc.o object/octree_key_op.cc.o object/octree_mask_op.cc.o object/octree_max_pool_op.cc.o object/octree_new_op.cc.o object/octree_pad_op.cc.o object/octree_property_op.cc.o object/octree_samples.cc.o object/octree_search_op.cc.o object/octree_set_property_op.cc.o object/octree_update_op.cc.o object/points2octree_op.cc.o object/points_property_op.cc.o object/transform_octree_op.cc.o object/transform_points_op.cc.o -gpu_objects := object/tensorflow_gpu_gemm.cu.cc.o - -.PHONY : all clean - -all : libocnn.so - -libocnn.so : $(cpu_objects) $(gpu_objects) - $(CC) $(CC_FLAGS1) -shared -o libocnn.so object/*.o $(CC_FLAGS2) - -object/octree2col_op.cc.o : octree2col_op.cc - $(CC) $(CC_FLAGS1) -c octree2col_op.cc $(CC_FLAGS2) -o object/octree2col_op.cc.o - -object/octree_align_op.cc.o : octree_align_op.cc - $(CC) $(CC_FLAGS1) -c octree_align_op.cc $(CC_FLAGS2) -o object/octree_align_op.cc.o - -object/octree_batch_op.cc.o : octree_batch_op.cc - $(CC) $(CC_FLAGS1) -c octree_batch_op.cc $(CC_FLAGS2) -o object/octree_batch_op.cc.o - -object/octree_bilinear_op.cc.o : octree_bilinear_op.cc - $(CC) $(CC_FLAGS1) -c octree_bilinear_op.cc $(CC_FLAGS2) -o object/octree_bilinear_op.cc.o - -object/octree_conv_op.cc.o : tensorflow_gpu_gemm.h octree_conv_op.cc - $(CC) $(CC_FLAGS1) -c octree_conv_op.cc $(CC_FLAGS2) -o object/octree_conv_op.cc.o - -object/octree_gather_op.cc.o : octree_gather_op.cc - $(CC) $(CC_FLAGS1) -c octree_gather_op.cc $(CC_FLAGS2) -o object/octree_gather_op.cc.o - -object/octree_grow_op.cc.o : octree_grow_op.cc - $(CC) $(CC_FLAGS1) -c octree_grow_op.cc $(CC_FLAGS2) -o object/octree_grow_op.cc.o - -object/octree_key_op.cc.o : octree_key_op.cc - $(CC) $(CC_FLAGS1) -c octree_key_op.cc $(CC_FLAGS2) -o object/octree_key_op.cc.o - -object/octree_mask_op.cc.o : octree_mask_op.cc - $(CC) $(CC_FLAGS1) -c octree_mask_op.cc $(CC_FLAGS2) -o object/octree_mask_op.cc.o - -object/octree_max_pool_op.cc.o : octree_max_pool_op.cc - $(CC) $(CC_FLAGS1) -c octree_max_pool_op.cc $(CC_FLAGS2) -o object/octree_max_pool_op.cc.o - -object/octree_new_op.cc.o : octree_new_op.cc - $(CC) $(CC_FLAGS1) -c octree_new_op.cc $(CC_FLAGS2) -o object/octree_new_op.cc.o - -object/octree_pad_op.cc.o : octree_pad_op.cc - $(CC) $(CC_FLAGS1) -c octree_pad_op.cc $(CC_FLAGS2) -o object/octree_pad_op.cc.o - -object/octree_property_op.cc.o : octree_property_op.cc - $(CC) $(CC_FLAGS1) -c octree_property_op.cc $(CC_FLAGS2) -o object/octree_property_op.cc.o - -object/octree_samples.cc.o : octree_samples.cc - $(CC) $(CC_FLAGS1) -c octree_samples.cc $(CC_FLAGS2) -o object/octree_samples.cc.o - -object/octree_search_op.cc.o : octree_search_op.cc - $(CC) $(CC_FLAGS1) -c octree_search_op.cc $(CC_FLAGS2) -o object/octree_search_op.cc.o - -object/octree_set_property_op.cc.o : octree_set_property_op.cc - $(CC) $(CC_FLAGS1) -c octree_set_property_op.cc $(CC_FLAGS2) -o object/octree_set_property_op.cc.o - -object/octree_update_op.cc.o : octree_update_op.cc - $(CC) $(CC_FLAGS1) -c octree_update_op.cc $(CC_FLAGS2) -o object/octree_update_op.cc.o - -object/points2octree_op.cc.o : points2octree_op.cc - $(CC) $(CC_FLAGS1) -c points2octree_op.cc $(CC_FLAGS2) -o object/points2octree_op.cc.o - -object/points_property_op.cc.o : points_property_op.cc - $(CC) $(CC_FLAGS1) -c points_property_op.cc $(CC_FLAGS2) -o object/points_property_op.cc.o - -object/transform_octree_op.cc.o : transform_octree_op.cc - $(CC) $(CC_FLAGS1) -c transform_octree_op.cc $(CC_FLAGS2) -o object/transform_octree_op.cc.o - -object/transform_points_op.cc.o : transform_points_op.cc - $(CC) $(CC_FLAGS1) -c transform_points_op.cc $(CC_FLAGS2) -o object/transform_points_op.cc.o - -object/tensorflow_gpu_gemm.cu.cc.o : tensorflow_gpu_gemm.h tensorflow_gpu_gemm.cu.cc - $(NVCC) $(NVCC_FLAGS1) tensorflow_gpu_gemm.cu.cc $(NVCC_FLAGS2) -o object/tensorflow_gpu_gemm.cu.cc.o - -clean : - rm object/*.o - diff --git a/tensorflow/libs/__init__.py b/tensorflow/libs/__init__.py index 71f9927..e36fa52 100644 --- a/tensorflow/libs/__init__.py +++ b/tensorflow/libs/__init__.py @@ -3,7 +3,22 @@ from tensorflow.python.framework import ops -_current_path = os.path.dirname(os.path.realpath(__file__)) + +if 'OCTREE_KEY' in os.environ and os.environ['OCTREE_KEY'] == '64': + print('INFO from ocnn: The octree key is 64 bits') + octree_key64 = True + tf_uintk = tf.uint64 + tf_uints = tf.uint16 + tf_intk = tf.int64 +else: + print('INFO from ocnn: The octree key is 32 bits, ' + 'the octree depth should be smaller than 10.') + octree_key64 = False + tf_uintk = tf.uint32 + tf_uints = tf.uint8 + tf_intk = tf.int32 + +_current_path = os.path.dirname(os.path.realpath(__file__)) _tf_ocnn_module = tf.load_op_library(os.path.join(_current_path, 'libocnn.so')) # check the modules @@ -12,6 +27,9 @@ bounding_sphere = _tf_ocnn_module.bounding_sphere points_property = _tf_ocnn_module.points_property transform_points = _tf_ocnn_module.transform_points +normalize_points = _tf_ocnn_module.normalize_points +points_new = _tf_ocnn_module.points_new +points_set_property = _tf_ocnn_module.points_set_property octree_drop = _tf_ocnn_module.octree_drop octree_scan = _tf_ocnn_module.octree_scan octree_cast = _tf_ocnn_module.octree_cast @@ -22,7 +40,7 @@ octree_depad = _tf_ocnn_module.octree_depad octree2col = _tf_ocnn_module.octree_to_col col2octree = _tf_ocnn_module.col_to_octree -octree_grow = _tf_ocnn_module.octree_grow +# octree_grow = _tf_ocnn_module.octree_grow octree_new = _tf_ocnn_module.octree_new octree_update = _tf_ocnn_module.octree_update octree_align = _tf_ocnn_module.octree_align @@ -52,6 +70,9 @@ ops.NotDifferentiable('OctreeSetProperty') ops.NotDifferentiable('OctreeBatch') ops.NotDifferentiable('TransformPoints') +ops.NotDifferentiable('NormalizePoints') +ops.NotDifferentiable('PointsNew') +ops.NotDifferentiable('PointsSetProperty') ops.NotDifferentiable('PointsToOctree') ops.NotDifferentiable('OctreeProperty') ops.NotDifferentiable('OctreeNew') @@ -101,22 +122,22 @@ def _ColToOctreeGrad(op, grad): @ops.RegisterGradient('OctreeMaxPool') def _OctreeMaxPoolGrad(op, *grad): - grad_out = _octree_max_unpool(grad[0], op.outputs[1], op.inputs[1], + grad_out = _octree_max_unpool(grad[0], op.outputs[1], op.inputs[1], op.get_attr('depth')) return [grad_out, None] @ops.RegisterGradient('OctreeMaxUnpool') def _OctreeMaxUnpoolGrad(op, grad): - grad_out = _octree_mask_pool(grad, op.inputs[1], op.inputs[2], + grad_out = _octree_mask_pool(grad, op.inputs[1], op.inputs[2], op.get_attr('depth')) return [grad_out, None, None] @ops.RegisterGradient('OctreeMaskPool') def _OctreeMaskPoolGrad(op, grad): - grad_out = _octree_max_unpool(grad, op.inputs[1], op.inputs[2], - op.get_attr('depth')) + grad_out = _octree_max_unpool(grad, op.inputs[1], op.inputs[2], + op.get_attr('depth')) return [grad_out, None, None] @@ -132,7 +153,7 @@ def _OctreeConvGrad(op, grad): def _OctreeDeconvGrad(op, grad): grad_out = _octree_deconv_grad(op.inputs[0], op.inputs[1], op.inputs[2], grad, op.get_attr('depth'), op.get_attr('num_output'), - op.get_attr('kernel_size'), op.get_attr('stride')) + op.get_attr('kernel_size'), op.get_attr('stride')) return grad_out + (None, ) @@ -163,7 +184,7 @@ def octree_max_pool(data, octree, depth): def octree_max_unpool(data, mask, octree, depth): - with tf.variable_scope('octree_max_unpool'): + with tf.variable_scope('octree_max_unpool'): data = octree_depad(data, octree, depth) # !!! depth data = _octree_max_unpool(data, mask, octree, depth) # the bottom data depth return data @@ -180,12 +201,12 @@ def octree_avg_pool(data, octree, depth): # todo: merge octree_conv_fast and octree_conv_memory to reduce code redundancy def octree_conv_fast(data, octree, depth, channel, kernel_size=[3], stride=1): assert(type(kernel_size) is list and len(kernel_size) < 4) - for i in range(len(kernel_size), 3): + for i in range(len(kernel_size), 3): kernel_size.append(kernel_size[-1]) - with tf.variable_scope('octree_conv'): + with tf.variable_scope('octree_conv'): dim = int(data.shape[1]) * kernel_size[0] * kernel_size[1] * kernel_size[2] - kernel = tf.get_variable('weights', shape=[channel, dim], dtype=tf.float32, + kernel = tf.get_variable('weights', shape=[channel, dim], dtype=tf.float32, initializer=tf.contrib.layers.xavier_initializer()) col = octree2col(data, octree, depth, kernel_size, stride) col = tf.reshape(col, [dim, -1]) @@ -193,17 +214,17 @@ def octree_conv_fast(data, octree, depth, channel, kernel_size=[3], stride=1): conv = tf.expand_dims(tf.expand_dims(conv, 0), -1) # [C, H] -> [1, C, H, 1] if stride == 2: conv = octree_pad(conv, octree, depth-1, 0) - return conv + return conv def octree_conv_memory(data, octree, depth, channel, kernel_size=[3], stride=1): assert(type(kernel_size) is list and len(kernel_size) < 4) - for i in range(len(kernel_size), 3): + for i in range(len(kernel_size), 3): kernel_size.append(kernel_size[-1]) - with tf.variable_scope('octree_conv'): + with tf.variable_scope('octree_conv'): dim = int(data.shape[1]) * kernel_size[0] * kernel_size[1] * kernel_size[2] - kernel = tf.get_variable('weights', shape=[channel, dim], dtype=tf.float32, + kernel = tf.get_variable('weights', shape=[channel, dim], dtype=tf.float32, initializer=tf.contrib.layers.xavier_initializer()) conv = _octree_conv(data, kernel, octree, depth, channel, kernel_size, stride) if stride == 2: @@ -213,14 +234,14 @@ def octree_conv_memory(data, octree, depth, channel, kernel_size=[3], stride=1): def octree_deconv_fast(data, octree, depth, channel, kernel_size=[3], stride=1): assert(type(kernel_size) is list and len(kernel_size) < 4) - for i in range(len(kernel_size), 3): + for i in range(len(kernel_size), 3): kernel_size.append(kernel_size[-1]) with tf.variable_scope('octree_deconv'): kernel_sdim = kernel_size[0] * kernel_size[1] * kernel_size[2] dim = channel * kernel_sdim - kernel = tf.get_variable('weights', shape=[int(data.shape[1]), dim], dtype=tf.float32, - initializer=tf.contrib.layers.xavier_initializer()) + kernel = tf.get_variable('weights', shape=[int(data.shape[1]), dim], dtype=tf.float32, + initializer=tf.contrib.layers.xavier_initializer()) if stride == 2: data = octree_depad(data, octree, depth) depth = depth + 1 @@ -233,14 +254,14 @@ def octree_deconv_fast(data, octree, depth, channel, kernel_size=[3], stride=1): def octree_deconv_memory(data, octree, depth, channel, kernel_size=[3], stride=1): assert(type(kernel_size) is list and len(kernel_size) < 4) - for i in range(len(kernel_size), 3): + for i in range(len(kernel_size), 3): kernel_size.append(kernel_size[-1]) - with tf.variable_scope('octree_deconv'): + with tf.variable_scope('octree_deconv'): kernel_sdim = kernel_size[0] * kernel_size[1] * kernel_size[2] dim = channel * kernel_sdim - kernel = tf.get_variable('weights', shape=[int(data.shape[1]), dim], dtype=tf.float32, - initializer=tf.contrib.layers.xavier_initializer()) + kernel = tf.get_variable('weights', shape=[int(data.shape[1]), dim], dtype=tf.float32, + initializer=tf.contrib.layers.xavier_initializer()) if stride == 2: data = octree_depad(data, octree, depth) deconv = _octree_deconv(data, kernel, octree, depth, channel, kernel_size, stride) @@ -250,7 +271,7 @@ def octree_deconv_memory(data, octree, depth, channel, kernel_size=[3], stride=1 def octree_full_voxel(data, depth): height = 2 ** (3 * depth) channel = int(data.shape[1]) - with tf.variable_scope('octree_full_voxel'): + with tf.variable_scope('octree_full_voxel'): data = tf.reshape(data, [channel, -1, height]) # (1, C, H, 1) -> (C, batch_size, H1) data = tf.transpose(data, perm=[1, 0, 2]) return data @@ -300,12 +321,12 @@ def octree_bilinear_legacy(data, octree, depth, target_depth): def octree_bilinear_v1(pts, data, octree, depth): with tf.variable_scope('octree_bilinear'): mask = tf.constant( - [[0, 0, 0], [0, 0, 1], [0, 1, 0], [0, 1, 1], - [1, 0, 0], [1, 0, 1], [1, 1, 0], [1, 1, 1]], dtype=tf.float32) - - xyzf, ids = tf.split(pts, [3, 1], 1) + [[0, 0, 0], [0, 0, 1], [0, 1, 0], [0, 1, 1], + [1, 0, 0], [1, 0, 1], [1, 1, 0], [1, 1, 1]], dtype=tf.float32) + + xyzf, ids = tf.split(pts, [3, 1], 1) xyzf = xyzf - 0.5 # since the value is defined on the center of each voxel - xyzi = tf.floor(xyzf) # the integer part + xyzi = tf.floor(xyzf) # the integer part frac = xyzf - xyzi # the fraction part feat = tf.transpose(tf.squeeze(data, [0, 3])) # (1, C, H, 1) -> (H, C) @@ -316,14 +337,14 @@ def octree_bilinear_v1(pts, data, octree, depth): maski = mask[i, :] maskc = 1.0 - maski xyzm = xyzi + maski - xyzm = tf.cast(tf.concat([xyzm, ids], axis=1), dtype=tf.uint8) + xyzm = tf.cast(tf.concat([xyzm, ids], axis=1), dtype=tf_uints) idxi = octree_search_key(octree_encode_key(xyzm), octree, depth, is_xyz=True) - + weight = tf.abs(tf.reduce_prod(maskc - frac, axis=1, keepdims=True)) - output += weight * tf.gather(feat, idxi) - norm += weight * tf.expand_dims(tf.cast(idxi > -1, dtype=tf.float32), -1) + output += weight * tf.gather(feat, idxi) + norm += weight * tf.expand_dims(tf.cast(idxi > -1, dtype=tf.float32), -1) output = tf.div(output, norm) - + output = tf.expand_dims(tf.expand_dims(tf.transpose(output), 0), -1) frac = tf.expand_dims(tf.expand_dims(tf.transpose(frac), 0), -1) @@ -334,14 +355,14 @@ def octree_bilinear_v1(pts, data, octree, depth): def octree_bilinear_v2(pts, data, octree, depth): with tf.variable_scope('octree_bilinear'): mask = tf.constant( - [[0, 0, 0], [0, 0, 1], [0, 1, 0], [0, 1, 1], - [1, 0, 0], [1, 0, 1], [1, 1, 0], [1, 1, 1]], dtype=tf.float32) - - xyzf, ids = tf.split(pts, [3, 1], 1) + [[0, 0, 0], [0, 0, 1], [0, 1, 0], [0, 1, 1], + [1, 0, 0], [1, 0, 1], [1, 1, 0], [1, 1, 1]], dtype=tf.float32) + + xyzf, ids = tf.split(pts, [3, 1], 1) xyzf = xyzf - 0.5 # since the value is defined on the center of each voxel - xyzi = tf.floor(xyzf) # the integer part + xyzi = tf.floor(xyzf) # the integer part frac = xyzf - xyzi # the fraction part - + output = tf.zeros([1, tf.shape(data)[1], tf.shape(xyzi)[0], 1], dtype=tf.float32) norm = tf.zeros([tf.shape(xyzi)[0], 1], dtype=tf.float32) @@ -349,60 +370,66 @@ def octree_bilinear_v2(pts, data, octree, depth): maski = mask[i, :] maskc = 1.0 - maski xyzm = xyzi + maski - xyzm = tf.cast(tf.concat([xyzm, ids], axis=1), dtype=tf.uint8) + xyzm = tf.cast(tf.concat([xyzm, ids], axis=1), dtype=tf_uints) # !!! Note some elements of idxi may be -1 idxi = octree_search_key(octree_encode_key(xyzm), octree, depth, is_xyz=True) - + weight = tf.abs(tf.reduce_prod(maskc - frac, axis=1, keepdims=True)) - # output += weight * tf.gather(data, idxi, axis=2) + # output += weight * tf.gather(data, idxi, axis=2) output += weight * octree_gather(data, idxi) norm += weight * tf.expand_dims(tf.cast(idxi > -1, dtype=tf.float32), -1) - output = tf.div(output, norm) + output = tf.div(output, norm) return output -# pts: (N, 4), i.e. N x (x, y, z, id). +# pts: (N, 4), i.e. N x (x, y, z, id). # data: (1, C, H, 1) # !!! Note: the pts should be scaled into [0, 2^depth] def octree_bilinear_v3(pts, data, octree, depth): with tf.variable_scope('octree_linear'): mask = tf.constant( - [[0, 0, 0], [0, 0, 1], [0, 1, 0], [0, 1, 1], + [[0, 0, 0], [0, 0, 1], [0, 1, 0], [0, 1, 1], [1, 0, 0], [1, 0, 1], [1, 1, 0], [1, 1, 1]], dtype=tf.float32) - masku = tf.constant([0, 65536, 256, 65792, 1, 65537, 257, 65793], dtype=tf.int32) + if octree_key64: + masku = tf.constant([0, 4294967296, 65536, 4295032832, + 1, 4294967297, 65537, 4295032833], dtype=tf.int64) + else: + masku = tf.constant([0, 65536, 256, 65792, + 1, 65537, 257, 65793], dtype=tf.int32) + maskc = 1 - mask - - xyzf, ids = tf.split(pts, [3, 1], 1) + + xyzf, ids = tf.split(pts, [3, 1], 1) xyzf = xyzf - 0.5 # since the value is defined on the center of each voxel xyzi = tf.floor(xyzf) # the integer part (N, 3) frac = xyzf - xyzi # the fraction part (N, 3) - - key = tf.cast(tf.concat([xyzi, ids], axis=1), dtype=tf.uint8) - key = tf.cast(octree_encode_key(key), dtype=tf.int32) - # Cast the key to `int32` since the `add` below does not support `uint32` + + key = tf.cast(tf.concat([xyzi, ids], axis=1), dtype=tf_uints) + key = tf.cast(octree_encode_key(key), dtype=tf_intk) + # Cast the key to `int32` since the `add` below does not support `uint64` # The size effect is that the batch_size must be smaller than 128 - key = tf.expand_dims(key, 1) + masku # (N, 8), - key = tf.cast(tf.reshape(key, [-1]), dtype=tf.uint32) - + key = tf.expand_dims(key, 1) + masku # (N, 8), + key = tf.cast(tf.reshape(key, [-1]), dtype=tf_uintk) + idx = octree_search_key(key, octree, depth) # (N*8,) flgs = idx > -1 # filtering flags idx = tf.boolean_mask(idx, flgs) - + npt = tf.shape(xyzi)[0] ids = tf.reshape(tf.range(npt), [-1, 1]) - ids = tf.reshape(tf.tile(ids, [1, 8]), [-1]) # (N*8,) + ids = tf.reshape(tf.tile(ids, [1, 8]), [-1]) # (N*8,) ids = tf.boolean_mask(ids, flgs) frac = maskc - tf.expand_dims(frac, axis=1) weight = tf.abs(tf.reshape(tf.reduce_prod(frac, axis=2), [-1])) weight = tf.boolean_mask(weight, flgs) - indices = tf.concat([tf.expand_dims(ids, 1), tf.expand_dims(idx, 1)], 1) + indices = tf.concat([tf.expand_dims(ids, 1), tf.expand_dims(idx, 1)], 1) indices = tf.cast(indices, tf.int64) data = tf.squeeze(data, [0, 3]) # (C, H) h = tf.shape(data)[1] mat = tf.SparseTensor(indices=indices, values=weight, dense_shape=[npt, h]) - + # channel, max_channel = int(data.shape[0]), 512 # if channel > max_channel: # num = channel // max_channel @@ -431,16 +458,17 @@ def octree_bilinear_v3(pts, data, octree, depth): def octree_bilinear(data, octree, depth, target_depth, mask=None): with tf.name_scope('Octree_bilinear'): xyz = octree_property(octree, property_name='xyz', depth=target_depth, - channel=1, dtype=tf.uint32) + channel=1, dtype=tf_uintk) xyz = tf.reshape(xyz, [-1]) - if mask is not None: xyz = tf.boolean_mask(xyz, mask) + if mask is not None: + xyz = tf.boolean_mask(xyz, mask) xyz = tf.cast(octree_decode_key(xyz), dtype=tf.float32) - - # Attention: displacement 0.5, scale + + # Attention: displacement 0.5, scale scale = 2.0**(depth-target_depth) xyz += tf.constant([0.5, 0.5, 0.5, 0.0], dtype=tf.float32) xyz *= tf.constant([scale, scale, scale, 1.0], dtype=tf.float32) - + output = octree_bilinear_v3(xyz, data, octree, depth) return output @@ -450,16 +478,51 @@ def octree_bilinear(data, octree, depth, target_depth, mask=None): def octree_nearest_interp(pts, data, octree, depth): with tf.variable_scope('octree_nearest_interp'): # The value is defined on the center of each voxel, - # so we can get the closest grid point by simply casting the value to uint8 - pts = tf.cast(pts, dtype=tf.uint8) + # so we can get the closest grid point by simply casting the value to tf_uints + pts = tf.cast(pts, dtype=tf_uints) key = tf.reshape(octree_encode_key(pts), [-1]) idx = octree_search_key(key, octree, depth) # !!! Note that some of idx may be -1 or over-bound - # Use tf.gather may be problematic with some version of tensorflow - # according to my experiments. So I implemented octree_gather to - # replace the original tf.gather. If you encounter errors, please + # Use tf.gather may be problematic with some version of tensorflow + # according to my experiments. So I implemented octree_gather to + # replace the original tf.gather. If you encounter errors, please # use the octree_gather # output = tf.gather(data, idx, axis=2) output = octree_gather(data, idx) return output + + + +def octree_signal(octree, depth, channel): + with tf.name_scope('octree_signal'): + signal = octree_property(octree, property_name='feature', dtype=tf.float32, + depth=depth, channel=channel) + signal = tf.reshape(signal, [1, channel, -1, 1]) + return signal + + +def octree_xyz(octree, depth, decode=True): + with tf.name_scope('octree_xyz'): + xyz = octree_property(octree, property_name='xyz', dtype=tf_uintk, + depth=depth, channel=1) + xyz = tf.reshape(xyz, [-1]) # uint32, N + if decode: + xyz = octree_decode_key(xyz) # uint8, Nx4 + return xyz + + +def octree_child(octree, depth): + with tf.name_scope('octree_child'): + child = octree_property(octree, property_name='child', dtype=tf.int32, + depth=depth, channel=1) + child = tf.reshape(child, [-1]) + return child + + +def octree_split(octree, depth): + with tf.name_scope('octree_split'): + split = octree_property(octree, property_name='split', dtype=tf.float32, + depth=depth, channel=1) + split = tf.reshape(split, [-1]) + return split \ No newline at end of file diff --git a/tensorflow/libs/build.py b/tensorflow/libs/build.py index 20862ff..ede055a 100644 --- a/tensorflow/libs/build.py +++ b/tensorflow/libs/build.py @@ -2,15 +2,26 @@ import sys import tensorflow as tf import subprocess +import argparse -OCTREE_DIR = '../../octree' -CUDA_DIR = '/usr/local/cuda-10.1' -if len(sys.argv) > 1: OCTREE_DIR = sys.argv[1] -if len(sys.argv) > 2: CUDA_DIR = sys.argv[2] +parser = argparse.ArgumentParser() +parser.add_argument("--octree", type=str, required=False, + default='../../octree') +parser.add_argument("--cuda", type=str, required=False, + default='/usr/local/cuda-10.1') +parser.add_argument('--key64', type=str, required=False, + default='false') +parser.add_argument('--cc', type=str, required=False, + default='g++') +args = parser.parse_args() +OCTREE_DIR = args.octree +CUDA_DIR = args.cuda +CC = args.cc +KEY64 = '-DKEY64' if args.key64.lower() == 'true' else '' -lines = [] +lines = [] TF_CFLAGS = " ".join(tf.sysconfig.get_compile_flags()) TF_LFLAGS = " ".join(tf.sysconfig.get_link_flags()) lines.append("TF_CFLAGS := %s" % TF_CFLAGS) @@ -20,12 +31,16 @@ lines.append("") lines.append("NVCC_FLAGS1 := -std=c++11 -O2 -c") -lines.append("NVCC_FLAGS2 := $(TF_CFLAGS) $(OCT_CFLAGS) -I %s/include -x cu -Xcompiler -fPIC -D GOOGLE_CUDA=1 -I /usr/local -expt-relaxed-constexpr -DNDEBUG" % CUDA_DIR) +lines.append("NVCC_FLAGS2 := $(TF_CFLAGS) $(OCT_CFLAGS) -I %s/include " \ + "-x cu -Xcompiler -fPIC -D GOOGLE_CUDA=1 -I /usr/local " \ + "-expt-relaxed-constexpr -DNDEBUG %s" % (CUDA_DIR, KEY64)) lines.append("CC_FLAGS1 := -std=c++11 -O2") -lines.append("CC_FLAGS2 := $(TF_CFLAGS) $(OCT_CFLAGS) -I %s/include -L %s/lib64 -D GOOGLE_CUDA=1 $(TF_LFLAGS) $(OCT_LFLAGS) -fPIC -lcudart" % (CUDA_DIR, CUDA_DIR)) +lines.append("CC_FLAGS2 := $(TF_CFLAGS) $(OCT_CFLAGS) -I %s/include " \ + "-L %s/lib64 -D GOOGLE_CUDA=1 $(TF_LFLAGS) $(OCT_LFLAGS) " \ + "-fPIC -lcudart %s" % (CUDA_DIR, CUDA_DIR, KEY64)) lines.append("") -lines.append("CC := g++") +lines.append("CC := %s" % CC) lines.append("NVCC := %s/bin/nvcc" % CUDA_DIR) lines.append("") @@ -35,16 +50,16 @@ gpu_sources = [] all_headers = [] for filename in sorted(os.listdir(".")): - if filename.endswith(".cu.cc") or filename.endswith(".cu"): - targetname = filename + ".o" - gpu_sources.append(filename) - gpu_objects.append(os.path.join("object", targetname)) - elif filename.endswith(".cc") or filename.endswith(".cpp"): - targetname = filename + ".o" - cpu_sources.append(filename) - cpu_objects.append(os.path.join("object", targetname)) - elif filename.endswith(".h"): - all_headers.append(filename) + if filename.endswith(".cu.cc") or filename.endswith(".cu"): + targetname = filename + ".o" + gpu_sources.append(filename) + gpu_objects.append(os.path.join("object", targetname)) + elif filename.endswith(".cc") or filename.endswith(".cpp"): + targetname = filename + ".o" + cpu_sources.append(filename) + cpu_objects.append(os.path.join("object", targetname)) + elif filename.endswith(".h"): + all_headers.append(filename) lines.append("cpu_objects := %s" % " ".join(cpu_objects)) lines.append("gpu_objects := %s" % " ".join(gpu_objects)) @@ -60,27 +75,38 @@ lines.append("\t$(CC) $(CC_FLAGS1) -shared -o libocnn.so object/*.o $(CC_FLAGS2)") lines.append("") + for i in range(len(cpu_objects)): - dependency = b" ".join(subprocess.Popen("g++ -std=c++11 -MM -MG %s" % cpu_sources[i], stdin=subprocess.PIPE, stdout=subprocess.PIPE, shell=True).stdout.readlines()).decode("utf-8") - headers = [] - for h in all_headers: - if dependency.find(h) > 0: - headers.append(h) - headers = " ".join(headers) - lines.append("%s : %s %s" % (cpu_objects[i], headers, cpu_sources[i])) - lines.append("\t$(CC) $(CC_FLAGS1) -c %s $(CC_FLAGS2) -o %s" % (cpu_sources[i], cpu_objects[i])) - lines.append("") + dependency = b" ".join( + subprocess.Popen("%s -std=c++11 -MM -MG %s" % (CC, cpu_sources[i]), + stdin=subprocess.PIPE, + stdout=subprocess.PIPE, + shell=True).stdout.readlines()).decode("utf-8") + headers = [] + for h in all_headers: + if dependency.find(h) > 0: + headers.append(h) + headers = " ".join(headers) + lines.append("%s : %s %s" % (cpu_objects[i], headers, cpu_sources[i])) + lines.append("\t$(CC) $(CC_FLAGS1) -c %s $(CC_FLAGS2) -o %s" % \ + (cpu_sources[i], cpu_objects[i])) + lines.append("") for i in range(len(gpu_objects)): - dependency = b" ".join(subprocess.Popen("g++ -std=c++11 -MM -MG %s" % gpu_sources[i], stdin=subprocess.PIPE, stdout=subprocess.PIPE, shell=True).stdout.readlines()).decode("utf-8") - headers = [] - for h in all_headers: - if dependency.find(h) > 0: - headers.append(h) - headers = " ".join(headers) - lines.append("%s : %s %s" % (gpu_objects[i], headers, gpu_sources[i])) - lines.append("\t$(NVCC) $(NVCC_FLAGS1) %s $(NVCC_FLAGS2) -o %s" % (gpu_sources[i], gpu_objects[i])) - lines.append("") + dependency = b" ".join( + subprocess.Popen("%s -std=c++11 -MM -MG %s" % (CC, gpu_sources[i]), + stdin=subprocess.PIPE, + stdout=subprocess.PIPE, + shell=True).stdout.readlines()).decode("utf-8") + headers = [] + for h in all_headers: + if dependency.find(h) > 0: + headers.append(h) + headers = " ".join(headers) + lines.append("%s : %s %s" % (gpu_objects[i], headers, gpu_sources[i])) + lines.append("\t$(NVCC) $(NVCC_FLAGS1) %s $(NVCC_FLAGS2) -o %s" % \ + (gpu_sources[i], gpu_objects[i])) + lines.append("") lines.append("clean :") lines.append("\t rm %s" % os.path.join("object", "*.o")) @@ -89,8 +115,8 @@ lines = [line + "\n" for line in lines] with open("Makefile", "w") as f: - f.writelines(lines) + f.writelines(lines) if not os.path.exists("object"): - os.mkdir("object") + os.mkdir("object") os.system("make -j all") diff --git a/tensorflow/libs/octree2col_op.cc b/tensorflow/libs/octree2col_op.cc index a079682..b1da354 100644 --- a/tensorflow/libs/octree2col_op.cc +++ b/tensorflow/libs/octree2col_op.cc @@ -62,8 +62,6 @@ class Octree2ColBase : public OpKernel { vector& ni_cpu = NeighHelper::Get().get_ni(kernel_size_); int count = ni_cpu.size(); OP_REQUIRES_OK(ctx, ctx->allocate_temp(DT_INT32, TensorShape({ count }), &ni_gpu)); - // int* ni_ptr = ni_gpu.flat().data(); - // cudaMemcpy(ni_ptr, ni_cpu.data(), sizeof(int) * count, cudaMemcpyHostToDevice); memcpy_gpu(count, ni_cpu.data(), ni_gpu.flat().data()); } diff --git a/tensorflow/libs/octree_align_op.cc b/tensorflow/libs/octree_align_op.cc index a9b151c..66f9af3 100644 --- a/tensorflow/libs/octree_align_op.cc +++ b/tensorflow/libs/octree_align_op.cc @@ -1,4 +1,3 @@ -#include #include #include #include @@ -57,17 +56,17 @@ class OctreeAlignOp : public OpKernel { CHECK_EQ(src_octree.info().node_num(curr_depth_), src_h); // get key - const uint32* src_key = src_octree.key_gpu(curr_depth_); + const uintk* src_key = src_octree.key_gpu(curr_depth_); Tensor src_key_tensor; if (src_octree.info().is_key2xyz()) { xyz2key_gpu_op(context, &src_key_tensor, src_key, src_h, curr_depth_); - src_key = src_key_tensor.flat().data(); + src_key = src_key_tensor.flat().data(); } - const uint32* des_key = des_octree.key_gpu(curr_depth_); + const uintk* des_key = des_octree.key_gpu(curr_depth_); Tensor des_key_tensor; if (des_octree.info().is_key2xyz()) { xyz2key_gpu_op(context, &des_key_tensor, des_key, des_h, curr_depth_); - des_key = des_key_tensor.flat().data(); + des_key = des_key_tensor.flat().data(); } // binary search @@ -89,10 +88,11 @@ class OctreeAlignOp : public OpKernel { protected: void xyz2key_gpu_op(OpKernelContext* context, Tensor* key_tensor, - const uint32* xyz, const int num, const int depth) { - OP_REQUIRES_OK(context, context->allocate_temp( - DT_UINT32, TensorShape({num}), key_tensor)); - auto ptr = key_tensor->flat().data(); + const uintk* xyz, const int num, const int depth) { + auto dtype = std::is_same::value ? DT_UINT32 : DT_UINT64; + OP_REQUIRES_OK( + context, context->allocate_temp(dtype, TensorShape({num}), key_tensor)); + auto ptr = key_tensor->flat().data(); xyz2key_gpu(ptr, xyz, num, depth); } diff --git a/tensorflow/libs/octree_batch_op.cc b/tensorflow/libs/octree_batch_op.cc index d424180..d5f840c 100644 --- a/tensorflow/libs/octree_batch_op.cc +++ b/tensorflow/libs/octree_batch_op.cc @@ -27,9 +27,9 @@ class OctreeBatchOp : public OpKernel { const Tensor& data_in = context->input(0); auto octree_buffer = data_in.flat(); // int batch_size = data_in.shape().dim_size(0); - int batch_size = data_in.shape().num_elements(); + int batch_size = data_in.shape().num_elements(); // qq: TODO: long? vector octrees_in; - for (int i = 0; i < batch_size; ++i) { + for (int i = 0; i < batch_size; ++i) { // qq: TODO: long? octrees_in.push_back(octree_buffer(i).data()); } diff --git a/tensorflow/libs/octree_bilinear_op.cc b/tensorflow/libs/octree_bilinear_op.cc index 8ec89c7..2f096e0 100644 --- a/tensorflow/libs/octree_bilinear_op.cc +++ b/tensorflow/libs/octree_bilinear_op.cc @@ -1,10 +1,10 @@ -#include "octree_nn.h" -#include "octree_parser.h" - #include #include #include +#include "octree_nn.h" +#include "octree_parser.h" + namespace tensorflow { REGISTER_OP("OctreeBilinear") @@ -14,21 +14,20 @@ REGISTER_OP("OctreeBilinear") .Output("index: int32") .Output("fracs: float") .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { - c->set_output(0, c->MakeShape({ c->UnknownDim(), 8 })); - c->set_output(1, c->MakeShape({ c->UnknownDim(), 3 })); + c->set_output(0, c->MakeShape({c->UnknownDim(), 8})); + c->set_output(1, c->MakeShape({c->UnknownDim(), 3})); return Status::OK(); }) .Doc(R"doc(Octree bilinear operator.)doc"); - class OctreeBilinearOp : public OpKernel { public: explicit OctreeBilinearOp(OpKernelConstruction* context) : OpKernel(context) { OP_REQUIRES_OK(context, context->GetAttr("curr_depth", &curr_depth_)); OP_REQUIRES_OK(context, context->GetAttr("target_depth", &target_depth_)); - CHECK_GT(curr_depth_, 0) - << "The curr_depth should be larger than 0"; - CHECK_GT(target_depth_, curr_depth_) + CHECK_GT(curr_depth_, 0) + << "The curr_depth should be larger than 0"; + CHECK_GT(target_depth_, curr_depth_) << "The target_depth should be larger than curr_depth"; } @@ -42,41 +41,41 @@ class OctreeBilinearOp : public OpKernel { // get key & xyz Tensor src_buffer; int src_h = octree_.info().node_num(curr_depth_); - const uint32* src_key = octree_.key_gpu(curr_depth_); + const uintk* src_key = octree_.key_gpu(curr_depth_); if (octree_.info().is_key2xyz()) { xyz2key_gpu_op(context, &src_buffer, src_key, src_h, curr_depth_); - src_key = src_buffer.flat().data(); + src_key = src_buffer.flat().data(); } Tensor des_buffer; int des_h = octree_.info().node_num(target_depth_); - const uint32* des_xyz = octree_.key_gpu(target_depth_); + const uintk* des_xyz = octree_.key_gpu(target_depth_); if (!octree_.info().is_key2xyz()) { key2xyz_gpu_op(context, &des_buffer, des_xyz, des_h, target_depth_); - des_xyz = des_buffer.flat().data(); + des_xyz = des_buffer.flat().data(); } // out data Tensor* idx_tensor = nullptr; - TensorShape idx_shape({ des_h, 8}); + TensorShape idx_shape({des_h, 8}); OP_REQUIRES_OK(context, context->allocate_output(0, idx_shape, &idx_tensor)); auto idx_ptr = idx_tensor->flat().data(); - + Tensor* frac_tensor = nullptr; - TensorShape frac_shape({ des_h, 3}); + TensorShape frac_shape({des_h, 3}); OP_REQUIRES_OK(context, context->allocate_output(1, frac_shape, &frac_tensor)); auto frac_ptr = frac_tensor->flat().data(); // calc bilinear xyz Tensor buf_xyz; - TensorShape rst_shape({ des_h, 8}); - OP_REQUIRES_OK(context, context->allocate_temp(DT_UINT32, rst_shape, &buf_xyz)); - auto rst_xyz = buf_xyz.flat().data(); + TensorShape rst_shape({des_h, 8}); + OP_REQUIRES_OK(context, context->allocate_temp(get_dtype(), rst_shape, &buf_xyz)); + auto rst_xyz = buf_xyz.flat().data(); bilinear_xyz_gpu(rst_xyz, frac_ptr, curr_depth_, des_xyz, target_depth_, des_h); - Tensor buf_key; + Tensor buf_key; xyz2key_gpu_op(context, &buf_key, rst_xyz, des_h * 8, target_depth_); - auto rst_key = buf_key.flat().data(); + auto rst_key = buf_key.flat().data(); // binary search search_key_gpu(idx_ptr, src_key, src_h, rst_key, des_h * 8); @@ -84,28 +83,28 @@ class OctreeBilinearOp : public OpKernel { protected: void xyz2key_gpu_op(OpKernelContext* context, Tensor* key_tensor, - const uint32* xyz, const int num, const int depth) { - OP_REQUIRES_OK(context, - context->allocate_temp(DT_UINT32, TensorShape({ num }), key_tensor)); - auto ptr = key_tensor->flat().data(); + const uintk* xyz, const int num, const int depth) { + OP_REQUIRES_OK(context, + context->allocate_temp(get_dtype(), TensorShape({num}), key_tensor)); + auto ptr = key_tensor->flat().data(); xyz2key_gpu(ptr, xyz, num, depth); } void key2xyz_gpu_op(OpKernelContext* context, Tensor* xyz_tensor, - const uint32* key, const int num, const int depth) { - OP_REQUIRES_OK(context, - context->allocate_temp(DT_UINT32, TensorShape({ num }), xyz_tensor)); - auto ptr = xyz_tensor->flat().data(); + const uintk* key, const int num, const int depth) { + OP_REQUIRES_OK(context, + context->allocate_temp(get_dtype(), TensorShape({num}), xyz_tensor)); + auto ptr = xyz_tensor->flat().data(); key2xyz_gpu(ptr, key, num, depth); } + DataType get_dtype() { return sizeof(uintk) == 4 ? DT_UINT32 : DT_UINT64; } private: int curr_depth_; int target_depth_; }; - REGISTER_KERNEL_BUILDER(Name("OctreeBilinear").Device(DEVICE_GPU), OctreeBilinearOp); } // namespace tensorflow diff --git a/tensorflow/libs/octree_conv_op.cc b/tensorflow/libs/octree_conv_op.cc index 24bbfa3..897db1f 100644 --- a/tensorflow/libs/octree_conv_op.cc +++ b/tensorflow/libs/octree_conv_op.cc @@ -119,7 +119,7 @@ class OctreeConvTF : public OpKernel, public OctreeBaseConv { Tensor* data_buffer, Tensor* result_buffer, Tensor* ni_gpu) { OctreeBaseConv::reshape(); - int count = num_elements(this->workspace_shape_); + int count = num_elements(this->workspace_shape_); // qq: TODO: long? OP_REQUIRES_OK(ctx, ctx->allocate_temp(DT_FLOAT, TensorShape({ count }), workspace)); this->workspace_ = workspace->flat().data(); diff --git a/tensorflow/libs/octree_grow_op.cc b/tensorflow/libs/octree_grow_op.cc deleted file mode 100644 index 168075a..0000000 --- a/tensorflow/libs/octree_grow_op.cc +++ /dev/null @@ -1,140 +0,0 @@ -#include "octree_nn.h" -#include "octree_parser.h" - -#include -#include -#include -#include - -namespace tensorflow { - -REGISTER_OP("OctreeGrow") - .Input("in_octree: int8") - .Attr("target_depth: int") - .Attr("full_octree: bool = false") - .Output("out_octree: int8") - .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { - c->set_output(0, c->MakeShape({ c->UnknownDim() })); - return Status::OK(); - }) - .Doc(R"doc(Octree grow operator.)doc"); - - -class OctreeGrowOp : public OpKernel { - public: - explicit OctreeGrowOp(OpKernelConstruction* context) : OpKernel(context) { - OP_REQUIRES_OK(context, context->GetAttr("target_depth", &target_depth_)); - OP_REQUIRES_OK(context, context->GetAttr("full_octree", &full_octree_)); - } - - void Compute(OpKernelContext* context) override { - // in octree - OctreeParser octree_in; - octree_in.set_gpu(context->input(0).flat().data()); - - // out info - batch_size_ = octree_in.info().batch_size(); - node_num_ = octree_in.info().node_num_nempty(target_depth_ - 1) << 3; - OctreeInfo oct_info_; - oct_info_ = octree_in.info(); - update_octreeinfo(oct_info_); - - // out octree - Tensor* tensor_out = nullptr; - TensorShape shape_out({ oct_info_.sizeof_octree() }); - OP_REQUIRES_OK(context, context->allocate_output(0, shape_out, &tensor_out)); - auto* ptr_out = tensor_out->flat().data(); - // memset_gpu(tensor_out->NumElements(), 0, ptr_out); - cudaMemset(ptr_out, 0, tensor_out->NumElements()); - - // copy octree - OctreeParser octree_out; - octree_out.set_gpu(ptr_out, &oct_info_); - copy_octree_gpu(octree_out, octree_in); - - // grow octree - if (full_octree_) { - calc_neigh_gpu(octree_out.mutable_neighbor_gpu(target_depth_), - target_depth_, batch_size_); - generate_key_gpu(octree_out.mutable_key_gpu(target_depth_), - target_depth_, batch_size_); - sequence_gpu(octree_out.mutable_children_gpu(target_depth_), node_num_); - } else { - Tensor displacement, parent; - init_neigh_ptrs(context, parent, displacement); - const int* label_ptr = octree_out.children_gpu(target_depth_ - 1); - calc_neigh_gpu(octree_out.mutable_neighbor_gpu(target_depth_), - octree_out.neighbor_gpu(target_depth_ - 1), label_ptr, - octree_out.info().node_num(target_depth_ - 1), ptr_parent_, ptr_dis_); - generate_key_gpu(octree_out.mutable_key_gpu(target_depth_), - octree_out.key_gpu(target_depth_ - 1), label_ptr, - octree_out.info().node_num(target_depth_ - 1)); - sequence_gpu(octree_out.mutable_children_gpu(target_depth_), node_num_); - } - } - - private: - void update_octreeinfo(OctreeInfo& oct_info_) { - oct_info_.set_depth(target_depth_); - if (full_octree_) { - oct_info_.set_full_layer(target_depth_); - } - float width = 1 << target_depth_; - float bbmin[] = { 0, 0, 0 }; - float bbmax[] = { width, width, width }; - oct_info_.set_bbox(bbmin, bbmax); - oct_info_.set_nnum(target_depth_, node_num_); - // Just set the non-empty node number as node_num_, - // it needs to be updated by the new node-splitting label - oct_info_.set_nempty(target_depth_, node_num_); - oct_info_.set_nnum_cum(); - oct_info_.set_ptr_dis(); - } - - // todo: replace the cudaMemcpy with the wrapper function memcpy_gpu - - void copy_octree_gpu(OctreeParser& octree_out, const OctreeParser& octree_in) { - int node_num_cum = octree_in.info().node_num_cum(target_depth_); - int key_channel = octree_in.info().channel(OctreeInfo::kKey); - int child_channel = octree_in.info().channel(OctreeInfo::kChild); - int neigh_channel = octree_in.info().channel(OctreeInfo::kNeigh); - int feature_channel = octree_in.info().channel(OctreeInfo::kFeature); - cudaMemcpy(octree_out.mutable_key_gpu(0), octree_in.key_gpu(0), - key_channel * node_num_cum * sizeof(int), cudaMemcpyDeviceToDevice); - cudaMemcpy(octree_out.mutable_children_gpu(0), octree_in.children_gpu(0), - child_channel * node_num_cum * sizeof(int), cudaMemcpyDeviceToDevice); - cudaMemcpy(octree_out.mutable_neighbor_gpu(0), octree_in.neighbor_gpu(0), - neigh_channel * node_num_cum * sizeof(int), cudaMemcpyDeviceToDevice); - cudaMemcpy(octree_out.mutable_feature_gpu(0), octree_in.feature_gpu(0), - feature_channel * node_num_cum * sizeof(float), cudaMemcpyDeviceToDevice); - } - - void init_neigh_ptrs(OpKernelContext* ctx, Tensor& parent, Tensor& dis) { - const vector& dis_cpu = NeighHelper::Get().get_dis_array(); - TensorShape dshape({ (long long int) dis_cpu.size() }); - OP_REQUIRES_OK(ctx, ctx->allocate_temp(DT_INT32, dshape, &dis)); - ptr_dis_ = dis.flat().data(); - cudaMemcpy(ptr_dis_, dis_cpu.data(), dis_cpu.size() * sizeof(int), - cudaMemcpyHostToDevice); - - const vector& parent_cpu = NeighHelper::Get().get_parent_array(); - TensorShape pshape({ (long long int) parent_cpu.size() }); - OP_REQUIRES_OK(ctx, ctx->allocate_temp(DT_INT32, pshape, &parent)); - ptr_parent_ = parent.flat().data(); - cudaMemcpy(ptr_parent_, parent_cpu.data(), parent_cpu.size() * sizeof(int), - cudaMemcpyHostToDevice); - } - - private: - int batch_size_; - int target_depth_; - int node_num_; - bool full_octree_; - int* ptr_parent_; - int* ptr_dis_; -}; - - -REGISTER_KERNEL_BUILDER(Name("OctreeGrow").Device(DEVICE_GPU), OctreeGrowOp); - -} // namespace tensorflow diff --git a/tensorflow/libs/octree_key_op.cc b/tensorflow/libs/octree_key_op.cc index 53e17e0..6dd7b9c 100644 --- a/tensorflow/libs/octree_key_op.cc +++ b/tensorflow/libs/octree_key_op.cc @@ -1,35 +1,48 @@ -#include "octree_nn.h" -#include "octree_parser.h" - #include #include #include #include +#include +#include "octree_nn.h" +#include "octree_parser.h" + namespace tensorflow { +inline string uintk_modifier(string str) { + string dtype = std::is_same::value ? "uint32" : "uint64"; + size_t pos = str.find("uintk"); + return str.replace(pos, 5, dtype); +} + +inline string uints_modifier(string str) { + string dtype = std::is_same::value ? "uint8" : "uint16"; + size_t pos = str.find("uints"); + return str.replace(pos, 5, dtype); +} + REGISTER_OP("OctreeEncodeKey") - .Input("xyz: uint8") - .Output("key: uint32") + .Input(uints_modifier("xyz: uints")) + .Output(uintk_modifier("key: uintk")) .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { c->set_output(0, c->MakeShape({c->Dim(c->input(0), 0)})); return Status::OK(); }) - .Doc(R"doc(Encode the (x, y, z, id) to key in uint32)")doc"); + .Doc(R"doc(Encode the (x, y, z, id) to key in uintk)")doc"); REGISTER_OP("OctreeDecodeKey") - .Input("key: uint32") - .Output("xyz: uint8") + .Input(uintk_modifier("key: uintk")) + .Output(uints_modifier("xyz: uints")) .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { c->set_output(0, c->MakeShape({c->Dim(c->input(0), 0), 4})); return Status::OK(); }) - .Doc(R"doc(Decode the key to (x, y, z, id) in uint8)")doc"); + .Doc(R"doc(Decode the key to (x, y, z, id) in uints)")doc"); REGISTER_OP("OctreeKeyToXyz") - .Input("key: uint32") + .Input(uintk_modifier("key: uintk")) .Attr("depth: int = 8") - .Output("xyz: uint32") + .Output(uintk_modifier("xyz: uintk")) .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { c->set_output(0, c->input(0)); return Status::OK(); @@ -37,9 +50,9 @@ REGISTER_OP("OctreeKeyToXyz") .Doc(R"doc(Convert the key to xyz)")doc"); REGISTER_OP("OctreeXyzToKey") - .Input("xyz: uint32") + .Input(uintk_modifier("xyz: uintk")) .Attr("depth: int = 8") - .Output("key: uint32") + .Output(uintk_modifier("key: uintk")) .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { c->set_output(0, c->input(0)); return Status::OK(); @@ -47,27 +60,28 @@ REGISTER_OP("OctreeXyzToKey") .Doc(R"doc(Convert the xyz to key)")doc"); REGISTER_OP("OctreeSearchKey") - .Input("key: uint32") + .Input(uintk_modifier("key: uintk")) .Input("octree: int8") .Attr("depth: int") .Attr("is_xyz: bool = True") .Output("kidx: int32") .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { - c->set_output(0, c->MakeShape({ c->UnknownDim() })); + c->set_output(0, c->MakeShape({c->UnknownDim()})); return Status::OK(); }) .Doc(R"doc(Octree search operator.)doc"); - class OctreeEncodeKeyOp : public OpKernel { public: explicit OctreeEncodeKeyOp(OpKernelConstruction* context) - : OpKernel(context) {} + : OpKernel(context) {} void Compute(OpKernelContext* context) override { + typedef typename KeyTrait::uints uints; + // in data const Tensor& data_in = context->input(0); - auto ptr_in = data_in.flat().data(); + auto ptr_in = data_in.flat().data(); int num = data_in.dim_size(0); int channel = data_in.dim_size(1); CHECK_EQ(data_in.dims(), 2) << "The dim of input tensor must be 2."; @@ -75,24 +89,27 @@ class OctreeEncodeKeyOp : public OpKernel { // out data Tensor* data_out = nullptr; - TensorShape shape_out({ num }); + TensorShape shape_out({num}); OP_REQUIRES_OK(context, context->allocate_output(0, shape_out, &data_out)); - auto ptr_out = data_out->flat().data(); + auto ptr_out = data_out->flat().data(); // copy data - cudaMemcpy(ptr_out, ptr_in, sizeof(uint8) * channel * num, cudaMemcpyDeviceToDevice); + int n = channel * num; + cudaMemcpy(ptr_out, ptr_in, sizeof(uints) * n, cudaMemcpyDeviceToDevice); } }; class OctreeDecodeKeyOp : public OpKernel { public: explicit OctreeDecodeKeyOp(OpKernelConstruction* context) - : OpKernel(context) {} + : OpKernel(context) {} void Compute(OpKernelContext* context) override { + typedef typename KeyTrait::uints uints; + // in data const Tensor& data_in = context->input(0); - auto ptr_in = data_in.flat().data(); + auto ptr_in = data_in.flat().data(); int num = data_in.dim_size(0); CHECK_EQ(data_in.dims(), 1) << "The dim of input tensor must be 1."; @@ -100,10 +117,10 @@ class OctreeDecodeKeyOp : public OpKernel { Tensor* data_out = nullptr; TensorShape shape_out({num, 4}); OP_REQUIRES_OK(context, context->allocate_output(0, shape_out, &data_out)); - auto ptr_out = data_out->flat().data(); + auto ptr_out = data_out->flat().data(); // copy data - cudaMemcpy(ptr_out, ptr_in, sizeof(uint32) * num, cudaMemcpyDeviceToDevice); + cudaMemcpy(ptr_out, ptr_in, sizeof(uintk) * num, cudaMemcpyDeviceToDevice); } }; @@ -117,14 +134,14 @@ class OctreeKeyToXyzOp : public OpKernel { // in data const Tensor& data_in = context->input(0); const TensorShape& shape_in = data_in.shape(); - auto ptr_in = data_in.flat().data(); + auto ptr_in = data_in.flat().data(); int num = shape_in.num_elements(); CHECK_GE(num, 1) << "The element number of input tensor must be 1."; // out data Tensor* data_out = nullptr; OP_REQUIRES_OK(context, context->allocate_output(0, shape_in, &data_out)); - auto ptr_out = data_out->flat().data(); + auto ptr_out = data_out->flat().data(); // convert key2xyz_gpu(ptr_out, ptr_in, num, depth_); @@ -136,8 +153,7 @@ class OctreeKeyToXyzOp : public OpKernel { class OctreeXyzToKeyOp : public OpKernel { public: - explicit OctreeXyzToKeyOp(OpKernelConstruction* context) - : OpKernel(context) { + explicit OctreeXyzToKeyOp(OpKernelConstruction* context) : OpKernel(context) { OP_REQUIRES_OK(context, context->GetAttr("depth", &depth_)); } @@ -145,14 +161,14 @@ class OctreeXyzToKeyOp : public OpKernel { // in data const Tensor& data_in = context->input(0); const TensorShape& shape_in = data_in.shape(); - auto ptr_in = data_in.flat().data(); + auto ptr_in = data_in.flat().data(); int num = shape_in.num_elements(); CHECK_GE(num, 1) << "The element number of input tensor must be 1."; // out data Tensor* data_out = nullptr; OP_REQUIRES_OK(context, context->allocate_output(0, shape_in, &data_out)); - auto ptr_out = data_out->flat().data(); + auto ptr_out = data_out->flat().data(); // convert xyz2key_gpu(ptr_out, ptr_in, num, depth_); @@ -165,7 +181,7 @@ class OctreeXyzToKeyOp : public OpKernel { class OctreeSearchKeyOp : public OpKernel { public: explicit OctreeSearchKeyOp(OpKernelConstruction* context) - : OpKernel(context) { + : OpKernel(context) { OP_REQUIRES_OK(context, context->GetAttr("depth", &depth_)); OP_REQUIRES_OK(context, context->GetAttr("is_xyz", &is_xyz_)); } @@ -174,7 +190,7 @@ class OctreeSearchKeyOp : public OpKernel { // input const Tensor& data_in = context->input(0); const TensorShape& shape_in = data_in.shape(); - const uint32* src_key = data_in.flat().data(); + const uintk* src_key = data_in.flat().data(); int src_h = shape_in.num_elements(); CHECK_GE(src_h, 1) << "The element number of input tensor must be 1."; @@ -182,18 +198,18 @@ class OctreeSearchKeyOp : public OpKernel { Tensor src_key_tensor; if (is_xyz_) { xyz2key_gpu_op(context, &src_key_tensor, src_key, src_h, depth_); - src_key = src_key_tensor.flat().data(); + src_key = src_key_tensor.flat().data(); } // octree OctreeParser octree_; octree_.set_gpu(context->input(1).flat().data()); int des_h = octree_.info().node_num(depth_); - const uint32* des_key = octree_.key_gpu(depth_); + const uintk* des_key = octree_.key_gpu(depth_); Tensor des_key_tensor; if (octree_.info().is_key2xyz()) { xyz2key_gpu_op(context, &des_key_tensor, des_key, des_h, depth_); - des_key = des_key_tensor.flat().data(); + des_key = des_key_tensor.flat().data(); } // output @@ -206,12 +222,12 @@ class OctreeSearchKeyOp : public OpKernel { } protected: - // todo: isolated the following functions out of this file void xyz2key_gpu_op(OpKernelContext* context, Tensor* key_tensor, - const uint32* xyz, const int num, const int depth) { - OP_REQUIRES_OK(context, - context->allocate_temp(DT_UINT32, TensorShape({ num }), key_tensor)); - auto ptr = key_tensor->flat().data(); + const uintk* xyz, const int num, const int depth) { + auto dtype = std::is_same::value ? DT_UINT32 : DT_UINT64; + OP_REQUIRES_OK( + context, context->allocate_temp(dtype, TensorShape({num}), key_tensor)); + auto ptr = key_tensor->flat().data(); xyz2key_gpu(ptr, xyz, num, depth); } @@ -220,7 +236,6 @@ class OctreeSearchKeyOp : public OpKernel { bool is_xyz_; }; - REGISTER_KERNEL_BUILDER(Name("OctreeDecodeKey").Device(DEVICE_GPU), OctreeDecodeKeyOp); REGISTER_KERNEL_BUILDER(Name("OctreeEncodeKey").Device(DEVICE_GPU), OctreeEncodeKeyOp); REGISTER_KERNEL_BUILDER(Name("OctreeKeyToXyz").Device(DEVICE_GPU), OctreeKeyToXyzOp); diff --git a/tensorflow/libs/octree_new_op.cc b/tensorflow/libs/octree_new_op.cc index e025f7a..54b4a89 100644 --- a/tensorflow/libs/octree_new_op.cc +++ b/tensorflow/libs/octree_new_op.cc @@ -1,4 +1,3 @@ -#include #include #include #include @@ -47,7 +46,7 @@ class OctreeNewOp : public OpKernel { oct_info_.set_adaptive(false); } oct_info_.set_key2xyz(true); - oct_info_.set_property(OctreeInfo::kKey, 2, -1); + oct_info_.set_property(OctreeInfo::kKey, 1, -1); oct_info_.set_property(OctreeInfo::kChild, 1, -1); oct_info_.set_property(OctreeInfo::kNeigh, 8, -1); oct_info_.set_property(OctreeInfo::kFeature, channel_, -1); @@ -63,14 +62,14 @@ class OctreeNewOp : public OpKernel { Tensor* tensor_out = nullptr; TensorShape shape_out({oct_info_.sizeof_octree()}); OP_REQUIRES_OK(context, context->allocate_output(0, shape_out, &tensor_out)); - auto* ptr_out = tensor_out->flat().data(); - cudaMemset(ptr_out, 0, tensor_out->NumElements()); + int8* ptr_out = tensor_out->flat().data(); + memset(ptr_out, 0, tensor_out->NumElements()); // set octree, skip the propoerties neigh and feature OctreeParser octree_out; - octree_out.set_gpu(ptr_out, &oct_info_); - sequence_gpu(octree_out.mutable_key_gpu(depth_), node_num_); - sequence_gpu(octree_out.mutable_children_gpu(depth_), node_num_); + octree_out.set_cpu(ptr_out, &oct_info_); + sequence_cpu(octree_out.mutable_key_cpu(depth_), node_num_); + sequence_cpu(octree_out.mutable_children_cpu(depth_), node_num_); } private: @@ -80,6 +79,6 @@ class OctreeNewOp : public OpKernel { bool has_displace_; }; -REGISTER_KERNEL_BUILDER(Name("OctreeNew").Device(DEVICE_GPU), OctreeNewOp); +REGISTER_KERNEL_BUILDER(Name("OctreeNew").Device(DEVICE_CPU), OctreeNewOp); } // namespace tensorflow diff --git a/tensorflow/libs/octree_property_op.cc b/tensorflow/libs/octree_property_op.cc index 123dd56..10f1b1c 100644 --- a/tensorflow/libs/octree_property_op.cc +++ b/tensorflow/libs/octree_property_op.cc @@ -1,11 +1,11 @@ -#include "octree_nn.h" -#include "octree_parser.h" - #include #include #include #include +#include "octree_nn.h" +#include "octree_parser.h" + namespace tensorflow { REGISTER_OP("OctreeProperty") @@ -13,7 +13,7 @@ REGISTER_OP("OctreeProperty") .Attr("property_name: string") .Attr("depth: int") .Attr("channel: int") - .Attr("dtype: {int32,float32,uint32}") + .Attr("dtype: {int32,float32,uint32,uint64}") .Output("out_property: dtype") .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { int channel; @@ -23,11 +23,9 @@ REGISTER_OP("OctreeProperty") }) .Doc(R"doc(Octree property operator.)doc"); - class OctreePropertyOp : public OpKernel { public: - explicit OctreePropertyOp(OpKernelConstruction* context) : - OpKernel(context) { + explicit OctreePropertyOp(OpKernelConstruction* context) : OpKernel(context) { OP_REQUIRES_OK(context, context->GetAttr("property_name", &property_name_)); OP_REQUIRES_OK(context, context->GetAttr("depth", &depth_)); OP_REQUIRES_OK(context, context->GetAttr("channel", &channel_)); @@ -42,35 +40,28 @@ class OctreePropertyOp : public OpKernel { Tensor buf0, buf1; const void* property_ptr = nullptr; int length = octree_.info().node_num(depth_), channel = 1; + bool key32 = std::is_same::value; + DataType key_dtype = key32 ? DataType::DT_UINT32 : DataType::DT_UINT64; if (property_name_ == "key") { property_ptr = octree_.key_gpu(depth_); channel = octree_.info().channel(OctreeInfo::kKey); - CHECK_EQ(dtype_, DataType::DT_UINT32); + CHECK_EQ(dtype_, key_dtype); } else if (property_name_ == "xyz") { - // key2xzy property_ptr = octree_.key_gpu(depth_); channel = octree_.info().channel(OctreeInfo::kKey); if (!octree_.info().is_key2xyz()) { - OP_REQUIRES_OK(context, - context->allocate_temp(DT_UINT32, TensorShape({ length }), &buf0)); - uint32* ptr = buf0.flat().data(); - key2xyz_gpu(ptr, (const uint32*)property_ptr, length, depth_); + OP_REQUIRES_OK(context, context->allocate_temp( + key_dtype, TensorShape({length}), &buf0)); + uintk* ptr = buf0.flat().data(); + key2xyz_gpu(ptr, (const uintk*)property_ptr, length, depth_); property_ptr = ptr; } - CHECK_EQ(dtype_, DataType::DT_UINT32); - //// xyz to float - //channel = channel_; - //OP_REQUIRES_OK(context, - // context->allocate_temp(DT_FLOAT, TensorShape({ length * channel }), &buf1)); - //CHECK_EQ(dtype_, DataType::DT_FLOAT); - //float* ptr = buf1.flat().data(); - //xyz2coord_gpu(ptr, xyz, length, channel); - //property_ptr = ptr; + CHECK_EQ(dtype_, key_dtype); } else if (property_name_ == "index") { - const unsigned int* key_ptr = octree_.key_gpu(depth_); + const uintk* key_ptr = octree_.key_gpu(depth_); channel = octree_.info().channel(OctreeInfo::kKey); - OP_REQUIRES_OK(context, - context->allocate_temp(DT_INT32, TensorShape({ length }), &buf0)); + OP_REQUIRES_OK(context, context->allocate_temp( + DT_INT32, TensorShape({length}), &buf0)); int* idx_ptr = buf0.flat().data(); key2idx_gpu(idx_ptr, key_ptr, length); property_ptr = idx_ptr; @@ -98,31 +89,38 @@ class OctreePropertyOp : public OpKernel { } else { LOG(FATAL) << "Unsupported Octree Property"; } - CHECK_EQ(channel_, channel) << "The specified channel_ is wrong."; + CHECK_EQ(channel_, channel) << " The specified channel_ is wrong." + << " Property name: " << property_name_; Tensor* out_tensor; - TensorShape out_shape({ channel, length }); - OP_REQUIRES_OK(context, context->allocate_output(0, out_shape, &out_tensor)); + TensorShape out_shape({channel, length}); + OP_REQUIRES_OK(context, + context->allocate_output(0, out_shape, &out_tensor)); int num = channel * length; switch (dtype_) { - case DataType::DT_UINT32: { - auto ptr = out_tensor->flat().data(); - cudaMemcpy(ptr, property_ptr, sizeof(uint32) * num, cudaMemcpyDeviceToDevice); - } - break; - case DataType::DT_INT32: { - auto ptr = out_tensor->flat().data(); - cudaMemcpy(ptr, property_ptr, sizeof(int) * num, cudaMemcpyDeviceToDevice); - } - break; - case DataType::DT_FLOAT: { - auto ptr = out_tensor->flat().data(); - cudaMemcpy(ptr, property_ptr, sizeof(float) * num, cudaMemcpyDeviceToDevice); - } - break; - default: - LOG(FATAL) << "Invalid DataType"; + case DataType::DT_UINT32: { + auto ptr = out_tensor->flat().data(); + cudaMemcpy(ptr, property_ptr, sizeof(uint32) * num, + cudaMemcpyDeviceToDevice); + } break; + case DataType::DT_UINT64: { + auto ptr = out_tensor->flat().data(); + cudaMemcpy(ptr, property_ptr, sizeof(uint64) * num, + cudaMemcpyDeviceToDevice); + } break; + case DataType::DT_INT32: { + auto ptr = out_tensor->flat().data(); + cudaMemcpy(ptr, property_ptr, sizeof(int) * num, + cudaMemcpyDeviceToDevice); + } break; + case DataType::DT_FLOAT: { + auto ptr = out_tensor->flat().data(); + cudaMemcpy(ptr, property_ptr, sizeof(float) * num, + cudaMemcpyDeviceToDevice); + } break; + default: + LOG(FATAL) << "Invalid DataType"; } } @@ -133,6 +131,7 @@ class OctreePropertyOp : public OpKernel { int channel_; }; -REGISTER_KERNEL_BUILDER(Name("OctreeProperty").Device(DEVICE_GPU), OctreePropertyOp); +REGISTER_KERNEL_BUILDER(Name("OctreeProperty").Device(DEVICE_GPU), + OctreePropertyOp); } // namespace tensorflow diff --git a/tensorflow/libs/octree_search_op.cc b/tensorflow/libs/octree_search_op.cc index 5c51215..9ebdb68 100644 --- a/tensorflow/libs/octree_search_op.cc +++ b/tensorflow/libs/octree_search_op.cc @@ -1,30 +1,27 @@ -#include "octree_nn.h" -#include "octree_parser.h" - #include #include #include +#include "octree_nn.h" +#include "octree_parser.h" + namespace tensorflow { REGISTER_OP("OctreeSearch") - .Input("xyz: float") // C * H + .Input("xyz: float") // C * H .Input("octree: int8") .Attr("depth: int") - //.Attr("dtype: {int32,float32,uint32}") .Output("kidx: int32") .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { - c->set_output(0, c->MakeShape({ c->UnknownDim() })); + c->set_output(0, c->MakeShape({c->UnknownDim()})); return Status::OK(); }) .Doc(R"doc(Octree search operator.)doc"); - class OctreeSearchOp : public OpKernel { public: explicit OctreeSearchOp(OpKernelConstruction* context) : OpKernel(context) { OP_REQUIRES_OK(context, context->GetAttr("depth", &depth_)); - //OP_REQUIRES_OK(context, context->GetAttr("dtype", &dtype_)); } void Compute(OpKernelContext* context) override { @@ -38,27 +35,27 @@ class OctreeSearchOp : public OpKernel { // coord2xyz Tensor src_xyz_tensor; coord2xyz_gpu_op(context, &src_xyz_tensor, src_ptr, src_h, channel); - const uint32* src_xyz = src_xyz_tensor.flat().data(); + const uintk* src_xyz = src_xyz_tensor.flat().data(); // xyz2key Tensor src_key_tensor; xyz2key_gpu_op(context, &src_key_tensor, src_xyz, src_h, depth_); - const uint32* src_key = src_key_tensor.flat().data(); + const uintk* src_key = src_key_tensor.flat().data(); // octree OctreeParser octree_; octree_.set_gpu(context->input(1).flat().data()); int des_h = octree_.info().node_num(depth_); - const uint32* des_key = octree_.key_gpu(depth_); + const uintk* des_key = octree_.key_gpu(depth_); Tensor des_key_tensor; if (octree_.info().is_key2xyz()) { xyz2key_gpu_op(context, &des_key_tensor, des_key, des_h, depth_); - des_key = des_key_tensor.flat().data(); + des_key = des_key_tensor.flat().data(); } // output Tensor* des_tensor = nullptr; - TensorShape des_shape({ src_h }); + TensorShape des_shape({src_h}); OP_REQUIRES_OK(context, context->allocate_output(0, des_shape, &des_tensor)); auto idx_ptr = des_tensor->flat().data(); @@ -69,27 +66,28 @@ class OctreeSearchOp : public OpKernel { protected: // todo: isolated the following functions out of this file void xyz2key_gpu_op(OpKernelContext* context, Tensor* key_tensor, - const uint32* xyz, const int num, const int depth) { - OP_REQUIRES_OK(context, - context->allocate_temp(DT_UINT32, TensorShape({ num }), key_tensor)); - auto ptr = key_tensor->flat().data(); + const uintk* xyz, const int num, const int depth) { + auto dtype = std::is_same::value ? DT_UINT32 : DT_UINT64; + OP_REQUIRES_OK( + context, context->allocate_temp(dtype, TensorShape({num}), key_tensor)); + auto ptr = key_tensor->flat().data(); xyz2key_gpu(ptr, xyz, num, depth); } void coord2xyz_gpu_op(OpKernelContext* context, Tensor* xyz_tensor, - const float* coord, const int num, const int channel) { - OP_REQUIRES_OK(context, - context->allocate_temp(DT_UINT32, TensorShape({ num }), xyz_tensor)); - auto xyz = xyz_tensor->flat().data(); + const float* coord, const int num, const int channel) { + auto dtype = std::is_same::value ? DT_UINT32 : DT_UINT64; + OP_REQUIRES_OK( + context, context->allocate_temp(dtype, TensorShape({num}), xyz_tensor)); + auto xyz = xyz_tensor->flat().data(); coord2xyz_gpu(xyz, coord, num, channel); } private: int depth_; - //DataType dtype_; + // DataType dtype_; }; - REGISTER_KERNEL_BUILDER(Name("OctreeSearch").Device(DEVICE_GPU), OctreeSearchOp); } // namespace tensorflow diff --git a/tensorflow/libs/octree_set_property_op.cc b/tensorflow/libs/octree_set_property_op.cc index 19aeeb5..2e3a0e6 100644 --- a/tensorflow/libs/octree_set_property_op.cc +++ b/tensorflow/libs/octree_set_property_op.cc @@ -1,20 +1,20 @@ -#include "octree_parser.h" -#include "octree_info.h" - #include #include #include #include +#include "octree_info.h" +#include "octree_parser.h" + namespace tensorflow { REGISTER_OP("OctreeSetProperty") - .Input("in_octree: int8") - .Input("in_property: dtype") + .Input("octree_in: int8") + .Input("property_in: dtype") .Attr("property_name: string") .Attr("depth: int") - .Attr("dtype: {int32,float32,uint32}") - .Output("out_octree: int8") + .Attr("dtype: {int32,float32,uint32,uint64}") + .Output("octree_out: int8") .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { c->set_output(0, c->input(0)); return Status::OK(); @@ -23,31 +23,33 @@ REGISTER_OP("OctreeSetProperty") class OctreeSetPropertyOp : public OpKernel { public: - explicit OctreeSetPropertyOp(OpKernelConstruction* context) : - OpKernel(context) { + explicit OctreeSetPropertyOp(OpKernelConstruction* context) + : OpKernel(context) { OP_REQUIRES_OK(context, context->GetAttr("property_name", &property_name_)); OP_REQUIRES_OK(context, context->GetAttr("depth", &depth_)); OP_REQUIRES_OK(context, context->GetAttr("dtype", &dtype_)); } void Compute(OpKernelContext* context) override { - const Tensor& in_octree = context->input(0); - const Tensor& in_property = context->input(1); - auto in_ptr = in_octree.flat().data(); + const Tensor& octree_in = context->input(0); + const Tensor& property_in = context->input(1); + auto ptr_in = octree_in.flat().data(); - Tensor* out_octree; - OP_REQUIRES_OK(context, context->allocate_output(0, in_octree.shape(), &out_octree)); - auto out_ptr = out_octree->flat().data(); - cudaMemcpy(out_ptr, in_ptr, in_octree.NumElements(), cudaMemcpyDeviceToDevice); + Tensor* octree_out; + OP_REQUIRES_OK(context, context->allocate_output(0, octree_in.shape(), &octree_out)); + auto ptr_out = octree_out->flat().data(); + cudaMemcpy(ptr_out, ptr_in, octree_in.NumElements(), cudaMemcpyDeviceToDevice); OctreeParser oct_parser; - int length; + oct_parser.set_gpu(ptr_out); void* property_ptr = nullptr; - oct_parser.set_gpu(out_ptr); - length = oct_parser.info().node_num(depth_); + int length = oct_parser.info().node_num(depth_); if (property_name_ == "key") { + bool key32 = std::is_same::value; + DataType key_dtype = key32 ? DataType::DT_UINT32 : DataType::DT_UINT64; property_ptr = oct_parser.mutable_key_gpu(depth_); - CHECK_EQ(dtype_, DataType::DT_UINT32); + length *= oct_parser.info().channel(OctreeInfo::kKey); + CHECK_EQ(dtype_, key_dtype); } else if (property_name_ == "child") { property_ptr = oct_parser.mutable_children_gpu(depth_); length *= oct_parser.info().channel(OctreeInfo::kChild); @@ -71,28 +73,31 @@ class OctreeSetPropertyOp : public OpKernel { } else { LOG(FATAL) << "Unsupported Octree Property"; } - CHECK_EQ(length, in_property.NumElements()) << "Wrong Property Size"; + + CHECK_EQ(length, property_in.NumElements()) << "Wrong Property Size"; switch (dtype_) { - case DataType::DT_UINT32: { - auto in_property_ptr = in_property.flat().data(); - cudaMemcpy(property_ptr, in_property_ptr, sizeof(uint32) * length, - cudaMemcpyDeviceToDevice); - } - break; - case DataType::DT_INT32: { - auto in_property_ptr = in_property.flat().data(); - cudaMemcpy(property_ptr, in_property_ptr, sizeof(int) * length, - cudaMemcpyDeviceToDevice); - } - break; - case DataType::DT_FLOAT: { - auto in_property_ptr = in_property.flat().data(); - cudaMemcpy(property_ptr, in_property_ptr, sizeof(float) * length, - cudaMemcpyDeviceToDevice); - } - break; - default: - LOG(FATAL) << "Wrong DataType"; + case DataType::DT_UINT32: { + auto property_in_ptr = property_in.flat().data(); + cudaMemcpy(property_ptr, property_in_ptr, sizeof(uint32) * length, + cudaMemcpyDeviceToDevice); + } break; + case DataType::DT_UINT64: { + auto property_in_ptr = property_in.flat().data(); + cudaMemcpy(property_ptr, property_in_ptr, sizeof(uint64) * length, + cudaMemcpyDeviceToDevice); + } break; + case DataType::DT_INT32: { + auto property_in_ptr = property_in.flat().data(); + cudaMemcpy(property_ptr, property_in_ptr, sizeof(int) * length, + cudaMemcpyDeviceToDevice); + } break; + case DataType::DT_FLOAT: { + auto property_in_ptr = property_in.flat().data(); + cudaMemcpy(property_ptr, property_in_ptr, sizeof(float) * length, + cudaMemcpyDeviceToDevice); + } break; + default: + LOG(FATAL) << "Wrong DataType"; } } @@ -100,7 +105,6 @@ class OctreeSetPropertyOp : public OpKernel { string property_name_; DataType dtype_; int depth_; - }; REGISTER_KERNEL_BUILDER(Name("OctreeSetProperty").Device(DEVICE_GPU), OctreeSetPropertyOp); diff --git a/tensorflow/libs/points_property_op.cc b/tensorflow/libs/points_property_op.cc index 7956ae4..1286925 100644 --- a/tensorflow/libs/points_property_op.cc +++ b/tensorflow/libs/points_property_op.cc @@ -1,9 +1,9 @@ -#include "points_parser.h" - #include #include #include +#include "points_parser.h" + namespace tensorflow { REGISTER_OP("PointsProperty") @@ -14,15 +14,14 @@ REGISTER_OP("PointsProperty") .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { int channel; TF_RETURN_IF_ERROR(c->GetAttr("channel", &channel)); - c->set_output(0, c->MakeShape({ c->UnknownDim(), channel })); + c->set_output(0, c->MakeShape({c->UnknownDim(), channel})); return Status::OK(); }) .Doc(R"doc(Points property operator.)doc"); class PointsPropertyOp : public OpKernel { public: - explicit PointsPropertyOp(OpKernelConstruction* context) : - OpKernel(context) { + explicit PointsPropertyOp(OpKernelConstruction* context) : OpKernel(context) { OP_REQUIRES_OK(context, context->GetAttr("property_name", &property_name_)); OP_REQUIRES_OK(context, context->GetAttr("channel", &channel_)); } @@ -46,46 +45,58 @@ class PointsPropertyOp : public OpKernel { } // channel - int channel = 0; + PointsInfo::PropType ptype; if (property_name_ == "xyz") { - channel = 4; // x, y, z, id + ptype = PointsInfo::kPoint; } else if (property_name_ == "label") { - channel = 1; + ptype = PointsInfo::kLabel; + } else if (property_name_ == "normal") { + ptype = PointsInfo::kNormal; + } else if (property_name_ == "feature") { + ptype = PointsInfo::kFeature; } else { LOG(FATAL) << "Unsupported Property: " << property_name_; } - CHECK_EQ(channel_, channel) << "The specified channel_ is wrong."; + int channel = channel_; // `channel` is the actual channel saved in points + if (ptype == PointsInfo::kPoint) { + CHECK(channel_ == 3 || channel_ == 4) + << "The specified channel_ for xyz is wrong."; + channel = 3; + } + for (int i = 0; i < batch_size; ++i) { + int ch = points_in[i].info().channel(ptype); + CHECK_EQ(ch, channel) << "The specified channel_ is wrong."; + const float* ptr = points_in[i].ptr(ptype); + CHECK_NE(ptr, nullptr) << "The specified property does not exist."; + } // init output Tensor* out_tensor; - TensorShape out_shape({ total_num, channel }); - OP_REQUIRES_OK(context, context->allocate_output(0, out_shape, &out_tensor)); + TensorShape out_shp({total_num, channel_}); + OP_REQUIRES_OK(context, context->allocate_output(0, out_shp, &out_tensor)); float* out_ptr = out_tensor->flat().data(); // copy output - if (property_name_ == "xyz") { - for (int i = 0; i < batch_size; ++i) { - const float *in_ptr = points_in[i].points(); - for (int j = 0; j < npts[i]; ++j) { - int jx3 = j * 3, jx4 = j * 4; - for (int c = 0; c < 3; ++c) { - out_ptr[jx4 + c] = in_ptr[jx3 + c]; - } - out_ptr[jx4 + 3] = static_cast(i); // id + for (int i = 0; i < batch_size; ++i) { + const float* in_ptr = points_in[i].ptr(ptype); + for (int j = 0; j < npts[i]; ++j) { + int jxc_in = j * channel, jxc_out = j * channel_; + for (int c = 0; c < channel; ++c) { + out_ptr[jxc_out + c] = in_ptr[jxc_in + c]; } - out_ptr += npts[i] * channel; } - } else if (property_name_ == "label") { + out_ptr += npts[i] * channel_; + } + + // output point index if channel == 4 + if (ptype == PointsInfo::kPoint && channel_ == 4) { + out_ptr = out_tensor->flat().data(); for (int i = 0; i < batch_size; ++i) { - const float *in_ptr = points_in[i].label(); - CHECK(in_ptr != nullptr) << "The points have on labels"; for (int j = 0; j < npts[i]; ++j) { - out_ptr[j] = in_ptr[j]; + out_ptr[j * channel_ + 3] = static_cast(i); // id } - out_ptr += npts[i]; + out_ptr += npts[i] * channel_; } - } else { - LOG(FATAL) << "Unsupported Property: " << property_name_; } } diff --git a/tensorflow/libs/points_set_property_op.cc b/tensorflow/libs/points_set_property_op.cc new file mode 100644 index 0000000..f1c6583 --- /dev/null +++ b/tensorflow/libs/points_set_property_op.cc @@ -0,0 +1,132 @@ +#include +#include +#include + +#include "points.h" + +namespace tensorflow { + +REGISTER_OP("PointsNew") + .Input("pts: float") + .Input("normals: float") + .Input("features: float") + .Input("labels: float") + .Output("points: string") + .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { + c->set_output(0, c->MakeShape({1})); + return Status::OK(); + }) + .Doc(R"doc(Create a point cloud.)doc"); + +REGISTER_OP("PointsSetProperty") + .Input("points: string") + .Input("data: float") + .Attr("property_name: string") + .Output("points_out: string") + .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { + c->set_output(0, c->MakeShape({1})); + return Status::OK(); + }) + .Doc(R"doc(Set points property operator.)doc"); + +class PointsNewOp : public OpKernel { + public: + explicit PointsNewOp(OpKernelConstruction* context) : OpKernel(context) {} + + void Compute(OpKernelContext* context) override { + // input + auto get_data = [&](vector& vec, int idx) { + const Tensor& data_in = context->input(idx); + const int64 num = data_in.NumElements(); + if (num > 0) { + const float* ptr = data_in.flat().data(); + vec.assign(ptr, ptr + num); + } + }; + vector pts, normals, features, labels; + get_data(pts, 0); + get_data(normals, 1); + get_data(features, 2); + get_data(labels, 3); + + // create the point cloud + Points point_cloud; + bool succ = point_cloud.set_points(pts, normals, features, labels); + CHECK(succ) << "Error occurs when setting points"; + + // output + Tensor* tsr = nullptr; + OP_REQUIRES_OK(context, context->allocate_output(0, TensorShape{1}, &tsr)); + string& out_str = tsr->flat()(0); + const vector& points_buf = point_cloud.get_buffer(); + out_str.assign(points_buf.begin(), points_buf.end()); + } +}; + +class PointsSetPropertyOp : public OpKernel { + public: + explicit PointsSetPropertyOp(OpKernelConstruction* context) + : OpKernel(context) { + OP_REQUIRES_OK(context, context->GetAttr("property_name", &property_name_)); + } + + void Compute(OpKernelContext* context) override { + // input points + const Tensor& data_in = context->input(0); + CHECK_EQ(data_in.NumElements(), 1); + const Tensor& data = context->input(1); + CHECK_EQ(data.dims(), 2); + int num = data.dim_size(0); + int channel = data.dim_size(1); + + // copy the data out of the input tensor + auto points_array = data_in.flat(); + vector points_buf(points_array(0).begin(), points_array(0).end()); + + // init the points + Points pts; + pts.set(points_buf.data()); + + // check the points + string msg; + bool succ = pts.info().check_format(msg); + CHECK(succ) << msg; + + // get prop + PointsInfo::PropType ptype; + if (property_name_ == "xyz") { + ptype = PointsInfo::kPoint; + } else if (property_name_ == "label") { + ptype = PointsInfo::kLabel; + } else if (property_name_ == "normal") { + ptype = PointsInfo::kNormal; + } else if (property_name_ == "feature") { + ptype = PointsInfo::kFeature; + } else { + LOG(FATAL) << "Unsupported Property: " << property_name_; + } + + // set the property + float* ptr = pts.mutable_ptr(ptype); + CHECK(ptr != nullptr) << "The property does not exist."; + CHECK_EQ(channel, pts.info().channel(ptype)) << "The channel is wrong."; + CHECK_EQ(num, pts.info().pt_num()) << "The point number is wrong."; + memcpy(ptr, data.flat().data(), num * channel * sizeof(float)); + + // output + Tensor* out_data = nullptr; + const TensorShape& shape = data_in.shape(); + OP_REQUIRES_OK(context, context->allocate_output(0, shape, &out_data)); + string& out_str = out_data->flat()(0); + out_str.assign(points_buf.begin(), points_buf.end()); + } + + private: + string property_name_; + int channel_; +}; + +REGISTER_KERNEL_BUILDER(Name("PointsSetProperty").Device(DEVICE_CPU), PointsSetPropertyOp); +REGISTER_KERNEL_BUILDER(Name("PointsNew").Device(DEVICE_CPU), PointsNewOp); + +} // namespace tensorflow diff --git a/tensorflow/libs/transform_points_op.cc b/tensorflow/libs/transform_points_op.cc index 2226e1c..7eaf2dc 100644 --- a/tensorflow/libs/transform_points_op.cc +++ b/tensorflow/libs/transform_points_op.cc @@ -23,9 +23,9 @@ REGISTER_OP("TransformPoints") .Input("ratio: float") .Input("dim: int32") .Input("stddev: float") - .Attr("axis: string='y'") // todo: delete this attribute + .Attr("axis: string='y'") // todo: delete this attribute .Attr("depth: int=6") - .Attr("offset: float=0.55") + .Attr("offset: float=0.0") .Output("points_out: string") .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { c->set_output(0, c->input(0)); @@ -33,13 +33,25 @@ REGISTER_OP("TransformPoints") }) .Doc(R"doc(Transform points.)doc"); +REGISTER_OP("NormalizePoints") + .Input("points: string") + .Input("radius: float") + .Input("center: float") + .Output("points_out: string") + .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { + c->set_output(0, c->input(0)); + return Status::OK(); + }) + .Doc(R"doc(Move the center to the origin, and normalize input to [-1, 1].)doc"); + REGISTER_OP("BoundingSphere") .Input("points: string") + .Attr("method: string='sphere'") .Output("radius: float") .Output("center: float") .SetShapeFn([](::tensorflow::shape_inference::InferenceContext* c) { - c->set_output(0, c->MakeShape({ 1 })); - c->set_output(1, c->MakeShape({ 3 })); + c->set_output(0, c->MakeShape({1})); + c->set_output(1, c->MakeShape({3})); return Status::OK(); }) .Doc(R"doc(Compute the bounding sphere of a point cloud.)doc"); @@ -63,7 +75,7 @@ REGISTER_OP("MakeGrids") class TransformPointsOp : public OpKernel { public: explicit TransformPointsOp(OpKernelConstruction* context) - : OpKernel(context) { + : OpKernel(context) { OP_REQUIRES_OK(context, context->GetAttr("axis", &axis_)); OP_REQUIRES_OK(context, context->GetAttr("depth", &depth_)); OP_REQUIRES_OK(context, context->GetAttr("offset", &offset_)); @@ -71,29 +83,27 @@ class TransformPointsOp : public OpKernel { void Compute(OpKernelContext* context) override { // input - auto extract_param = [](float * vec, const Tensor & ts) { + auto extract_param = [](float* vec, const Tensor& ts) { for (int i = 0; i < 3 && i < ts.NumElements(); ++i) { vec[i] = ts.flat()(i); } }; const Tensor& data_in = context->input(0); // float rotate = context->input(1).flat()(0); - float angle[3] = { 0 }; + float angle[3] = {0}; extract_param(angle, context->input(1)); - float scales[3] = { 1.0f, 1.0f, 1.0f }; + float scales[3] = {1.0f, 1.0f, 1.0f}; extract_param(scales, context->input(2)); - float jitter[3] = { 0 }; + float jitter[3] = {0}; extract_param(jitter, context->input(3)); float radius = context->input(4).flat()(0); - float center[3] = { 0 }; + float center[3] = {0}; extract_param(center, context->input(5)); float ratio = context->input(6).flat()(0); int dim = context->input(7).flat()(0); - float stddev[3] = { 0 }; // std_points, std_normals, std_features + float stddev[3] = {0}; // std_points, std_normals, std_features extract_param(stddev, context->input(8)); -// std::cout << angle[0] << " " << scales[0] << " " << jitter[0] << " " << radius[0] << " " << center[0] << " " << stddev[0] << std::endl; - // check CHECK_EQ(data_in.NumElements(), 1); for (int i = 0; i < 3; ++i) { @@ -113,126 +123,35 @@ class TransformPointsOp : public OpKernel { bool succ = pts.info().check_format(msg); CHECK(succ) << msg; - int N = pts.info().pt_num(); -// std::cout << "N in transorm points: " << N << std::endl; + // centralize + float dis[3] = {-center[0], -center[1], -center[2]}; + if (dis[0] != 0.0f || dis[1] != 0.0f || dis[2] != 0.0f) { + pts.translate(dis); + } - // centralize & displacement // QQ revise: we do not want to add offset. and adjust the radius + // displacement const float kEPS = 1.0e-10f; - // float dis[3] = { -center[0], -center[1], -center[2] }; - // pts.translate(dis); - // if (offset_ > kEPS) { - // // !!! rescale the offset, relative to the octree node size - // float offset = offset_ * 2.0f * radius / float(1 << depth_); - // pts.displace(offset); - // radius += offset; - // } + if (offset_ > kEPS) { + // !!! rescale the offset, relative to the octree node size + float offset = offset_ * 2.0f * radius / float(1 << depth_); + pts.displace(offset); + radius += offset; + } // data augmentation: rotate the point cloud if (fabs(angle[0]) > kEPS || fabs(angle[1]) > kEPS || fabs(angle[2]) > kEPS) { - // float axes[] = { 0.0f, 0.0f, 0.0f }; - // if (axis_ == "x") axes[0] = 1.0f; - // else if (axis_ == "y") axes[1] = 1.0f; - // else axes[2] = 1.0f; - // pts.rotate(rotate, axes); - - if (axis_ == "x") { angle[1] = angle[2] = 0; pts.rotate(angle);} - else if (axis_ == "y") { angle[0] = angle[2] = 0; pts.rotate(angle);} - else if (axis_ == "z") { angle[0] = angle[1] = 0; pts.rotate(angle); } - else if (axis_ == "xyz") //QQ revise: randomly along xyz. - { - int rand_num = rand()%6; - - if (rand_num == 0){ - float x_angle[3] = { 0 }; - x_angle[0] = angle[0]; - pts.rotate(x_angle); - - float y_angle[3] = { 0 }; - y_angle[1] = angle[1]; - pts.rotate(y_angle); - - float z_angle[3] = { 0 }; - z_angle[2] = angle[2]; - pts.rotate(z_angle); - } - - if (rand_num == 1){ - float x_angle[3] = { 0 }; - x_angle[0] = angle[0]; - pts.rotate(x_angle); - - float z_angle[3] = { 0 }; - z_angle[2] = angle[2]; - pts.rotate(z_angle); - - float y_angle[3] = { 0 }; - y_angle[1] = angle[1]; - pts.rotate(y_angle); - } - - if (rand_num == 2){ - float y_angle[3] = { 0 }; - y_angle[1] = angle[1]; - pts.rotate(y_angle); - - float x_angle[3] = { 0 }; - x_angle[0] = angle[0]; - pts.rotate(x_angle); - - float z_angle[3] = { 0 }; - z_angle[2] = angle[2]; - pts.rotate(z_angle); - } - - if (rand_num == 3){ - float y_angle[3] = { 0 }; - y_angle[1] = angle[1]; - pts.rotate(y_angle); - - float z_angle[3] = { 0 }; - z_angle[2] = angle[2]; - pts.rotate(z_angle); - - float x_angle[3] = { 0 }; - x_angle[0] = angle[0]; - pts.rotate(x_angle); - } - - if (rand_num == 4){ - - float z_angle[3] = { 0 }; - z_angle[2] = angle[2]; - pts.rotate(z_angle); - - float x_angle[3] = { 0 }; - x_angle[0] = angle[0]; - pts.rotate(x_angle); - - float y_angle[3] = { 0 }; - y_angle[1] = angle[1]; - pts.rotate(y_angle); - } - - if (rand_num == 5){ - float z_angle[3] = { 0 }; - z_angle[2] = angle[2]; - pts.rotate(z_angle); - - float y_angle[3] = { 0 }; - y_angle[1] = angle[1]; - pts.rotate(y_angle); - - float x_angle[3] = { 0 }; - x_angle[0] = angle[0]; - pts.rotate(x_angle); - } - + if (axis_ == "x") { + angle[1] = angle[2] = 0; + } else if (axis_ == "y") { + angle[0] = angle[2] = 0; + } else if (axis_ == "z") { + angle[0] = angle[1] = 0; + } else { } - else {} -// pts.rotate(angle); + pts.rotate(angle); } - // jitter // QQ revise: we can keep the jitter, in our case, + // jitter float max_jitter = -1.0; for (int i = 0; i < 3; i++) { // !!! rescale the jitter, relative to the radius @@ -243,54 +162,109 @@ class TransformPointsOp : public OpKernel { } if (fabs(max_jitter) > kEPS) { pts.translate(jitter); - //radius += max_jitter; + // radius += max_jitter; } - // scale to [-1, 1]^3 + // scale to [-1, 1]^3 if (radius == 0) radius = kEPS; - float max_scale = -1.0f; - for (int i = 0; i < 3; ++i) { - scales[i] /= radius; - if (max_scale < scales[i]) { max_scale = scales[i]; } + for (int i = 0; i < 3; ++i) { scales[i] /= radius; } + if (scales[0] != 1.0f || scales[1] != 1.0f || scales[2] != 1.0f) { + pts.scale(scales); } - pts.scale(scales); // add noise if (stddev[0] > 0 || stddev[1] > 0 || stddev[2] > 0) { pts.add_noise(stddev[0], stddev[1]); } - // clip the points to the box[-1, 1] ^ 3, - const float bbmin[] = { -1.0f, -1.0f, -1.0f }; - const float bbmax[] = { 1.0f, 1.0f, 1.0f }; - if (max_scale > 1.0f || max_jitter > kEPS) { - pts.clip(bbmin, bbmax); - } + // clip the points to the box[-1, 1] ^ 3, + const float bbmin[] = {-1.0f, -1.0f, -1.0f}; + const float bbmax[] = {1.0f, 1.0f, 1.0f}; + pts.clip(bbmin, bbmax); + // float max_scale = -1.0f; + // for (int i = 0; i < 3; ++i) { + // if (max_scale < scales[i]) { max_scale = scales[i]; } + // } + // if (max_scale > 1.0f || max_jitter > kEPS) { + // pts.clip(bbmin, bbmax); + // } - // dropout points // qq: omit -// if (dim > 0 && ratio > 0) { -// DropPoints drop_points(dim, ratio, bbmin, bbmax); -// drop_points.dropout(pts); -// } + // dropout points + if (dim > 0 && ratio > 0) { + DropPoints drop_points(dim, ratio, bbmin, bbmax); + drop_points.dropout(pts); + } // output Tensor* out_data = nullptr; - OP_REQUIRES_OK(context, context->allocate_output(0, data_in.shape(), &out_data)); + const TensorShape& shape = data_in.shape(); + OP_REQUIRES_OK(context, context->allocate_output(0, shape, &out_data)); string& out_str = out_data->flat()(0); out_str.assign(points_buf.begin(), points_buf.end()); } - private: string axis_; int depth_; float offset_; }; +class NormalizePointsOp : public OpKernel { + public: + explicit NormalizePointsOp(OpKernelConstruction* context) + : OpKernel(context) {} + + void Compute(OpKernelContext* context) override { + // input + const string& data_in = context->input(0).flat()(0); + const float radius = context->input(1).flat()(0); + const float* center = context->input(2).flat().data(); + + // check + CHECK_EQ(context->input(0).NumElements(), 1); + CHECK_EQ(context->input(1).NumElements(), 1); + CHECK_EQ(context->input(2).NumElements(), 3); + + // copy the data out of the input tensor + vector points_buf(data_in.begin(), data_in.end()); + + // init the points + Points pts; + pts.set(points_buf.data()); + + // check the points + string msg; + bool succ = pts.info().check_format(msg); + CHECK(succ) << msg; + + // centralize + const float dis[3] = {-center[0], -center[1], -center[2]}; + if (dis[0] != 0.0f || dis[1] != 0.0f || dis[2] != 0.0f) { + pts.translate(dis); + } + + // scale to [-1, 1] + CHECK_GE(radius, 0.0f); + const float inv_radius = 1.0f / radius; + const float scales[3] = {inv_radius, inv_radius, inv_radius}; + if (scales[0] != 1.0f || scales[1] != 1.0f || scales[2] != 1.0f) { + pts.scale(scales); + } + + // output + Tensor* out_data = nullptr; + const TensorShape& shape = context->input(0).shape(); + OP_REQUIRES_OK(context, context->allocate_output(0, shape, &out_data)); + string& out_str = out_data->flat()(0); + out_str.assign(points_buf.begin(), points_buf.end()); + } +}; + class BoundingSphereOp : public OpKernel { public: - explicit BoundingSphereOp(OpKernelConstruction* context) - : OpKernel(context) {} + explicit BoundingSphereOp(OpKernelConstruction* context) : OpKernel(context) { + OP_REQUIRES_OK(context, context->GetAttr("method", &method_)); + } void Compute(OpKernelContext* context) override { const Tensor& data_in = context->input(0); @@ -306,20 +280,34 @@ class BoundingSphereOp : public OpKernel { CHECK(succ) << msg; // bounding sphere - float radius, center[3]; - bounding_sphere(radius, center, pts.points(), pts.info().pt_num()); + float radius = 0.0f, center[3] = {0.0f}; + if (method_ == "sphere") { + bounding_sphere(radius, center, pts.points(), pts.info().pt_num()); + } else { + float bbmin[3] = {0.0f}, bbmax[3] = {0.0f}; + bounding_box(bbmin, bbmax, pts.points(), pts.info().pt_num()); + for (int j = 0; j < 3; ++j) { + center[j] = (bbmax[j] + bbmin[j]) / 2.0f; + float width = (bbmax[j] - bbmin[j]) / 2.0f; + radius += width * width; + } + radius = sqrtf(radius + 1.0e-20f); + } // output Tensor* out0 = nullptr; - OP_REQUIRES_OK(context, context->allocate_output(0, TensorShape({ 1 }), &out0)); + OP_REQUIRES_OK(context, context->allocate_output(0, TensorShape({1}), &out0)); float* ptr0 = out0->flat().data(); ptr0[0] = radius; Tensor* out1 = nullptr; - OP_REQUIRES_OK(context, context->allocate_output(1, TensorShape({ 3 }), &out1)); + OP_REQUIRES_OK(context, context->allocate_output(1, TensorShape({3}), &out1)); float* ptr1 = out1->flat().data(); for (int i = 0; i < 3; ++i) { ptr1[i] = center[i]; } } + + private: + string method_; }; class MakeGridsOp : public OpKernel { @@ -425,9 +413,8 @@ class MakeGridsOp : public OpKernel { int out_size_; }; - - REGISTER_KERNEL_BUILDER(Name("TransformPoints").Device(DEVICE_CPU), TransformPointsOp); +REGISTER_KERNEL_BUILDER(Name("NormalizePoints").Device(DEVICE_CPU), NormalizePointsOp); REGISTER_KERNEL_BUILDER(Name("BoundingSphere").Device(DEVICE_CPU), BoundingSphereOp); REGISTER_KERNEL_BUILDER(Name("MakeGrids").Device(DEVICE_CPU), MakeGridsOp); diff --git a/tensorflow/script/.DS_Store b/tensorflow/script/.DS_Store index 2f74965..53c5fb4 100644 Binary files a/tensorflow/script/.DS_Store and b/tensorflow/script/.DS_Store differ diff --git a/tensorflow/script/config.py b/tensorflow/script/config.py index 1949b24..a1acf5f 100644 --- a/tensorflow/script/config.py +++ b/tensorflow/script/config.py @@ -15,7 +15,7 @@ _C.SOLVER.type = 'adam' # Choose from sgd or adam _C.SOLVER.max_iter = 160000 # Maximum training iterations _C.SOLVER.test_iter = 100 # Test steps in testing phase -_C.SOLVER.test_every_iter = 1000 # Test model every n training steps +_C.SOLVER.test_every_iter = 4000 # Test model every n training steps _C.SOLVER.lr_type = 'step' # Learning rate type: step or cos _C.SOLVER.learning_rate = 0.01 # Initial learning rate _C.SOLVER.gamma = 0.1 # Learning rate step-wise decay @@ -24,7 +24,7 @@ _C.SOLVER.var_name = ('_name',)# Variable names used for finetuning _C.SOLVER.ignore_var_name = ('_name',)# Ignore variable names when loading ckpt _C.SOLVER.verbose = False # Whether to output some messages -_C.SOLVER.task = 'class' +_C.SOLVER.task = 'reg' # DATA related parameters @@ -59,7 +59,7 @@ _C.DATA.train.batch_size = 32 # Training data batch size _C.DATA.train.mask_ratio = 0.0 # Mask out some point features -_C.DATA.train.return_iter= False # Return the data iterator +# _C.DATA.train.return_iter= False # Return the data iterator _C.DATA.train.return_pts = False # Also return points @@ -86,6 +86,10 @@ _C.LOSS = CN() _C.LOSS.num_class = 40 # The class number for the cross-entropy loss _C.LOSS.weight_decay = 0.0005 # The weight decay on model weights +_C.LOSS.sigma = 0.1 # Use for MID training +_C.LOSS.momentum = 0.5 # Use for MID training +_C.LOSS.inst_num = 57449 # The object number in MID training +_C.LOSS.seg_num = 100 # The clustering number in MID training _C.LOSS.weights = (1.0, 1.0) # The weight factors for different losses _C.LOSS.label_smoothing = 0.0 # The factor of label smoothing diff --git a/tensorflow/script/logs/pdbbind/resnet_point2grid_20200806_reg_6/.DS_Store b/tensorflow/script/configs/.DS_Store similarity index 92% rename from tensorflow/script/logs/pdbbind/resnet_point2grid_20200806_reg_6/.DS_Store rename to tensorflow/script/configs/.DS_Store index f7d19a6..5008ddf 100644 Binary files a/tensorflow/script/logs/pdbbind/resnet_point2grid_20200806_reg_6/.DS_Store and b/tensorflow/script/configs/.DS_Store differ diff --git a/tensorflow/script/configs/ae_resnet.yaml b/tensorflow/script/configs/ae_resnet.yaml deleted file mode 100644 index 52153a3..0000000 --- a/tensorflow/script/configs/ae_resnet.yaml +++ /dev/null @@ -1,39 +0,0 @@ -SOLVER: - gpu: 0, - logdir: logs/ae/0609_resnet - run: train - max_iter: 320000 - test_iter: 336 - test_every_iter: 2000 - step_size: (80000,) - ckpt_num: 20 - -DATA: - train: - dtype: points - depth: 6 - location: dataset/ocnn_completion/completion_train_points.tfrecords - batch_size: 16 - distort: False - offset: 0.0 - node_dis: True - split_label: True - - test: - dtype: points - depth: 6 - location: dataset/ocnn_completion/completion_test_points.tfrecords - batch_size: 16 - distort: False - offset: 0.0 - node_dis: True - split_label: True - -MODEL: - name: resnet - channel: 4 - nout: 32 # The channel of the hidden code, the code length is 4*4*4*32 (2048) - depth: 6 - -LOSS: - weight_decay: 0.0005 \ No newline at end of file diff --git a/tensorflow/script/configs/ae_resnet_decode.yaml b/tensorflow/script/configs/ae_resnet_decode.yaml deleted file mode 100644 index d75ca5e..0000000 --- a/tensorflow/script/configs/ae_resnet_decode.yaml +++ /dev/null @@ -1,26 +0,0 @@ -SOLVER: - gpu: 0, - logdir: logs/ae/0609_resnet_decode_shape - ckpt: logs/ae/0609_resnet/model/iter_320000.ckpt - run: decode_shape - test_iter: 200 - -DATA: - test: - dtype: points - depth: 6 - location: dataset/ocnn_completion/completion_test_points.tfrecords - batch_size: 1 - distort: False - offset: 0.0 - node_dis: True - split_label: True - -MODEL: - name: resnet - channel: 4 - nout: 32 # The channel of the hidden code - depth: 6 - -LOSS: - weight_decay: 0.0005 \ No newline at end of file diff --git a/tensorflow/script/configs/ae_resnet_test.yaml b/tensorflow/script/configs/ae_resnet_test.yaml deleted file mode 100644 index 7811a30..0000000 --- a/tensorflow/script/configs/ae_resnet_test.yaml +++ /dev/null @@ -1,26 +0,0 @@ -SOLVER: - gpu: 0, - logdir: logs/ae/0609_resnet_test - ckpt: logs/ae/0609_resnet/model/iter_320000.ckpt - run: test - test_iter: 336 - -DATA: - test: - dtype: points - depth: 6 - location: dataset/ocnn_completion/completion_test_points.tfrecords - batch_size: 16 - distort: False - offset: 0.0 - node_dis: True - split_label: True - -MODEL: - name: resnet - channel: 4 - nout: 32 # The channel of the hidden code, the code length is 4*4*4*32 (2048) - depth: 6 - -LOSS: - weight_decay: 0.0005 \ No newline at end of file diff --git a/tensorflow/script/configs/cls_octree.yaml b/tensorflow/script/configs/cls_octree.yaml deleted file mode 100644 index ac511ae..0000000 --- a/tensorflow/script/configs/cls_octree.yaml +++ /dev/null @@ -1,35 +0,0 @@ -SOLVER: - gpu: 0, - logdir: logs/m40/0322_ocnn_octree - run: train - max_iter: 160000 - test_iter: 925 - test_every_iter: 2000 - step_size: (40000,) - -DATA: - train: - dtype: octree - distort: True - depth: 5 - location: dataset/ModelNet40/m40_5_2_12_train_octree.tfrecords - batch_size: 32 - x_alias: data - test: - dtype: octree - distort: False - depth: 5 - location: dataset/ModelNet40/m40_5_2_12_test_octree.tfrecords - shuffle: 0 - batch_size: 32 - x_alias: data - -MODEL: - name: ocnn - channel: 3 - nout: 40 - depth: 5 - -LOSS: - num_class: 40 - weight_decay: 0.0005 diff --git a/tensorflow/script/configs/cls_octree_test.yaml b/tensorflow/script/configs/cls_octree_test.yaml deleted file mode 100644 index f375889..0000000 --- a/tensorflow/script/configs/cls_octree_test.yaml +++ /dev/null @@ -1,27 +0,0 @@ -# To test the model with the tensorflow checkpoint - -SOLVER: - gpu: 0, - logdir: logs/m40/0322_ocnn_octree_test - ckpt: logs/m40/0322_ocnn_octree/model/iter_160000.ckpt - run: test - test_iter: 925 - -DATA: - test: - dtype: octree - depth: 5 - location: dataset/ModelNet40/m40_5_2_12_test_octree.tfrecords - shuffle: 0 - batch_size: 32 - x_alias: data - -MODEL: - name: ocnn - channel: 3 - nout: 40 - depth: 5 - -LOSS: - num_class: 40 - weight_decay: 0.0005 diff --git a/tensorflow/script/configs/cls_pdbbind_points.yaml b/tensorflow/script/configs/cls_pdbbind_points.yaml deleted file mode 100644 index 1e4f875..0000000 --- a/tensorflow/script/configs/cls_pdbbind_points.yaml +++ /dev/null @@ -1,50 +0,0 @@ -SOLVER: - gpu: 0,1 - logdir: logs/pdbbind/ocnn_points_20200716_reg_5 - run: train -# ckpt: logs/pdbbind/ocnn_points_20200704_class_7/model/iter_120000.ckpt - max_iter: 120000 - test_iter: 17 # 689 = 13*53, 221 = 13 * 17 - test_every_iter: 1000 - step_size: (40000,) - learning_rate: 0.001 - task: reg - -DATA: - train: - dtype: points - distort: True - depth: 5 - axis: xyz - angle: (6, 6, 6) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.0 - location: /media/data/data_share/pdbbind/tfrecords/test_reg_points_den5.tfrecords - batch_size: 30 - x_alias: data - shuffle: 200 - test: - dtype: points - distort: False - depth: 5 - axis: z - angle: (5, 5, 5) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.0 - location: /media/data/data_share/pdbbind/tfrecords/test_reg_points_den5.tfrecords - shuffle: 1 - batch_size: 13 - x_alias: data - -MODEL: - name: ocnn #ocnn_input_logit - channel: 24 - nout: 1 - depth: 5 - resblock_num: 3 - -LOSS: - num_class: 1 - weight_decay: 0.0005 diff --git a/tensorflow/script/configs/cls_pdbbind_points_resnet.yaml b/tensorflow/script/configs/cls_pdbbind_points_resnet.yaml deleted file mode 100644 index 780c858..0000000 --- a/tensorflow/script/configs/cls_pdbbind_points_resnet.yaml +++ /dev/null @@ -1,50 +0,0 @@ -SOLVER: - gpu: 0,1 - logdir: logs/pdbbind/cnn_points_20200722_reg_5 - run: train - #ckpt: logs/pdbbind/ocnn_points_20200630_class/model/iter_003800.ckpt -# ckpt: logs/pdbbind/ocnn_points_20200630_class_7/model/iter_000400.ckpt - max_iter: 16000 - test_iter: 53 # 689 = 13*53, 221 = 13 * 17 - test_every_iter: 1000 - step_size: (40000,) - learning_rate: 0.01 - -DATA: - train: - dtype: point2grid #points, point2grid, octree, grids - distort: True - depth: 6 - axis: xyz - angle: (5, 5, 5) - interval: (1, 1, 1) - scale: 0.0 - jitter: 4.0 - location: /media/data/data_share/pdbbind/tfrecords/test_reg_points_den5.tfrecords #train_class_points_records - batch_size: 30 - x_alias: data - shuffle: 500 - test: - dtype: point2grid - distort: False - depth: 6 - axis: z - angle: (5, 5, 5) - interval: (1, 1, 1) - scale: 0.0 - jitter: 4.0 - location: /media/data/data_share/pdbbind/tfrecords/test_reg_points_den5.tfrecords #val_class_points.tfrecords - shuffle: 0 - batch_size: 13 - x_alias: data - -MODEL: - name: cnn #ocnn, cnn, resnet - channel: 24 - nout: 1 - depth: 6 - resblock_num: 3 - -LOSS: - num_class: 2 - weight_decay: 0.0005 \ No newline at end of file diff --git a/tensorflow/script/configs/cls_points.yaml b/tensorflow/script/configs/cls_points.yaml deleted file mode 100644 index 582b341..0000000 --- a/tensorflow/script/configs/cls_points.yaml +++ /dev/null @@ -1,49 +0,0 @@ -# Resent with small rotations with testing accuarcy 92.5% - -SOLVER: - gpu: 0, - logdir: logs/m40/0608_resnet_points - run: train - max_iter: 160000 - test_iter: 77 - test_every_iter: 2000 - step_size: (40000,) - ckpt_num: 20 - -DATA: - train: - dtype: points - distort: True - depth: 8 - axis: z - angle: (5, 5, 5) - interval: (1, 1, 1) # small rotation - scale: 0.25 - jitter: 0.125 - location: dataset/ModelNet40/m40_train_points.tfrecords - batch_size: 32 - x_alias: data - test: - dtype: points - distort: False - depth: 8 - axis: z - angle: (5, 5, 5) - interval: (1, 1, 1) - scale: 0.25 - jitter: 0.125 - location: dataset/ModelNet40/m40_test_points.tfrecords - shuffle: 0 - batch_size: 32 - x_alias: data - -MODEL: - name: resnet - channel: 3 - nout: 40 - depth: 8 - resblock_num: 3 - -LOSS: - num_class: 40 - weight_decay: 0.0005 \ No newline at end of file diff --git a/tensorflow/script/configs/completion_test.yaml b/tensorflow/script/configs/completion_test.yaml deleted file mode 100644 index 881ac83..0000000 --- a/tensorflow/script/configs/completion_test.yaml +++ /dev/null @@ -1,29 +0,0 @@ -SOLVER: - gpu: 0, - logdir: logs/completion/skip_connections_test - ckpt: logs/completion/skip_connectinos/model/iter_320000.ckpt - run: decode_shape - test_iter: 1200 - - -DATA: - test: - dtype: points - depth: 6 - distort: False - location: dataset/ocnn_completion/completion_test_scans_points.tfrecords - batch_size: 1 - depth: 6 - offset: 0.0 - node_dis: True - split_label: True - x_alias: data - y_alias: index - shuffle: 0 - - -MODEL: - name: resnet - channel: 4 - depth: 6 - skip_connections: True diff --git a/tensorflow/script/configs/completion_train.yaml b/tensorflow/script/configs/completion_train.yaml deleted file mode 100644 index 330e956..0000000 --- a/tensorflow/script/configs/completion_train.yaml +++ /dev/null @@ -1,44 +0,0 @@ -SOLVER: - gpu: 0, - logdir: logs/completion/skip_connectinos - run: train - max_iter: 320000 - test_iter: 100 - test_every_iter: 2000 - step_size: (80000,) - ckpt_num: 20 - - -DATA: - train: - dtype: points - depth: 6 - distort: False - location: dataset/ocnn_completion/completion_train_points.tfrecords - camera: dataset/ocnn_completion/completion_train_points.camera_path.dict - batch_size: 16 - depth: 6 - offset: 0.0 - node_dis: True - split_label: True - - test: - dtype: points - depth: 6 - distort: False - location: dataset/ocnn_completion/completion_train_points.tfrecords - batch_size: 16 - depth: 6 - offset: 0.0 - node_dis: True - split_label: True - - -MODEL: - name: resnet - channel: 4 - depth: 6 - - -LOSS: - weight_decay: 0.0005 diff --git a/tensorflow/script/configs/reg_pdbbind_general_points.yaml b/tensorflow/script/configs/reg_pdbbind_general_points.yaml deleted file mode 100644 index 161dfd3..0000000 --- a/tensorflow/script/configs/reg_pdbbind_general_points.yaml +++ /dev/null @@ -1,49 +0,0 @@ -SOLVER: - gpu: 0, - logdir: logs/pdbbind/resnet_points_20200811_general_reg_6 - run: train - max_iter: 190437 # 190437 # 100 epochs for batch_size=8 - test_iter: 120 - test_every_iter: 4000 - step_size: (40000,) - learning_rate: 0.001 - task: reg - -DATA: - train: - dtype: points - distort: True - depth: 6 - axis: xyz - angle: (180, 180, 180) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.125 - location: /media/data/data_share/pdbbind/tfrecords/train_reg_points_den3.tfrecords - batch_size: 8 - x_alias: data - shuffle: 100 - test: - dtype: points - distort: False - depth: 6 - axis: xyz - angle: (12, 12, 12) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.0 - location: /media/data/data_share/pdbbind/tfrecords/val_reg_points_den3.tfrecords - shuffle: 1 - batch_size: 5 - x_alias: data - -MODEL: - name: ocnn #ocnn #resnet - channel: 24 - nout: 1 - depth: 6 - resblock_num: 3 - -LOSS: - num_class: 1 - weight_decay: 0.001 \ No newline at end of file diff --git a/tensorflow/script/configs/reg_pdbbind_general_test_points.yaml b/tensorflow/script/configs/reg_pdbbind_general_test_points.yaml deleted file mode 100644 index f779692..0000000 --- a/tensorflow/script/configs/reg_pdbbind_general_test_points.yaml +++ /dev/null @@ -1,32 +0,0 @@ -SOLVER: - gpu: 0, - run: test - ckpt: logs/pdbbind/ocnn_points_20200811_general_reg_6/model/iter_188000.ckpt - test_iter: 2280 # 689 = 13*53, 221 = 13 * 17 - task: reg - -DATA: - test: - dtype: points - distort: True - depth: 6 - axis: xyz - angle: (180, 180, 180) - interval: (10, 10, 10) - scale: 0.0 - jitter: 0.125 - location: /media/data/data_share/pdbbind/tfrecords/test_refine_reg_points_den3.tfrecords - shuffle: 1 - batch_size: 5 - x_alias: data - -MODEL: - name: ocnn #resnet - channel: 24 - nout: 1 - depth: 6 - resblock_num: 3 - -LOSS: - num_class: 1 - weight_decay: 0.001 \ No newline at end of file diff --git a/tensorflow/script/configs/reg_pdbbind_grids.yaml b/tensorflow/script/configs/reg_pdbbind_grids.yaml deleted file mode 100644 index e8f268d..0000000 --- a/tensorflow/script/configs/reg_pdbbind_grids.yaml +++ /dev/null @@ -1,50 +0,0 @@ -SOLVER: - gpu: 0, - logdir: logs/pdbbind/resnet_grids_20200728_reg_5 - run: train -# ckpt: logs/pdbbind/ocnn_points_20200704_class_7/model/iter_120000.ckpt - max_iter: 10000 - test_iter: 20 # 689 = 13*53, 221 = 13 * 17 - test_every_iter: 20000 - step_size: (40000,) - learning_rate: 0.001 - task: reg - -DATA: - train: - dtype: grids - distort: True - depth: 6 - axis: xyz - angle: (6, 6, 6) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.0 - location: /media/data/data_share/pdbbind/tfrecords/refine_reg_grids_dep5.tfrecords - batch_size: 8 # 285 = 15 * 19 - x_alias: data - shuffle: 50 - test: - dtype: grids - distort: False - depth: 6 - axis: z - angle: (6, 6, 6) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.0 - location: /media/data/data_share/pdbbind/tfrecords/test_reg_grids_dep5.tfrecords - shuffle: 1 - batch_size: 16 - x_alias: data - -MODEL: - name: resnet_grids #resnet_grids - channel: 24 - nout: 1 - depth: 6 - resblock_num: 3 - -LOSS: - num_class: 1 - weight_decay: 0.0005 diff --git a/tensorflow/script/configs/reg_pdbbind_octree.yaml b/tensorflow/script/configs/reg_pdbbind_octree.yaml deleted file mode 100644 index 8726112..0000000 --- a/tensorflow/script/configs/reg_pdbbind_octree.yaml +++ /dev/null @@ -1,50 +0,0 @@ -SOLVER: - gpu: 0, - logdir: logs/pdbbind/ocnn_octree_20200716_reg_5 - run: train -# ckpt: logs/pdbbind/ocnn_points_20200704_class_7/model/iter_120000.ckpt - max_iter: 10000 - test_iter: 20 # 689 = 13*53, 221 = 13 * 17 - test_every_iter: 20000 - step_size: (40000,) - learning_rate: 0.001 - task: reg - -DATA: - train: - dtype: octree - distort: True - depth: 5 - axis: xyz - angle: (6, 6, 6) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.0 - location: /media/data/data_share/pdbbind/tfrecords/refine_reg_octree_dep5.tfrecords - batch_size: 16 # 285 = 15 * 19 - x_alias: data - shuffle: 200 - test: - dtype: octree - distort: False - depth: 5 - axis: z - angle: (6, 6, 6) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.0 - location: /media/data/data_share/pdbbind/tfrecords/test_reg_octree_dep5.tfrecords - shuffle: 1 - batch_size: 16 - x_alias: data - -MODEL: - name: ocnn #ocnn_input_logit - channel: 24 - nout: 1 - depth: 5 - resblock_num: 3 - -LOSS: - num_class: 1 - weight_decay: 0.0005 diff --git a/tensorflow/script/configs/reg_pdbbind_point2grid.yaml b/tensorflow/script/configs/reg_pdbbind_point2grid.yaml deleted file mode 100644 index dd37d97..0000000 --- a/tensorflow/script/configs/reg_pdbbind_point2grid.yaml +++ /dev/null @@ -1,49 +0,0 @@ -SOLVER: - gpu: 0, - logdir: logs/pdbbind/resnet_point2grid_20200806_reg_6 - run: train - max_iter: 160000 - test_iter: 20 # 689 = 13*53, 221 = 13 * 17 - test_every_iter: 10 - step_size: (40000,) - learning_rate: 0.00001 - task: reg - -DATA: - train: - dtype: point2grid - distort: True - depth: 6 - axis: xyz - angle: (12, 12, 12) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.125 #0.125 - location: /media/data/data_share/pdbbind/tfrecords/train_reg_points_den3.tfrecords - batch_size: 32 - x_alias: data - shuffle: 100 - test: - dtype: point2grid - distort: False - depth: 6 - axis: xyz - angle: (6, 6, 6) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.0 - location: /media/data/data_share/pdbbind/tfrecords/test_refine_reg_points_den3.tfrecords #val_reg_points_den3.tfrecords - shuffle: 1 - batch_size: 8 - x_alias: data - -MODEL: - name: resnet_grids # cnn_grids OR resnet_grids - channel: 24 - nout: 1 - depth: 6 - resblock_num: 3 - -LOSS: - num_class: 1 - weight_decay: 0.001 diff --git a/tensorflow/script/configs/reg_pdbbind_points.yaml b/tensorflow/script/configs/reg_pdbbind_points.yaml deleted file mode 100644 index e4827c9..0000000 --- a/tensorflow/script/configs/reg_pdbbind_points.yaml +++ /dev/null @@ -1,50 +0,0 @@ -SOLVER: - gpu: 0, - logdir: logs/pdbbind/resnet_points_20200831_reg_6 -# ckpt: logs/pdbbind/resnet_points_20200728_reg_6/model/iter_000200.ckpt - run: train - max_iter: 160000 - test_iter: 38 # 689 = 13*53, 221 = 13 * 17 - test_every_iter: 200 - step_size: (40000,) - learning_rate: 0.001 - task: reg - -DATA: - train: - dtype: points - distort: True - depth: 6 - axis: xyz - angle: (12, 12, 12) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.0 #0.125 - location: /media/data/data_share/pdbbind/tfrecords/train_reg_points_den3.tfrecords - batch_size: 32 - x_alias: data - shuffle: 100 - test: - dtype: points - distort: True - depth: 6 - axis: xyz - angle: (12, 12, 12) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.0 - location: /media/data/data_share/pdbbind/tfrecords/val_refine_reg_points_den3.tfrecords - shuffle: 0 - batch_size: 15 - x_alias: data - -MODEL: - name: resnet # resnet - channel: 24 - nout: 1 - depth: 6 - resblock_num: 3 - -LOSS: - num_class: 1 - weight_decay: 0.001 diff --git a/tensorflow/script/configs/reg_pdbbind_refine_test_points.yaml b/tensorflow/script/configs/reg_pdbbind_refine_test_points.yaml deleted file mode 100644 index e0eebbe..0000000 --- a/tensorflow/script/configs/reg_pdbbind_refine_test_points.yaml +++ /dev/null @@ -1,50 +0,0 @@ -SOLVER: - gpu: 1, - logdir: logs/pdbbind/resnet_points_20200728_refine_reg_6 - run: test -# ckpt: logs/pdbbind/ocnn_points_20200704_class_7/model/iter_120000.ckpt - max_iter: 10000 - test_iter: 20 #689 = 13*53, 221 = 13 * 17 - test_every_iter: 20000 - step_size: (40000,) - learning_rate: 0.001 - task: reg - -DATA: - train: - dtype: points - distort: True - depth: 6 - axis: xyz - angle: (12, 12, 12) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.0 #0.125 - location: /media/data/data_share/pdbbind/tfrecords/train_reg_points_den3.tfrecords - batch_size: 16 - x_alias: data - shuffle: 100 - test: - dtype: points - distort: False - depth: 6 - axis: z - angle: (6, 6, 6) - interval: (1, 1, 1) - scale: 0.0 - jitter: 0.0 - location: /scratch/qil15006/pdbbind/tfrecords/test_refine_reg_points_den3.tfrecords - shuffle: 1 - batch_size: 16 - x_alias: data - -MODEL: - name: resnet #ocnn_input_logit - channel: 24 - nout: 1 - depth: 6 - resblock_num: 3 - -LOSS: - num_class: 1 - weight_decay: 0.001 diff --git a/tensorflow/script/dataset.py b/tensorflow/script/dataset.py index 61560e0..9be89d8 100644 --- a/tensorflow/script/dataset.py +++ b/tensorflow/script/dataset.py @@ -1,17 +1,11 @@ import sys import tensorflow as tf sys.path.append("..") -from libs import bounding_sphere, points2octree, transform_points, octree_batch, make_grids +from libs import bounding_sphere, points2octree, \ + transform_points, octree_batch, normalize_points, make_grids import numpy as np -import sys -# sys.path.append('../') -# sys.path.insert(0, '/home/qil15006/2020Summer/OCNN_Jun26_2020/octree/build/python') -# import pyoctree -# from util import make_voxel - - class ParseExample: def __init__(self, x_alias='data', y_alias='label', y_type = 'int', **kwargs): self.x_alias = x_alias @@ -50,6 +44,14 @@ def __call__(self, points): save_pts=self.save_pts) return octree +class NormalizePoints: + def __init__(self): + pass # normalize with bounding_sphere + + def __call__(self, points): + radius, center = bounding_sphere(points) + points = normalize_points(points, radius, center) + return points class MakeGrids: def __init__(self, out_size, feature_num, **kwargs): @@ -63,8 +65,7 @@ def __call__(self, points): class TransformPoints: def __init__(self, distort, depth, offset=0.55, axis='xyz', scale=0.25, jitter=8, drop_dim=[8, 32], angle=[20, 180, 20], dropout=[0, 0], - stddev=[0, 0, 0], uniform=False, interval=[1, 1, 1], - bounding_sphere=bounding_sphere, **kwargs): + stddev=[0, 0, 0], uniform=False, interval=[1, 1, 1], **kwargs): self.distort = distort self.axis = axis self.scale = scale @@ -77,7 +78,6 @@ def __init__(self, distort, depth, offset=0.55, axis='xyz', scale=0.25, self.stddev = stddev self.uniform_scale = uniform self.interval = interval - self.bounding_sphere = bounding_sphere def __call__(self, points): angle, scale, jitter, ratio, dim, angle, stddev = 0.0, 1.0, 0.0, 0.0, 0, 0, 0 @@ -109,9 +109,7 @@ def __call__(self, points): stddev = [tf.random.uniform(shape=[], minval=0, maxval=s) for s in self.stddev] stddev = tf.stack(stddev) - # radius, center = self.bounding_sphere(points) #// QQ revise: we have fixed radius and center. - radius = 32 - center = [0,0,0] + radius, center = tf.constant(32.0), tf.constant([0.0, 0.0, 0.0]) points = transform_points(points, angle=angle, scale=scale, jitter=jitter, radius=radius, center=center, axis=self.axis, depth=self.depth, offset=self.offset, @@ -121,8 +119,9 @@ def __call__(self, points): class PointDataset: - def __init__(self, parse_example, transform_points, points2octree): + def __init__(self, parse_example, normalize_points, transform_points, points2octree): self.parse_example = parse_example + self.normalize_points = normalize_points self.transform_points = transform_points self.points2octree = points2octree @@ -131,6 +130,7 @@ def __call__(self, record_names, batch_size, shuffle_size=1000, with tf.name_scope('points_dataset'): def preprocess(record): points, label = self.parse_example(record) + # points = self.normalize_points(points) points = self.transform_points(points) octree = self.points2octree(points) outputs= (octree, label) @@ -142,64 +142,19 @@ def merge_octrees(octrees, *args): return (octree,) + args dataset = tf.data.TFRecordDataset(record_names).take(take).repeat() - if shuffle_size > 1: - dataset = dataset.shuffle(shuffle_size) - print('shuffle_size: {}'.format(shuffle_size)) - itr = dataset.map(preprocess, num_parallel_calls=12) \ - .batch(batch_size).map(merge_octrees, num_parallel_calls=12) \ - .prefetch(12).make_one_shot_iterator() + if shuffle_size > 1: dataset = dataset.shuffle(shuffle_size) + itr = dataset.map(preprocess, num_parallel_calls=16) \ + .batch(batch_size).map(merge_octrees, num_parallel_calls=8) \ + .prefetch(8).make_one_shot_iterator() return itr if return_iter else itr.get_next() + class Point2GridDataset: def __init__(self, parse_example, transform_points, make_grids): self.parse_example = parse_example self.transform_points = transform_points self.make_grids = make_grids - # def parse_points(self, pts): - # # parse .points file - # pts_num = pts.pts_num() - # coords = pts.points() - # normals = pts.normals() - # features = pts.features() - # - # # transform into numpy arrays - # coords = np.array(coords).reshape((pts_num, -1)) - # normals = np.array(normals).reshape((pts_num, -1)) - # features = np.array(features).reshape((pts_num, -1)) - # features = np.concatenate((normals, features), axis = 1) - # - # return coords, features - # - # def parse_coords(self, pts): - # pts_num = pts.pts_num() - # coords = pts.points() - # # normals = pts.normals() - # # features = pts.features() - # - # # transform into numpy arrays - # coords = np.array(coords).reshape((pts_num, -1)) - # # normals = np.array(normals).reshape((pts_num, -1)) - # # features = np.array(features).reshape((pts_num, -1)) - # # features = np.concatenate((normals, features), axis=1) - # - # return coords - # - # def parse_features(self, pts): - # pts_num = pts.pts_num() - # # coords = pts.points() - # normals = pts.normals() - # features = pts.features() - # - # # transform into numpy arrays - # # coords = np.array(coords).reshape((pts_num, -1)) - # normals = np.array(normals).reshape((pts_num, -1)) - # features = np.array(features).reshape((pts_num, -1)) - # features = np.concatenate((normals, features), axis=1) - # - # return features - - def __call__(self, record_names, batch_size, shuffle_size=1000, return_iter=False, take=-1, return_pts=False, **kwargs): with tf.name_scope('points2grids_dataset'): @@ -232,7 +187,6 @@ def wrap_preprocess(record): #https://www.tensorflow.org/api_docs/python/tf/data/Dataset#prefetch return itr if return_iter else itr.get_next() - class OctreeDataset: def __init__(self, parse_example): self.parse_example = parse_example @@ -277,14 +231,12 @@ def preprocess(record): return itr if return_iter else itr.get_next() class DatasetFactory: - def __init__(self, flags, y_type = 'int', bounding_sphere=bounding_sphere, - point_dataset=PointDataset): + def __init__(self, flags, y_type = 'int', normalize_points=NormalizePoints, + point_dataset=PointDataset, transform_points=TransformPoints): self.flags = flags if flags.dtype == 'points': - print(flags) - self.dataset = point_dataset(ParseExample(y_type = y_type, **flags), - TransformPoints(**flags, bounding_sphere=bounding_sphere), - Points2Octree(**flags)) + self.dataset = point_dataset(ParseExample(y_type = y_type, **flags), normalize_points(), + transform_points(**flags), Points2Octree(**flags)) elif flags.dtype == 'octree': self.dataset = OctreeDataset(ParseExample(y_type = y_type, **flags)) elif flags.dtype == 'grids': @@ -298,13 +250,8 @@ def __init__(self, flags, y_type = 'int', bounding_sphere=bounding_sphere, else: print('Error: unsupported datatype ' + flags.dtype) - def __call__(self): + def __call__(self, return_iter=False): return self.dataset( record_names=self.flags.location, batch_size=self.flags.batch_size, - shuffle_size=self.flags.shuffle, return_iter=self.flags.return_iter, - take=self.flags.take, return_pts=self.flags.return_pts, - depth = self.flags.depth) - - -# Put tfrecords, o.w. the disk io will be bottleneck. -# Big CPU memory, can support large tfrecords. \ No newline at end of file + shuffle_size=self.flags.shuffle, return_iter=return_iter, + take=self.flags.take, return_pts=self.flags.return_pts, depth = self.flags.depth) diff --git a/tensorflow/script/dataset/README.md b/tensorflow/script/dataset/README.md deleted file mode 100644 index 428c8b6..0000000 --- a/tensorflow/script/dataset/README.md +++ /dev/null @@ -1,3 +0,0 @@ -# Dataset - -This folder contains the data used in the experiments. diff --git a/tensorflow/script/detail.txt b/tensorflow/script/detail.txt deleted file mode 100644 index f6752df..0000000 --- a/tensorflow/script/detail.txt +++ /dev/null @@ -1,39 +0,0 @@ -1. Tensorboard is available -https://stackoverflow.com/questions/37987839/how-can-i-run-tensorboard-on-a-remote-server - -depth=8 sometimes stop -2020-08-03 11:16:59.926547: I tensorflow/stream_executor/platform/default/dso_loader.cc:42] Successfully opened dynamic library libcudnn.so.7 - 10%|███▋ | 4151/40720 [48:24<7:15:29, 1.40it/s]2020-08-03 12:05:10.841355: F tensorflow/core/framework/tensor_shape.cc:324] Check failed: size >= 0 (-269897832 vs. 0) -Aborted (core dumped) -Question: shape溢出?check - -2020-08-05 08:59:35.437257: I tensorflow/stream_executor/platform/default/dso_loader.cc:42] Successfully opened dynamic library libcudnn.so.7 - 7%|██▌ | 1325/19044 [15:41<3:20:12, 1.47it/s]2020-08-05 09:15:02.874012: F tensorflow/core/framework/tensor_shape.cc:324] Check failed: size >= 0 (-268584336 vs. 0) -Aborted (core dumped) - - - 19%|██████▋ | 3550/19044 [32:33<1:38:42, 2.62it/s]2020-08-13 18:16:04.658965: F tensorflow/core/framework/tensor_shape.cc:324] Check failed: size >= 0 (-275657904 vs. 0) -Aborted (core dumped) -Check failed: size >= 0 (-1872442624 vs. 0) - -depth=8: -den5 vs den6 in 1a1e: octree node: 206744 vs 215912. -Question: will density affect the performance? -try den3 and den4 on depth=6 octree, compare. - - -astex: protein.mol2 ligand.mol -This Mol2 file is non-standard. Problem with molecule: A_1G9V_PROTEIN Cannot interpret atom types correctly, instead attempting to interpret atom type: C as elements instead. - -for D in /media/data/data_share/qil15006/astex_diverse_set/*/; -do - echo "${D}"; - cd "${D}"; - obabel ligand.mol -O ligand.mol2; - obabel protein.mol2 -O pocket.pdb; - java -cp /home/qil15006/2020Summer/OCNN_Jun26_2020/pdbbind/java/cdk-2.3-SNAPSHOT.jar:/home/qil15006/2020Summer/OCNN_Jun26_2020/pdbbind/java Surface_for_single 5 ico pdbbind; - /home/qil15006/.conda/envs/tf-OCNN/bin/python /home/qil15006/2020Summer/OCNN_Jun26_2020/pdbbind/write_complex.py - /home/qil15006/.conda/envs/tf-OCNN/bin/python /home/qil15006/2020Summer/OCNN_Jun26_2020/pdbbind/atomic_feature_astex.py - /home/qil15006/2020Summer/OCNN_Jun26_2020/octree/build/pdb_to_points --complex_id file_list.txt - cd ..; -done \ No newline at end of file diff --git a/tensorflow/script/logs/.DS_Store b/tensorflow/script/logs/.DS_Store deleted file mode 100644 index 48a8af9..0000000 Binary files a/tensorflow/script/logs/.DS_Store and /dev/null differ diff --git a/tensorflow/script/logs/pdbbind/.DS_Store b/tensorflow/script/logs/pdbbind/.DS_Store deleted file mode 100644 index 5051dbe..0000000 Binary files a/tensorflow/script/logs/pdbbind/.DS_Store and /dev/null differ diff --git a/tensorflow/script/logs/pdbbind/resnet_point2grid_20200806_reg_6/timeline.json b/tensorflow/script/logs/pdbbind/resnet_point2grid_20200806_reg_6/timeline.json deleted file mode 100644 index 022b34c..0000000 --- a/tensorflow/script/logs/pdbbind/resnet_point2grid_20200806_reg_6/timeline.json +++ /dev/null @@ -1,47367 +0,0 @@ -{ - "traceEvents": [ - { - "name": "process_name", - "ph": "M", - "pid": 0, - "args": { - "name": "Allocators" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 1, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/stream#3:MemcpyDtoH Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 2, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/stream#3:MemcpyDtoH Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 3, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/stream#2:MemcpyHtoD Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 4, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/stream#2:MemcpyHtoD Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 5, - "args": { - "name": "/device:GPU:0/stream:all Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 6, - "args": { - "name": "/device:GPU:0/stream:all Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 7, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/stream#1 Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 8, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/stream#1 Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 9, - "args": { - "name": "/host:CPU Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 10, - "args": { - "name": "/host:CPU Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 11, - "args": { - "name": "/job:localhost/replica:0/task:0/device:GPU:0 Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 12, - "args": { - "name": "/job:localhost/replica:0/task:0/device:GPU:0 Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 13, - "args": { - "name": "/job:localhost/replica:0/task:0/device:CPU:0 Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 14, - "args": { - "name": "/job:localhost/replica:0/task:0/device:CPU:0 Tensors" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596771182231017, - "dur": 118, - "args": { - "name": "edge_321_solver/step_lr/PiecewiseConstant/and_3::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596771182231031, - "dur": 174, - "args": { - "name": "edge_309_solver/step_lr/PiecewiseConstant/and::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596771182231126, - "dur": 92, - "args": { - "name": "edge_317_solver/step_lr/PiecewiseConstant/and_2::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596771182231663, - "dur": 46, - "args": { - "name": "edge_313_solver/step_lr/PiecewiseConstant/and_1::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596771182231766, - "dur": 16, - "args": { - "name": "edge_273_solver/step_lr/PiecewiseConstant/case/preds_c::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596771182231823, - "dur": 15, - "args": { - "name": "edge_263_solver/step_lr/PiecewiseConstant/case/Cast::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596771182232191, - "dur": 41, - "args": { - "name": "edge_439_solver/step_lr/PiecewiseConstant/case/cond/Merge::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596771182233612, - "dur": 17, - "args": { - "name": "edge_178_loss/l2_regularizer/mul::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596771182821389, - "dur": 3, - "args": { - "name": "edge_640_loss/mse_loss/mean_squared_error/value::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596771182821395, - "dur": 4, - "args": { - "name": "edge_647_add::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596771182821709, - "dur": 12, - "args": { - "name": "edge_596_solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1596771182230226, - "dur": 39, - "args": { - "name": "edge_113_solver/step_lr/PiecewiseConstant/LessEqual_4::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1596771182230298, - "dur": 35, - "args": { - "name": "edge_164_solver/step_lr/PiecewiseConstant/Greater::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1596771182230396, - "dur": 218, - "args": { - "name": "edge_115_solver/step_lr/PiecewiseConstant/LessEqual_3::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 1, - "ts": 1596771182230412, - "dur": 309, - "args": { - "name": "edge_112_solver/step_lr/PiecewiseConstant/Greater_4::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 2, - "ts": 1596771182230426, - "dur": 118, - "args": { - "name": "edge_119_solver/step_lr/PiecewiseConstant/LessEqual_1::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 3, - "ts": 1596771182230469, - "dur": 237, - "args": { - "name": "edge_116_solver/step_lr/PiecewiseConstant/Greater_2::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 4, - "ts": 1596771182230509, - "dur": 181, - "args": { - "name": "edge_163_solver/step_lr/PiecewiseConstant/LessEqual::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1596771182230626, - "dur": 139, - "args": { - "name": "edge_117_solver/step_lr/PiecewiseConstant/LessEqual_2::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 5, - "ts": 1596771182230523, - "dur": 215, - "args": { - "name": "edge_114_solver/step_lr/PiecewiseConstant/Greater_3::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 2, - "ts": 1596771182230567, - "dur": 185, - "args": { - "name": "edge_118_solver/step_lr/PiecewiseConstant/Greater_1::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1596771182233113, - "dur": 17, - "args": { - "name": "edge_587_solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1596771182795501, - "dur": 16, - "args": { - "name": "edge_616_IteratorGetNext::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1596771182795561, - "dur": 4106, - "args": { - "name": "edge_100_IteratorGetNext::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1596771182821349, - "dur": 4, - "args": { - "name": "edge_586_solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1596771182821357, - "dur": 3, - "args": { - "name": "edge_610_solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182230780, - "dur": 36, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_3", - "op": "LogicalAnd#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182230831, - "dur": 54, - "args": { - "name": "loss/l2_regularizer/L2Loss_33", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182230889, - "dur": 154, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_2", - "op": "LogicalAnd#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182230894, - "dur": 188, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_1", - "op": "LogicalAnd#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd#id=52#", - "pid": 5, - "tid": 2, - "ts": 1596771182230899, - "dur": 35, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and", - "op": "LogicalAnd#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 2, - "ts": 1596771182230976, - "dur": 140, - "args": { - "name": "loss/l2_regularizer/L2Loss_33", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231178, - "dur": 70, - "args": { - "name": "loss/l2_regularizer/L2Loss_23", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231292, - "dur": 27, - "args": { - "name": "loss/l2_regularizer/L2Loss_23", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231346, - "dur": 38, - "args": { - "name": "loss/l2_regularizer/L2Loss_13", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231413, - "dur": 27, - "args": { - "name": "loss/l2_regularizer/L2Loss_8", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231542, - "dur": 17, - "args": { - "name": "loss/l2_regularizer/L2Loss_31", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231563, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_31", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231591, - "dur": 25, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Cast", - "op": "Cast#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231626, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_40", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231668, - "dur": 20, - "args": { - "name": "loss/l2_regularizer/L2Loss_39", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231719, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_39", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231791, - "dur": 18, - "args": { - "name": "loss/l2_regularizer/L2Loss_29", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231844, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_38", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231863, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_38", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231899, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_28", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231917, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_28", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231948, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_18", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182231969, - "dur": 18, - "args": { - "name": "loss/l2_regularizer/L2Loss_18", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232010, - "dur": 18, - "args": { - "name": "loss/l2_regularizer/L2Loss_37", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232033, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_37", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232070, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_27", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232099, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_17", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232146, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_7", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232187, - "dur": 28, - "args": { - "name": "loss/l2_regularizer/L2Loss_12", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232238, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_36", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232260, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_36", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232290, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_26", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232324, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_16", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232358, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_6", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232392, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_11", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232410, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_11", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232440, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_30", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232461, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_30", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232492, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_35", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232511, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_35", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232542, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_25", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232559, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_25", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232593, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_15", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232614, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_15", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232647, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_5", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232680, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_41", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232711, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_34", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232731, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_34", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232760, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_19", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232792, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_9", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232821, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_4", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232852, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_10", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232884, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_24", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232913, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_14", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232946, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_2", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182232979, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_22", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233007, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_3", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233041, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_21", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233058, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_21", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233172, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_1", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233212, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_20", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233243, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233264, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233297, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_32", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233314, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_32", - "op": "L2Loss#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233357, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233378, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233398, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233414, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233430, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233450, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233535, - "dur": 19, - "args": { - "name": "loss/l2_regularizer/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233672, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_31_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233724, - "dur": 18, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_38_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233769, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_35_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233810, - "dur": 14, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_33_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233847, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_8_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233887, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_6_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233931, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_18_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182233967, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_15_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234001, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_11_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234037, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_10_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234074, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_25_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234114, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_13_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234147, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_28_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234185, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_16_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234223, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_12_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234259, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_29_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234292, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_26_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234327, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_19_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234365, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_14_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234400, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_27_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234436, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_24_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234469, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_2_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234506, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_17_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234542, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_36_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234580, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_32_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234613, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_9_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234651, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_7_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234687, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_3_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234724, - "dur": 17, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_34_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234766, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_30_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234798, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234834, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_21_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234874, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_23_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234910, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_4_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234942, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_1_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182234978, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_40_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182235015, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_22_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182235052, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_39_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182235084, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_5_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182235119, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_41_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182235155, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_20_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182235188, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_37_grad/mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182799866, - "dur": 29, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182799954, - "dur": 27, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182799981, - "dur": 173, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182800155, - "dur": 3, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182800160, - "dur": 3463, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182803625, - "dur": 384, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182804010, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182804019, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182804034, - "dur": 44, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182804080, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182804084, - "dur": 372, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182804458, - "dur": 96, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182804555, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182804567, - "dur": 24, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182804592, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182804638, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182804643, - "dur": 1424, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182806068, - "dur": 97, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182806166, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182806170, - "dur": 485, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182806657, - "dur": 383, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182807042, - "dur": 567, - "args": { - "name": "ocnn_resnet/resblock_6_0/add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182807610, - "dur": 382, - "args": { - "name": "ocnn_resnet/resblock_6_0/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182807993, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182808000, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182808015, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182808061, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182808065, - "dur": 371, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182808436, - "dur": 95, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182808534, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182808542, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182808565, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182808612, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182808616, - "dur": 1426, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182810043, - "dur": 98, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182810142, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182810147, - "dur": 467, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182810616, - "dur": 384, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182811001, - "dur": 570, - "args": { - "name": "ocnn_resnet/resblock_6_1/add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182811573, - "dur": 384, - "args": { - "name": "ocnn_resnet/resblock_6_1/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182811958, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182811964, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182811977, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182812024, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182812028, - "dur": 372, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182812401, - "dur": 96, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182812499, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182812512, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182812536, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182812582, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182812586, - "dur": 1425, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182814012, - "dur": 97, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182814110, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182814115, - "dur": 469, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182814585, - "dur": 384, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182814971, - "dur": 565, - "args": { - "name": "ocnn_resnet/resblock_6_2/add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182815537, - "dur": 382, - "args": { - "name": "ocnn_resnet/resblock_6_2/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182815920, - "dur": 226, - "args": { - "name": "ocnn_resnet/max_pool_6/MaxPool3D", - "op": "MaxPool3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816147, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816152, - "dur": 141, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816295, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816299, - "dur": 60, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816360, - "dur": 96, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816458, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816485, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816495, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816507, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816521, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816526, - "dur": 313, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816840, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816867, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182816872, - "dur": 127, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817000, - "dur": 97, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817098, - "dur": 144, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817245, - "dur": 96, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817343, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817347, - "dur": 100, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817450, - "dur": 24, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182817474, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817482, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817493, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817507, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817511, - "dur": 314, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817827, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182817853, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817858, - "dur": 124, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182817983, - "dur": 97, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182818081, - "dur": 144, - "args": { - "name": "ocnn_resnet/resblock_5_1/add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182818227, - "dur": 96, - "args": { - "name": "ocnn_resnet/resblock_5_1/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182818325, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182818329, - "dur": 101, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182818432, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182818457, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182818469, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182818481, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182818495, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182818500, - "dur": 313, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182818815, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182818841, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182818846, - "dur": 128, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182818975, - "dur": 97, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819074, - "dur": 144, - "args": { - "name": "ocnn_resnet/resblock_5_2/add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819219, - "dur": 97, - "args": { - "name": "ocnn_resnet/resblock_5_2/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819317, - "dur": 63, - "args": { - "name": "ocnn_resnet/max_pool_5/MaxPool3D", - "op": "MaxPool3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819383, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819388, - "dur": 73, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819462, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819467, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819500, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819526, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819536, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819545, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819555, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819561, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819566, - "dur": 79, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819646, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819651, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819658, - "dur": 61, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819722, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819748, - "dur": 39, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182819787, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819814, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819819, - "dur": 42, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819862, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819868, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819876, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819885, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819891, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819896, - "dur": 79, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819976, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819981, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182819985, - "dur": 66, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820053, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182820078, - "dur": 39, - "args": { - "name": "ocnn_resnet/resblock_4_1/add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820118, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_4_1/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820145, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820150, - "dur": 43, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820194, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820199, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820210, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820221, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820227, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820232, - "dur": 79, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820312, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820317, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820322, - "dur": 61, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182820383, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820410, - "dur": 38, - "args": { - "name": "ocnn_resnet/resblock_4_2/add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820449, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_4_2/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820476, - "dur": 20, - "args": { - "name": "ocnn_resnet/max_pool_4/MaxPool3D", - "op": "MaxPool3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820497, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820506, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820517, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820523, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820528, - "dur": 29, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820558, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820565, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820573, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820577, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820581, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820608, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820613, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820617, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820629, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820638, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820644, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820647, - "dur": 82, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820730, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820734, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820744, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820753, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820759, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820763, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820786, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820791, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820800, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820805, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820817, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820827, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820831, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820835, - "dur": 38, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820874, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820879, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820891, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820901, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820905, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820909, - "dur": 81, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820991, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182820995, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821005, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821015, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821021, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821025, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821048, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821053, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_3_1/add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821062, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821067, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821080, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821089, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821093, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821097, - "dur": 38, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821136, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821140, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821153, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821163, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821167, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821171, - "dur": 81, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821254, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821258, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821267, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821277, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821284, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821287, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182821309, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821314, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_3_2/add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821323, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/Relu", - "op": "Relu#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3D#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821329, - "dur": 7, - "args": { - "name": "ocnn_resnet/max_pool_3/MaxPool3D", - "op": "MaxPool3D#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mean#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821337, - "dur": 4, - "args": { - "name": "ocnn_resnet/global_average/Mean", - "op": "Mean#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821343, - "dur": 4, - "args": { - "name": "ocnn_resnet/fc2/dense/MatMul", - "op": "MatMul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BiasAdd#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821348, - "dur": 3, - "args": { - "name": "ocnn_resnet/fc2/dense/BiasAdd", - "op": "BiasAdd#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "SquaredDifference#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821353, - "dur": 3, - "args": { - "name": "loss/mse_loss/mean_squared_error/SquaredDifference", - "op": "SquaredDifference#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Fill#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821358, - "dur": 4, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like", - "op": "Fill#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821363, - "dur": 4, - "args": { - "name": "loss/mse_loss/mean_squared_error/Sum", - "op": "Sum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821369, - "dur": 3, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present", - "op": "Sum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DivNoNan#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821373, - "dur": 3, - "args": { - "name": "loss/mse_loss/mean_squared_error/value", - "op": "DivNoNan#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DivNoNan#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821377, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan", - "op": "DivNoNan#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821381, - "dur": 3, - "args": { - "name": "add", - "op": "Add#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Tile#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821385, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile", - "op": "Tile#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821390, - "dur": 4, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/sub", - "op": "Sub#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821396, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Mul", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821401, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/mul_1", - "op": "Mul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BiasAddGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821415, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad", - "op": "BiasAddGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821425, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul_1", - "op": "MatMul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821431, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul", - "op": "MatMul#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821436, - "dur": 3, - "args": { - "name": "solver/gradients/AddN", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821440, - "dur": 2, - "args": { - "name": "solver/gradients/AddN_1", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821444, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821448, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821452, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821457, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DynamicStitch#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821587, - "dur": 68, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch", - "op": "DynamicStitch#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182821600, - "dur": 28, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Cast", - "op": "Cast#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Tile#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821805, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Tile", - "op": "Tile#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "RealDiv#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821846, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/truediv", - "op": "RealDiv#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3DGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821895, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/MaxPool3D_grad/MaxPool3DGrad", - "op": "MaxPool3DGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3DGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821912, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/MaxPool3D_grad/MaxPool3DGrad", - "op": "MaxPool3DGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821945, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182821970, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822040, - "dur": 121, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822162, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822167, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822174, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822180, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822184, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822197, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822243, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822257, - "dur": 9, - "args": { - "name": "solver/gradients/AddN_2", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822319, - "dur": 171, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822492, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822500, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822510, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182822514, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822520, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822524, - "dur": 81, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822607, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822612, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822617, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822621, - "dur": 5, - "args": { - "name": "solver/gradients/AddN_3", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822630, - "dur": 161, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822793, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822798, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822804, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822811, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822819, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822823, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182822847, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822854, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822862, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_4", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822871, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_5", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822876, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822884, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822888, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822902, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182822953, - "dur": 116, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182823069, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823075, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823083, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823091, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823096, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823101, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823141, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823145, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_6", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823198, - "dur": 169, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823369, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823378, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823392, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823400, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823404, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823409, - "dur": 81, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823491, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823495, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823500, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823506, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_7", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823516, - "dur": 161, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823679, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823684, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823691, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823699, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823705, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823710, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823734, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823741, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823748, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_8", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823758, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_9", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823762, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823770, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823775, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823779, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823790, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823848, - "dur": 124, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823973, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823979, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182823990, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824000, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824005, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824010, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824058, - "dur": 115, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824174, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824180, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824188, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824199, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824203, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824208, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824248, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_11", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824253, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824258, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_10", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824279, - "dur": 10, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824291, - "dur": 8, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824347, - "dur": 171, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824520, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824528, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824540, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824549, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824554, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824559, - "dur": 80, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824641, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824645, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824650, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824655, - "dur": 5, - "args": { - "name": "solver/gradients/AddN_12", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824668, - "dur": 164, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824833, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824838, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824844, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824856, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824861, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824865, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824890, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824895, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824901, - "dur": 5, - "args": { - "name": "solver/gradients/AddN_13", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824907, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_14", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3DGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824912, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/MaxPool3D_grad/MaxPool3DGrad", - "op": "MaxPool3DGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3DGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824926, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/MaxPool3D_grad/MaxPool3DGrad", - "op": "MaxPool3DGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824966, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824971, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182824975, - "dur": 37, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825013, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825056, - "dur": 609, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825668, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825673, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825680, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825688, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825695, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825699, - "dur": 32, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825733, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825740, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_15", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825746, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825754, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825757, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182825761, - "dur": 961, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826724, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826729, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826736, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826747, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826753, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826757, - "dur": 81, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826839, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826844, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826848, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826856, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_16", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826867, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826875, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826879, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182826882, - "dur": 826, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827710, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827714, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827723, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827730, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827743, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827748, - "dur": 48, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827797, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827802, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827807, - "dur": 37, - "args": { - "name": "solver/gradients/AddN_17", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827846, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_18", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827850, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827889, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827894, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827900, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182827942, - "dur": 606, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182828549, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182828554, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182828562, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182828568, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182828574, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182828579, - "dur": 30, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182828609, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182828617, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_19", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182828625, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182828637, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182828641, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182828645, - "dur": 966, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182829612, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182829618, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182829626, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182829636, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182829642, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182829647, - "dur": 82, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182829729, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182829734, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182829739, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182829746, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_20", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182829755, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182829759, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182829763, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182829767, - "dur": 829, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830598, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830603, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830608, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830618, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830633, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830637, - "dur": 48, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830686, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830691, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830696, - "dur": 38, - "args": { - "name": "solver/gradients/AddN_21", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830735, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_22", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830739, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830778, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830783, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830787, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830826, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182830867, - "dur": 625, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182831494, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182831498, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182831506, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182831510, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182831519, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182831525, - "dur": 42, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182831569, - "dur": 599, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832170, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832174, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832180, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832190, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832197, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832201, - "dur": 31, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832234, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_24", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832238, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832245, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_23", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832250, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832255, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832264, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832270, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832273, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182832277, - "dur": 952, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833231, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833237, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833243, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833248, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833255, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833258, - "dur": 82, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833341, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833346, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833350, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833358, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_25", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833368, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833378, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833381, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182833385, - "dur": 853, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834239, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834244, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834256, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834266, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834275, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834279, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834301, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834307, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834312, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_26", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834329, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_27", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3DGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834333, - "dur": 81, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/MaxPool3D_grad/MaxPool3DGrad", - "op": "MaxPool3DGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3DGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834415, - "dur": 93, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/MaxPool3D_grad/MaxPool3DGrad", - "op": "MaxPool3DGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834510, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834514, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834518, - "dur": 144, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834663, - "dur": 144, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834813, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834825, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834829, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182834833, - "dur": 5873, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182840708, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182840713, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182840719, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182840729, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182840744, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182840748, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182840841, - "dur": 37, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182840879, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_28", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182840891, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182840902, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182840906, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182840911, - "dur": 3870, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182844781, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182844786, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182844799, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182844811, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182844825, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182844828, - "dur": 313, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182845143, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182845147, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182845152, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182845192, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_29", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182845200, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182845211, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182845215, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182845220, - "dur": 3769, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182848990, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182848994, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849001, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849011, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849059, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849063, - "dur": 127, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849191, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849196, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849200, - "dur": 144, - "args": { - "name": "solver/gradients/AddN_30", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849346, - "dur": 2, - "args": { - "name": "solver/gradients/AddN_31", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849350, - "dur": 144, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849496, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849501, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849505, - "dur": 145, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849657, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849670, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849673, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182849677, - "dur": 5880, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182855558, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182855563, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182855572, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182855582, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182855597, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182855601, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182855694, - "dur": 37, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182855732, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_32", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182855744, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182855755, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182855760, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182855764, - "dur": 3853, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182859618, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182859623, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182859635, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182859648, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182859662, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182859666, - "dur": 311, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182859979, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182859984, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182859988, - "dur": 40, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182860029, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_33", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182860037, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182860048, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182860052, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182860055, - "dur": 3766, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182863823, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182863828, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182863838, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182863848, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182863895, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182863898, - "dur": 125, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864024, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864029, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864033, - "dur": 144, - "args": { - "name": "solver/gradients/AddN_34", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864179, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_35", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864183, - "dur": 144, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864329, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864334, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864338, - "dur": 144, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864483, - "dur": 145, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864633, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864645, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864648, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182864652, - "dur": 5796, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182870449, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182870454, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182870465, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182870476, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182870501, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182870505, - "dur": 105, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182870613, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182870624, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182870628, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182870632, - "dur": 5799, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876432, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876437, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876445, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876456, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876470, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876474, - "dur": 91, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876566, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_37", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876570, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876609, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_36", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876613, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876618, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876625, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876637, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876641, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182876645, - "dur": 3877, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880524, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880528, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880541, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880554, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880567, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880571, - "dur": 312, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880885, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880890, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880894, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880934, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_38", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880943, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880954, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880958, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182880962, - "dur": 3726, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182884691, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182884695, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182884703, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182884713, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182884739, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182884743, - "dur": 67, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182884811, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182884817, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182884821, - "dur": 74, - "args": { - "name": "solver/gradients/AddN_39", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182884895, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_40", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3DGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182884900, - "dur": 273, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_6/MaxPool3D_grad/MaxPool3DGrad", - "op": "MaxPool3DGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3DGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182885174, - "dur": 248, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_6/MaxPool3D_grad/MaxPool3DGrad", - "op": "MaxPool3DGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182885423, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182885428, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182885432, - "dur": 574, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182886009, - "dur": 579, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182886590, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182886606, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182886610, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182886614, - "dur": 15276, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182901891, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182901895, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182901901, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182901916, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182901962, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182901967, - "dur": 369, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182902336, - "dur": 144, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182902482, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_41", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182902486, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182902499, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182902525, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182902571, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182902575, - "dur": 1427, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182904007, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182904022, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182904026, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182904030, - "dur": 15487, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182919518, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182919523, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182919527, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182919531, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_42", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182919536, - "dur": 140, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182919678, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182919683, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182919687, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182919696, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182919711, - "dur": 173, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182919886, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182919890, - "dur": 439, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182920336, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182920351, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182920356, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182920360, - "dur": 15025, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182935386, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182935390, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_44", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182935394, - "dur": 564, - "args": { - "name": "solver/gradients/AddN_43", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182935959, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182935964, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182935968, - "dur": 575, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182936545, - "dur": 578, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182937131, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182937146, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182937150, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182937154, - "dur": 15269, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182952425, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182952428, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182952435, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182952450, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182952496, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182952500, - "dur": 369, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182952870, - "dur": 143, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182953015, - "dur": 2, - "args": { - "name": "solver/gradients/AddN_45", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182953019, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182953028, - "dur": 25, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771182953053, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182953099, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182953103, - "dur": 1425, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182954534, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182954556, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182954560, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182954564, - "dur": 15606, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970171, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970176, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970180, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970184, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_46", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970188, - "dur": 142, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970332, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970336, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970341, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970354, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970369, - "dur": 172, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970543, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970546, - "dur": 438, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182970993, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182971009, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182971013, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182971017, - "dur": 15137, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182986155, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182986159, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_48", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182986163, - "dur": 562, - "args": { - "name": "solver/gradients/AddN_47", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182986726, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182986730, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182986734, - "dur": 574, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182987311, - "dur": 574, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182987891, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182987906, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182987910, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771182987913, - "dur": 15649, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183003564, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183003567, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183003578, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183003593, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183003640, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183003644, - "dur": 369, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 1, - "ts": 1596771183004013, - "dur": 143, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183004158, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_49", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183004162, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183004168, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183004195, - "dur": 44, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183004241, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183004244, - "dur": 1424, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183005675, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183005691, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183005695, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183005699, - "dur": 15538, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183021238, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183021242, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183021247, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183021251, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_50", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183021255, - "dur": 140, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183021398, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183021402, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183021406, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183021412, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183021427, - "dur": 172, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183021601, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183021605, - "dur": 437, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183022051, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183022066, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183022070, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183022074, - "dur": 15063, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183037138, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183037142, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_52", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183037146, - "dur": 564, - "args": { - "name": "solver/gradients/AddN_51", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183037711, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183037715, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183037719, - "dur": 577, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183038301, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183038316, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183038320, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183038324, - "dur": 15183, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183053508, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183053513, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_53", - "op": "AddN#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183053519, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=52#", - "pid": 5, - "tid": 0, - "ts": 1596771183053523, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 3, - "ts": 1596771182230226, - "dur": 39, - "args": { - "name": "edge_113_solver/step_lr/PiecewiseConstant/LessEqual_4", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 3, - "ts": 1596771182230298, - "dur": 35, - "args": { - "name": "edge_164_solver/step_lr/PiecewiseConstant/Greater", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 3, - "ts": 1596771182230396, - "dur": 218, - "args": { - "name": "edge_115_solver/step_lr/PiecewiseConstant/LessEqual_3", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 4, - "ts": 1596771182230412, - "dur": 309, - "args": { - "name": "edge_112_solver/step_lr/PiecewiseConstant/Greater_4", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 5, - "ts": 1596771182230426, - "dur": 118, - "args": { - "name": "edge_119_solver/step_lr/PiecewiseConstant/LessEqual_1", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 6, - "ts": 1596771182230469, - "dur": 237, - "args": { - "name": "edge_116_solver/step_lr/PiecewiseConstant/Greater_2", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 7, - "ts": 1596771182230509, - "dur": 181, - "args": { - "name": "edge_163_solver/step_lr/PiecewiseConstant/LessEqual", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 3, - "ts": 1596771182230626, - "dur": 139, - "args": { - "name": "edge_117_solver/step_lr/PiecewiseConstant/LessEqual_2", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 8, - "ts": 1596771182230523, - "dur": 215, - "args": { - "name": "edge_114_solver/step_lr/PiecewiseConstant/Greater_3", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 5, - "ts": 1596771182230567, - "dur": 185, - "args": { - "name": "edge_118_solver/step_lr/PiecewiseConstant/Greater_1", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 3, - "ts": 1596771182231017, - "dur": 118, - "args": { - "name": "edge_321_solver/step_lr/PiecewiseConstant/and_3", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 4, - "ts": 1596771182231031, - "dur": 174, - "args": { - "name": "edge_309_solver/step_lr/PiecewiseConstant/and", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182231126, - "dur": 92, - "args": { - "name": "edge_317_solver/step_lr/PiecewiseConstant/and_2", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack#id=52#", - "pid": 5, - "tid": 3, - "ts": 1596771182231193, - "dur": 88, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack#id=52#", - "pid": 5, - "tid": 2, - "ts": 1596771182231322, - "dur": 33, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack#id=52#", - "pid": 5, - "tid": 2, - "ts": 1596771182231365, - "dur": 41, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack#id=52#", - "pid": 5, - "tid": 2, - "ts": 1596771182231449, - "dur": 22, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack#id=52#", - "pid": 5, - "tid": 2, - "ts": 1596771182231478, - "dur": 21, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack#id=52#", - "pid": 5, - "tid": 2, - "ts": 1596771182231507, - "dur": 20, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack#id=52#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182231663, - "dur": 46, - "args": { - "name": "edge_313_solver/step_lr/PiecewiseConstant/and_1", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182231766, - "dur": 16, - "args": { - "name": "edge_273_solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182231823, - "dur": 15, - "args": { - "name": "edge_263_solver/step_lr/PiecewiseConstant/case/Cast", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182232191, - "dur": 41, - "args": { - "name": "edge_439_solver/step_lr/PiecewiseConstant/case/cond/Merge", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182233113, - "dur": 17, - "args": { - "name": "edge_587_solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182233612, - "dur": 17, - "args": { - "name": "edge_178_loss/l2_regularizer/mul", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182795501, - "dur": 16, - "args": { - "name": "edge_616_IteratorGetNext", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182795561, - "dur": 4106, - "args": { - "name": "edge_100_IteratorGetNext", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182821349, - "dur": 4, - "args": { - "name": "edge_586_solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182821357, - "dur": 3, - "args": { - "name": "edge_610_solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182821389, - "dur": 3, - "args": { - "name": "edge_640_loss/mse_loss/mean_squared_error/value", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182821395, - "dur": 4, - "args": { - "name": "edge_647_add", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 5, - "tid": 2, - "ts": 1596771182821709, - "dur": 12, - "args": { - "name": "edge_596_solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182230780, - "dur": 36, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_3:LogicalAnd#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIbLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIbbNS0_21scalar_boolean_and_opEEEKNS4_INS5_IKbLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182230831, - "dur": 54, - "args": { - "name": "loss/l2_regularizer/L2Loss_33:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182230889, - "dur": 154, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_2:LogicalAnd#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIbLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIbbNS0_21scalar_boolean_and_opEEEKNS4_INS5_IKbLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182230894, - "dur": 188, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_1:LogicalAnd#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIbLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIbbNS0_21scalar_boolean_and_opEEEKNS4_INS5_IKbLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 2, - "ts": 1596771182230899, - "dur": 35, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and:LogicalAnd#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIbLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIbbNS0_21scalar_boolean_and_opEEEKNS4_INS5_IKbLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 2, - "ts": 1596771182230976, - "dur": 140, - "args": { - "name": "loss/l2_regularizer/L2Loss_33:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231178, - "dur": 70, - "args": { - "name": "loss/l2_regularizer/L2Loss_23:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231292, - "dur": 27, - "args": { - "name": "loss/l2_regularizer/L2Loss_23:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231346, - "dur": 38, - "args": { - "name": "loss/l2_regularizer/L2Loss_13:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231413, - "dur": 27, - "args": { - "name": "loss/l2_regularizer/L2Loss_8:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231542, - "dur": 17, - "args": { - "name": "loss/l2_regularizer/L2Loss_31:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231563, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_31:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231591, - "dur": 25, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Cast:Cast#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIiLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_18TensorConversionOpIiKNS4_INS5_IKbLi1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231626, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_40:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231668, - "dur": 20, - "args": { - "name": "loss/l2_regularizer/L2Loss_39:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231719, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_39:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231791, - "dur": 18, - "args": { - "name": "loss/l2_regularizer/L2Loss_29:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231844, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_38:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231863, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_38:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231899, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_28:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231917, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_28:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231948, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_18:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182231969, - "dur": 18, - "args": { - "name": "loss/l2_regularizer/L2Loss_18:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232010, - "dur": 18, - "args": { - "name": "loss/l2_regularizer/L2Loss_37:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232033, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_37:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232070, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_27:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232099, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_17:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232146, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_7:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232187, - "dur": 28, - "args": { - "name": "loss/l2_regularizer/L2Loss_12:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232238, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_36:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232260, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_36:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232290, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_26:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232324, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_16:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232358, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_6:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232392, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_11:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232410, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_11:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232440, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_30:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232461, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_30:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232492, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_35:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232511, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_35:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232542, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_25:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232559, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_25:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232593, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_15:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232614, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_15:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232647, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_5:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232680, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_41:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232711, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_34:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232731, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_34:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232760, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_19:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232792, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_9:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232821, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_4:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232852, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_10:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232884, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_24:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232913, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_14:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232946, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_2:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182232979, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_22:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233007, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_3:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233041, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_21:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233058, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_21:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233172, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_1:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233212, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_20:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233243, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233264, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233297, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_32:L2Loss#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233314, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_32:L2Loss#id=52#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233357, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233378, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233398, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233414, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233430, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233450, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233535, - "dur": 19, - "args": { - "name": "loss/l2_regularizer/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233672, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_31_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233724, - "dur": 18, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_38_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233769, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_35_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233810, - "dur": 14, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_33_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233847, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_8_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233887, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_6_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233931, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_18_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182233967, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_15_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234001, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_11_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234037, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_10_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234074, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_25_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234114, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_13_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234147, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_28_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234185, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_16_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234223, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_12_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234259, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_29_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234292, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_26_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234327, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_19_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234365, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_14_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234400, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_27_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234436, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_24_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234469, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_2_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234506, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_17_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234542, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_36_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234580, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_32_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234613, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_9_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234651, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_7_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234687, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_3_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234724, - "dur": 17, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_34_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234766, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_30_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234798, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234834, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_21_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234874, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_23_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234910, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_4_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234942, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_1_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182234978, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_40_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182235015, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_22_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182235052, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_39_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182235084, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_5_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182235119, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_41_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182235155, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_20_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182235188, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_37_grad/mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182799866, - "dur": 29, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182799954, - "dur": 27, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182799981, - "dur": 173, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182800155, - "dur": 3, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182800160, - "dur": 3463, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182803625, - "dur": 384, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182804010, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182804019, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182804034, - "dur": 44, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182804080, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182804084, - "dur": 372, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182804458, - "dur": 96, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182804555, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182804567, - "dur": 24, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182804592, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182804638, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182804643, - "dur": 1424, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182806068, - "dur": 97, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182806166, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182806170, - "dur": 485, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182806657, - "dur": 383, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182807042, - "dur": 567, - "args": { - "name": "ocnn_resnet/resblock_6_0/add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182807610, - "dur": 382, - "args": { - "name": "ocnn_resnet/resblock_6_0/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182807993, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182808000, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182808015, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182808061, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182808065, - "dur": 371, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182808436, - "dur": 95, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182808534, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182808542, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182808565, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182808612, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182808616, - "dur": 1426, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182810043, - "dur": 98, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182810142, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182810147, - "dur": 467, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182810616, - "dur": 384, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182811001, - "dur": 570, - "args": { - "name": "ocnn_resnet/resblock_6_1/add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182811573, - "dur": 384, - "args": { - "name": "ocnn_resnet/resblock_6_1/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182811958, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182811964, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182811977, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182812024, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182812028, - "dur": 372, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182812401, - "dur": 96, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182812499, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182812512, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182812536, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182812582, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182812586, - "dur": 1425, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182814012, - "dur": 97, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182814110, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182814115, - "dur": 469, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182814585, - "dur": 384, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182814971, - "dur": 565, - "args": { - "name": "ocnn_resnet/resblock_6_2/add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182815537, - "dur": 382, - "args": { - "name": "ocnn_resnet/resblock_6_2/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182815920, - "dur": 226, - "args": { - "name": "ocnn_resnet/max_pool_6/MaxPool3D:MaxPool3D#id=52#::_ZN5cudnn6detail20pooling_fw_5d_kernelIffNS0_15maxpooling_funcIfL21cudnnNanPropagation_t0EEELi0ELb0EEEv17cudnnTensorStructPKT_S5_PS6_18cudnnPoolingStructT0_SB_iNS_15reduced_divisorESC_SC_SC_SC_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816147, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816152, - "dur": 141, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816295, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816299, - "dur": 60, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816360, - "dur": 96, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816458, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816485, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816495, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816507, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816521, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816526, - "dur": 313, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816840, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816867, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182816872, - "dur": 127, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817000, - "dur": 97, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817098, - "dur": 144, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817245, - "dur": 96, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817343, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817347, - "dur": 100, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817450, - "dur": 24, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182817474, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817482, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817493, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817507, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817511, - "dur": 314, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817827, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182817853, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817858, - "dur": 124, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182817983, - "dur": 97, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182818081, - "dur": 144, - "args": { - "name": "ocnn_resnet/resblock_5_1/add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182818227, - "dur": 96, - "args": { - "name": "ocnn_resnet/resblock_5_1/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182818325, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182818329, - "dur": 101, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182818432, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182818457, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182818469, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182818481, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182818495, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182818500, - "dur": 313, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182818815, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182818841, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182818846, - "dur": 128, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182818975, - "dur": 97, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819074, - "dur": 144, - "args": { - "name": "ocnn_resnet/resblock_5_2/add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819219, - "dur": 97, - "args": { - "name": "ocnn_resnet/resblock_5_2/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819317, - "dur": 63, - "args": { - "name": "ocnn_resnet/max_pool_5/MaxPool3D:MaxPool3D#id=52#::_ZN5cudnn6detail20pooling_fw_5d_kernelIffNS0_15maxpooling_funcIfL21cudnnNanPropagation_t0EEELi0ELb0EEEv17cudnnTensorStructPKT_S5_PS6_18cudnnPoolingStructT0_SB_iNS_15reduced_divisorESC_SC_SC_SC_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819383, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819388, - "dur": 73, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi6ELi7ELi3ELi3ELi5ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819462, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819467, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819500, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819526, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819536, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819545, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819555, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819561, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819566, - "dur": 79, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819646, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819651, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819658, - "dur": 61, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi6ELi7ELi3ELi3ELi5ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819722, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819748, - "dur": 39, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182819787, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819814, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819819, - "dur": 42, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819862, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819868, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819876, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819885, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819891, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819896, - "dur": 79, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819976, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819981, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182819985, - "dur": 66, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi6ELi7ELi3ELi3ELi5ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820053, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182820078, - "dur": 39, - "args": { - "name": "ocnn_resnet/resblock_4_1/add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820118, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_4_1/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820145, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820150, - "dur": 43, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi5ELi5ELi3ELi3ELi3ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820194, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820199, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820210, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820221, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820227, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820232, - "dur": 79, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820312, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820317, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820322, - "dur": 61, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn6detail25implicit_convolveNd_sgemmIfLi3ELi1024ELi6ELi7ELi3ELi3ELi5ELi1ELb1ELb0ELb1EEEviiiPKT_iPS2_S5_20kernel_convNd_paramsiffiS5_S5_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182820383, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820410, - "dur": 38, - "args": { - "name": "ocnn_resnet/resblock_4_2/add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820449, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_4_2/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820476, - "dur": 20, - "args": { - "name": "ocnn_resnet/max_pool_4/MaxPool3D:MaxPool3D#id=52#::_ZN5cudnn6detail20pooling_fw_5d_kernelIffNS0_15maxpooling_funcIfL21cudnnNanPropagation_t0EEELi0ELb0EEEv17cudnnTensorStructPKT_S5_PS6_18cudnnPoolingStructT0_SB_iNS_15reduced_divisorESC_SC_SC_SC_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820497, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820506, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820517, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820523, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820528, - "dur": 29, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x128_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820558, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820565, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820573, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820577, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820581, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820608, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820613, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820617, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820629, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820638, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820644, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820647, - "dur": 82, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x64_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820730, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820734, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820744, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820753, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820759, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820763, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x128_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820786, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820791, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820800, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820805, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820817, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820827, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820831, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820835, - "dur": 38, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820874, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820879, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820891, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820901, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820905, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820909, - "dur": 81, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x64_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820991, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182820995, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821005, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821015, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821021, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821025, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x128_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821048, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821053, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_3_1/add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821062, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821067, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821080, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821089, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821093, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821097, - "dur": 38, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821136, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821140, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821153, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821163, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821167, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821171, - "dur": 81, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x64_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821254, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821258, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821267, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821277, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821284, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821287, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D#id=52#::maxwell_scudnn_128x128_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182821309, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821314, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_3_2/add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821323, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/Relu:Relu#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821329, - "dur": 7, - "args": { - "name": "ocnn_resnet/max_pool_3/MaxPool3D:MaxPool3D#id=52#::_ZN5cudnn6detail20pooling_fw_5d_kernelIffNS0_15maxpooling_funcIfL21cudnnNanPropagation_t0EEELi0ELb0EEEv17cudnnTensorStructPKT_S5_PS6_18cudnnPoolingStructT0_SB_iNS_15reduced_divisorESC_SC_SC_SC_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821337, - "dur": 4, - "args": { - "name": "ocnn_resnet/global_average/Mean:Mean#id=52#::_ZN10tensorflow7functor15RowReduceKernelIPfNS_23TransformOutputIteratorIffNS0_9DividesByIffEElEENS0_3SumIfEEEEvT_T0_iiT1_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821343, - "dur": 4, - "args": { - "name": "ocnn_resnet/fc2/dense/MatMul:MatMul#id=52#::_Z17gemv2T_kernel_valIiifffLi128ELi16ELi2ELi2ELb0E16cublasGemvParamsI16cublasGemvTensorIKfES1_IfEfEEvT9_T3_S7_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821348, - "dur": 3, - "args": { - "name": "ocnn_resnet/fc2/dense/BiasAdd:BiasAdd#id=52#::_ZN10tensorflow14BiasNHWCKernelIfEEviPKT_S3_PS1_i", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821353, - "dur": 3, - "args": { - "name": "loss/mse_loss/mean_squared_error/SquaredDifference:SquaredDifference#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_28scalar_squared_difference_opIfEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821358, - "dur": 4, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like:Fill#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_15scalar_const_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821363, - "dur": 4, - "args": { - "name": "loss/mse_loss/mean_squared_error/Sum:Sum#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIPfS2_Li256ENS0_3SumIfEEEEvT_T0_iT2_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821369, - "dur": 3, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present:Sum#id=52#::_ZN10tensorflow7functor17BlockReduceKernelIPfS2_Li256ENS0_3SumIfEEEEvT_T0_iT2_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821373, - "dur": 3, - "args": { - "name": "loss/mse_loss/mean_squared_error/value:DivNoNan#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_13div_no_nan_opIfEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821377, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan:DivNoNan#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_13div_no_nan_opIfEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821381, - "dur": 3, - "args": { - "name": "add:Add#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_13scalar_sum_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821385, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile:Tile#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorBroadcastingOpIKNS_5arrayIiLm1EEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821390, - "dur": 4, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/sub:Sub#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821396, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Mul:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821401, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/mul_1:Mul#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821415, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad:BiasAddGrad#id=52#::_ZN10tensorflow26BiasGradNHWC_SharedAtomicsIfEEviPKT_PS1_i", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821425, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul_1:MatMul#id=52#::_Z13gemv2N_kernelIiifffLi128ELi1ELi4ELi4ELi1E16cublasGemvParamsI16cublasGemvTensorIKfES1_IfEfEEvT9_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821431, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul:MatMul#id=52#::_Z13gemmk1_kernelIfLi256ELi5ELb1ELb0ELb0ELb0E30cublasGemvTensorStridedBatchedIKfES0_IfEfEv18cublasGemmk1ParamsIT_T6_T7_T8_E", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821436, - "dur": 3, - "args": { - "name": "solver/gradients/AddN:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821440, - "dur": 2, - "args": { - "name": "solver/gradients/AddN_1:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821444, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821448, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821452, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821457, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821587, - "dur": 68, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch:DynamicStitch#id=52#::_ZN10tensorflow95_GLOBAL__N__71_tmpxft_0001e163_00000000_12_dynamic_stitch_op_gpu_cu_compute_75_cpp1_ii_7d12ea8519DynamicStitchKernelIiEEviiNS_20GpuDeviceArrayStructIiLi8EEENS2_IPKT_Li8EEEPS4_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182821600, - "dur": 28, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Cast:Cast#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_18TensorConversionOpIfKNS4_INS5_IKiLi1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821805, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Tile:Tile#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi5ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorBroadcastingOpIKNS_5arrayIiLm5EEEKNS4_INS5_IKfLi5ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821846, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/truediv:RealDiv#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_18scalar_quotient_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821895, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/MaxPool3D_grad/MaxPool3DGrad:MaxPool3DGrad#id=52#::_Z20scaleTensor5d_kernelIffLi8ELi8ELi8EEv17cudnnTensorStructPT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821912, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/MaxPool3D_grad/MaxPool3DGrad:MaxPool3DGrad#id=52#::_ZN5cudnn6detail24pooling_bw_5d_kernel_maxIffNS0_15maxpooling_funcIfL21cudnnNanPropagation_t0EEELb0EEEv17cudnnTensorStructPKT_S5_S8_S5_S8_S5_PS6_18cudnnPoolingStructT0_SB_iNS_15reduced_divisorESC_SC_SC_SC_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821945, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182821970, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822040, - "dur": 121, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi128ELi6ELi8ELi3ELi3ELi5ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822162, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822167, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822174, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822180, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822184, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822197, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822243, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822257, - "dur": 9, - "args": { - "name": "solver/gradients/AddN_2:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822319, - "dur": 171, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi512ELi6ELi5ELi3ELi3ELi3ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822492, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822500, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822510, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182822514, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822520, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822524, - "dur": 81, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822607, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822612, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822617, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822621, - "dur": 5, - "args": { - "name": "solver/gradients/AddN_3:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822630, - "dur": 161, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi512ELi6ELi5ELi3ELi3ELi3ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822793, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822798, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822804, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822811, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822819, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822823, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x128_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182822847, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822854, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822862, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_4:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822871, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_5:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822876, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822884, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822888, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822902, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182822953, - "dur": 116, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi128ELi6ELi8ELi3ELi3ELi5ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182823069, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823075, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823083, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823091, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823096, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823101, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823141, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823145, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_6:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823198, - "dur": 169, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi512ELi6ELi5ELi3ELi3ELi3ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823369, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823378, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823392, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823400, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823404, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823409, - "dur": 81, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823491, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823495, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823500, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823506, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_7:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823516, - "dur": 161, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi512ELi6ELi5ELi3ELi3ELi3ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823679, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823684, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823691, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823699, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823705, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823710, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x128_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823734, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823741, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823748, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_8:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823758, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_9:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823762, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823770, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823775, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823779, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823790, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823848, - "dur": 124, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi128ELi6ELi8ELi3ELi3ELi5ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823973, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823979, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182823990, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824000, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824005, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824010, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x128_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824058, - "dur": 115, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi128ELi6ELi8ELi3ELi3ELi5ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824174, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824180, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824188, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824199, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824203, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824208, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824248, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_11:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824253, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824258, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_10:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824279, - "dur": 10, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824291, - "dur": 8, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824347, - "dur": 171, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi512ELi6ELi5ELi3ELi3ELi3ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824520, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824528, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824540, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824549, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824554, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824559, - "dur": 80, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824641, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824645, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824650, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824655, - "dur": 5, - "args": { - "name": "solver/gradients/AddN_12:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824668, - "dur": 164, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi512ELi6ELi5ELi3ELi3ELi3ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824833, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824838, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824844, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824856, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824861, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824865, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x128_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824890, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824895, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824901, - "dur": 5, - "args": { - "name": "solver/gradients/AddN_13:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824907, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_14:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824912, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/MaxPool3D_grad/MaxPool3DGrad:MaxPool3DGrad#id=52#::_Z20scaleTensor5d_kernelIffLi8ELi8ELi8EEv17cudnnTensorStructPT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824926, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/MaxPool3D_grad/MaxPool3DGrad:MaxPool3DGrad#id=52#::_ZN5cudnn6detail24pooling_bw_5d_kernel_maxIffNS0_15maxpooling_funcIfL21cudnnNanPropagation_t0EEELb0EEEv17cudnnTensorStructPKT_S5_S8_S5_S8_S5_PS6_18cudnnPoolingStructT0_SB_iNS_15reduced_divisorESC_SC_SC_SC_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824966, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824971, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182824975, - "dur": 37, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825013, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825056, - "dur": 609, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi128ELi6ELi7ELi3ELi3ELi5ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825668, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825673, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825680, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825688, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825695, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825699, - "dur": 32, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825733, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825740, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_15:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825746, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825754, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825757, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182825761, - "dur": 961, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826724, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826729, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826736, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826747, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826753, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826757, - "dur": 81, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826839, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826844, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826848, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826856, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_16:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826867, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826875, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826879, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182826882, - "dur": 826, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827710, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827714, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827723, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827730, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827743, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827748, - "dur": 48, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x128_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827797, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827802, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827807, - "dur": 37, - "args": { - "name": "solver/gradients/AddN_17:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827846, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_18:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827850, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827889, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827894, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827900, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182827942, - "dur": 606, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi128ELi6ELi7ELi3ELi3ELi5ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182828549, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182828554, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182828562, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182828568, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182828574, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182828579, - "dur": 30, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182828609, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182828617, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_19:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182828625, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182828637, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182828641, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182828645, - "dur": 966, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182829612, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182829618, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182829626, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182829636, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182829642, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182829647, - "dur": 82, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182829729, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182829734, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182829739, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182829746, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_20:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182829755, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182829759, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182829763, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182829767, - "dur": 829, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830598, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830603, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830608, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830618, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830633, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830637, - "dur": 48, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x128_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830686, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830691, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830696, - "dur": 38, - "args": { - "name": "solver/gradients/AddN_21:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830735, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_22:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830739, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830778, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830783, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830787, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830826, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182830867, - "dur": 625, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi128ELi6ELi7ELi3ELi3ELi5ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182831494, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182831498, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182831506, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182831510, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182831519, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182831525, - "dur": 42, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182831569, - "dur": 599, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn6detail23convolveNd_wgrad_engineIfLi3ELi128ELi6ELi7ELi3ELi3ELi5ELb1EEEviiiPKT_iPS2_S4_20kernel_gradNd_paramsifi", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832170, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832174, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832180, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832190, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832197, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832201, - "dur": 31, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832234, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_24:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832238, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832245, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_23:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832250, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832255, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832264, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832270, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832273, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182832277, - "dur": 952, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833231, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833237, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833243, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833248, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833255, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833258, - "dur": 82, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833341, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833346, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833350, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833358, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_25:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833368, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833378, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833381, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182833385, - "dur": 853, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834239, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834244, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834256, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834266, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834275, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834279, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834301, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834307, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834312, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_26:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834329, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_27:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834333, - "dur": 81, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/MaxPool3D_grad/MaxPool3DGrad:MaxPool3DGrad#id=52#::_Z20scaleTensor5d_kernelIffLi8ELi8ELi8EEv17cudnnTensorStructPT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834415, - "dur": 93, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/MaxPool3D_grad/MaxPool3DGrad:MaxPool3DGrad#id=52#::_ZN5cudnn6detail24pooling_bw_5d_kernel_maxIffNS0_15maxpooling_funcIfL21cudnnNanPropagation_t0EEELb0EEEv17cudnnTensorStructPKT_S5_S8_S5_S8_S5_PS6_18cudnnPoolingStructT0_SB_iNS_15reduced_divisorESC_SC_SC_SC_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834510, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834514, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834518, - "dur": 144, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834663, - "dur": 144, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834813, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834825, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834829, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182834833, - "dur": 5873, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182840708, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182840713, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182840719, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182840729, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182840744, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182840748, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182840841, - "dur": 37, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182840879, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_28:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182840891, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182840902, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182840906, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182840911, - "dur": 3870, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182844781, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182844786, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182844799, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182844811, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182844825, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182844828, - "dur": 313, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182845143, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182845147, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182845152, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182845192, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_29:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182845200, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182845211, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182845215, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182845220, - "dur": 3769, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182848990, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182848994, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849001, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849011, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849059, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849063, - "dur": 127, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849191, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849196, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849200, - "dur": 144, - "args": { - "name": "solver/gradients/AddN_30:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849346, - "dur": 2, - "args": { - "name": "solver/gradients/AddN_31:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849350, - "dur": 144, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849496, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849501, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849505, - "dur": 145, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849657, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849670, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849673, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182849677, - "dur": 5880, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182855558, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182855563, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182855572, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182855582, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182855597, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182855601, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182855694, - "dur": 37, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182855732, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_32:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182855744, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182855755, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182855760, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182855764, - "dur": 3853, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182859618, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182859623, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182859635, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182859648, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182859662, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182859666, - "dur": 311, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182859979, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182859984, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182859988, - "dur": 40, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182860029, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_33:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182860037, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182860048, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182860052, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182860055, - "dur": 3766, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182863823, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182863828, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182863838, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182863848, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182863895, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182863898, - "dur": 125, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864024, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864029, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864033, - "dur": 144, - "args": { - "name": "solver/gradients/AddN_34:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864179, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_35:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864183, - "dur": 144, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864329, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864334, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864338, - "dur": 144, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864483, - "dur": 145, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864633, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864645, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864648, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182864652, - "dur": 5796, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182870449, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182870454, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182870465, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182870476, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182870501, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182870505, - "dur": 105, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182870613, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182870624, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182870628, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182870632, - "dur": 5799, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x64_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876432, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876437, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876445, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876456, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876470, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876474, - "dur": 91, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876566, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_37:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876570, - "dur": 38, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876609, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_36:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876613, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876618, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876625, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876637, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876641, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182876645, - "dur": 3877, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880524, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880528, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880541, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880554, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880567, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880571, - "dur": 312, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880885, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880890, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880894, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880934, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_38:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880943, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880954, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880958, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182880962, - "dur": 3726, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182884691, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182884695, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182884703, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182884713, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182884739, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182884743, - "dur": 67, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182884811, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182884817, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182884821, - "dur": 74, - "args": { - "name": "solver/gradients/AddN_39:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182884895, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_40:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182884900, - "dur": 273, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_6/MaxPool3D_grad/MaxPool3DGrad:MaxPool3DGrad#id=52#::_Z20scaleTensor5d_kernelIffLi8ELi8ELi8EEv17cudnnTensorStructPT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182885174, - "dur": 248, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_6/MaxPool3D_grad/MaxPool3DGrad:MaxPool3DGrad#id=52#::_ZN5cudnn6detail24pooling_bw_5d_kernel_maxIffNS0_15maxpooling_funcIfL21cudnnNanPropagation_t0EEELb0EEEv17cudnnTensorStructPKT_S5_S8_S5_S8_S5_PS6_18cudnnPoolingStructT0_SB_iNS_15reduced_divisorESC_SC_SC_SC_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182885423, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182885428, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182885432, - "dur": 574, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182886009, - "dur": 579, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182886590, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182886606, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182886610, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182886614, - "dur": 15276, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182901891, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182901895, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182901901, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182901916, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182901962, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182901967, - "dur": 369, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182902336, - "dur": 144, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182902482, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_41:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182902486, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182902499, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182902525, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182902571, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182902575, - "dur": 1427, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182904007, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182904022, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182904026, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182904030, - "dur": 15487, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_medium_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182919518, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182919523, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182919527, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182919531, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_42:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182919536, - "dur": 140, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182919678, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182919683, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182919687, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182919696, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182919711, - "dur": 173, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182919886, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182919890, - "dur": 439, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182920336, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182920351, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182920356, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182920360, - "dur": 15025, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182935386, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182935390, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_44:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182935394, - "dur": 564, - "args": { - "name": "solver/gradients/AddN_43:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182935959, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182935964, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182935968, - "dur": 575, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182936545, - "dur": 578, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182937131, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182937146, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182937150, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182937154, - "dur": 15269, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182952425, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182952428, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182952435, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182952450, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182952496, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182952500, - "dur": 369, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182952870, - "dur": 143, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182953015, - "dur": 2, - "args": { - "name": "solver/gradients/AddN_45:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182953019, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182953028, - "dur": 25, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771182953053, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182953099, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182953103, - "dur": 1425, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182954534, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182954556, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182954560, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182954564, - "dur": 15606, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_medium_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970171, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970176, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970180, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970184, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_46:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970188, - "dur": 142, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970332, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970336, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970341, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970354, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970369, - "dur": 172, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970543, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970546, - "dur": 438, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182970993, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182971009, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182971013, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182971017, - "dur": 15137, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182986155, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182986159, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_48:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182986163, - "dur": 562, - "args": { - "name": "solver/gradients/AddN_47:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182986726, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182986730, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182986734, - "dur": 574, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182987311, - "dur": 574, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182987891, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182987906, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182987910, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771182987913, - "dur": 15649, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183003564, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183003567, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183003578, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183003593, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183003640, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183003644, - "dur": 369, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 1, - "ts": 1596771183004013, - "dur": 143, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183004158, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_49:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183004162, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183004168, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183004195, - "dur": 44, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183004241, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183004244, - "dur": 1424, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_small_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183005675, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183005691, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183005695, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183005699, - "dur": 15538, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_medium_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183021238, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183021242, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183021247, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183021251, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_50:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183021255, - "dur": 140, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183021398, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183021402, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183021406, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183021412, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm20computeOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183021427, - "dur": 172, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183021601, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183021605, - "dur": 437, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183022051, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183022066, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183022070, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183022074, - "dur": 15063, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_interior_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183037138, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183037142, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_52:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183037146, - "dur": 564, - "args": { - "name": "solver/gradients/AddN_51:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183037711, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183037715, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183037719, - "dur": 577, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183038301, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm25computeWgradOffsetsKernelENS1_20ComputeOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183038316, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm15setOutputKernelIfEEvmPT_f", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183038320, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN5cudnn7maxwell4gemm21computeBOffsetsKernelENS1_21ComputeBOffsetsParamsE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183038324, - "dur": 15183, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::maxwell_scudnn_128x32_stridedB_splitK_medium_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183053508, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2#id=52#::_ZN10tensorflow7functor22ShuffleInTensor3SimpleIfLi2ELi1ELi0ELb0EEEviPKT_NS0_9DimensionILi3EEEPS2_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183053513, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_53:AddN#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183053519, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 0, - "ts": 1596771183053523, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum#id=52#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 2, - "ts": 1596771182231193, - "dur": 88, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack#id=52#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 2, - "ts": 1596771182231322, - "dur": 33, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack#id=52#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 2, - "ts": 1596771182231365, - "dur": 41, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack#id=52#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 2, - "ts": 1596771182231449, - "dur": 22, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack#id=52#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 2, - "ts": 1596771182231478, - "dur": 21, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack#id=52#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 7, - "tid": 2, - "ts": 1596771182231507, - "dur": 20, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack#id=52#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182230141, - "dur": 55, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_2:LessEqual", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182230267, - "dur": 25, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_2/_18:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182289869, - "dur": 10, - "args": { - "name": "random_uniform_7/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182289902, - "dur": 1955, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182291878, - "dur": 19745, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182311631, - "dur": 477830, - "args": { - "name": "MakeGrids:MakeGrids", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182795402, - "dur": 121, - "args": { - "name": "IteratorGetNext/_58:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182797951, - "dur": 8, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182797963, - "dur": 3, - "args": { - "name": "Cast:Cast", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182797972, - "dur": 4, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182797987, - "dur": 8, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182821498, - "dur": 17, - "args": { - "name": "summary_train/loss:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182821538, - "dur": 78, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Cast:Cast", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182821752, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1596771182230137, - "dur": 18, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_4:Greater", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1596771182230188, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_4/_8:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1596771182230732, - "dur": 278, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_2:LogicalAnd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1596771182231029, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_2/_44:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1596771182289858, - "dur": 12, - "args": { - "name": "random_uniform_5/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1596771182289881, - "dur": 15, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1596771182289900, - "dur": 2, - "args": { - "name": "Cast:Cast", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1596771182289906, - "dur": 3, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182289868, - "dur": 5, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182289878, - "dur": 19, - "args": { - "name": "random_uniform_4/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182289900, - "dur": 1, - "args": { - "name": "random_uniform_4:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1596771182797919, - "dur": 16, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1596771182797943, - "dur": 3214, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1596771182801180, - "dur": 22926, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 3, - "ts": 1596771182230059, - "dur": 25, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_4:LessEqual", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 3, - "ts": 1596771182230102, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_4/_10:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 3, - "ts": 1596771182230144, - "dur": 60, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1:LessEqual", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 3, - "ts": 1596771182230263, - "dur": 13, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1/_22:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 3, - "ts": 1596771182289876, - "dur": 6, - "args": { - "name": "random_uniform_9/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182289903, - "dur": 3, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182797950, - "dur": 9, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182797963, - "dur": 3, - "args": { - "name": "Cast_2:Cast", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182797972, - "dur": 4, - "args": { - "name": "mul_2:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182799802, - "dur": 202, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800030, - "dur": 19, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800058, - "dur": 121, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800190, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800200, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800220, - "dur": 81, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800310, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800318, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800337, - "dur": 74, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800420, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800427, - "dur": 23, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800455, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_6_0/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800481, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_6_0/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800498, - "dur": 76, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800583, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800590, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800607, - "dur": 73, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800689, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800695, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800712, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800766, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800772, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800789, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_6_1/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800809, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_6_1/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800825, - "dur": 75, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800909, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800916, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182800933, - "dur": 71, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801012, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801018, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801035, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801089, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801095, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801111, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_6_2/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801131, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_6_2/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801147, - "dur": 29, - "args": { - "name": "ocnn_resnet/max_pool_6/MaxPool3D:MaxPool3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801186, - "dur": 62, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801258, - "dur": 49, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801316, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801322, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801339, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801355, - "dur": 76, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801439, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801445, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801461, - "dur": 48, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801518, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801524, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801540, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801560, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801576, - "dur": 45, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801629, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801635, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801651, - "dur": 72, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801731, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801737, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801754, - "dur": 43, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801805, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801811, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801827, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_1/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801846, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_1/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801861, - "dur": 43, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801912, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801918, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182801934, - "dur": 71, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802013, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802019, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802036, - "dur": 44, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802088, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802094, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802110, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_2/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802129, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802145, - "dur": 21, - "args": { - "name": "ocnn_resnet/max_pool_5/MaxPool3D:MaxPool3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802174, - "dur": 51, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802233, - "dur": 46, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802287, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802293, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802310, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802326, - "dur": 73, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802407, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802412, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802429, - "dur": 46, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802482, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802488, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802505, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802524, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802540, - "dur": 43, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802590, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802595, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802611, - "dur": 70, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802690, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802696, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802712, - "dur": 43, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802763, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802768, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802785, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_1/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802803, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_1/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802819, - "dur": 42, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802868, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802874, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802891, - "dur": 73, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802971, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802977, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182802993, - "dur": 43, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803045, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803051, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803067, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_2/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803085, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803101, - "dur": 20, - "args": { - "name": "ocnn_resnet/max_pool_4/MaxPool3D:MaxPool3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803129, - "dur": 76, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803212, - "dur": 74, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803294, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803300, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803316, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803331, - "dur": 73, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803412, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803417, - "dur": 23, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803446, - "dur": 72, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803525, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803531, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803547, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803565, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803581, - "dur": 70, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803658, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803664, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803680, - "dur": 70, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803758, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803763, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803779, - "dur": 69, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803855, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803860, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803877, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_1/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803895, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_1/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803910, - "dur": 70, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803988, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182803993, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804009, - "dur": 76, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804093, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804099, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804116, - "dur": 70, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D:Conv3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804193, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804199, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804215, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_2/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804232, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_2/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804248, - "dur": 20, - "args": { - "name": "ocnn_resnet/max_pool_3/MaxPool3D:MaxPool3D", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804274, - "dur": 22, - "args": { - "name": "ocnn_resnet/global_average/Mean:Mean", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804302, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804309, - "dur": 1, - "args": { - "name": "ocnn_resnet/fc2/flatten/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804314, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2/_50:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804321, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Prod:Size", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804327, - "dur": 7, - "args": { - "name": "ocnn_resnet/fc2/flatten/strided_slice:StridedSlice", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804340, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Prod_1:Size", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804398, - "dur": 5, - "args": { - "name": "ocnn_resnet/fc2/flatten/Reshape/shape:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804409, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum_1:Maximum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804416, - "dur": 2, - "args": { - "name": "ocnn_resnet/fc2/flatten/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804423, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1:FloorDiv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804431, - "dur": 35, - "args": { - "name": "ocnn_resnet/fc2/dense/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804470, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1/_56:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804474, - "dur": 15, - "args": { - "name": "ocnn_resnet/fc2/dense/BiasAdd:BiasAdd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804522, - "dur": 1, - "args": { - "name": "loss/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804529, - "dur": 2, - "args": { - "name": "solver/gradients/loss/Reshape_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804534, - "dur": 17, - "args": { - "name": "loss/mse_loss/mean_squared_error/SquaredDifference:SquaredDifference", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804557, - "dur": 1, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804563, - "dur": 1, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804568, - "dur": 1, - "args": { - "name": "loss/mse_loss/mean_squared_error/Mul:Snapshot", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804572, - "dur": 2, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804580, - "dur": 15, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like:Fill", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804600, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804607, - "dur": 19, - "args": { - "name": "loss/mse_loss/mean_squared_error/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804630, - "dur": 1, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804636, - "dur": 0, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights:Snapshot", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804640, - "dur": 12, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804658, - "dur": 16, - "args": { - "name": "loss/mse_loss/mean_squared_error/value:DivNoNan", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804678, - "dur": 11, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan:DivNoNan", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804694, - "dur": 13, - "args": { - "name": "add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804712, - "dur": 26, - "args": { - "name": "loss/mse_loss/mean_squared_error/value/_62:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804740, - "dur": 1, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804746, - "dur": 20, - "args": { - "name": "add/_64:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804768, - "dur": 17, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile:Tile", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804791, - "dur": 1, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Mul:Snapshot", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804795, - "dur": 1, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804800, - "dur": 0, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804805, - "dur": 16, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/sub:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804826, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/scalar:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804833, - "dur": 15, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804852, - "dur": 12, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804870, - "dur": 1, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804875, - "dur": 0, - "args": { - "name": "solver/gradients/loss/Reshape_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804880, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad:BiasAddGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804909, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804934, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804959, - "dur": 16, - "args": { - "name": "solver/gradients/AddN:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804981, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_1:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182804998, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182805034, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182821498, - "dur": 17, - "args": { - "name": "summary_train/rmse:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182821538, - "dur": 103, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch:DynamicStitch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182821658, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch/_54:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1596771182821741, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum:Maximum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182821762, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv:FloorDiv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182821776, - "dur": 28, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Tile:Tile", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182821820, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/truediv:RealDiv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182821851, - "dur": 59, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/MaxPool3D_grad/MaxPool3DGrad:MaxPool3DGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182821922, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182821948, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182821970, - "dur": 101, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822082, - "dur": 115, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822210, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822235, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_2:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822259, - "dur": 80, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822351, - "dur": 102, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822467, - "dur": 30, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822506, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822529, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_3:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822552, - "dur": 71, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822635, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822745, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822781, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_4:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822804, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_5:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822825, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822848, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822881, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822902, - "dur": 71, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182822985, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823093, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823120, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_6:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823143, - "dur": 72, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823227, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823338, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823376, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823398, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_7:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823420, - "dur": 68, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823499, - "dur": 100, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823612, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823648, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_8:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823670, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_9:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823692, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823714, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823747, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823769, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823791, - "dur": 75, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823878, - "dur": 96, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182823985, - "dur": 68, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824064, - "dur": 109, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824185, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_11:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824211, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824234, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_10:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824257, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824292, - "dur": 73, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824377, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824489, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824525, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824548, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_12:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824570, - "dur": 68, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824647, - "dur": 95, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824756, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824792, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_13:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824815, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_14:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824837, - "dur": 44, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/MaxPool3D_grad/MaxPool3DGrad:MaxPool3DGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824892, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824927, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824950, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182824971, - "dur": 72, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825052, - "dur": 96, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825161, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825185, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_15:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825206, - "dur": 96, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825313, - "dur": 95, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825420, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825455, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825478, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_16:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825500, - "dur": 93, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825602, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825711, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825747, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_17:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825769, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_18:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825790, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825813, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825846, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825866, - "dur": 69, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182825945, - "dur": 95, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826052, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826077, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_19:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826099, - "dur": 93, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826202, - "dur": 94, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826307, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826343, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826365, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_20:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826387, - "dur": 91, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826487, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826591, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826627, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_21:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826650, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_22:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826670, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826692, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826725, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826746, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826768, - "dur": 70, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826846, - "dur": 96, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182826954, - "dur": 67, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827030, - "dur": 94, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827136, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_24:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827161, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827184, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_23:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827205, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827239, - "dur": 94, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827343, - "dur": 96, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827451, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827486, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827509, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_25:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827531, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827632, - "dur": 93, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827739, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827775, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_26:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827797, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_27:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827820, - "dur": 42, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/MaxPool3D_grad/MaxPool3DGrad:MaxPool3DGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827875, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827909, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827931, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182827952, - "dur": 95, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828056, - "dur": 102, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828171, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828196, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_28:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828218, - "dur": 93, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828322, - "dur": 94, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828430, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828466, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828489, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_29:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828511, - "dur": 94, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828613, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828719, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828755, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_30:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828777, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_31:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828799, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828822, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828854, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828876, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182828977, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829081, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829106, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_32:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829128, - "dur": 93, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829230, - "dur": 93, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829338, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829375, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829397, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_33:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829419, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829519, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829624, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829661, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_34:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829685, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_35:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829705, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829728, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829761, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829783, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829805, - "dur": 94, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182829907, - "dur": 93, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830013, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830113, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830224, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_37:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830247, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830270, - "dur": 47, - "args": { - "name": "solver/gradients/AddN_36:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830326, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830360, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830462, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830567, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830602, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830624, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_38:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830645, - "dur": 89, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830742, - "dur": 90, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830845, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830880, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_39:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830901, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_40:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830921, - "dur": 40, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_6/MaxPool3D_grad/MaxPool3DGrad:MaxPool3DGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182830974, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831007, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831030, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831050, - "dur": 91, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831150, - "dur": 91, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831253, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831277, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_41:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831298, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831402, - "dur": 93, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831508, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831542, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_42:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831563, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831586, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831617, - "dur": 93, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831722, - "dur": 89, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831820, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_44:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831842, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_43:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831862, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831894, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831916, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182831937, - "dur": 90, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832035, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832144, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832168, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_45:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832189, - "dur": 93, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832294, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832397, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832431, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_46:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832452, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832475, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832506, - "dur": 92, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832610, - "dur": 89, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832709, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_48:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832731, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_47:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832752, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832784, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832806, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832827, - "dur": 89, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182832923, - "dur": 88, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833024, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833048, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_49:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833068, - "dur": 89, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833169, - "dur": 91, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833272, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833306, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_50:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833327, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833349, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833381, - "dur": 91, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2:Conv3DBackpropInputV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833484, - "dur": 89, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833582, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_52:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833604, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_51:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833626, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833658, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833679, - "dur": 89, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2:Conv3DBackpropFilterV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833780, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_53:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833801, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833834, - "dur": 0, - "args": { - "name": "solver/Momentum/update:NoOp", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833842, - "dur": 3, - "args": { - "name": "solver/Momentum/update/_66:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771182833849, - "dur": 33, - "args": { - "name": "solver/Momentum/update/_67:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1596771183053640, - "dur": 5, - "args": { - "name": "solver/Momentum:AssignAdd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 4, - "ts": 1596771182230144, - "dur": 86, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3:LessEqual", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 4, - "ts": 1596771182230258, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3/_14:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 5, - "ts": 1596771182228796, - "dur": 12, - "args": { - "name": "solver/global_step:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 5, - "ts": 1596771182228868, - "dur": 8, - "args": { - "name": "solver/global_step/read/_4:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 5, - "ts": 1596771182230103, - "dur": 25, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater:Greater", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 5, - "ts": 1596771182230158, - "dur": 7, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater/_26:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 3, - "ts": 1596771182797951, - "dur": 13, - "args": { - "name": "random_uniform_9/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 6, - "ts": 1596771182230142, - "dur": 80, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_1:Greater", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 5, - "ts": 1596771182230257, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_1/_20:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 4, - "ts": 1596771182289872, - "dur": 9, - "args": { - "name": "random_uniform_8/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 4, - "ts": 1596771182795475, - "dur": 120, - "args": { - "name": "IteratorGetNext/_6:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 4, - "ts": 1596771182797901, - "dur": 15, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 4, - "ts": 1596771182797920, - "dur": 9, - "args": { - "name": "random_uniform_4/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 4, - "ts": 1596771182797932, - "dur": 3, - "args": { - "name": "random_uniform_4:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 4, - "ts": 1596771182797939, - "dur": 2, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 5, - "ts": 1596771182288519, - "dur": 1264, - "args": { - "name": "Iterator::Model::Prefetch::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 6, - "ts": 1596771182288517, - "dur": 1274, - "args": { - "name": "Iterator::Model::Prefetch::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 7, - "ts": 1596771182288517, - "dur": 1276, - "args": { - "name": "Iterator::Model::Prefetch::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 8, - "ts": 1596771182288515, - "dur": 1278, - "args": { - "name": "Iterator::Model::Prefetch::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 5, - "ts": 1596771182795297, - "dur": 2422, - "args": { - "name": "Iterator::Model::Prefetch::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 6, - "ts": 1596771182795296, - "dur": 2426, - "args": { - "name": "Iterator::Model::Prefetch::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 7, - "ts": 1596771182795294, - "dur": 2428, - "args": { - "name": "Iterator::Model::Prefetch::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 8, - "ts": 1596771182795292, - "dur": 2432, - "args": { - "name": "Iterator::Model::Prefetch::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228654, - "dur": 11, - "args": { - "name": "_SOURCE:NoOp", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228740, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Const:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228763, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_7:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228774, - "dur": 1, - "args": { - "name": "ocnn_resnet/fc2/flatten/strided_slice/stack_2:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228789, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228810, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228822, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228833, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228862, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228875, - "dur": 3, - "args": { - "name": "ocnn_resnet/fc2/dense/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228885, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/mod:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228893, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_3:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228900, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228908, - "dur": 2, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_8:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228916, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228927, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228938, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_4:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228946, - "dur": 2, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_10:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228954, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_9:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228961, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228971, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228981, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182228992, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/n_true_conds:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229000, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_2:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229007, - "dur": 2, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Const:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229014, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229024, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229035, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229045, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229056, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229066, - "dur": 2, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_5:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229074, - "dur": 1, - "args": { - "name": "ocnn_resnet/fc2/flatten/Reshape/shape/1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229080, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229091, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229101, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229112, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229122, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229132, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229142, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229149, - "dur": 1, - "args": { - "name": "loss/Reshape/shape:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229156, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229166, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229176, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229186, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229208, - "dur": 2, - "args": { - "name": "loss/l2_regularizer/mul/y:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229216, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229227, - "dur": 2, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_6:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229235, - "dur": 3, - "args": { - "name": "ocnn_resnet/fc2/dense/bias:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229244, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229258, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229269, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229283, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229293, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229307, - "dur": 2, - "args": { - "name": "solver/Momentum/momentum:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229318, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229325, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229336, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229343, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229355, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229365, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229375, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229388, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229398, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229412, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum/y:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229419, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229430, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229438, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229451, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229460, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229470, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229483, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229493, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229506, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229515, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229529, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229537, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229548, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229555, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229565, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229577, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229587, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229600, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229610, - "dur": 3, - "args": { - "name": "ocnn_resnet/fc2/dense/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229630, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229643, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229654, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/range:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229662, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229673, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229680, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229694, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229704, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229717, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229726, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229736, - "dur": 5, - "args": { - "name": "ocnn_resnet/fc2/dense/bias/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229751, - "dur": 6, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229765, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229775, - "dur": 1, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/ones_like/Shape:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229785, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229793, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229803, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229810, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229819, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229832, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229842, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229854, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229870, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229877, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229887, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229894, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229904, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229917, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229927, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229940, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229950, - "dur": 3, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229962, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229969, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229978, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182229991, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230000, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230013, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230073, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230082, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230092, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230109, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230119, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230133, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230185, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230215, - "dur": 23, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230267, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230310, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230321, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230340, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230349, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230362, - "dur": 1, - "args": { - "name": "ocnn_resnet/fc2/dense/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230370, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230384, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230392, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230404, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230412, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230421, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230433, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230441, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230453, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230461, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230473, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230482, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230494, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230502, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230514, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230523, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230536, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230544, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230557, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230567, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230579, - "dur": 1, - "args": { - "name": "ocnn_resnet/fc2/dense/bias/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230587, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230595, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230607, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230615, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230627, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230636, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230648, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230657, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230670, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230679, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230692, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230701, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill/_52:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230709, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230722, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230731, - "dur": 1, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230745, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182230754, - "dur": 337, - "args": { - "name": "loss/l2_regularizer/L2Loss_33:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182231104, - "dur": 180, - "args": { - "name": "loss/l2_regularizer/L2Loss_23:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182231294, - "dur": 54, - "args": { - "name": "loss/l2_regularizer/L2Loss_13:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182231362, - "dur": 40, - "args": { - "name": "loss/l2_regularizer/L2Loss_8:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182231411, - "dur": 134, - "args": { - "name": "loss/l2_regularizer/L2Loss_31:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182231554, - "dur": 51, - "args": { - "name": "loss/l2_regularizer/L2Loss_40:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182231618, - "dur": 80, - "args": { - "name": "loss/l2_regularizer/L2Loss_39:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182231723, - "dur": 48, - "args": { - "name": "loss/l2_regularizer/L2Loss_29:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182231785, - "dur": 53, - "args": { - "name": "loss/l2_regularizer/L2Loss_38:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182231847, - "dur": 45, - "args": { - "name": "loss/l2_regularizer/L2Loss_28:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182231900, - "dur": 54, - "args": { - "name": "loss/l2_regularizer/L2Loss_18:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182231962, - "dur": 51, - "args": { - "name": "loss/l2_regularizer/L2Loss_37:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232022, - "dur": 22, - "args": { - "name": "loss/l2_regularizer/L2Loss_27:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232052, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_17:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232098, - "dur": 23, - "args": { - "name": "loss/l2_regularizer/L2Loss_7:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232129, - "dur": 50, - "args": { - "name": "loss/l2_regularizer/L2Loss_12:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232188, - "dur": 47, - "args": { - "name": "loss/l2_regularizer/L2Loss_36:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232243, - "dur": 22, - "args": { - "name": "loss/l2_regularizer/L2Loss_26:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232276, - "dur": 25, - "args": { - "name": "loss/l2_regularizer/L2Loss_16:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232311, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_6:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232340, - "dur": 44, - "args": { - "name": "loss/l2_regularizer/L2Loss_11:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232392, - "dur": 43, - "args": { - "name": "loss/l2_regularizer/L2Loss_30:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232444, - "dur": 43, - "args": { - "name": "loss/l2_regularizer/L2Loss_35:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232494, - "dur": 43, - "args": { - "name": "loss/l2_regularizer/L2Loss_25:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232545, - "dur": 47, - "args": { - "name": "loss/l2_regularizer/L2Loss_15:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232600, - "dur": 22, - "args": { - "name": "loss/l2_regularizer/L2Loss_5:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232630, - "dur": 24, - "args": { - "name": "loss/l2_regularizer/L2Loss_41:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232663, - "dur": 43, - "args": { - "name": "loss/l2_regularizer/L2Loss_34:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232713, - "dur": 20, - "args": { - "name": "loss/l2_regularizer/L2Loss_19:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232745, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_9:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232773, - "dur": 24, - "args": { - "name": "loss/l2_regularizer/L2Loss_4:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232805, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_10:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232837, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_24:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232866, - "dur": 25, - "args": { - "name": "loss/l2_regularizer/L2Loss_14:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232899, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_2:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232932, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_22:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232961, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_3:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182232993, - "dur": 40, - "args": { - "name": "loss/l2_regularizer/L2Loss_21:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233120, - "dur": 28, - "args": { - "name": "loss/l2_regularizer/L2Loss_1:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233164, - "dur": 23, - "args": { - "name": "loss/l2_regularizer/L2Loss_20:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233195, - "dur": 45, - "args": { - "name": "loss/l2_regularizer/L2Loss:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233249, - "dur": 45, - "args": { - "name": "loss/l2_regularizer/L2Loss_32:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233305, - "dur": 119, - "args": { - "name": "loss/l2_regularizer/AddN:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233484, - "dur": 33, - "args": { - "name": "loss/l2_regularizer/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233528, - "dur": 3, - "args": { - "name": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233548, - "dur": 63, - "args": { - "name": "loss/l2_regularizer/mul/_28:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233617, - "dur": 34, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_31_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233674, - "dur": 30, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_38_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233718, - "dur": 26, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_35_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233756, - "dur": 30, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_33_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233798, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_8_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233838, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_6_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233882, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_18_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233915, - "dur": 27, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_15_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233952, - "dur": 27, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_11_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182233988, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_10_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234025, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_25_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234061, - "dur": 27, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_13_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234098, - "dur": 26, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_28_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234136, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_16_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234174, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_12_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234207, - "dur": 27, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_29_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234243, - "dur": 26, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_26_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234278, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_19_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234315, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_14_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234351, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_27_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234384, - "dur": 28, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_24_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234420, - "dur": 23, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_2_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234457, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_17_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234494, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_36_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234526, - "dur": 29, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_32_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234564, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_9_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234602, - "dur": 23, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_7_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234639, - "dur": 23, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_3_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234671, - "dur": 33, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_34_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234713, - "dur": 27, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_30_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234750, - "dur": 26, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234785, - "dur": 23, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_21_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234825, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_23_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234858, - "dur": 27, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_4_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234894, - "dur": 27, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_1_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234930, - "dur": 23, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_40_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234966, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_22_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182234999, - "dur": 28, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_39_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182235036, - "dur": 26, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_5_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182235071, - "dur": 23, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_41_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182235106, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_20_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182235139, - "dur": 24, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_37_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182289908, - "dur": 11, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182289926, - "dur": 2, - "args": { - "name": "Cast_2:Cast", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182289932, - "dur": 4, - "args": { - "name": "mul_2:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182289938, - "dur": 8, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 9, - "ts": 1596771182795509, - "dur": 11, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1/_60:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 5, - "ts": 1596771182797908, - "dur": 16, - "args": { - "name": "random_uniform_5/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 5, - "ts": 1596771182797935, - "dur": 2, - "args": { - "name": "random_uniform_7/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 10, - "ts": 1596771182230152, - "dur": 18, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual:LessEqual", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 10, - "ts": 1596771182230208, - "dur": 17, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual/_24:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 10, - "ts": 1596771182230717, - "dur": 64, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_3:LogicalAnd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 10, - "ts": 1596771182230798, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_3/_46:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 10, - "ts": 1596771182289862, - "dur": 11, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 10, - "ts": 1596771182289882, - "dur": 13, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 10, - "ts": 1596771182289907, - "dur": 3, - "args": { - "name": "Cast_1:Cast", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 10, - "ts": 1596771182289914, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 11, - "ts": 1596771182230141, - "dur": 32, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_2:Greater", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 11, - "ts": 1596771182230203, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_2/_16:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 11, - "ts": 1596771182230744, - "dur": 156, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and:LogicalAnd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 11, - "ts": 1596771182230917, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and/_40:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 11, - "ts": 1596771182231982, - "dur": 16, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Assert/data_0/_38:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 11, - "ts": 1596771182232232, - "dur": 17, - "args": { - "name": "summary_train/lr:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 4, - "ts": 1596771182797950, - "dur": 11, - "args": { - "name": "random_uniform_8/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 12, - "ts": 1596771182228890, - "dur": 566425, - "args": { - "name": "Iterator::Model::Prefetch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 13, - "ts": 1596771182228885, - "dur": 566456, - "args": { - "name": "Iterator::Model", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182230143, - "dur": 24, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_3:Greater", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182230196, - "dur": 53, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_3/_12:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182230817, - "dur": 232, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_1:LogicalAnd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231071, - "dur": 421, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231512, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_1/_42:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231522, - "dur": 59, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Cast:Cast", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231591, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c/_32:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231698, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Cast/_30:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231821, - "dur": 13, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/num_true_conds:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231848, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/LessEqual:LessEqual", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231863, - "dur": 2, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231873, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Assert/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231883, - "dur": 1, - "args": { - "name": "ConstantFoldingCtrl/solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch_1:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231893, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/control_dependency:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231905, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Merge:Merge", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231918, - "dur": 50, - "args": { - "name": "ConstantFoldingCtrl/solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch_0/_35:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231972, - "dur": 2, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231985, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/cond/Switch/Switch:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182231994, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182232003, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182232012, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182232019, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/Switch/Switch:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182232029, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/Switch/Switch:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182232037, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/Switch/Switch:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182232045, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/Switch/Switch:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182232054, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/cond/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182232062, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182232070, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182232078, - "dur": 16, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge:Merge", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 14, - "ts": 1596771182232112, - "dur": 99, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge/_48:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 11, - "ts": 1596771182233631, - "dur": 10, - "args": { - "name": "summary_train/regularizer:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 5, - "ts": 1596771182797951, - "dur": 12, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 3, - "ts": 1596771182797970, - "dur": 3, - "args": { - "name": "Cast_1:Cast", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 3, - "ts": 1596771182797977, - "dur": 4, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 3, - "ts": 1596771182821548, - "dur": 19, - "args": { - "name": "summary_train/total_loss:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 3, - "ts": 1596771182821591, - "dur": 22, - "args": { - "name": "summary_train/Merge/MergeSummary:MergeSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "NoOp", - "pid": 11, - "tid": 0, - "ts": 1596771182228639, - "dur": 60, - "args": { - "name": "_SOURCE", - "op": "NoOp" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228738, - "dur": 19, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Const", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228761, - "dur": 10, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_7", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228773, - "dur": 13, - "args": { - "name": "ocnn_resnet/fc2/flatten/strided_slice/stack_2", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182228787, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182228808, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182228820, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182228832, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182228860, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182228873, - "dur": 8, - "args": { - "name": "ocnn_resnet/fc2/dense/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228883, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/mod", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228891, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_3", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228899, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228907, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_8", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182228915, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182228926, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228936, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_4", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228944, - "dur": 7, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_10", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228953, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_9", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182228960, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182228970, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182228980, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228991, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/n_true_conds", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228998, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_2", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229005, - "dur": 6, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Const", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229013, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229023, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229034, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229044, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229055, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229065, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_5", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229073, - "dur": 5, - "args": { - "name": "ocnn_resnet/fc2/flatten/Reshape/shape/1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229079, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229090, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229100, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229110, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229121, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229131, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229141, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229148, - "dur": 5, - "args": { - "name": "loss/Reshape/shape", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229155, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229165, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229175, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229185, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229206, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/mul/y", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229215, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229222, - "dur": 10, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_6", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229233, - "dur": 8, - "args": { - "name": "ocnn_resnet/fc2/dense/bias", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229242, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229257, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229268, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229281, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229292, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229302, - "dur": 13, - "args": { - "name": "solver/Momentum/momentum", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229316, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229324, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229334, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229342, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229351, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229364, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229374, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229387, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229397, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229411, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum/y", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229417, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229428, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229436, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229447, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229459, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229469, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229481, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229491, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229504, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229514, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229527, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229535, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229542, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229554, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229563, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229576, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229586, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229599, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229608, - "dur": 8, - "args": { - "name": "ocnn_resnet/fc2/dense/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229628, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229639, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229652, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/range", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229660, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229671, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229679, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229693, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229702, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229715, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229725, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229734, - "dur": 10, - "args": { - "name": "ocnn_resnet/fc2/dense/bias/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229750, - "dur": 11, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229763, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229774, - "dur": 5, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/ones_like/Shape", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229784, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229791, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229798, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229809, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229818, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229831, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229841, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229853, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229868, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229876, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229883, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229893, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229903, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229916, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229926, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229939, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229949, - "dur": 8, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182229961, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229968, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229977, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229989, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182229999, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182230011, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182230071, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182230081, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 11, - "tid": 1, - "ts": 1596771182230052, - "dur": 44, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_4", - "op": "LessEqual", - "input0": "solver/global_step/read/_5", - "input1": "solver/step_lr/PiecewiseConstant/Const_4" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1596771182228863, - "id": 0 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 11, - "tid": 1, - "ts": 1596771182230052, - "id": 0 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_4", - "pid": 11, - "tid": 0, - "ts": 1596771182228942, - "id": 1 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_4", - "pid": 11, - "tid": 1, - "ts": 1596771182230052, - "id": 1 - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182230091, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182230108, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182230118, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 11, - "tid": 2, - "ts": 1596771182230095, - "dur": 54, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater", - "op": "Greater", - "input0": "solver/global_step/read/_5", - "input1": "solver/step_lr/PiecewiseConstant/Const_4" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1596771182228863, - "id": 2 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 11, - "tid": 2, - "ts": 1596771182230095, - "id": 2 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_4", - "pid": 11, - "tid": 0, - "ts": 1596771182228942, - "id": 3 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_4", - "pid": 11, - "tid": 2, - "ts": 1596771182230095, - "id": 3 - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182230131, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 11, - "tid": 1, - "ts": 1596771182230129, - "dur": 45, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_4", - "op": "Greater", - "input0": "solver/global_step/read/_5", - "input1": "solver/step_lr/PiecewiseConstant/Const_3" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1596771182228863, - "id": 4 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 11, - "tid": 1, - "ts": 1596771182230129, - "id": 4 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_3", - "pid": 11, - "tid": 0, - "ts": 1596771182228897, - "id": 5 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_3", - "pid": 11, - "tid": 1, - "ts": 1596771182230129, - "id": 5 - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 11, - "tid": 3, - "ts": 1596771182230135, - "dur": 52, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_3", - "op": "Greater", - "input0": "solver/global_step/read/_5", - "input1": "solver/step_lr/PiecewiseConstant/Const_2" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1596771182228863, - "id": 6 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 11, - "tid": 3, - "ts": 1596771182230135, - "id": 6 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_2", - "pid": 11, - "tid": 0, - "ts": 1596771182229004, - "id": 7 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_2", - "pid": 11, - "tid": 3, - "ts": 1596771182230135, - "id": 7 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 11, - "tid": 4, - "ts": 1596771182230144, - "dur": 48, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual", - "op": "LessEqual", - "input0": "solver/global_step/read/_5", - "input1": "solver/step_lr/PiecewiseConstant/Const" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1596771182228863, - "id": 8 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 11, - "tid": 4, - "ts": 1596771182230144, - "id": 8 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228905, - "id": 9 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const", - "pid": 11, - "tid": 4, - "ts": 1596771182230144, - "id": 9 - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 11, - "tid": 5, - "ts": 1596771182230131, - "dur": 63, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_2", - "op": "Greater", - "input0": "solver/global_step/read/_5", - "input1": "solver/step_lr/PiecewiseConstant/Const_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1596771182228863, - "id": 10 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 11, - "tid": 5, - "ts": 1596771182230131, - "id": 10 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_1", - "pid": 11, - "tid": 0, - "ts": 1596771182229146, - "id": 11 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_1", - "pid": 11, - "tid": 5, - "ts": 1596771182230131, - "id": 11 - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182230183, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 11, - "tid": 6, - "ts": 1596771182230134, - "dur": 113, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_1", - "op": "Greater", - "input0": "solver/global_step/read/_5", - "input1": "solver/step_lr/PiecewiseConstant/Const" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1596771182228863, - "id": 12 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 11, - "tid": 6, - "ts": 1596771182230134, - "id": 12 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const", - "pid": 11, - "tid": 0, - "ts": 1596771182228905, - "id": 13 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const", - "pid": 11, - "tid": 6, - "ts": 1596771182230134, - "id": 13 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 11, - "tid": 7, - "ts": 1596771182230134, - "dur": 115, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3", - "op": "LessEqual", - "input0": "solver/global_step/read/_5", - "input1": "solver/step_lr/PiecewiseConstant/Const_3" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1596771182228863, - "id": 14 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 11, - "tid": 7, - "ts": 1596771182230134, - "id": 14 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_3", - "pid": 11, - "tid": 0, - "ts": 1596771182228897, - "id": 15 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_3", - "pid": 11, - "tid": 7, - "ts": 1596771182230134, - "id": 15 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 11, - "tid": 8, - "ts": 1596771182230139, - "dur": 112, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1", - "op": "LessEqual", - "input0": "solver/global_step/read/_5", - "input1": "solver/step_lr/PiecewiseConstant/Const_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1596771182228863, - "id": 16 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 11, - "tid": 8, - "ts": 1596771182230139, - "id": 16 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_1", - "pid": 11, - "tid": 0, - "ts": 1596771182229146, - "id": 17 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_1", - "pid": 11, - "tid": 8, - "ts": 1596771182230139, - "id": 17 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 11, - "tid": 9, - "ts": 1596771182230131, - "dur": 128, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_2", - "op": "LessEqual", - "input0": "solver/global_step/read/_5", - "input1": "solver/step_lr/PiecewiseConstant/Const_2" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1596771182228863, - "id": 18 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 11, - "tid": 9, - "ts": 1596771182230131, - "id": 18 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_2", - "pid": 11, - "tid": 0, - "ts": 1596771182229004, - "id": 19 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Const_2", - "pid": 11, - "tid": 9, - "ts": 1596771182230131, - "id": 19 - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 11, - "tid": 0, - "ts": 1596771182230213, - "dur": 49, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230265, - "dur": 38, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230308, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230319, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230338, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230348, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230360, - "dur": 6, - "args": { - "name": "ocnn_resnet/fc2/dense/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/fc2/dense/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230369, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230382, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230391, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230400, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230411, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230419, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230431, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230439, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230451, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230460, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230472, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230480, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230492, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230501, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230513, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230522, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230534, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230543, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230553, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230565, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230574, - "dur": 9, - "args": { - "name": "ocnn_resnet/fc2/dense/bias/read", - "op": "Identity", - "input0": "ocnn_resnet/fc2/dense/bias" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230585, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230594, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230605, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230614, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230626, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230635, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230647, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230655, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230668, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230677, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230691, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230708, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230721, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230730, - "dur": 7, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182230740, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd", - "pid": 11, - "tid": 1, - "ts": 1596771182230713, - "dur": 78, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_3", - "op": "LogicalAnd", - "input0": "solver/step_lr/PiecewiseConstant/Greater_4/_9", - "input1": "solver/step_lr/PiecewiseConstant/LessEqual_4/_11" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd", - "pid": 11, - "tid": 2, - "ts": 1596771182230740, - "dur": 170, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and", - "op": "LogicalAnd", - "input0": "solver/step_lr/PiecewiseConstant/Greater_1/_21", - "input1": "solver/step_lr/PiecewiseConstant/LessEqual_1/_23" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_1", - "pid": 11, - "tid": 6, - "ts": 1596771182230247, - "id": 20 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_1", - "pid": 11, - "tid": 2, - "ts": 1596771182230740, - "id": 20 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1", - "pid": 11, - "tid": 8, - "ts": 1596771182230251, - "id": 21 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1", - "pid": 11, - "tid": 2, - "ts": 1596771182230740, - "id": 21 - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd", - "pid": 11, - "tid": 3, - "ts": 1596771182230728, - "dur": 293, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_2", - "op": "LogicalAnd", - "input0": "solver/step_lr/PiecewiseConstant/Greater_3/_13", - "input1": "solver/step_lr/PiecewiseConstant/LessEqual_3/_15" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3", - "pid": 11, - "tid": 7, - "ts": 1596771182230249, - "id": 22 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3", - "pid": 11, - "tid": 3, - "ts": 1596771182230728, - "id": 22 - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd", - "pid": 11, - "tid": 0, - "ts": 1596771182230813, - "dur": 248, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_1", - "op": "LogicalAnd", - "input0": "solver/step_lr/PiecewiseConstant/Greater_2/_17", - "input1": "solver/step_lr/PiecewiseConstant/LessEqual_2/_19" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_2", - "pid": 11, - "tid": 5, - "ts": 1596771182230194, - "id": 23 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_2", - "pid": 11, - "tid": 0, - "ts": 1596771182230813, - "id": 23 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_2", - "pid": 11, - "tid": 9, - "ts": 1596771182230259, - "id": 24 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_2", - "pid": 11, - "tid": 0, - "ts": 1596771182230813, - "id": 24 - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 4, - "ts": 1596771182230752, - "dur": 346, - "args": { - "name": "loss/l2_regularizer/L2Loss_33", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 0, - "ts": 1596771182230303, - "id": 25 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 4, - "ts": 1596771182230752, - "id": 25 - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182231102, - "dur": 187, - "args": { - "name": "loss/l2_regularizer/L2Loss_23", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182231293, - "dur": 61, - "args": { - "name": "loss/l2_regularizer/L2Loss_13", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182231360, - "dur": 46, - "args": { - "name": "loss/l2_regularizer/L2Loss_8", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack", - "pid": 11, - "tid": 1, - "ts": 1596771182231068, - "dur": 437, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack", - "input0": "solver/step_lr/PiecewiseConstant/LessEqual/_25", - "input1": "solver/step_lr/PiecewiseConstant/Greater/_27", - "input2": "solver/step_lr/PiecewiseConstant/and", - "input3": "solver/step_lr/PiecewiseConstant/and_1", - "input4": "solver/step_lr/PiecewiseConstant/and_2", - "input5": "solver/step_lr/PiecewiseConstant/and_3" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual", - "pid": 11, - "tid": 4, - "ts": 1596771182230192, - "id": 26 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual", - "pid": 11, - "tid": 1, - "ts": 1596771182231068, - "id": 26 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater", - "pid": 11, - "tid": 2, - "ts": 1596771182230149, - "id": 27 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater", - "pid": 11, - "tid": 1, - "ts": 1596771182231068, - "id": 27 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and", - "pid": 11, - "tid": 2, - "ts": 1596771182230910, - "id": 28 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and", - "pid": 11, - "tid": 1, - "ts": 1596771182231068, - "id": 28 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_1", - "pid": 11, - "tid": 0, - "ts": 1596771182231061, - "id": 29 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_1", - "pid": 11, - "tid": 1, - "ts": 1596771182231068, - "id": 29 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_2", - "pid": 11, - "tid": 3, - "ts": 1596771182231021, - "id": 30 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_2", - "pid": 11, - "tid": 1, - "ts": 1596771182231068, - "id": 30 - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182231409, - "dur": 140, - "args": { - "name": "loss/l2_regularizer/L2Loss_31", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast", - "pid": 11, - "tid": 1, - "ts": 1596771182231520, - "dur": 66, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Cast", - "op": "Cast", - "input0": "solver/step_lr/PiecewiseConstant/case/preds_c" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182231552, - "dur": 61, - "args": { - "name": "loss/l2_regularizer/L2Loss_40", - "op": "L2Loss", - "input0": "ocnn_resnet/fc2/dense/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182231616, - "dur": 102, - "args": { - "name": "loss/l2_regularizer/L2Loss_39", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182231722, - "dur": 54, - "args": { - "name": "loss/l2_regularizer/L2Loss_29", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 11, - "tid": 0, - "ts": 1596771182231817, - "dur": 24, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/num_true_conds", - "op": "Sum", - "input0": "solver/step_lr/PiecewiseConstant/case/Cast/_31", - "input1": "solver/step_lr/PiecewiseConstant/case/Const" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/Cast", - "pid": 11, - "tid": 1, - "ts": 1596771182231586, - "id": 31 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/Cast", - "pid": 11, - "tid": 0, - "ts": 1596771182231817, - "id": 31 - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 1, - "ts": 1596771182231780, - "dur": 62, - "args": { - "name": "loss/l2_regularizer/L2Loss_38", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 0, - "ts": 1596771182230397, - "id": 32 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 1, - "ts": 1596771182231780, - "id": 32 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 11, - "tid": 0, - "ts": 1596771182231846, - "dur": 12, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/LessEqual", - "op": "LessEqual", - "input0": "solver/step_lr/PiecewiseConstant/case/num_true_conds", - "input1": "solver/step_lr/PiecewiseConstant/case/n_true_conds" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182231861, - "dur": 8, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/case/LessEqual", - "input1": "solver/step_lr/PiecewiseConstant/case/LessEqual" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182231872, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Assert/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/case/preds_c/_33", - "input1": "solver/step_lr/PiecewiseConstant/case/LessEqual" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "pid": 11, - "tid": 1, - "ts": 1596771182231505, - "id": 33 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "pid": 11, - "tid": 0, - "ts": 1596771182231872, - "id": 33 - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182231881, - "dur": 6, - "args": { - "name": "ConstantFoldingCtrl/solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch_1", - "op": "Identity", - "input0": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 1, - "ts": 1596771182231845, - "dur": 50, - "args": { - "name": "loss/l2_regularizer/L2Loss_28", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 0, - "ts": 1596771182230409, - "id": 34 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 1, - "ts": 1596771182231845, - "id": 34 - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182231891, - "dur": 8, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/control_dependency", - "op": "Const", - "input0": "^ConstantFoldingCtrl/solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Merge", - "pid": 11, - "tid": 0, - "ts": 1596771182231904, - "dur": 10, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Merge", - "op": "Merge", - "input0": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/control_dependency_1", - "input1": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/control_dependency" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 1, - "ts": 1596771182231898, - "dur": 59, - "args": { - "name": "loss/l2_regularizer/L2Loss_18", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 0, - "ts": 1596771182230417, - "id": 35 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 1, - "ts": 1596771182231898, - "id": 35 - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 11, - "tid": 0, - "ts": 1596771182231970, - "dur": 10, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "op": "Identity", - "input0": "solver/step_lr/PiecewiseConstant/LessEqual", - "input1": "^solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Merge" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual", - "pid": 11, - "tid": 4, - "ts": 1596771182230192, - "id": 36 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual", - "pid": 11, - "tid": 0, - "ts": 1596771182231970, - "id": 36 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182231984, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/and_3/_47", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_3", - "pid": 11, - "tid": 1, - "ts": 1596771182230791, - "id": 37 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_3", - "pid": 11, - "tid": 0, - "ts": 1596771182231984, - "id": 37 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182231993, - "dur": 7, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_5", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182232002, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_6", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182232010, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_10", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 1, - "ts": 1596771182231960, - "dur": 57, - "args": { - "name": "loss/l2_regularizer/L2Loss_37", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 0, - "ts": 1596771182230429, - "id": 38 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 1, - "ts": 1596771182231960, - "id": 38 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182232018, - "dur": 7, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Greater", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater", - "pid": 11, - "tid": 2, - "ts": 1596771182230149, - "id": 39 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater", - "pid": 11, - "tid": 0, - "ts": 1596771182232018, - "id": 39 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182232027, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/and/_41", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and", - "pid": 11, - "tid": 2, - "ts": 1596771182230910, - "id": 40 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and", - "pid": 11, - "tid": 0, - "ts": 1596771182232027, - "id": 40 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182232036, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/and_1/_43", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 1, - "ts": 1596771182232020, - "dur": 28, - "args": { - "name": "loss/l2_regularizer/L2Loss_27", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 0, - "ts": 1596771182230437, - "id": 41 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 1, - "ts": 1596771182232020, - "id": 41 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182232044, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/and_2/_45", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_2", - "pid": 11, - "tid": 3, - "ts": 1596771182231021, - "id": 42 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_2", - "pid": 11, - "tid": 0, - "ts": 1596771182232044, - "id": 42 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182232053, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_9", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182232060, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_7", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 11, - "tid": 0, - "ts": 1596771182232068, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_8", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 1, - "ts": 1596771182232051, - "dur": 42, - "args": { - "name": "loss/l2_regularizer/L2Loss_17", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 0, - "ts": 1596771182230449, - "id": 43 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 1, - "ts": 1596771182232051, - "id": 43 - }, - { - "ph": "X", - "cat": "Op", - "name": "Merge", - "pid": 11, - "tid": 0, - "ts": 1596771182232077, - "dur": 27, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "op": "Merge", - "input0": "solver/step_lr/PiecewiseConstant/case/cond/cond/Merge", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/Switch_1:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 1, - "ts": 1596771182232096, - "dur": 29, - "args": { - "name": "loss/l2_regularizer/L2Loss_7", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 0, - "ts": 1596771182230457, - "id": 44 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "pid": 11, - "tid": 1, - "ts": 1596771182232096, - "id": 44 - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232128, - "dur": 56, - "args": { - "name": "loss/l2_regularizer/L2Loss_12", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232187, - "dur": 52, - "args": { - "name": "loss/l2_regularizer/L2Loss_36", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232242, - "dur": 26, - "args": { - "name": "loss/l2_regularizer/L2Loss_26", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232275, - "dur": 31, - "args": { - "name": "loss/l2_regularizer/L2Loss_16", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232309, - "dur": 27, - "args": { - "name": "loss/l2_regularizer/L2Loss_6", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232338, - "dur": 50, - "args": { - "name": "loss/l2_regularizer/L2Loss_11", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232391, - "dur": 48, - "args": { - "name": "loss/l2_regularizer/L2Loss_30", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232442, - "dur": 48, - "args": { - "name": "loss/l2_regularizer/L2Loss_35", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232492, - "dur": 49, - "args": { - "name": "loss/l2_regularizer/L2Loss_25", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232544, - "dur": 52, - "args": { - "name": "loss/l2_regularizer/L2Loss_15", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232598, - "dur": 27, - "args": { - "name": "loss/l2_regularizer/L2Loss_5", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232628, - "dur": 30, - "args": { - "name": "loss/l2_regularizer/L2Loss_41", - "op": "L2Loss", - "input0": "ocnn_resnet/fc2/dense/bias/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232661, - "dur": 48, - "args": { - "name": "loss/l2_regularizer/L2Loss_34", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232712, - "dur": 25, - "args": { - "name": "loss/l2_regularizer/L2Loss_19", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232743, - "dur": 27, - "args": { - "name": "loss/l2_regularizer/L2Loss_9", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232772, - "dur": 29, - "args": { - "name": "loss/l2_regularizer/L2Loss_4", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232804, - "dur": 26, - "args": { - "name": "loss/l2_regularizer/L2Loss_10", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232836, - "dur": 26, - "args": { - "name": "loss/l2_regularizer/L2Loss_24", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232865, - "dur": 30, - "args": { - "name": "loss/l2_regularizer/L2Loss_14", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232898, - "dur": 26, - "args": { - "name": "loss/l2_regularizer/L2Loss_2", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232927, - "dur": 30, - "args": { - "name": "loss/l2_regularizer/L2Loss_22", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232959, - "dur": 30, - "args": { - "name": "loss/l2_regularizer/L2Loss_3", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182232991, - "dur": 48, - "args": { - "name": "loss/l2_regularizer/L2Loss_21", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182233118, - "dur": 36, - "args": { - "name": "loss/l2_regularizer/L2Loss_1", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182233162, - "dur": 29, - "args": { - "name": "loss/l2_regularizer/L2Loss_20", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182233193, - "dur": 51, - "args": { - "name": "loss/l2_regularizer/L2Loss", - "op": "L2Loss", - "input0": "ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 11, - "tid": 0, - "ts": 1596771182233247, - "dur": 51, - "args": { - "name": "loss/l2_regularizer/L2Loss_32", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182233301, - "dur": 170, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN", - "input0": "loss/l2_regularizer/L2Loss", - "input1": "loss/l2_regularizer/L2Loss_1", - "input2": "loss/l2_regularizer/L2Loss_10", - "input3": "loss/l2_regularizer/L2Loss_11", - "input4": "loss/l2_regularizer/L2Loss_12", - "input5": "loss/l2_regularizer/L2Loss_13", - "input6": "loss/l2_regularizer/L2Loss_14", - "input7": "loss/l2_regularizer/L2Loss_15", - "input8": "loss/l2_regularizer/L2Loss_16", - "input9": "loss/l2_regularizer/L2Loss_17", - "input10": "loss/l2_regularizer/L2Loss_18", - "input11": "loss/l2_regularizer/L2Loss_19", - "input12": "loss/l2_regularizer/L2Loss_2", - "input13": "loss/l2_regularizer/L2Loss_20", - "input14": "loss/l2_regularizer/L2Loss_21", - "input15": "loss/l2_regularizer/L2Loss_22", - "input16": "loss/l2_regularizer/L2Loss_23", - "input17": "loss/l2_regularizer/L2Loss_24", - "input18": "loss/l2_regularizer/L2Loss_25", - "input19": "loss/l2_regularizer/L2Loss_26", - "input20": "loss/l2_regularizer/L2Loss_27", - "input21": "loss/l2_regularizer/L2Loss_28", - "input22": "loss/l2_regularizer/L2Loss_29", - "input23": "loss/l2_regularizer/L2Loss_3", - "input24": "loss/l2_regularizer/L2Loss_30", - "input25": "loss/l2_regularizer/L2Loss_31", - "input26": "loss/l2_regularizer/L2Loss_32", - "input27": "loss/l2_regularizer/L2Loss_33", - "input28": "loss/l2_regularizer/L2Loss_34", - "input29": "loss/l2_regularizer/L2Loss_35", - "input30": "loss/l2_regularizer/L2Loss_36", - "input31": "loss/l2_regularizer/L2Loss_37", - "input32": "loss/l2_regularizer/L2Loss_38", - "input33": "loss/l2_regularizer/L2Loss_39", - "input34": "loss/l2_regularizer/L2Loss_4", - "input35": "loss/l2_regularizer/L2Loss_40", - "input36": "loss/l2_regularizer/L2Loss_41", - "input37": "loss/l2_regularizer/L2Loss_5", - "input38": "loss/l2_regularizer/L2Loss_6", - "input39": "loss/l2_regularizer/L2Loss_7", - "input40": "loss/l2_regularizer/L2Loss_8", - "input41": "loss/l2_regularizer/L2Loss_9" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_17", - "pid": 11, - "tid": 1, - "ts": 1596771182232093, - "id": 45 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_17", - "pid": 11, - "tid": 0, - "ts": 1596771182233301, - "id": 45 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_18", - "pid": 11, - "tid": 1, - "ts": 1596771182231957, - "id": 46 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_18", - "pid": 11, - "tid": 0, - "ts": 1596771182233301, - "id": 46 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_27", - "pid": 11, - "tid": 1, - "ts": 1596771182232048, - "id": 47 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_27", - "pid": 11, - "tid": 0, - "ts": 1596771182233301, - "id": 47 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_28", - "pid": 11, - "tid": 1, - "ts": 1596771182231895, - "id": 48 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_28", - "pid": 11, - "tid": 0, - "ts": 1596771182233301, - "id": 48 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_33", - "pid": 11, - "tid": 4, - "ts": 1596771182231098, - "id": 49 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_33", - "pid": 11, - "tid": 0, - "ts": 1596771182233301, - "id": 49 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_37", - "pid": 11, - "tid": 1, - "ts": 1596771182232017, - "id": 50 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_37", - "pid": 11, - "tid": 0, - "ts": 1596771182233301, - "id": 50 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_38", - "pid": 11, - "tid": 1, - "ts": 1596771182231842, - "id": 51 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_38", - "pid": 11, - "tid": 0, - "ts": 1596771182233301, - "id": 51 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_7", - "pid": 11, - "tid": 1, - "ts": 1596771182232125, - "id": 52 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/l2_regularizer/L2Loss_7", - "pid": 11, - "tid": 0, - "ts": 1596771182233301, - "id": 52 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182233482, - "dur": 40, - "args": { - "name": "loss/l2_regularizer/mul", - "op": "Mul", - "input0": "loss/l2_regularizer/AddN", - "input1": "loss/l2_regularizer/mul/y" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182233525, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8", - "op": "Const", - "input0": "^loss/l2_regularizer/AddN" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182233615, - "dur": 42, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_31_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182233672, - "dur": 38, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_38_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182233716, - "dur": 33, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_35_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182233754, - "dur": 37, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_33_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182233797, - "dur": 35, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_8_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182233836, - "dur": 31, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_6_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182233880, - "dur": 31, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_18_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182233914, - "dur": 33, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_15_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182233950, - "dur": 33, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_11_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182233986, - "dur": 30, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_10_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234023, - "dur": 31, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_25_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234060, - "dur": 34, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_13_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234097, - "dur": 32, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_28_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234135, - "dur": 31, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_16_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234173, - "dur": 30, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_12_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234205, - "dur": 34, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_29_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234242, - "dur": 32, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_26_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234277, - "dur": 33, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_19_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234314, - "dur": 30, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_14_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234346, - "dur": 34, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_27_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234382, - "dur": 34, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_24_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234419, - "dur": 34, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_2_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234456, - "dur": 30, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_17_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234489, - "dur": 33, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_36_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234525, - "dur": 35, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_32_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234563, - "dur": 35, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_9_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234601, - "dur": 30, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_7_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234637, - "dur": 30, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_3_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234670, - "dur": 39, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_34_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234712, - "dur": 33, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_30_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234748, - "dur": 33, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234783, - "dur": 30, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_21_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234823, - "dur": 31, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_23_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234856, - "dur": 34, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_4_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234892, - "dur": 33, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_1_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234928, - "dur": 30, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_40_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/fc2/dense/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234964, - "dur": 30, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_22_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182234997, - "dur": 35, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_39_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182235034, - "dur": 33, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_5_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182235070, - "dur": 28, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_41_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/fc2/dense/bias/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182235104, - "dur": 31, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_20_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182235138, - "dur": 31, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_37_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_8" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182799796, - "dur": 219, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "IteratorGetNext/_7", - "input1": "ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 1, - "ts": 1596771182795372, - "id": 53 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 11, - "tid": 0, - "ts": 1596771182799796, - "id": 53 - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182800028, - "dur": 26, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182800057, - "dur": 126, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/conv1/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182800189, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/conv1/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182800199, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182800218, - "dur": 86, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182800309, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182800317, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182800336, - "dur": 78, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182800419, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182800426, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182800454, - "dur": 21, - "args": { - "name": "ocnn_resnet/resblock_6_0/add", - "op": "Add", - "input0": "ocnn_resnet/conv1/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182800480, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_6_0/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_6_0/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182800497, - "dur": 81, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_6_0/Relu", - "input1": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182800582, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/resblock_6_0/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182800589, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182800606, - "dur": 77, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182800688, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182800694, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182800711, - "dur": 50, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182800765, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182800771, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182800788, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_6_1/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_6_0/Relu", - "input1": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182800808, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_6_1/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_6_1/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182800824, - "dur": 79, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_6_1/Relu", - "input1": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182800908, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/resblock_6_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182800915, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182800932, - "dur": 75, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182801011, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801017, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182801034, - "dur": 50, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182801088, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801094, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182801110, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_6_2/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_6_1/Relu", - "input1": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801130, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_6_2/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_6_2/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3D", - "pid": 11, - "tid": 0, - "ts": 1596771182801146, - "dur": 34, - "args": { - "name": "ocnn_resnet/max_pool_6/MaxPool3D", - "op": "MaxPool3D", - "input0": "ocnn_resnet/resblock_6_2/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182801185, - "dur": 67, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/max_pool_6/MaxPool3D", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182801256, - "dur": 54, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/max_pool_6/MaxPool3D", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182801315, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/max_pool_6/MaxPool3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801321, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801338, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182801354, - "dur": 80, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182801438, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801444, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182801461, - "dur": 52, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182801517, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801523, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182801539, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801559, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_c/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_c/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182801575, - "dur": 49, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_c/Relu", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182801628, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_c/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801634, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182801650, - "dur": 76, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182801730, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801736, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182801753, - "dur": 47, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182801804, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801810, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182801826, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_1/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_c/Relu", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801845, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_1/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_1/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182801861, - "dur": 47, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_5_1/Relu", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182801911, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182801917, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182801933, - "dur": 75, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182802012, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802019, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182802035, - "dur": 48, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182802087, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802093, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182802109, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_2/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_5_1/Relu", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802128, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_2/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3D", - "pid": 11, - "tid": 0, - "ts": 1596771182802144, - "dur": 26, - "args": { - "name": "ocnn_resnet/max_pool_5/MaxPool3D", - "op": "MaxPool3D", - "input0": "ocnn_resnet/resblock_5_2/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182802173, - "dur": 55, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/max_pool_5/MaxPool3D", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182802232, - "dur": 50, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/max_pool_5/MaxPool3D", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182802286, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/max_pool_5/MaxPool3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802293, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802309, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182802325, - "dur": 77, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182802405, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802411, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182802428, - "dur": 49, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182802481, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802487, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182802504, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802522, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182802539, - "dur": 46, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/Relu", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182802589, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802595, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182802611, - "dur": 74, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182802689, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802695, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182802711, - "dur": 47, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182802762, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802768, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182802784, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/Relu", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802802, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_1/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_1/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182802818, - "dur": 46, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_4_1/Relu", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182802867, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802873, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182802890, - "dur": 77, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182802970, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182802976, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182802993, - "dur": 47, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182803043, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182803050, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182803066, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_2/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_4_1/Relu", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182803085, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_2/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_2/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3D", - "pid": 11, - "tid": 0, - "ts": 1596771182803100, - "dur": 24, - "args": { - "name": "ocnn_resnet/max_pool_4/MaxPool3D", - "op": "MaxPool3D", - "input0": "ocnn_resnet/resblock_4_2/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182803128, - "dur": 80, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/max_pool_4/MaxPool3D", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182803211, - "dur": 78, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/max_pool_4/MaxPool3D", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182803293, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/max_pool_4/MaxPool3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182803299, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182803315, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182803330, - "dur": 77, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182803411, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182803416, - "dur": 27, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182803445, - "dur": 75, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182803524, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182803530, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182803546, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182803564, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_c/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_c/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182803580, - "dur": 73, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_c/Relu", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182803657, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_c/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182803663, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182803679, - "dur": 74, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182803757, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182803762, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182803778, - "dur": 73, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182803854, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182803860, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182803876, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_c/Relu", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182803894, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_1/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_1/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182803910, - "dur": 73, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_3_1/Relu", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182803987, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182803993, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182804008, - "dur": 80, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182804092, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182804098, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3D", - "pid": 11, - "tid": 0, - "ts": 1596771182804115, - "dur": 73, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D", - "op": "Conv3D", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182804192, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182804198, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182804214, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_2/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_3_1/Relu", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 11, - "tid": 0, - "ts": 1596771182804231, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_2/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3D", - "pid": 11, - "tid": 0, - "ts": 1596771182804247, - "dur": 24, - "args": { - "name": "ocnn_resnet/max_pool_3/MaxPool3D", - "op": "MaxPool3D", - "input0": "ocnn_resnet/resblock_3_2/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mean", - "pid": 11, - "tid": 0, - "ts": 1596771182804273, - "dur": 26, - "args": { - "name": "ocnn_resnet/global_average/Mean", - "op": "Mean", - "input0": "ocnn_resnet/max_pool_3/MaxPool3D", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/mod" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182804301, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2", - "op": "Shape", - "input0": "ocnn_resnet/max_pool_3/MaxPool3D" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182804308, - "dur": 4, - "args": { - "name": "ocnn_resnet/fc2/flatten/Shape", - "op": "Shape", - "input0": "ocnn_resnet/global_average/Mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Size", - "pid": 11, - "tid": 0, - "ts": 1596771182804320, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Prod", - "op": "Size", - "input0": "ocnn_resnet/max_pool_3/MaxPool3D", - "input1": "^solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "StridedSlice", - "pid": 11, - "tid": 0, - "ts": 1596771182804326, - "dur": 11, - "args": { - "name": "ocnn_resnet/fc2/flatten/strided_slice", - "op": "StridedSlice", - "input0": "ocnn_resnet/fc2/flatten/Shape", - "input1": "solver/step_lr/PiecewiseConstant/case/Const", - "input2": "ocnn_resnet/fc2/flatten/strided_slice/stack_2", - "input3": "ocnn_resnet/fc2/flatten/strided_slice/stack_2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Size", - "pid": 11, - "tid": 0, - "ts": 1596771182804339, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Prod_1", - "op": "Size", - "input0": "ocnn_resnet/global_average/Mean", - "input1": "^ocnn_resnet/fc2/flatten/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack", - "pid": 11, - "tid": 0, - "ts": 1596771182804396, - "dur": 10, - "args": { - "name": "ocnn_resnet/fc2/flatten/Reshape/shape", - "op": "Pack", - "input0": "ocnn_resnet/fc2/flatten/strided_slice", - "input1": "ocnn_resnet/fc2/flatten/Reshape/shape/1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Maximum", - "pid": 11, - "tid": 0, - "ts": 1596771182804408, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum_1", - "op": "Maximum", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Prod_1", - "input1": "solver/step_lr/PiecewiseConstant/case/n_true_conds" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 11, - "tid": 0, - "ts": 1596771182804415, - "dur": 5, - "args": { - "name": "ocnn_resnet/fc2/flatten/Reshape", - "op": "Reshape", - "input0": "ocnn_resnet/global_average/Mean", - "input1": "ocnn_resnet/fc2/flatten/Reshape/shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FloorDiv", - "pid": 11, - "tid": 0, - "ts": 1596771182804422, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1", - "op": "FloorDiv", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Prod", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 11, - "tid": 0, - "ts": 1596771182804430, - "dur": 38, - "args": { - "name": "ocnn_resnet/fc2/dense/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/fc2/flatten/Reshape", - "input1": "ocnn_resnet/fc2/dense/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BiasAdd", - "pid": 11, - "tid": 0, - "ts": 1596771182804474, - "dur": 18, - "args": { - "name": "ocnn_resnet/fc2/dense/BiasAdd", - "op": "BiasAdd", - "input0": "ocnn_resnet/fc2/dense/MatMul", - "input1": "ocnn_resnet/fc2/dense/bias/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 11, - "tid": 0, - "ts": 1596771182804521, - "dur": 4, - "args": { - "name": "loss/Reshape", - "op": "Reshape", - "input0": "ocnn_resnet/fc2/dense/BiasAdd", - "input1": "loss/Reshape/shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182804528, - "dur": 4, - "args": { - "name": "solver/gradients/loss/Reshape_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/fc2/dense/BiasAdd" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "SquaredDifference", - "pid": 11, - "tid": 0, - "ts": 1596771182804533, - "dur": 21, - "args": { - "name": "loss/mse_loss/mean_squared_error/SquaredDifference", - "op": "SquaredDifference", - "input0": "IteratorGetNext/_59", - "input1": "loss/Reshape" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 1, - "ts": 1596771182795372, - "id": 54 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 11, - "tid": 0, - "ts": 1596771182804533, - "id": 54 - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182804556, - "dur": 4, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape", - "op": "Shape", - "input0": "loss/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182804562, - "dur": 3, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Shape", - "op": "Shape", - "input0": "loss/mse_loss/mean_squared_error/SquaredDifference" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Snapshot", - "pid": 11, - "tid": 0, - "ts": 1596771182804567, - "dur": 3, - "args": { - "name": "loss/mse_loss/mean_squared_error/Mul", - "op": "Snapshot", - "input0": "loss/mse_loss/mean_squared_error/SquaredDifference" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 11, - "tid": 0, - "ts": 1596771182804572, - "dur": 6, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1/_61" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1", - "pid": 13, - "tid": 0, - "ts": 1596771182795499, - "id": 55 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1", - "pid": 11, - "tid": 0, - "ts": 1596771182804572, - "id": 55 - }, - { - "ph": "X", - "cat": "Op", - "name": "Fill", - "pid": 11, - "tid": 0, - "ts": 1596771182804579, - "dur": 18, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like", - "op": "Fill", - "input0": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Shape", - "input1": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 11, - "tid": 0, - "ts": 1596771182804599, - "dur": 6, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Shape", - "input1": "loss/mse_loss/mean_squared_error/num_present/ones_like/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 11, - "tid": 0, - "ts": 1596771182804606, - "dur": 22, - "args": { - "name": "loss/mse_loss/mean_squared_error/Sum", - "op": "Sum", - "input0": "loss/mse_loss/mean_squared_error/Mul", - "input1": "solver/step_lr/PiecewiseConstant/case/Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 11, - "tid": 0, - "ts": 1596771182804630, - "dur": 4, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Shape", - "op": "Shape", - "input0": "loss/mse_loss/mean_squared_error/Mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Snapshot", - "pid": 11, - "tid": 0, - "ts": 1596771182804636, - "dur": 2, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights", - "op": "Snapshot", - "input0": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 11, - "tid": 0, - "ts": 1596771182804640, - "dur": 15, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present", - "op": "Sum", - "input0": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights", - "input1": "solver/step_lr/PiecewiseConstant/case/Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DivNoNan", - "pid": 11, - "tid": 0, - "ts": 1596771182804657, - "dur": 19, - "args": { - "name": "loss/mse_loss/mean_squared_error/value", - "op": "DivNoNan", - "input0": "loss/mse_loss/mean_squared_error/Sum", - "input1": "loss/mse_loss/mean_squared_error/num_present" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DivNoNan", - "pid": 11, - "tid": 0, - "ts": 1596771182804677, - "dur": 14, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan", - "op": "DivNoNan", - "input0": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Const", - "input1": "loss/mse_loss/mean_squared_error/num_present" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 11, - "tid": 0, - "ts": 1596771182804693, - "dur": 16, - "args": { - "name": "add", - "op": "Add", - "input0": "loss/l2_regularizer/mul", - "input1": "loss/mse_loss/mean_squared_error/value" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 11, - "tid": 0, - "ts": 1596771182804739, - "dur": 4, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan", - "input1": "ocnn_resnet/fc2/flatten/strided_slice/stack_2", - "input2": "^loss/mse_loss/mean_squared_error/Sum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Tile", - "pid": 11, - "tid": 0, - "ts": 1596771182804767, - "dur": 21, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile", - "op": "Tile", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Snapshot", - "pid": 11, - "tid": 0, - "ts": 1596771182804790, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Mul", - "op": "Snapshot", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 11, - "tid": 0, - "ts": 1596771182804795, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Mul", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 11, - "tid": 0, - "ts": 1596771182804799, - "dur": 4, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Sum", - "input1": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 11, - "tid": 0, - "ts": 1596771182804804, - "dur": 20, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/sub", - "op": "Sub", - "input0": "loss/Reshape", - "input1": "IteratorGetNext/_59", - "input2": "^solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 1, - "ts": 1596771182795372, - "id": 56 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 11, - "tid": 0, - "ts": 1596771182804804, - "id": 56 - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182804825, - "dur": 6, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/scalar", - "op": "Const", - "input0": "^solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182804832, - "dur": 18, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Mul", - "op": "Mul", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/scalar" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 11, - "tid": 0, - "ts": 1596771182804852, - "dur": 16, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/mul_1", - "op": "Mul", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Mul", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 11, - "tid": 0, - "ts": 1596771182804869, - "dur": 4, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/mul_1", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 11, - "tid": 0, - "ts": 1596771182804874, - "dur": 4, - "args": { - "name": "solver/gradients/loss/Reshape_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Sum", - "input1": "solver/gradients/loss/Reshape_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BiasAddGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182804879, - "dur": 27, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad", - "op": "BiasAddGrad", - "input0": "solver/gradients/loss/Reshape_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 11, - "tid": 0, - "ts": 1596771182804908, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/fc2/flatten/Reshape", - "input1": "solver/gradients/loss/Reshape_grad/Reshape", - "input2": "^solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 11, - "tid": 0, - "ts": 1596771182804933, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/loss/Reshape_grad/Reshape", - "input1": "ocnn_resnet/fc2/dense/kernel/read", - "input2": "^solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182804958, - "dur": 20, - "args": { - "name": "solver/gradients/AddN", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_41_grad/mul", - "input1": "solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182804980, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_1", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_40_grad/mul", - "input1": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul_1", - "input2": "^solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182804997, - "dur": 33, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/fc2/dense/bias", - "input1": "ocnn_resnet/fc2/dense/bias/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182805032, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/fc2/dense/kernel", - "input1": "ocnn_resnet/fc2/dense/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_1", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast", - "pid": 11, - "tid": 0, - "ts": 1596771182821531, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Cast", - "op": "Cast", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1/_57" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DynamicStitch", - "pid": 11, - "tid": 1, - "ts": 1596771182821531, - "dur": 120, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch", - "op": "DynamicStitch", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/range", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/mod", - "input2": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2/_51", - "input3": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill/_53" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/range", - "pid": 11, - "tid": 0, - "ts": 1596771182229658, - "id": 57 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/range", - "pid": 11, - "tid": 1, - "ts": 1596771182821531, - "id": 57 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/mod", - "pid": 11, - "tid": 0, - "ts": 1596771182228890, - "id": 58 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/mod", - "pid": 11, - "tid": 1, - "ts": 1596771182821531, - "id": 58 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2", - "pid": 11, - "tid": 0, - "ts": 1596771182804306, - "id": 59 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2", - "pid": 11, - "tid": 1, - "ts": 1596771182821531, - "id": 59 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill", - "pid": 11, - "tid": 0, - "ts": 1596771182229533, - "id": 60 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill", - "pid": 11, - "tid": 1, - "ts": 1596771182821531, - "id": 60 - }, - { - "ph": "X", - "cat": "Op", - "name": "Maximum", - "pid": 11, - "tid": 0, - "ts": 1596771182821739, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum", - "op": "Maximum", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch/_55", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum/y" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch", - "pid": 11, - "tid": 1, - "ts": 1596771182821651, - "id": 61 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch", - "pid": 11, - "tid": 0, - "ts": 1596771182821739, - "id": 61 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 11, - "tid": 1, - "ts": 1596771182821749, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch/_55", - "input2": "^solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul", - "pid": 11, - "tid": 0, - "ts": 1596771182804956, - "id": 62 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul", - "pid": 11, - "tid": 1, - "ts": 1596771182821749, - "id": 62 - }, - { - "ph": "X", - "cat": "Op", - "name": "FloorDiv", - "pid": 11, - "tid": 0, - "ts": 1596771182821760, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv", - "op": "FloorDiv", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Tile", - "pid": 11, - "tid": 0, - "ts": 1596771182821774, - "dur": 36, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Tile", - "op": "Tile", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Reshape", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Reshape", - "pid": 11, - "tid": 1, - "ts": 1596771182821764, - "id": 63 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Reshape", - "pid": 11, - "tid": 0, - "ts": 1596771182821774, - "id": 63 - }, - { - "ph": "X", - "cat": "Op", - "name": "RealDiv", - "pid": 11, - "tid": 0, - "ts": 1596771182821819, - "dur": 28, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/truediv", - "op": "RealDiv", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Tile", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Cast" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3DGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182821849, - "dur": 66, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/MaxPool3D_grad/MaxPool3DGrad", - "op": "MaxPool3DGrad", - "input0": "ocnn_resnet/resblock_3_2/Relu", - "input1": "ocnn_resnet/max_pool_3/MaxPool3D", - "input2": "solver/gradients/ocnn_resnet/global_average/Mean_grad/truediv" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182821921, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/max_pool_3/MaxPool3D_grad/MaxPool3DGrad", - "input1": "ocnn_resnet/resblock_3_2/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182821947, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182821968, - "dur": 107, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182822080, - "dur": 123, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182822208, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182822233, - "dur": 22, - "args": { - "name": "solver/gradients/AddN_2", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_39_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182822258, - "dur": 86, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182822349, - "dur": 110, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182822465, - "dur": 37, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_2", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182822505, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182822527, - "dur": 21, - "args": { - "name": "solver/gradients/AddN_3", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_38_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182822550, - "dur": 78, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_3_1/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182822633, - "dur": 105, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Shape_1", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182822742, - "dur": 36, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_3", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182822780, - "dur": 21, - "args": { - "name": "solver/gradients/AddN_4", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/Relu_grad/ReluGrad", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182822803, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_5", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_37_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182822824, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_4", - "input1": "ocnn_resnet/resblock_3_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182822846, - "dur": 31, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_5", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182822879, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182822901, - "dur": 77, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182822983, - "dur": 104, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182823092, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182823119, - "dur": 21, - "args": { - "name": "solver/gradients/AddN_6", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_36_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182823142, - "dur": 78, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182823225, - "dur": 105, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182823336, - "dur": 36, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_6", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182823374, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182823397, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_7", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_35_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182823419, - "dur": 74, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_c/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182823498, - "dur": 107, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Shape_1", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182823609, - "dur": 36, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_7", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182823647, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_8", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/Relu_grad/ReluGrad", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182823669, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_9", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_34_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182823690, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_8", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_c/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182823712, - "dur": 32, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_9", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182823746, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182823768, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182823790, - "dur": 81, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/max_pool_4/MaxPool3D", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182823876, - "dur": 103, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182823983, - "dur": 74, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182824062, - "dur": 117, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182824183, - "dur": 24, - "args": { - "name": "solver/gradients/AddN_11", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_33_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182824210, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182824233, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_10", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_32_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182824255, - "dur": 33, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_11", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182824291, - "dur": 79, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182824375, - "dur": 106, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182824486, - "dur": 36, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_10", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182824524, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182824546, - "dur": 21, - "args": { - "name": "solver/gradients/AddN_12", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_31_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182824569, - "dur": 73, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/max_pool_4/MaxPool3D", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182824645, - "dur": 102, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182824754, - "dur": 35, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_12", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182824791, - "dur": 21, - "args": { - "name": "solver/gradients/AddN_13", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input3": "^solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182824814, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_14", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_30_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3DGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182824835, - "dur": 51, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/MaxPool3D_grad/MaxPool3DGrad", - "op": "MaxPool3DGrad", - "input0": "ocnn_resnet/resblock_4_2/Relu", - "input1": "ocnn_resnet/max_pool_4/MaxPool3D", - "input2": "solver/gradients/AddN_13" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182824890, - "dur": 33, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_14", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182824925, - "dur": 21, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/max_pool_4/MaxPool3D_grad/MaxPool3DGrad", - "input1": "ocnn_resnet/resblock_4_2/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182824949, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182824970, - "dur": 77, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182825050, - "dur": 104, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182825159, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182825183, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_15", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_29_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182825205, - "dur": 102, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182825311, - "dur": 102, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182825417, - "dur": 35, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_15", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182825454, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182825477, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_16", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_28_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182825499, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_4_1/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182825600, - "dur": 104, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Shape_1", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182825709, - "dur": 34, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_16", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182825746, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_17", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/Relu_grad/ReluGrad", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182825768, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_18", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_27_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182825789, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_17", - "input1": "ocnn_resnet/resblock_4_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182825811, - "dur": 31, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_18", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182825844, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182825865, - "dur": 75, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182825943, - "dur": 103, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182826051, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182826076, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_19", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_26_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182826097, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182826200, - "dur": 101, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182826305, - "dur": 34, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_19", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182826341, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182826364, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_20", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_25_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182826386, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182826485, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Shape_1", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182826589, - "dur": 35, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_20", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182826626, - "dur": 21, - "args": { - "name": "solver/gradients/AddN_21", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/Relu_grad/ReluGrad", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182826649, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_22", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_24_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182826669, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_21", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182826691, - "dur": 31, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_22", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182826724, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182826745, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182826767, - "dur": 75, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/max_pool_5/MaxPool3D", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182826845, - "dur": 102, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182826952, - "dur": 73, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182827028, - "dur": 101, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182827134, - "dur": 23, - "args": { - "name": "solver/gradients/AddN_24", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_23_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182827159, - "dur": 21, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182827183, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_23", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_22_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182827203, - "dur": 32, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_24", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182827237, - "dur": 100, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182827341, - "dur": 103, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182827448, - "dur": 35, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_23", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182827485, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182827508, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_25", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_21_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182827530, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/max_pool_5/MaxPool3D", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182827630, - "dur": 100, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182827737, - "dur": 35, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_25", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182827774, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_26", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input3": "^solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182827796, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_27", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_20_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3DGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182827818, - "dur": 50, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/MaxPool3D_grad/MaxPool3DGrad", - "op": "MaxPool3DGrad", - "input0": "ocnn_resnet/resblock_5_2/Relu", - "input1": "ocnn_resnet/max_pool_5/MaxPool3D", - "input2": "solver/gradients/AddN_26" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182827874, - "dur": 32, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_27", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182827908, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/max_pool_5/MaxPool3D_grad/MaxPool3DGrad", - "input1": "ocnn_resnet/resblock_5_2/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182827930, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182827951, - "dur": 101, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182828055, - "dur": 109, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182828170, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182828195, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_28", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_19_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182828217, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182828321, - "dur": 101, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182828428, - "dur": 35, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_28", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182828465, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182828488, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_29", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_18_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182828510, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_5_1/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182828611, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape_1", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182828716, - "dur": 36, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_29", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182828754, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_30", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/Relu_grad/ReluGrad", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182828776, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_31", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_17_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182828797, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_30", - "input1": "ocnn_resnet/resblock_5_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182828820, - "dur": 31, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_31", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182828853, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182828875, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182828975, - "dur": 100, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182829080, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182829105, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_32", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_16_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182829127, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182829229, - "dur": 101, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182829336, - "dur": 35, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_32", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182829373, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182829396, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_33", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_15_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182829418, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_c/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182829517, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape_1", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182829622, - "dur": 36, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_33", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182829660, - "dur": 21, - "args": { - "name": "solver/gradients/AddN_34", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/Relu_grad/ReluGrad", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182829683, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_35", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_14_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182829704, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_34", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_c/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182829726, - "dur": 32, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_35", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182829760, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182829782, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182829804, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/max_pool_6/MaxPool3D", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182829906, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182830011, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182830111, - "dur": 106, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182830222, - "dur": 22, - "args": { - "name": "solver/gradients/AddN_37", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_13_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182830246, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182830269, - "dur": 52, - "args": { - "name": "solver/gradients/AddN_36", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_12_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182830324, - "dur": 32, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_37", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182830359, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182830461, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182830565, - "dur": 33, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_36", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182830600, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182830623, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_38", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_11_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182830644, - "dur": 94, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/max_pool_6/MaxPool3D", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182830740, - "dur": 96, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182830843, - "dur": 34, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_38", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182830879, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_39", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input3": "^solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182830900, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_40", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_10_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MaxPool3DGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182830920, - "dur": 47, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_6/MaxPool3D_grad/MaxPool3DGrad", - "op": "MaxPool3DGrad", - "input0": "ocnn_resnet/resblock_6_2/Relu", - "input1": "ocnn_resnet/max_pool_6/MaxPool3D", - "input2": "solver/gradients/AddN_39" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182830972, - "dur": 32, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_40", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182831006, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/max_pool_6/MaxPool3D_grad/MaxPool3DGrad", - "input1": "ocnn_resnet/resblock_6_2/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182831028, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_6_2/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_2/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182831049, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182831148, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182831252, - "dur": 21, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182831276, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_41", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_9_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182831297, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182831401, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182831506, - "dur": 33, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_41", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182831541, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_42", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_8_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182831562, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182831584, - "dur": 30, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_42", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182831616, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_6_2/add_grad/Shape_1", - "input1": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182831720, - "dur": 95, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_6_1/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182831818, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_44", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_7_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182831841, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_43", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/Relu_grad/ReluGrad", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182831861, - "dur": 30, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_44", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182831893, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_43", - "input1": "ocnn_resnet/resblock_6_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182831915, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_6_1/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_1/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182831935, - "dur": 96, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182832033, - "dur": 104, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182832143, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182832167, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_45", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_6_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182832188, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182832292, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182832395, - "dur": 32, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_45", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182832430, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_46", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_5_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182832451, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182832473, - "dur": 30, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_46", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182832504, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_6_1/add_grad/Shape_1", - "input1": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182832609, - "dur": 96, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_6_0/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182832707, - "dur": 21, - "args": { - "name": "solver/gradients/AddN_48", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_4_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182832730, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_47", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "solver/gradients/ocnn_resnet/resblock_6_1/Relu_grad/ReluGrad", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182832750, - "dur": 31, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_48", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182832783, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_47", - "input1": "ocnn_resnet/resblock_6_0/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182832805, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_6_0/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_0/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182832825, - "dur": 94, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182832922, - "dur": 96, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182833023, - "dur": 21, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182833047, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_49", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_3_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182833067, - "dur": 95, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape", - "input1": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182833168, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182833270, - "dur": 33, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_49", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182833305, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_50", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_2_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182833326, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182833348, - "dur": 29, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_50", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropInputV2", - "pid": 11, - "tid": 0, - "ts": 1596771182833380, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "op": "Conv3DBackpropInputV2", - "input0": "solver/gradients/ocnn_resnet/resblock_6_0/add_grad/Shape_1", - "input1": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/read", - "input2": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182833482, - "dur": 96, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "ocnn_resnet/conv1/conv_bn_relu/Relu", - "input1": "solver/gradients/ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182833581, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_52", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_1_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182833603, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_51", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropInputV2", - "input1": "solver/gradients/ocnn_resnet/resblock_6_0/Relu_grad/ReluGrad", - "input2": "^solver/gradients/ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182833624, - "dur": 31, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_52", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 11, - "tid": 0, - "ts": 1596771182833657, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_51", - "input1": "ocnn_resnet/conv1/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Conv3DBackpropFilterV2", - "pid": 11, - "tid": 0, - "ts": 1596771182833678, - "dur": 95, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2", - "op": "Conv3DBackpropFilterV2", - "input0": "IteratorGetNext/_7", - "input1": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Shape_1", - "input2": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/Relu_grad/ReluGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 1, - "ts": 1596771182795372, - "id": 64 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 11, - "tid": 0, - "ts": 1596771182833678, - "id": 64 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 11, - "tid": 0, - "ts": 1596771182833778, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_53", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_grad/mul", - "input1": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/conv3d/Conv3D_grad/Conv3DBackpropFilterV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 11, - "tid": 0, - "ts": 1596771182833800, - "dur": 30, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel", - "input1": "ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_53", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "NoOp", - "pid": 11, - "tid": 0, - "ts": 1596771182833832, - "dur": 4, - "args": { - "name": "solver/Momentum/update", - "op": "NoOp", - "input0": "^solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input1": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input2": "^solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input3": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input4": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input5": "^solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input6": "^solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input7": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input8": "^solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input9": "^solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input10": "^solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input11": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input12": "^solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input13": "^solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum", - "input14": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input15": "^solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input16": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_c/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input17": "^solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input18": "^solver/Momentum/update_ocnn_resnet/resblock_6_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input19": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input20": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input21": "^solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input22": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input23": "^solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input24": "^solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input25": "^solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum", - "input26": "^solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input27": "^solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input28": "^solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input29": "^solver/Momentum/update_ocnn_resnet/resblock_6_0/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input30": "^solver/Momentum/update_ocnn_resnet/resblock_6_2/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input31": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input32": "^solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input33": "^solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input34": "^solver/Momentum/update_ocnn_resnet/resblock_6_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input35": "^solver/Momentum/update_ocnn_resnet/resblock_6_2/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input36": "^solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input37": "^solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input38": "^solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input39": "^solver/Momentum/update_ocnn_resnet/resblock_6_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input40": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/conv3d/kernel/ApplyMomentum", - "input41": "^solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv_bn_relu/conv3d/kernel/ApplyMomentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 11, - "tid": 0, - "ts": 1596771182833841, - "dur": 6, - "args": { - "name": "solver/Momentum/update/_66", - "op": "Const", - "input0": "^solver/Momentum/update" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "NoOp", - "pid": 13, - "tid": 0, - "ts": 1596771182228646, - "dur": 14, - "args": { - "name": "_SOURCE", - "op": "NoOp" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1596771182228745, - "dur": 16, - "args": { - "name": "summary_train/total_loss/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1596771182228765, - "dur": 4, - "args": { - "name": "summary_train/loss/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1596771182228771, - "dur": 13, - "args": { - "name": "summary_train/regularizer/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1596771182228786, - "dur": 4, - "args": { - "name": "summary_train/lr/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1596771182228792, - "dur": 3, - "args": { - "name": "summary_train/rmse/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OneShotIterator", - "pid": 13, - "tid": 0, - "ts": 1596771182228798, - "dur": 22, - "args": { - "name": "points2grids_dataset/OneShotIterator", - "op": "OneShotIterator" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 1, - "ts": 1596771182228792, - "dur": 36, - "args": { - "name": "solver/global_step", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1596771182228858, - "dur": 5, - "args": { - "name": "solver/global_step/read", - "op": "Identity", - "input0": "solver/global_step" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step", - "pid": 13, - "tid": 1, - "ts": 1596771182228828, - "id": 65 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step", - "pid": 13, - "tid": 0, - "ts": 1596771182228858, - "id": 65 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 13, - "tid": 0, - "ts": 1596771182232231, - "dur": 27, - "args": { - "name": "summary_train/lr", - "op": "ScalarSummary", - "input0": "summary_train/lr/tags", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/Merge/_49" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 11, - "tid": 0, - "ts": 1596771182232104, - "id": 66 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1596771182232231, - "id": 66 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 13, - "tid": 0, - "ts": 1596771182233629, - "dur": 18, - "args": { - "name": "summary_train/regularizer", - "op": "ScalarSummary", - "input0": "summary_train/regularizer/tags", - "input1": "loss/l2_regularizer/mul/_29" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/l2_regularizer/mul", - "pid": 11, - "tid": 0, - "ts": 1596771182233522, - "id": 67 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/l2_regularizer/mul", - "pid": 13, - "tid": 0, - "ts": 1596771182233629, - "id": 67 - }, - { - "ph": "X", - "cat": "Op", - "name": "IteratorGetNext", - "pid": 13, - "tid": 1, - "ts": 1596771182228831, - "dur": 566541, - "args": { - "name": "IteratorGetNext", - "op": "IteratorGetNext", - "input0": "points2grids_dataset/OneShotIterator" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "points2grids_dataset/OneShotIterator", - "pid": 13, - "tid": 0, - "ts": 1596771182228820, - "id": 68 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "points2grids_dataset/OneShotIterator", - "pid": 13, - "tid": 1, - "ts": 1596771182228831, - "id": 68 - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1596771182795467, - "dur": 32, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1", - "op": "Shape", - "input0": "IteratorGetNext:1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext:1", - "pid": 13, - "tid": 1, - "ts": 1596771182795372, - "id": 69 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext:1", - "pid": 13, - "tid": 0, - "ts": 1596771182795467, - "id": 69 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 13, - "tid": 0, - "ts": 1596771182821494, - "dur": 30, - "args": { - "name": "summary_train/rmse", - "op": "ScalarSummary", - "input0": "summary_train/rmse/tags", - "input1": "loss/mse_loss/mean_squared_error/value/_63" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/value", - "pid": 11, - "tid": 0, - "ts": 1596771182804676, - "id": 70 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/value", - "pid": 13, - "tid": 0, - "ts": 1596771182821494, - "id": 70 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 13, - "tid": 1, - "ts": 1596771182821494, - "dur": 33, - "args": { - "name": "summary_train/loss", - "op": "ScalarSummary", - "input0": "summary_train/loss/tags", - "input1": "loss/mse_loss/mean_squared_error/value/_63" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "summary_train/loss/tags", - "pid": 13, - "tid": 0, - "ts": 1596771182228769, - "id": 71 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "summary_train/loss/tags", - "pid": 13, - "tid": 1, - "ts": 1596771182821494, - "id": 71 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/value", - "pid": 11, - "tid": 0, - "ts": 1596771182804676, - "id": 72 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/value", - "pid": 13, - "tid": 1, - "ts": 1596771182821494, - "id": 72 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 13, - "tid": 0, - "ts": 1596771182821544, - "dur": 39, - "args": { - "name": "summary_train/total_loss", - "op": "ScalarSummary", - "input0": "summary_train/total_loss/tags", - "input1": "add/_65" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "add", - "pid": 11, - "tid": 0, - "ts": 1596771182804709, - "id": 73 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "add", - "pid": 13, - "tid": 0, - "ts": 1596771182821544, - "id": 73 - }, - { - "ph": "X", - "cat": "Op", - "name": "MergeSummary", - "pid": 13, - "tid": 0, - "ts": 1596771182821590, - "dur": 32, - "args": { - "name": "summary_train/Merge/MergeSummary", - "op": "MergeSummary", - "input0": "summary_train/loss", - "input1": "summary_train/rmse", - "input2": "summary_train/regularizer", - "input3": "summary_train/total_loss", - "input4": "summary_train/lr" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "summary_train/loss", - "pid": 13, - "tid": 1, - "ts": 1596771182821527, - "id": 74 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "summary_train/loss", - "pid": 13, - "tid": 0, - "ts": 1596771182821590, - "id": 74 - }, - { - "ph": "X", - "cat": "Op", - "name": "_Retval", - "pid": 13, - "tid": 0, - "ts": 1596771182821627, - "dur": 3, - "args": { - "name": "_retval_summary_train/Merge/MergeSummary_0_0", - "op": "_Retval", - "input0": "summary_train/Merge/MergeSummary" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1596771183053610, - "dur": 10, - "args": { - "name": "solver/Momentum/update/_69", - "op": "Identity", - "input0": "solver/Momentum/update/_68" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1596771183053628, - "dur": 7, - "args": { - "name": "solver/Momentum/value", - "op": "Const", - "input0": "^solver/Momentum/update/_69" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignAdd", - "pid": 13, - "tid": 0, - "ts": 1596771183053637, - "dur": 11, - "args": { - "name": "solver/Momentum", - "op": "AssignAdd", - "input0": "solver/global_step", - "input1": "solver/Momentum/value" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step", - "pid": 13, - "tid": 1, - "ts": 1596771182228828, - "id": 75 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step", - "pid": 13, - "tid": 0, - "ts": 1596771183053637, - "id": 75 - } - ] -} \ No newline at end of file diff --git a/tensorflow/script/logs/pdbbind/resnet_points_20200723_reg_5/timeline.json b/tensorflow/script/logs/pdbbind/resnet_points_20200723_reg_5/timeline.json deleted file mode 100644 index eb0ff30..0000000 --- a/tensorflow/script/logs/pdbbind/resnet_points_20200723_reg_5/timeline.json +++ /dev/null @@ -1,80163 +0,0 @@ -{ - "traceEvents": [ - { - "name": "process_name", - "ph": "M", - "pid": 0, - "args": { - "name": "Allocators" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 1, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/stream#3:MemcpyDtoH Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 2, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/stream#3:MemcpyDtoH Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 3, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/stream#2:MemcpyHtoD Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 4, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/stream#2:MemcpyHtoD Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 5, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/null stream Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 6, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/null stream Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 7, - "args": { - "name": "/device:GPU:0/stream:all Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 8, - "args": { - "name": "/device:GPU:0/stream:all Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 9, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/stream#1 Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 10, - "args": { - "name": "/gpu:0 (GeForce GTX 1080 Ti)/context#0/stream#1 Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 11, - "args": { - "name": "/host:CPU Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 12, - "args": { - "name": "/host:CPU Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 13, - "args": { - "name": "/job:localhost/replica:0/task:0/device:GPU:0 Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 14, - "args": { - "name": "/job:localhost/replica:0/task:0/device:GPU:0 Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 15, - "args": { - "name": "/job:localhost/replica:0/task:0/device:CPU:0 Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 16, - "args": { - "name": "/job:localhost/replica:0/task:0/device:CPU:0 Tensors" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1595535029372400, - "dur": 3, - "args": { - "name": "edge_344_loss/l2_regularizer/mul::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1595535029415984, - "dur": 70, - "args": { - "name": "edge_5770_solver/step_lr/PiecewiseConstant/and_1::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1595535029416098, - "dur": 123, - "args": { - "name": "edge_5766_solver/step_lr/PiecewiseConstant/and::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1595535029416123, - "dur": 133, - "args": { - "name": "edge_5774_solver/step_lr/PiecewiseConstant/and_2::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1595535029416621, - "dur": 69, - "args": { - "name": "edge_5469_solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1595535029416681, - "dur": 72, - "args": { - "name": "edge_5778_solver/step_lr/PiecewiseConstant/and_3::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1595535029416809, - "dur": 44, - "args": { - "name": "edge_5487_solver/step_lr/PiecewiseConstant/case/preds_c::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1595535029416886, - "dur": 12, - "args": { - "name": "edge_5467_solver/step_lr/PiecewiseConstant/case/Cast::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1595535029417085, - "dur": 10, - "args": { - "name": "edge_5819_loss/mse_loss/mean_squared_error/value::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1595535029417158, - "dur": 8, - "args": { - "name": "edge_5841_add::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1595535029417254, - "dur": 17, - "args": { - "name": "edge_5917_solver/step_lr/PiecewiseConstant/case/cond/Merge::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029360403, - "dur": 25, - "args": { - "name": "edge_2269_IteratorGetNext::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029361739, - "dur": 1391, - "args": { - "name": "edge_154_IteratorGetNext::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029413910, - "dur": 9, - "args": { - "name": "edge_5406_solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029415557, - "dur": 11, - "args": { - "name": "edge_5143_solver/step_lr/PiecewiseConstant/Greater_4::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029415593, - "dur": 8, - "args": { - "name": "edge_5146_solver/step_lr/PiecewiseConstant/LessEqual_3::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029415617, - "dur": 7, - "args": { - "name": "edge_5145_solver/step_lr/PiecewiseConstant/Greater_3::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029415642, - "dur": 7, - "args": { - "name": "edge_5148_solver/step_lr/PiecewiseConstant/LessEqual_2::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029415663, - "dur": 7, - "args": { - "name": "edge_5147_solver/step_lr/PiecewiseConstant/Greater_2::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029415685, - "dur": 6, - "args": { - "name": "edge_5150_solver/step_lr/PiecewiseConstant/LessEqual_1::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029415725, - "dur": 7, - "args": { - "name": "edge_5149_solver/step_lr/PiecewiseConstant/Greater_1::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029415819, - "dur": 128, - "args": { - "name": "edge_5155_solver/step_lr/PiecewiseConstant/LessEqual::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029415976, - "dur": 58, - "args": { - "name": "edge_5144_solver/step_lr/PiecewiseConstant/LessEqual_4::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029416079, - "dur": 52, - "args": { - "name": "edge_5156_solver/step_lr/PiecewiseConstant/Greater::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029416367, - "dur": 13, - "args": { - "name": "edge_5405_solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 3, - "tid": 0, - "ts": 1595535029416520, - "dur": 23, - "args": { - "name": "edge_5491_solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029365477, - "dur": 4397, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029373176, - "dur": 5841, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029382858, - "dur": 5861, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029392561, - "dur": 4579, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029400229, - "dur": 230, - "args": { - "name": "ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool:OctreeMaxPool#id=27#::_Z22octree_max_pool_kernelIfEvPT_iPiPKS0_ii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029400481, - "dur": 47, - "args": { - "name": "ocnn_resnet/max_pool_5/octree_max_pool/OctreePad:OctreePad#id=27#::_Z18pad_forward_kernelIfEvPT_iPKS0_iPKiiS0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029400963, - "dur": 1897, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029404136, - "dur": 1880, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029407263, - "dur": 1894, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029410194, - "dur": 104, - "args": { - "name": "ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool:OctreeMaxPool#id=27#::_Z22octree_max_pool_kernelIfEvPT_iPiPKS0_ii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029410316, - "dur": 25, - "args": { - "name": "ocnn_resnet/max_pool_4/octree_max_pool/OctreePad:OctreePad#id=27#::_Z18pad_forward_kernelIfEvPT_iPKS0_iPKiiS0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029410525, - "dur": 401, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029411353, - "dur": 405, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029412164, - "dur": 531, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029413039, - "dur": 30, - "args": { - "name": "ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool:OctreeMaxPool#id=27#::_Z22octree_max_pool_kernelIfEvPT_iPiPKS0_ii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029413640, - "dur": 20, - "args": { - "name": "ocnn_resnet/max_pool_3/octree_max_pool/OctreePad:OctreePad#id=27#::_Z18pad_forward_kernelIfEvPT_iPKS0_iPKiiS0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029417669, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreePad_grad/OctreeDepad:OctreeDepad#id=27#::_Z19pad_backward_kernelIfEvPT_iPKS0_iPKii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029417731, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool:OctreeMaxUnpool#id=27#::_Z24octree_max_unpool_kernelIfEvPKT_iPKiPS0_ii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029418331, - "dur": 408, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029419018, - "dur": 412, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17col2octree_kernelIfEvPKT_PS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029420059, - "dur": 535, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029420871, - "dur": 534, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17col2octree_kernelIfEvPKT_PS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029422050, - "dur": 401, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029422726, - "dur": 405, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17col2octree_kernelIfEvPKT_PS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029423429, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreePad_grad/OctreeDepad:OctreeDepad#id=27#::_Z19pad_backward_kernelIfEvPT_iPKS0_iPKii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029423513, - "dur": 94, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool:OctreeMaxUnpool#id=27#::_Z24octree_max_unpool_kernelIfEvPKT_iPKiPS0_ii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029424621, - "dur": 1568, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029427295, - "dur": 1585, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17col2octree_kernelIfEvPKT_PS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029430636, - "dur": 2427, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029434158, - "dur": 2431, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17col2octree_kernelIfEvPKT_PS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029439099, - "dur": 1849, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029442041, - "dur": 1897, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17col2octree_kernelIfEvPKT_PS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029444464, - "dur": 44, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreePad_grad/OctreeDepad:OctreeDepad#id=27#::_Z19pad_backward_kernelIfEvPT_iPKS0_iPKii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029444618, - "dur": 227, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool:OctreeMaxUnpool#id=27#::_Z24octree_max_unpool_kernelIfEvPKT_iPKiPS0_ii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029446892, - "dur": 4556, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029453575, - "dur": 4631, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17col2octree_kernelIfEvPKT_PS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029461571, - "dur": 5854, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029469556, - "dur": 5850, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17col2octree_kernelIfEvPKT_PS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029478768, - "dur": 5837, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029486730, - "dur": 5841, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17col2octree_kernelIfEvPKT_PS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029494933, - "dur": 3092, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17octree2col_kernelIfEvPT_PKS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 0, - "ts": 1595535029500780, - "dur": 3044, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::_Z17col2octree_kernelIfEvPKT_PS0_iiiPKiS5_iii", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029363301, - "dur": 33, - "args": { - "name": "ocnn_resnet/OctreeProperty:OctreeProperty#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029363352, - "dur": 66, - "args": { - "name": "ocnn_resnet/OctreeProperty:OctreeProperty#id=27#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029365393, - "dur": 25, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029365450, - "dur": 13, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029373112, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029373155, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029382791, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029382836, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029392492, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029392537, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029400208, - "dur": 12, - "args": { - "name": "ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool:OctreeMaxPool#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029400461, - "dur": 13, - "args": { - "name": "ocnn_resnet/max_pool_5/octree_max_pool/OctreePad:OctreePad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029400910, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029400947, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029404080, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029404118, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029407218, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029407248, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029410176, - "dur": 10, - "args": { - "name": "ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool:OctreeMaxPool#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029410298, - "dur": 11, - "args": { - "name": "ocnn_resnet/max_pool_4/octree_max_pool/OctreePad:OctreePad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029410480, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029410511, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029411293, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029411338, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029412117, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029412149, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029413021, - "dur": 10, - "args": { - "name": "ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool:OctreeMaxPool#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029413616, - "dur": 15, - "args": { - "name": "ocnn_resnet/max_pool_3/octree_max_pool/OctreePad:OctreePad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029417642, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreePad_grad/OctreeDepad:OctreeDepad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029417696, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool:OctreeMaxUnpool#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029418260, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029418302, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029419985, - "dur": 25, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029420031, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029421979, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029422019, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029423412, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreePad_grad/OctreeDepad:OctreeDepad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029423455, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool:OctreeMaxUnpool#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029424563, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029424596, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029430563, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029430604, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029439029, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029439065, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029444439, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreePad_grad/OctreeDepad:OctreeDepad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029444509, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool:OctreeMaxUnpool#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029446831, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029446866, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029461490, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029461535, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029478682, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029478730, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029494862, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyDtoH", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 5, - "tid": 1, - "ts": 1595535029494902, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029363947, - "dur": 23, - "args": { - "name": "loss/l2_regularizer/L2Loss_24", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029363974, - "dur": 8, - "args": { - "name": "loss/l2_regularizer/L2Loss_24", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029363996, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_14", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364014, - "dur": 8, - "args": { - "name": "loss/l2_regularizer/L2Loss_5", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364031, - "dur": 9, - "args": { - "name": "loss/l2_regularizer/L2Loss_9", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364047, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_55", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364064, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_54", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364075, - "dur": 5, - "args": { - "name": "loss/l2_regularizer/L2Loss_54", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364092, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_45", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364103, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_45", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364117, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_13", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364134, - "dur": 8, - "args": { - "name": "loss/l2_regularizer/L2Loss_4", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364151, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_81", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364162, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_81", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364177, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_67", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364193, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_73", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364210, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_63", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364223, - "dur": 5, - "args": { - "name": "loss/l2_regularizer/L2Loss_63", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364238, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_78", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364247, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_78", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364265, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_88", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364282, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_80", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364298, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_72", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364310, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_72", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364324, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_62", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364339, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_87", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364356, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_61", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364371, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_86", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364388, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_79", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364404, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_71", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364421, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_60", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364430, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_60", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364447, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_85", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364464, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_77", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364480, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_70", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364497, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_66", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364506, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_66", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364523, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_44", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364538, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_68", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364553, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_53", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364569, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_43", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364585, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_35", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364601, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_48", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364611, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_48", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364628, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_2", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364644, - "dur": 9, - "args": { - "name": "loss/l2_regularizer/L2Loss_12", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364660, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_29", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364675, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_52", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364692, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_38", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364708, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_34", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364724, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_51", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364734, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_51", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364749, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_23", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364766, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_6", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364776, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_6", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364792, - "dur": 9, - "args": { - "name": "loss/l2_regularizer/L2Loss_18", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364808, - "dur": 8, - "args": { - "name": "loss/l2_regularizer/L2Loss_50", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364826, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_41", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364842, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_36", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364851, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_36", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364868, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_57", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364877, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_57", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364893, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_20", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364910, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_11", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364926, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_1", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364943, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_28", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364960, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_49", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364976, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_40", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029364993, - "dur": 9, - "args": { - "name": "loss/l2_regularizer/L2Loss_33", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365003, - "dur": 5, - "args": { - "name": "loss/l2_regularizer/L2Loss_33", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365017, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_26", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365034, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_19", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365050, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_10", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365067, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_84", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365077, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_84", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365093, - "dur": 9, - "args": { - "name": "loss/l2_regularizer/L2Loss_27", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365109, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_56", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365125, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_47", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365140, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_37", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365157, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_32", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365173, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_58", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365189, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_69", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365198, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_69", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365215, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_8", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365231, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_46", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365248, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_39", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365257, - "dur": 5, - "args": { - "name": "loss/l2_regularizer/L2Loss_39", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365273, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_42", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365282, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_42", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365298, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_76", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365314, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_22", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365330, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_17", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365346, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_7", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365362, - "dur": 8, - "args": { - "name": "loss/l2_regularizer/L2Loss", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365372, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029365477, - "dur": 4397, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029369877, - "dur": 1106, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029370986, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_21", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029370997, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/L2Loss_31", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371004, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_83", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371011, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_65", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371019, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/L2Loss_16", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371025, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_30", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371033, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/L2Loss_30", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371039, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_59", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371047, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_82", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371054, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_74", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371061, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_64", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371068, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_75", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371075, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_75", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371083, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_15", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371093, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/L2Loss_15", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371099, - "dur": 5, - "args": { - "name": "loss/l2_regularizer/L2Loss_25", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371107, - "dur": 8, - "args": { - "name": "loss/l2_regularizer/L2Loss_3", - "op": "L2Loss#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029371124, - "dur": 979, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372106, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372114, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372121, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372128, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372135, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372142, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372148, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372156, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372162, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372168, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372173, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372179, - "dur": 187, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372369, - "dur": 3, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372374, - "dur": 3, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372379, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372384, - "dur": 3, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372389, - "dur": 2, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372393, - "dur": 182, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372577, - "dur": 3, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372583, - "dur": 4, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029372591, - "dur": 461, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029373055, - "dur": 46, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029373102, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029373107, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029373176, - "dur": 5841, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029379019, - "dur": 849, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029379872, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029379880, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029379892, - "dur": 464, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029380360, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029380366, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029380373, - "dur": 47, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029380423, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029380430, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029380437, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029380444, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029380450, - "dur": 132, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029380585, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029380591, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029380599, - "dur": 976, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029381578, - "dur": 279, - "args": { - "name": "ocnn_resnet/resblock_5_0/add", - "op": "Add#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029381858, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029381863, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029381868, - "dur": 189, - "args": { - "name": "ocnn_resnet/resblock_5_0/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029382059, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029382064, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029382069, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029382074, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029382079, - "dur": 176, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029382267, - "dur": 466, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029382734, - "dur": 46, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029382782, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029382786, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029382858, - "dur": 5861, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029388722, - "dur": 850, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029389575, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029389582, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029389599, - "dur": 457, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029390059, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029390066, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029390073, - "dur": 47, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029390124, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029390130, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029390137, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029390144, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029390151, - "dur": 132, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029390285, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029390292, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029390301, - "dur": 981, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029391284, - "dur": 277, - "args": { - "name": "ocnn_resnet/resblock_5_1/add", - "op": "Add#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029391562, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029391567, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029391574, - "dur": 186, - "args": { - "name": "ocnn_resnet/resblock_5_1/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029391761, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029391766, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029391771, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029391776, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029391782, - "dur": 176, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029391968, - "dur": 464, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029392434, - "dur": 47, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029392482, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029392487, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029392561, - "dur": 4579, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029397141, - "dur": 861, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398005, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398013, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398025, - "dur": 459, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398488, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398494, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398501, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398507, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398513, - "dur": 47, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398562, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398570, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398575, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398580, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398584, - "dur": 132, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029398728, - "dur": 981, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029399710, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029399716, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029399722, - "dur": 278, - "args": { - "name": "ocnn_resnet/resblock_5_2/add", - "op": "Add#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029400000, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400005, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400010, - "dur": 187, - "args": { - "name": "ocnn_resnet/resblock_5_2/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400198, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400203, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400229, - "dur": 230, - "args": { - "name": "ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400481, - "dur": 47, - "args": { - "name": "ocnn_resnet/max_pool_5/octree_max_pool/OctreePad", - "op": "OctreePad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400529, - "dur": 117, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400647, - "dur": 62, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400718, - "dur": 100, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400828, - "dur": 32, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400862, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400867, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400873, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400892, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400897, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400901, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400906, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029400963, - "dur": 1897, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029402862, - "dur": 477, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403343, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403350, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403357, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403364, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403376, - "dur": 33, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403412, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403419, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403427, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403450, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403456, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403463, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403471, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403478, - "dur": 75, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403555, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403562, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403575, - "dur": 95, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403673, - "dur": 119, - "args": { - "name": "ocnn_resnet/resblock_4_0/add", - "op": "Add#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403795, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403800, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403805, - "dur": 80, - "args": { - "name": "ocnn_resnet/resblock_4_0/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403887, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403892, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403897, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403903, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029403908, - "dur": 101, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029404017, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029404049, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029404070, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029404075, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029404136, - "dur": 1880, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406017, - "dur": 476, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406496, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406504, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406517, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406551, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406557, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406565, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406588, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406594, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406601, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406608, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406614, - "dur": 75, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406692, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406698, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406708, - "dur": 96, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406808, - "dur": 120, - "args": { - "name": "ocnn_resnet/resblock_4_1/add", - "op": "Add#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406930, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406937, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029406942, - "dur": 79, - "args": { - "name": "ocnn_resnet/resblock_4_1/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029407023, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029407029, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029407034, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029407039, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029407044, - "dur": 100, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029407155, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029407188, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029407209, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029407213, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029407263, - "dur": 1894, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409160, - "dur": 478, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409641, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409648, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409661, - "dur": 33, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409697, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409704, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409711, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409717, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409723, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409746, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409752, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409757, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409763, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409768, - "dur": 73, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409846, - "dur": 95, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409943, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409948, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029409953, - "dur": 120, - "args": { - "name": "ocnn_resnet/resblock_4_2/add", - "op": "Add#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410075, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410079, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410083, - "dur": 80, - "args": { - "name": "ocnn_resnet/resblock_4_2/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410164, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410171, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410194, - "dur": 104, - "args": { - "name": "ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410316, - "dur": 25, - "args": { - "name": "ocnn_resnet/max_pool_4/octree_max_pool/OctreePad", - "op": "OctreePad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410358, - "dur": 42, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410406, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410431, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410448, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410464, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410525, - "dur": 401, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029410931, - "dur": 89, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411021, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411026, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411036, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411051, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411055, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411058, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411063, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411068, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411072, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411076, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411080, - "dur": 24, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029411104, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411108, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411115, - "dur": 23, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411140, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_3_0/add", - "op": "Add#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411174, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411179, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411184, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_3_0/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411206, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411211, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411217, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411222, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411227, - "dur": 33, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411267, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029411278, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411284, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411289, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411353, - "dur": 405, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411762, - "dur": 92, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411855, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411859, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411865, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411879, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411883, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411887, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411892, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411895, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411899, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411903, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411907, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411930, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411933, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411942, - "dur": 23, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411967, - "dur": 29, - "args": { - "name": "ocnn_resnet/resblock_3_1/add", - "op": "Add#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029411998, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412003, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412010, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_3_1/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412030, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412036, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412041, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412046, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412052, - "dur": 32, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412092, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412103, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412108, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412112, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412164, - "dur": 531, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412702, - "dur": 92, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412797, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412805, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412817, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412830, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412837, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412843, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412849, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412855, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412862, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412868, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412873, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412878, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412883, - "dur": 23, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412915, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412941, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412948, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412953, - "dur": 30, - "args": { - "name": "ocnn_resnet/resblock_3_2/add", - "op": "Add#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029412983, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412988, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029412993, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_3_2/Relu", - "op": "Relu#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029413012, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029413017, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029413039, - "dur": 30, - "args": { - "name": "ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029413640, - "dur": 20, - "args": { - "name": "ocnn_resnet/max_pool_3/octree_max_pool/OctreePad", - "op": "OctreePad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Transpose#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029413865, - "dur": 25, - "args": { - "name": "ocnn_resnet/global_average/octree_full_voxel/transpose", - "op": "Transpose#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029413948, - "dur": 25, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_85_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029413986, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_78_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414006, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_74_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414024, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_76_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414041, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_70_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414059, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_65_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414076, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_60_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414094, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_1_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414112, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_25_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414129, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_22_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414146, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_2_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414164, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_12_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414182, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_6_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414202, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_7_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414220, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_26_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414237, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_66_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414253, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_61_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414270, - "dur": 8, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_72_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414289, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_27_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414306, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_64_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414323, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_67_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414340, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_82_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414357, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_86_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414374, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_73_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414391, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_77_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414407, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_71_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414424, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_68_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414442, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_62_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414458, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_83_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414475, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_79_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414492, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_28_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414508, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_69_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414526, - "dur": 8, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_63_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414544, - "dur": 8, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_13_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414562, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_87_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414579, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_88_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414597, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_24_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414616, - "dur": 34, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_80_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414661, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_23_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414678, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_75_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414695, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_14_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414712, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_8_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414729, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_3_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414747, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414765, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_59_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414783, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_29_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414799, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_15_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414818, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_18_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414836, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_43_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414852, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_9_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414869, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_4_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414886, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_55_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414903, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_51_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414920, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_45_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414938, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_21_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414956, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_16_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414972, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_19_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029414989, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_31_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415007, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_10_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415024, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_5_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415041, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_56_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415058, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_52_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415074, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_46_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415092, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_49_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415108, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_35_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415125, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_17_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415142, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_84_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415158, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_11_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415175, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_54_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415193, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_57_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415210, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_53_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415226, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_47_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415243, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_50_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415260, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_44_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415277, - "dur": 14, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_20_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415302, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_36_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415319, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_32_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415336, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_58_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415353, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_48_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415370, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_42_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415386, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_39_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415404, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_37_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415422, - "dur": 8, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_81_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415441, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_33_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415459, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_40_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415477, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_38_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415493, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_34_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415511, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_41_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415528, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_30_grad/mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415779, - "dur": 86, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_1", - "op": "LogicalAnd#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029415885, - "dur": 81, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_2", - "op": "LogicalAnd#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029415852, - "dur": 159, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and", - "op": "LogicalAnd#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029416110, - "dur": 128, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_3", - "op": "LogicalAnd#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mean#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029416216, - "dur": 68, - "args": { - "name": "ocnn_resnet/global_average/Mean", - "op": "Mean#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DynamicStitch#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029416483, - "dur": 30, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch", - "op": "DynamicStitch#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029416550, - "dur": 17, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Cast", - "op": "Cast#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029416575, - "dur": 15, - "args": { - "name": "ocnn_resnet/fc2/dense/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029416610, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Cast", - "op": "Cast#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BiasAdd#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029416667, - "dur": 75, - "args": { - "name": "ocnn_resnet/fc2/dense/BiasAdd", - "op": "BiasAdd#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "SquaredDifference#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029416799, - "dur": 27, - "args": { - "name": "loss/mse_loss/mean_squared_error/SquaredDifference", - "op": "SquaredDifference#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Fill#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029416905, - "dur": 12, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like", - "op": "Fill#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029416945, - "dur": 9, - "args": { - "name": "loss/mse_loss/mean_squared_error/Sum", - "op": "Sum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029416974, - "dur": 11, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present", - "op": "Sum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DivNoNan#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417002, - "dur": 10, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan", - "op": "DivNoNan#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DivNoNan#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417023, - "dur": 8, - "args": { - "name": "loss/mse_loss/mean_squared_error/value", - "op": "DivNoNan#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417052, - "dur": 8, - "args": { - "name": "add", - "op": "Add#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Tile#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417122, - "dur": 10, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile", - "op": "Tile#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417226, - "dur": 12, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/sub", - "op": "Sub#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417279, - "dur": 10, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Mul", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417303, - "dur": 8, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/mul_1", - "op": "Mul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BiasAddGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417350, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad", - "op": "BiasAddGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417378, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417405, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417430, - "dur": 9, - "args": { - "name": "solver/gradients/AddN", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417459, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_1", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417483, - "dur": 8, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417495, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Tile#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417520, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Tile", - "op": "Tile#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417548, - "dur": 8, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417559, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "RealDiv#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417581, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/truediv", - "op": "RealDiv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Transpose#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417608, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/transpose_grad/transpose", - "op": "Transpose#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417669, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417731, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417758, - "dur": 37, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417811, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417825, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417854, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417897, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_2", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417917, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_3", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029417944, - "dur": 73, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418018, - "dur": 30, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418050, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418054, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418058, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418062, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418080, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_4", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418100, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418120, - "dur": 8, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418131, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418153, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418166, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418184, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418217, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_5", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418239, - "dur": 7, - "args": { - "name": "solver/gradients/AddN_6", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418331, - "dur": 408, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418741, - "dur": 156, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029418900, - "dur": 110, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419018, - "dur": 412, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419431, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419440, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419447, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419455, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419462, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419475, - "dur": 7, - "args": { - "name": "solver/gradients/AddN_7", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419485, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419493, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419500, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419512, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419523, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419533, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_8", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419539, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_9", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419546, - "dur": 28, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419575, - "dur": 66, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419645, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419651, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419658, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419665, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419672, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_10", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419678, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419686, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419693, - "dur": 27, - "args": { - "name": "solver/gradients/AddN_11", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419722, - "dur": 29, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419755, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419761, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419768, - "dur": 34, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419805, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_12", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419811, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_13", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419818, - "dur": 62, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419883, - "dur": 32, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419917, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419923, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419928, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419933, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419938, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_14", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419944, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419953, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419959, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419965, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419969, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029419974, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029420059, - "dur": 535, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029420596, - "dur": 156, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029420756, - "dur": 108, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029420871, - "dur": 534, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421407, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_15", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421417, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_16", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421424, - "dur": 7, - "args": { - "name": "solver/gradients/AddN_17", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421435, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421447, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421454, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421461, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421469, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421476, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421486, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421496, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421503, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421510, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421526, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_18", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421533, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_19", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421540, - "dur": 27, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421571, - "dur": 66, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421640, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421646, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421655, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421661, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421668, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_20", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421675, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421682, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421689, - "dur": 26, - "args": { - "name": "solver/gradients/AddN_21", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421719, - "dur": 29, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421751, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421759, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421765, - "dur": 34, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421801, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_22", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421807, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_23", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421813, - "dur": 66, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421881, - "dur": 32, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421914, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421920, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421926, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421931, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421936, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_24", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421941, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421950, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421955, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421960, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421964, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029421968, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029422050, - "dur": 401, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029422454, - "dur": 156, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029422613, - "dur": 105, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029422726, - "dur": 405, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423132, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_25", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423142, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_26", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423149, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_27", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423158, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423170, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423178, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423185, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423192, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423198, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423207, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423216, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423222, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423228, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423243, - "dur": 2, - "args": { - "name": "solver/gradients/AddN_28", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423248, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_29", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423253, - "dur": 26, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423282, - "dur": 67, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029423349, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423356, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423361, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423366, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423370, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_30", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423375, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423379, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423384, - "dur": 26, - "args": { - "name": "solver/gradients/AddN_31", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423429, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423513, - "dur": 94, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029423607, - "dur": 124, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423733, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423736, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029423741, - "dur": 257, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424001, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_32", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424007, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_33", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424012, - "dur": 291, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424305, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424406, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424412, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424418, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424423, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424428, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_34", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424433, - "dur": 31, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424466, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424473, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424478, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424482, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424487, - "dur": 75, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029424621, - "dur": 1568, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029426191, - "dur": 659, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029426852, - "dur": 425, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029427295, - "dur": 1585, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029428882, - "dur": 5, - "args": { - "name": "solver/gradients/AddN_35", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029428890, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_36", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029428897, - "dur": 30, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029428930, - "dur": 9, - "args": { - "name": "solver/gradients/AddN_37", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029428942, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029428950, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029428957, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029428964, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029428971, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029428978, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029428984, - "dur": 78, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429065, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429076, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429085, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_38", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429092, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_39", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429100, - "dur": 257, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429360, - "dur": 73, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429436, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429443, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429450, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429458, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429465, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_40", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429472, - "dur": 118, - "args": { - "name": "solver/gradients/AddN_41", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429593, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429600, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429607, - "dur": 120, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429731, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429738, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029429744, - "dur": 256, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430003, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_42", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430009, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_43", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430016, - "dur": 287, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430304, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430406, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430412, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430418, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430422, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430428, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_44", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430434, - "dur": 30, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430466, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430473, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430478, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430483, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430487, - "dur": 76, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029430636, - "dur": 2427, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029433065, - "dur": 654, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029433723, - "dur": 421, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029434158, - "dur": 2431, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436591, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_45", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436600, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_46", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436607, - "dur": 31, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436641, - "dur": 7, - "args": { - "name": "solver/gradients/AddN_47", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436651, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436659, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436665, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436673, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436680, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436687, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436694, - "dur": 75, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436772, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436782, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436793, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_48", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436800, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_49", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029436807, - "dur": 258, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437068, - "dur": 73, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437144, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437151, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437158, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437165, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437172, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_50", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437180, - "dur": 119, - "args": { - "name": "solver/gradients/AddN_51", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437302, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437310, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437317, - "dur": 118, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437438, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437445, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437451, - "dur": 259, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437713, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437720, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437727, - "dur": 256, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437986, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_54", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029437994, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_55", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438001, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_52", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438008, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_53", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438015, - "dur": 280, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438298, - "dur": 122, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438424, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438431, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438437, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438444, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438451, - "dur": 295, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438749, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438850, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438857, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438863, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438868, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438873, - "dur": 5, - "args": { - "name": "solver/gradients/AddN_57", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438880, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_56", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438887, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438894, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438900, - "dur": 31, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438933, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438939, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438944, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438949, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029438953, - "dur": 74, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029439099, - "dur": 1849, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029440950, - "dur": 657, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029441611, - "dur": 415, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029442041, - "dur": 1897, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029443941, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_58", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029443950, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_59", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029443956, - "dur": 30, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029443989, - "dur": 7, - "args": { - "name": "solver/gradients/AddN_60", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444000, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444009, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444015, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444022, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444029, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444035, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444041, - "dur": 76, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444120, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444129, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444138, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_61", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444143, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_62", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444152, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444158, - "dur": 134, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444294, - "dur": 44, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444340, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444347, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444352, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444357, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444362, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_63", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444366, - "dur": 60, - "args": { - "name": "solver/gradients/AddN_64", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444427, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444433, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444464, - "dur": 44, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444618, - "dur": 227, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029444847, - "dur": 285, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029445135, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029445142, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029445149, - "dur": 716, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029445869, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_65", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029445874, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_66", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029445884, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029445890, - "dur": 383, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446276, - "dur": 179, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446457, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446463, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446469, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446474, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446479, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_67", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446486, - "dur": 71, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446558, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446563, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446570, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446574, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446578, - "dur": 251, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029446892, - "dur": 4556, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029451451, - "dur": 1398, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029452852, - "dur": 696, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029453575, - "dur": 4631, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458207, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_68", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458217, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_69", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458224, - "dur": 70, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458297, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_70", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458308, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458314, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458321, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458328, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458335, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458342, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458349, - "dur": 252, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458605, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458614, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458621, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_71", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458628, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_72", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458638, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029458646, - "dur": 384, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459033, - "dur": 134, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459168, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459175, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459182, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459189, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459197, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_73", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459203, - "dur": 276, - "args": { - "name": "solver/gradients/AddN_74", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459482, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459489, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459497, - "dur": 278, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459777, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459784, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029459791, - "dur": 721, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029460515, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_75", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029460523, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_76", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029460531, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029460537, - "dur": 397, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029460936, - "dur": 175, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029461115, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029461121, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029461127, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029461131, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029461137, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_77", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029461142, - "dur": 71, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029461214, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029461220, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029461225, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029461230, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029461233, - "dur": 256, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029461571, - "dur": 5854, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029467427, - "dur": 1400, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029468831, - "dur": 695, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029469556, - "dur": 5850, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475407, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_78", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475417, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_79", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475423, - "dur": 70, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475496, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_80", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475506, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475513, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475520, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475527, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475533, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475541, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475547, - "dur": 254, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475805, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475814, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475822, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_81", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475829, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_82", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475840, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029475847, - "dur": 382, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476232, - "dur": 137, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476372, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476379, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476386, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476394, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476401, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_83", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476407, - "dur": 279, - "args": { - "name": "solver/gradients/AddN_84", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476690, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476697, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476703, - "dur": 279, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476984, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476991, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029476998, - "dur": 717, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029477718, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_85", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029477724, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_86", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029477733, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029477739, - "dur": 387, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478128, - "dur": 177, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478307, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478315, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478320, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478325, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478331, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_87", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478336, - "dur": 70, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478407, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478413, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478417, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478422, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478426, - "dur": 254, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029478768, - "dur": 5837, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029484608, - "dur": 1396, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029486007, - "dur": 696, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029486730, - "dur": 5841, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492573, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_88", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492582, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_89", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492589, - "dur": 72, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492662, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_90", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492671, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492679, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492685, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492693, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492700, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492707, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492713, - "dur": 256, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492972, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492981, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492989, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_91", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029492995, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_92", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029493005, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029493011, - "dur": 393, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029493406, - "dur": 132, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029493542, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029493547, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029493552, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029493557, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029493562, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_93", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029493567, - "dur": 278, - "args": { - "name": "solver/gradients/AddN_94", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029493846, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029493852, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029493857, - "dur": 281, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029494139, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029494144, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029494148, - "dur": 714, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029494933, - "dur": 3092, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029498028, - "dur": 1381, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029499411, - "dur": 1348, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029500780, - "dur": 3044, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029503827, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_95", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029503831, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_96", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029503836, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_97", - "op": "AddN#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029503841, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029503845, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029503850, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029503853, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029503857, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum#id=27#", - "pid": 7, - "tid": 0, - "ts": 1595535029503862, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029360403, - "dur": 25, - "args": { - "name": "edge_2269_IteratorGetNext", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029361739, - "dur": 1391, - "args": { - "name": "edge_154_IteratorGetNext", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeProperty#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029363301, - "dur": 33, - "args": { - "name": "ocnn_resnet/OctreeProperty", - "op": "OctreeProperty#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeProperty#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029363352, - "dur": 66, - "args": { - "name": "ocnn_resnet/OctreeProperty", - "op": "OctreeProperty#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029365393, - "dur": 25, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029365450, - "dur": 13, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029372400, - "dur": 3, - "args": { - "name": "edge_344_loss/l2_regularizer/mul", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029373112, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029373155, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029382791, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029382836, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029392492, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029392537, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029400208, - "dur": 12, - "args": { - "name": "ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029400461, - "dur": 13, - "args": { - "name": "ocnn_resnet/max_pool_5/octree_max_pool/OctreePad", - "op": "OctreePad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029400910, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029400947, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029404080, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029404118, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029407218, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029407248, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029410176, - "dur": 10, - "args": { - "name": "ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029410298, - "dur": 11, - "args": { - "name": "ocnn_resnet/max_pool_4/octree_max_pool/OctreePad", - "op": "OctreePad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029410480, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029410511, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029411293, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029411338, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029412117, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029412149, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029413021, - "dur": 10, - "args": { - "name": "ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029413616, - "dur": 15, - "args": { - "name": "ocnn_resnet/max_pool_3/octree_max_pool/OctreePad", - "op": "OctreePad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029413910, - "dur": 9, - "args": { - "name": "edge_5406_solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029415557, - "dur": 11, - "args": { - "name": "edge_5143_solver/step_lr/PiecewiseConstant/Greater_4", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029415593, - "dur": 8, - "args": { - "name": "edge_5146_solver/step_lr/PiecewiseConstant/LessEqual_3", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029415617, - "dur": 7, - "args": { - "name": "edge_5145_solver/step_lr/PiecewiseConstant/Greater_3", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029415642, - "dur": 7, - "args": { - "name": "edge_5148_solver/step_lr/PiecewiseConstant/LessEqual_2", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029415663, - "dur": 7, - "args": { - "name": "edge_5147_solver/step_lr/PiecewiseConstant/Greater_2", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029415685, - "dur": 6, - "args": { - "name": "edge_5150_solver/step_lr/PiecewiseConstant/LessEqual_1", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029415725, - "dur": 7, - "args": { - "name": "edge_5149_solver/step_lr/PiecewiseConstant/Greater_1", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029415819, - "dur": 128, - "args": { - "name": "edge_5155_solver/step_lr/PiecewiseConstant/LessEqual", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029415976, - "dur": 58, - "args": { - "name": "edge_5144_solver/step_lr/PiecewiseConstant/LessEqual_4", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 3, - "ts": 1595535029415984, - "dur": 70, - "args": { - "name": "edge_5770_solver/step_lr/PiecewiseConstant/and_1", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029416079, - "dur": 52, - "args": { - "name": "edge_5156_solver/step_lr/PiecewiseConstant/Greater", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 3, - "ts": 1595535029416098, - "dur": 123, - "args": { - "name": "edge_5766_solver/step_lr/PiecewiseConstant/and", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 4, - "ts": 1595535029416123, - "dur": 133, - "args": { - "name": "edge_5774_solver/step_lr/PiecewiseConstant/and_2", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029416286, - "dur": 27, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029416319, - "dur": 32, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029416360, - "dur": 39, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 3, - "ts": 1595535029416367, - "dur": 13, - "args": { - "name": "edge_5405_solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029416411, - "dur": 16, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029416432, - "dur": 15, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029416452, - "dur": 16, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029416520, - "dur": 23, - "args": { - "name": "edge_5491_solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029416621, - "dur": 69, - "args": { - "name": "edge_5469_solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 3, - "ts": 1595535029416681, - "dur": 72, - "args": { - "name": "edge_5778_solver/step_lr/PiecewiseConstant/and_3", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029416809, - "dur": 44, - "args": { - "name": "edge_5487_solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029416886, - "dur": 12, - "args": { - "name": "edge_5467_solver/step_lr/PiecewiseConstant/case/Cast", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029417085, - "dur": 10, - "args": { - "name": "edge_5819_loss/mse_loss/mean_squared_error/value", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029417158, - "dur": 8, - "args": { - "name": "edge_5841_add", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "", - "pid": 7, - "tid": 2, - "ts": 1595535029417254, - "dur": 17, - "args": { - "name": "edge_5917_solver/step_lr/PiecewiseConstant/case/cond/Merge", - "op": "" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029417642, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029417696, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029418260, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029418302, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029419985, - "dur": 25, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029420031, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029421979, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029422019, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029423412, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool#id=27#", - "pid": 7, - "tid": 2, - "ts": 1595535029423455, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029424563, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029424596, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029430563, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029430604, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029439029, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029439065, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029444149, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029444439, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029444509, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029445880, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029446831, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029446866, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029458635, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029460528, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029461490, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029461535, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029475837, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029477730, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029478682, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029478730, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029493002, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029494862, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad#id=27#", - "pid": 7, - "tid": 1, - "ts": 1595535029494902, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad#id=27#" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029363947, - "dur": 23, - "args": { - "name": "loss/l2_regularizer/L2Loss_24:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029363974, - "dur": 8, - "args": { - "name": "loss/l2_regularizer/L2Loss_24:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029363996, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_14:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364014, - "dur": 8, - "args": { - "name": "loss/l2_regularizer/L2Loss_5:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364031, - "dur": 9, - "args": { - "name": "loss/l2_regularizer/L2Loss_9:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364047, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_55:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364064, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_54:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364075, - "dur": 5, - "args": { - "name": "loss/l2_regularizer/L2Loss_54:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364092, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_45:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364103, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_45:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364117, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_13:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364134, - "dur": 8, - "args": { - "name": "loss/l2_regularizer/L2Loss_4:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364151, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_81:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364162, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_81:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364177, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_67:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364193, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_73:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364210, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_63:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364223, - "dur": 5, - "args": { - "name": "loss/l2_regularizer/L2Loss_63:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364238, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_78:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364247, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_78:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364265, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_88:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364282, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_80:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364298, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_72:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364310, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_72:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364324, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_62:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364339, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_87:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364356, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_61:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364371, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_86:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364388, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_79:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364404, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_71:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364421, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_60:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364430, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_60:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364447, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_85:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364464, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_77:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364480, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_70:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364497, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_66:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364506, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_66:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364523, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_44:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364538, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_68:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364553, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_53:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364569, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_43:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364585, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_35:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364601, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_48:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364611, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_48:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364628, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_2:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364644, - "dur": 9, - "args": { - "name": "loss/l2_regularizer/L2Loss_12:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364660, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_29:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364675, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_52:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364692, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_38:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364708, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_34:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364724, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_51:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364734, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_51:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364749, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_23:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364766, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_6:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364776, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_6:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364792, - "dur": 9, - "args": { - "name": "loss/l2_regularizer/L2Loss_18:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364808, - "dur": 8, - "args": { - "name": "loss/l2_regularizer/L2Loss_50:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364826, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_41:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364842, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_36:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364851, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_36:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364868, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_57:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364877, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_57:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364893, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_20:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364910, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_11:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364926, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_1:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364943, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_28:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364960, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_49:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364976, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_40:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029364993, - "dur": 9, - "args": { - "name": "loss/l2_regularizer/L2Loss_33:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365003, - "dur": 5, - "args": { - "name": "loss/l2_regularizer/L2Loss_33:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365017, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_26:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365034, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_19:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365050, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_10:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365067, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_84:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365077, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_84:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365093, - "dur": 9, - "args": { - "name": "loss/l2_regularizer/L2Loss_27:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365109, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_56:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365125, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_47:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365140, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_37:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365157, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_32:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365173, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_58:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365189, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_69:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365198, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_69:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365215, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_8:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365231, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_46:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365248, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_39:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365257, - "dur": 5, - "args": { - "name": "loss/l2_regularizer/L2Loss_39:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365273, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_42:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365282, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_42:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365298, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_76:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365314, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_22:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365330, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_17:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365346, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_7:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365362, - "dur": 8, - "args": { - "name": "loss/l2_regularizer/L2Loss:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029365372, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029369877, - "dur": 1106, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::sgemm_128x128x8_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029370986, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/L2Loss_21:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029370997, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/L2Loss_31:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371004, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_83:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371011, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_65:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371019, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/L2Loss_16:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371025, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_30:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371033, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/L2Loss_30:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371039, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_59:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371047, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_82:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371054, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_74:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371061, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_64:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371068, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_75:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371075, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/L2Loss_75:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371083, - "dur": 6, - "args": { - "name": "loss/l2_regularizer/L2Loss_15:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371093, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/L2Loss_15:L2Loss#id=27#::_ZN10tensorflow7functor15CleanupSegmentsIPfS2_N3cub3SumEEEvT_T0_iiiT1_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371099, - "dur": 5, - "args": { - "name": "loss/l2_regularizer/L2Loss_25:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371107, - "dur": 8, - "args": { - "name": "loss/l2_regularizer/L2Loss_3:L2Loss#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIN3cub22TransformInputIteratorIfNS_10squareHalfIfEEPflEES6_Li256ENS2_3SumEEEvT_T0_iT2_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029371124, - "dur": 979, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail25bn_fw_tr_1C11_kernel_NCHWIffLi512ELb1ELi1EEEv17cudnnTensorStructPKT_S2_PS3_PKT0_S9_S7_S7_PS7_SA_SA_SA_S7_S7_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372106, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSC_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EESG_EESG_EESG_EESG_EESG_EESG_EESG_EESG_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372114, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372121, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372128, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372135, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372142, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372148, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372156, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372162, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372168, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372173, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/AddN:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKS8_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_ISB_KNS9_INSA_IKfSD_EEKNS4_INS5_ISD_Li1ELi1ElEELi16ES7_EESH_EESH_EESH_EESH_EESH_EESH_EESH_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372179, - "dur": 187, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372369, - "dur": 3, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372374, - "dur": 3, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372379, - "dur": 3, - "args": { - "name": "loss/l2_regularizer/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372384, - "dur": 3, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372389, - "dur": 2, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372393, - "dur": 182, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_32x32x32_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372577, - "dur": 3, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372583, - "dur": 4, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029372591, - "dur": 461, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail25bn_fw_tr_1C11_kernel_NCHWIffLi512ELb1ELi1EEEv17cudnnTensorStructPKT_S2_PS3_PKT0_S9_S7_S7_PS7_SA_SA_SA_S7_S7_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029373055, - "dur": 46, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029373102, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029373107, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029379019, - "dur": 849, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::sgemm_32x32x32_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029379872, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029379880, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029379892, - "dur": 464, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail25bn_fw_tr_1C11_kernel_NCHWIffLi512ELb1ELi1EEEv17cudnnTensorStructPKT_S2_PS3_PKT0_S9_S7_S7_PS7_SA_SA_SA_S7_S7_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029380360, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029380366, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029380373, - "dur": 47, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029380423, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029380430, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029380437, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029380444, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029380450, - "dur": 132, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_128x128x8_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029380585, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029380591, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029380599, - "dur": 976, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail25bn_fw_tr_1C11_kernel_NCHWIffLi512ELb1ELi1EEEv17cudnnTensorStructPKT_S2_PS3_PKT0_S9_S7_S7_PS7_SA_SA_SA_S7_S7_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029381578, - "dur": 279, - "args": { - "name": "ocnn_resnet/resblock_5_0/add:Add#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029381858, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029381863, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029381868, - "dur": 189, - "args": { - "name": "ocnn_resnet/resblock_5_0/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029382059, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029382064, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029382069, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029382074, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029382079, - "dur": 176, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_32x32x32_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029382267, - "dur": 466, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail25bn_fw_tr_1C11_kernel_NCHWIffLi512ELb1ELi1EEEv17cudnnTensorStructPKT_S2_PS3_PKT0_S9_S7_S7_PS7_SA_SA_SA_S7_S7_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029382734, - "dur": 46, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029382782, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029382786, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029388722, - "dur": 850, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::sgemm_32x32x32_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029389575, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029389582, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029389599, - "dur": 457, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail25bn_fw_tr_1C11_kernel_NCHWIffLi512ELb1ELi1EEEv17cudnnTensorStructPKT_S2_PS3_PKT0_S9_S7_S7_PS7_SA_SA_SA_S7_S7_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029390059, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029390066, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029390073, - "dur": 47, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029390124, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029390130, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029390137, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029390144, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029390151, - "dur": 132, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_128x128x8_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029390285, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029390292, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029390301, - "dur": 981, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail25bn_fw_tr_1C11_kernel_NCHWIffLi512ELb1ELi1EEEv17cudnnTensorStructPKT_S2_PS3_PKT0_S9_S7_S7_PS7_SA_SA_SA_S7_S7_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029391284, - "dur": 277, - "args": { - "name": "ocnn_resnet/resblock_5_1/add:Add#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029391562, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029391567, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029391574, - "dur": 186, - "args": { - "name": "ocnn_resnet/resblock_5_1/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029391761, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029391766, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029391771, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029391776, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029391782, - "dur": 176, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_32x32x32_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029391968, - "dur": 464, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail25bn_fw_tr_1C11_kernel_NCHWIffLi512ELb1ELi1EEEv17cudnnTensorStructPKT_S2_PS3_PKT0_S9_S7_S7_PS7_SA_SA_SA_S7_S7_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029392434, - "dur": 47, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029392482, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029392487, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029397141, - "dur": 861, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::sgemm_32x32x32_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398005, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398013, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398025, - "dur": 459, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail25bn_fw_tr_1C11_kernel_NCHWIffLi512ELb1ELi1EEEv17cudnnTensorStructPKT_S2_PS3_PKT0_S9_S7_S7_PS7_SA_SA_SA_S7_S7_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398488, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398494, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398501, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398507, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398513, - "dur": 47, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398562, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_11scalar_leftIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398570, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398575, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398580, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398584, - "dur": 132, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_128x128x8_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029398728, - "dur": 981, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail25bn_fw_tr_1C11_kernel_NCHWIffLi512ELb1ELi1EEEv17cudnnTensorStructPKT_S2_PS3_PKT0_S9_S7_S7_PS7_SA_SA_SA_S7_S7_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029399710, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029399716, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029399722, - "dur": 278, - "args": { - "name": "ocnn_resnet/resblock_5_2/add:Add#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029400000, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400005, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400010, - "dur": 187, - "args": { - "name": "ocnn_resnet/resblock_5_2/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400198, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400203, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400529, - "dur": 117, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_128x128x8_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400647, - "dur": 62, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_32x32x32_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400718, - "dur": 100, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi20EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400828, - "dur": 32, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi20EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400862, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400867, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400873, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400892, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400897, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400901, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029400906, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029402862, - "dur": 477, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::sgemm_32x32x32_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403343, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403350, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403357, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403364, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403376, - "dur": 33, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi20EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403412, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403419, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403427, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403450, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403456, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403463, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403471, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403478, - "dur": 75, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_128x128x8_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403555, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403562, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403575, - "dur": 95, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi20EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403673, - "dur": 119, - "args": { - "name": "ocnn_resnet/resblock_4_0/add:Add#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403795, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403800, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403805, - "dur": 80, - "args": { - "name": "ocnn_resnet/resblock_4_0/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403887, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403892, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403897, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403903, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029403908, - "dur": 101, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_32x32x32_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029404017, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi20EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029404049, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029404070, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029404075, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406017, - "dur": 476, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::sgemm_32x32x32_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406496, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406504, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406517, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi20EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406551, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406557, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406565, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406588, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406594, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406601, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406608, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406614, - "dur": 75, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_128x128x8_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406692, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406698, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406708, - "dur": 96, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi20EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406808, - "dur": 120, - "args": { - "name": "ocnn_resnet/resblock_4_1/add:Add#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406930, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406937, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029406942, - "dur": 79, - "args": { - "name": "ocnn_resnet/resblock_4_1/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029407023, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029407029, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029407034, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029407039, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029407044, - "dur": 100, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_32x32x32_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029407155, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi20EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029407188, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029407209, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029407213, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409160, - "dur": 478, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::sgemm_32x32x32_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409641, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409648, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409661, - "dur": 33, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi20EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409697, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409704, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409711, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409717, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409723, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409746, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409752, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409757, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409763, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409768, - "dur": 73, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul:MatMul#id=27#::sgemm_128x128x8_NN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409846, - "dur": 95, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi20EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409943, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409948, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029409953, - "dur": 120, - "args": { - "name": "ocnn_resnet/resblock_4_2/add:Add#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029410075, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029410079, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029410083, - "dur": 80, - "args": { - "name": "ocnn_resnet/resblock_4_2/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029410164, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029410171, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029410358, - "dur": 42, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul:MatMul#id=27#::maxwell_sgemm_128x64_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029410406, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029410431, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029410448, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029410464, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029410931, - "dur": 89, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::maxwell_sgemm_128x64_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411021, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411026, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411036, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411051, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411055, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411058, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411063, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411068, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411072, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411076, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411080, - "dur": 24, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul:MatMul#id=27#::maxwell_sgemm_128x128_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029411104, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411108, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411115, - "dur": 23, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411140, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_3_0/add:Add#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411174, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411179, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411184, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_3_0/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411206, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411211, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411217, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411222, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411227, - "dur": 33, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul:MatMul#id=27#::maxwell_sgemm_128x64_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411267, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029411278, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411284, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411289, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411762, - "dur": 92, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::maxwell_sgemm_128x64_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411855, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411859, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411865, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411879, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411883, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411887, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411892, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411895, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411899, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411903, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411907, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul:MatMul#id=27#::maxwell_sgemm_128x128_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411930, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411933, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411942, - "dur": 23, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411967, - "dur": 29, - "args": { - "name": "ocnn_resnet/resblock_3_1/add:Add#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029411998, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412003, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412010, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_3_1/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412030, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412036, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412041, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412046, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412052, - "dur": 32, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul:MatMul#id=27#::maxwell_sgemm_128x64_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412092, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412103, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412108, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412112, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412702, - "dur": 92, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv#id=27#::maxwell_sgemm_128x64_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412797, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412805, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412817, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412830, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412837, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412843, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412849, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412855, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412862, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412868, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412873, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412878, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412883, - "dur": 23, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul:MatMul#id=27#::maxwell_sgemm_128x128_nn", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412915, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm#id=27#::_ZN5cudnn6detail24bn_fw_tr_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEv17cudnnTensorStructPKT_S2_PS3_PKfS8_ffPfS9_S9_S9_ffNS_15reduced_divisorEiSA_PNS0_19bnFwPersistentStateEifffiffP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412941, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412948, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412953, - "dur": 30, - "args": { - "name": "ocnn_resnet/resblock_3_2/add:Add#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029412983, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412988, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029412993, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_3_2/Relu:Relu#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_max_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029413012, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029413017, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIKfSB_EEKS8_KNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029413865, - "dur": 25, - "args": { - "name": "ocnn_resnet/global_average/octree_full_voxel/transpose:Transpose#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIjLi3ELi1ElEELi16ENS_11MakePointerEEEKNS_17TensorShufflingOpIKNS_5arrayIiLm3EEEKNS4_INS5_IKjLi3ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029413948, - "dur": 25, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_85_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029413986, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_78_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414006, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_74_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414024, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_76_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414041, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_70_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414059, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_65_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414076, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_60_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414094, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_1_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414112, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_25_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414129, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_22_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414146, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_2_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414164, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_12_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414182, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_6_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414202, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_7_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414220, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_26_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414237, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_66_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414253, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_61_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414270, - "dur": 8, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_72_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414289, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_27_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414306, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_64_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414323, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_67_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414340, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_82_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414357, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_86_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414374, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_73_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414391, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_77_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414407, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_71_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414424, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_68_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414442, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_62_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414458, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_83_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414475, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_79_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414492, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_28_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414508, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_69_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414526, - "dur": 8, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_63_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414544, - "dur": 8, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_13_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414562, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_87_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414579, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_88_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414597, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_24_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414616, - "dur": 34, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_80_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414661, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_23_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414678, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_75_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414695, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_14_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414712, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_8_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414729, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_3_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414747, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414765, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_59_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414783, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_29_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414799, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_15_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414818, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_18_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414836, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_43_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414852, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_9_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414869, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_4_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414886, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_55_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414903, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_51_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414920, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_45_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414938, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_21_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414956, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_16_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414972, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_19_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029414989, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_31_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415007, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_10_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415024, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_5_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415041, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_56_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415058, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_52_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415074, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_46_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415092, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_49_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415108, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_35_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415125, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_17_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415142, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_84_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415158, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_11_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415175, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_54_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415193, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_57_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415210, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_53_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415226, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_47_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415243, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_50_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415260, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_44_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415277, - "dur": 14, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_20_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415302, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_36_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415319, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_32_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415336, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_58_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415353, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_48_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415370, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_42_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415386, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_39_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415404, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_37_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415422, - "dur": 8, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_81_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415441, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_33_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415459, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_40_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415477, - "dur": 6, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_38_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415493, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_34_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415511, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_41_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415528, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_30_grad/mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415779, - "dur": 86, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_1:LogicalAnd#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIbLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIbbNS0_21scalar_boolean_and_opEEEKNS4_INS5_IKbLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029415885, - "dur": 81, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_2:LogicalAnd#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIbLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIbbNS0_21scalar_boolean_and_opEEEKNS4_INS5_IKbLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029415852, - "dur": 159, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and:LogicalAnd#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIbLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIbbNS0_21scalar_boolean_and_opEEEKNS4_INS5_IKbLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029416110, - "dur": 128, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_3:LogicalAnd#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIbLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIbbNS0_21scalar_boolean_and_opEEEKNS4_INS5_IKbLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029416216, - "dur": 68, - "args": { - "name": "ocnn_resnet/global_average/Mean:Mean#id=27#::_ZN10tensorflow7functor15RowReduceKernelIPfNS_23TransformOutputIteratorIffNS0_9DividesByIffEElEENS0_3SumIfEEEEvT_T0_iiT1_NSt15iterator_traitsIS9_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029416483, - "dur": 30, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch:DynamicStitch#id=27#::_ZN10tensorflow95_GLOBAL__N__71_tmpxft_0001e163_00000000_12_dynamic_stitch_op_gpu_cu_compute_75_cpp1_ii_7d12ea8519DynamicStitchKernelIiEEviiNS_20GpuDeviceArrayStructIiLi8EEENS2_IPKT_Li8EEEPS4_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029416550, - "dur": 17, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Cast:Cast#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIiLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_18TensorConversionOpIiKNS4_INS5_IKbLi1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029416575, - "dur": 15, - "args": { - "name": "ocnn_resnet/fc2/dense/MatMul:MatMul#id=27#::_Z17gemv2T_kernel_valIiifffLi128ELi16ELi2ELi2ELb0E16cublasGemvParamsI16cublasGemvTensorIKfES1_IfEfEEvT9_T3_S7_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029416610, - "dur": 97, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Cast:Cast#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_18TensorConversionOpIfKNS4_INS5_IKiLi1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029416667, - "dur": 75, - "args": { - "name": "ocnn_resnet/fc2/dense/BiasAdd:BiasAdd#id=27#::_ZN10tensorflow14BiasNHWCKernelIfEEviPKT_S3_PS1_i", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029416799, - "dur": 27, - "args": { - "name": "loss/mse_loss/mean_squared_error/SquaredDifference:SquaredDifference#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_28scalar_squared_difference_opIfEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029416905, - "dur": 12, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like:Fill#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_15scalar_const_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029416945, - "dur": 9, - "args": { - "name": "loss/mse_loss/mean_squared_error/Sum:Sum#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIPfS2_Li256ENS0_3SumIfEEEEvT_T0_iT2_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029416974, - "dur": 11, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present:Sum#id=27#::_ZN10tensorflow7functor17BlockReduceKernelIPfS2_Li256ENS0_3SumIfEEEEvT_T0_iT2_NSt15iterator_traitsIS5_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417002, - "dur": 10, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan:DivNoNan#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_13div_no_nan_opIfEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417023, - "dur": 8, - "args": { - "name": "loss/mse_loss/mean_squared_error/value:DivNoNan#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_13div_no_nan_opIfEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417052, - "dur": 8, - "args": { - "name": "add:Add#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_13scalar_sum_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417122, - "dur": 10, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile:Tile#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorBroadcastingOpIKNS_5arrayIiLm1EEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417226, - "dur": 12, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/sub:Sub#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417279, - "dur": 10, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Mul:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_17scalar_product_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417303, - "dur": 8, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/mul_1:Mul#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIffEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEKNS4_INS5_ISC_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417350, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad:BiasAddGrad#id=27#::_ZN10tensorflow7functor30ColumnReduceMax16ColumnsKernelIPKfPfN3cub3SumEEEvT_T0_iiT1_NSt15iterator_traitsIS7_E10value_typeE", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417378, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul_1:MatMul#id=27#::_Z13gemv2N_kernelIiifffLi128ELi32ELi4ELi4ELi1E16cublasGemvParamsI16cublasGemvTensorIKfES1_IfEfEEvT9_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417405, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul:MatMul#id=27#::_Z13gemmk1_kernelIfLi256ELi5ELb1ELb0ELb0ELb0E30cublasGemvTensorStridedBatchedIKfES0_IfEfEv18cublasGemmk1ParamsIT_T6_T7_T8_E", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417430, - "dur": 9, - "args": { - "name": "solver/gradients/AddN:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417459, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_1:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417483, - "dur": 8, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417495, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417520, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Tile:Tile#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi3ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorBroadcastingOpIKNS_5arrayIiLm3EEEKNS4_INS5_IKfLi3ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417548, - "dur": 8, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417559, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417581, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/truediv:RealDiv#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_18TensorCwiseUnaryOpINS0_12scalar_rightIffNS0_18scalar_quotient_opIffEEEEKNS4_INS5_IKfLi1ELi1EiEELi16ES7_EEEEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417608, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/transpose_grad/transpose:Transpose#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIjLi3ELi1ElEELi16ENS_11MakePointerEEEKNS_17TensorShufflingOpIKNS_5arrayIiLm3EEEKNS4_INS5_IKjLi3ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417758, - "dur": 37, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417811, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417825, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417854, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEvffff17cudnnTensorStructPKT_S2_S5_S2_PS3_PKfPfS9_S8_S8_fNS_15reduced_divisorEiSA_PNS0_19bnBwPersistentStateEifffifP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417897, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_2:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417917, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_3:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029417944, - "dur": 73, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418018, - "dur": 30, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::maxwell_sgemm_128x64_nt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418050, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418054, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418058, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418062, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418080, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_4:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418100, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418120, - "dur": 8, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418131, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418153, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418166, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418184, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEvffff17cudnnTensorStructPKT_S2_S5_S2_PS3_PKfPfS9_S8_S8_fNS_15reduced_divisorEiSA_PNS0_19bnBwPersistentStateEifffifP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418217, - "dur": 8, - "args": { - "name": "solver/gradients/AddN_5:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418239, - "dur": 7, - "args": { - "name": "solver/gradients/AddN_6:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418741, - "dur": 156, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029418900, - "dur": 110, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419431, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419440, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419447, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419455, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419462, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419475, - "dur": 7, - "args": { - "name": "solver/gradients/AddN_7:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419485, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419493, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419500, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEvffff17cudnnTensorStructPKT_S2_S5_S2_PS3_PKfPfS9_S8_S8_fNS_15reduced_divisorEiSA_PNS0_19bnBwPersistentStateEifffifP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419512, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419523, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419533, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_8:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419539, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_9:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419546, - "dur": 28, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::maxwell_sgemm_128x128_nt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419575, - "dur": 66, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419645, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419651, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419658, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419665, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419672, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_10:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419678, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419686, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419693, - "dur": 27, - "args": { - "name": "solver/gradients/AddN_11:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419722, - "dur": 29, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419755, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419761, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419768, - "dur": 34, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEvffff17cudnnTensorStructPKT_S2_S5_S2_PS3_PKfPfS9_S8_S8_fNS_15reduced_divisorEiSA_PNS0_19bnBwPersistentStateEifffifP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419805, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_12:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419811, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_13:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419818, - "dur": 62, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419883, - "dur": 32, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::maxwell_sgemm_128x64_nt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419917, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419923, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419928, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419933, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419938, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_14:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419944, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419953, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419959, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419965, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419969, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029419974, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEvffff17cudnnTensorStructPKT_S2_S5_S2_PS3_PKfPfS9_S8_S8_fNS_15reduced_divisorEiSA_PNS0_19bnBwPersistentStateEifffifP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029420596, - "dur": 156, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029420756, - "dur": 108, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421407, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_15:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421417, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_16:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421424, - "dur": 7, - "args": { - "name": "solver/gradients/AddN_17:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421435, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421447, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421454, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421461, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421469, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421476, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421486, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421496, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421503, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421510, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEvffff17cudnnTensorStructPKT_S2_S5_S2_PS3_PKfPfS9_S8_S8_fNS_15reduced_divisorEiSA_PNS0_19bnBwPersistentStateEifffifP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421526, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_18:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421533, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_19:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421540, - "dur": 27, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::maxwell_sgemm_128x128_nt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421571, - "dur": 66, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421640, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421646, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421655, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421661, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421668, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_20:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421675, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421682, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421689, - "dur": 26, - "args": { - "name": "solver/gradients/AddN_21:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421719, - "dur": 29, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421751, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421759, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421765, - "dur": 34, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEvffff17cudnnTensorStructPKT_S2_S5_S2_PS3_PKfPfS9_S8_S8_fNS_15reduced_divisorEiSA_PNS0_19bnBwPersistentStateEifffifP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421801, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_22:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421807, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_23:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421813, - "dur": 66, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421881, - "dur": 32, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::maxwell_sgemm_128x64_nt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421914, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421920, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421926, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421931, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421936, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_24:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421941, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421950, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421955, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421960, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421964, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029421968, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEvffff17cudnnTensorStructPKT_S2_S5_S2_PS3_PKfPfS9_S8_S8_fNS_15reduced_divisorEiSA_PNS0_19bnBwPersistentStateEifffifP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029422454, - "dur": 156, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029422613, - "dur": 105, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423132, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_25:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423142, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_26:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423149, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_27:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423158, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423170, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423178, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423185, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423192, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423198, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423207, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423216, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423222, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423228, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_singlereadIfLi512ELb1ELi1ELi2ELi0EEEvffff17cudnnTensorStructPKT_S2_S5_S2_PS3_PKfPfS9_S8_S8_fNS_15reduced_divisorEiSA_PNS0_19bnBwPersistentStateEifffifP13cudnnStatus_tb", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423243, - "dur": 2, - "args": { - "name": "solver/gradients/AddN_28:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423248, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_29:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423253, - "dur": 26, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::maxwell_sgemm_128x128_nt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423282, - "dur": 67, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029423349, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423356, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423361, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423366, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423370, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_30:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423375, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423379, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423384, - "dur": 26, - "args": { - "name": "solver/gradients/AddN_31:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423607, - "dur": 124, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423733, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423736, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029423741, - "dur": 257, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424001, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_32:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424007, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_33:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424012, - "dur": 291, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424305, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_32x32x32_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424406, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424412, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424418, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424423, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424428, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_34:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424433, - "dur": 31, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424466, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424473, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424478, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424482, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029424487, - "dur": 75, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029426191, - "dur": 659, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029426852, - "dur": 425, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029428882, - "dur": 5, - "args": { - "name": "solver/gradients/AddN_35:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029428890, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_36:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029428897, - "dur": 30, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029428930, - "dur": 9, - "args": { - "name": "solver/gradients/AddN_37:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029428942, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029428950, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029428957, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029428964, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029428971, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029428978, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029428984, - "dur": 78, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429065, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429076, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429085, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_38:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429092, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_39:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429100, - "dur": 257, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429360, - "dur": 73, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429436, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429443, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429450, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429458, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429465, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_40:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429472, - "dur": 118, - "args": { - "name": "solver/gradients/AddN_41:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429593, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429600, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429607, - "dur": 120, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429731, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429738, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029429744, - "dur": 256, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430003, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_42:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430009, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_43:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430016, - "dur": 287, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430304, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_32x32x32_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430406, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430412, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430418, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430422, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430428, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_44:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430434, - "dur": 30, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430466, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430473, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430478, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430483, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029430487, - "dur": 76, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029433065, - "dur": 654, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029433723, - "dur": 421, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436591, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_45:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436600, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_46:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436607, - "dur": 31, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436641, - "dur": 7, - "args": { - "name": "solver/gradients/AddN_47:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436651, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436659, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436665, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436673, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436680, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436687, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436694, - "dur": 75, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436772, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436782, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436793, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_48:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436800, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_49:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029436807, - "dur": 258, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437068, - "dur": 73, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437144, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437151, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437158, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437165, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437172, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_50:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437180, - "dur": 119, - "args": { - "name": "solver/gradients/AddN_51:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437302, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437310, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437317, - "dur": 118, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437438, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437445, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437451, - "dur": 259, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437713, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437720, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437727, - "dur": 256, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437986, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_54:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029437994, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_55:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438001, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_52:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438008, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_53:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438015, - "dur": 280, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438298, - "dur": 122, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438424, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438431, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438437, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438444, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438451, - "dur": 295, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438749, - "dur": 98, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_32x32x32_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438850, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438857, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438863, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438868, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438873, - "dur": 5, - "args": { - "name": "solver/gradients/AddN_57:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438880, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_56:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438887, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438894, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438900, - "dur": 31, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438933, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438939, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438944, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438949, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029438953, - "dur": 74, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029440950, - "dur": 657, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029441611, - "dur": 415, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029443941, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_58:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029443950, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_59:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029443956, - "dur": 30, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029443989, - "dur": 7, - "args": { - "name": "solver/gradients/AddN_60:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444000, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444009, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444015, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444022, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444029, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444035, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444041, - "dur": 76, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444120, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444129, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444138, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_61:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444143, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_62:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444152, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z11scal_kernelIffLi1ELb1ELi6ELi5ELi5ELi3EEv21cublasTransposeParamsIT0_EPKT_PS3_PKS1_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444158, - "dur": 134, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z18sgemm_largek_lds64ILb1ELb0ELi5ELi5ELi4ELi4ELi4ELi34EEvPfPKfS2_iiiiiiS2_S2_ffiiPiS3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444294, - "dur": 44, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444340, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444347, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444352, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444357, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444362, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_63:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444366, - "dur": 60, - "args": { - "name": "solver/gradients/AddN_64:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444427, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444433, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029444847, - "dur": 285, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029445135, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029445142, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029445149, - "dur": 716, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029445869, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_65:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029445874, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_66:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029445884, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z11scal_kernelIffLi1ELb1ELi6ELi5ELi5ELi3EEv21cublasTransposeParamsIT0_EPKT_PS3_PKS1_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029445890, - "dur": 383, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z18sgemm_largek_lds64ILb1ELb0ELi5ELi5ELi4ELi4ELi4ELi34EEvPfPKfS2_iiiiiiS2_S2_ffiiPiS3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029446276, - "dur": 179, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_32x32x32_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029446457, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029446463, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029446469, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029446474, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029446479, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_67:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029446486, - "dur": 71, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029446558, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029446563, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029446570, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029446574, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029446578, - "dur": 251, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029451451, - "dur": 1398, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029452852, - "dur": 696, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458207, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_68:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458217, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_69:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458224, - "dur": 70, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458297, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_70:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458308, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458314, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458321, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458328, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458335, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458342, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458349, - "dur": 252, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458605, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458614, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458621, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_71:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458628, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_72:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458638, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z11scal_kernelIffLi1ELb1ELi6ELi5ELi5ELi3EEv21cublasTransposeParamsIT0_EPKT_PS3_PKS1_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029458646, - "dur": 384, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z18sgemm_largek_lds64ILb1ELb0ELi5ELi5ELi4ELi4ELi4ELi34EEvPfPKfS2_iiiiiiS2_S2_ffiiPiS3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459033, - "dur": 134, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459168, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459175, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459182, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459189, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459197, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_73:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459203, - "dur": 276, - "args": { - "name": "solver/gradients/AddN_74:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459482, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459489, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459497, - "dur": 278, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459777, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459784, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029459791, - "dur": 721, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029460515, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_75:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029460523, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_76:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029460531, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z11scal_kernelIffLi1ELb1ELi6ELi5ELi5ELi3EEv21cublasTransposeParamsIT0_EPKT_PS3_PKS1_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029460537, - "dur": 397, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z18sgemm_largek_lds64ILb1ELb0ELi5ELi5ELi4ELi4ELi4ELi34EEvPfPKfS2_iiiiiiS2_S2_ffiiPiS3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029460936, - "dur": 175, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_32x32x32_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029461115, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029461121, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029461127, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029461131, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029461137, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_77:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029461142, - "dur": 71, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029461214, - "dur": 5, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029461220, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029461225, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029461230, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029461233, - "dur": 256, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029467427, - "dur": 1400, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029468831, - "dur": 695, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475407, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_78:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475417, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_79:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475423, - "dur": 70, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475496, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_80:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475506, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475513, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475520, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475527, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475533, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475541, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475547, - "dur": 254, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475805, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475814, - "dur": 7, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475822, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_81:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475829, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_82:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475840, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z11scal_kernelIffLi1ELb1ELi6ELi5ELi5ELi3EEv21cublasTransposeParamsIT0_EPKT_PS3_PKS1_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029475847, - "dur": 382, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z18sgemm_largek_lds64ILb1ELb0ELi5ELi5ELi4ELi4ELi4ELi34EEvPfPKfS2_iiiiiiS2_S2_ffiiPiS3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476232, - "dur": 137, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476372, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476379, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476386, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476394, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476401, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_83:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476407, - "dur": 279, - "args": { - "name": "solver/gradients/AddN_84:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476690, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476697, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476703, - "dur": 279, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476984, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476991, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029476998, - "dur": 717, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029477718, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_85:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029477724, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_86:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029477733, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z11scal_kernelIffLi1ELb1ELi6ELi5ELi5ELi3EEv21cublasTransposeParamsIT0_EPKT_PS3_PKS1_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029477739, - "dur": 387, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z18sgemm_largek_lds64ILb1ELb0ELi5ELi5ELi4ELi4ELi4ELi34EEvPfPKfS2_iiiiiiS2_S2_ffiiPiS3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029478128, - "dur": 177, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_32x32x32_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029478307, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029478315, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029478320, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029478325, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029478331, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_87:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029478336, - "dur": 70, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029478407, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029478413, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029478417, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029478422, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029478426, - "dur": 254, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029484608, - "dur": 1396, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029486007, - "dur": 696, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492573, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_88:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492582, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_89:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492589, - "dur": 72, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492662, - "dur": 6, - "args": { - "name": "solver/gradients/AddN_90:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492671, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492679, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492685, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492693, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492700, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492707, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492713, - "dur": 256, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492972, - "dur": 6, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492981, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492989, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_91:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029492995, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_92:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029493005, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z11scal_kernelIffLi1ELb1ELi6ELi5ELi5ELi3EEv21cublasTransposeParamsIT0_EPKT_PS3_PKS1_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029493011, - "dur": 393, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::_Z18sgemm_largek_lds64ILb1ELb0ELi5ELi5ELi4ELi4ELi4ELi34EEvPfPKfS2_iiiiiiS2_S2_ffiiPiS3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029493406, - "dur": 132, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029493542, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029493547, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029493552, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029493557, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029493562, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_93:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029493567, - "dur": 278, - "args": { - "name": "solver/gradients/AddN_94:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029493846, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029493852, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029493857, - "dur": 281, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_17scalar_product_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EEKNS_18TensorConversionOpIfKNS9_INS0_13scalar_cmp_opISB_SB_LNS0_14ComparisonNameE5EEESF_KNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opISB_EESF_EEEEEEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029494139, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029494144, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1EiEELi16ENS_11MakePointerEEEKNS_20TensorCwiseNullaryOpINS0_18scalar_constant_opIfEEKS8_EEEENS_9GpuDeviceEEEiEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029494148, - "dur": 714, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad#id=27#::_ZN5cudnn6detail21bn_bw_1C11_kernel_newIff6float2Li512ELb1ELi1EEEvT0_S3_S3_S3_17cudnnTensorStructPKT_S4_S7_S4_PS5_PKS3_PS3_SB_SA_SA_S3_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029498028, - "dur": 1381, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_32x32x32_NT_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029499411, - "dur": 1348, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad#id=27#::sgemm_128x128x8_TN_vec", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029503827, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_95:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029503831, - "dur": 3, - "args": { - "name": "solver/gradients/AddN_96:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029503836, - "dur": 4, - "args": { - "name": "solver/gradients/AddN_97:AddN#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIKfSB_EEKNS4_INS5_ISB_Li1ELi1ElEELi16ES7_EESF_EEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029503841, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029503845, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029503850, - "dur": 2, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029503853, - "dur": 3, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029503857, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_13scalar_sum_opIffEEKNS9_INS0_17scalar_product_opIffEEKS8_KNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeIKfNSK_IJEEELi1ElEELi16ES7_EEEEEEEEKNS4_INS5_ISO_Li1ELi1ElEELi16ES7_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 0, - "ts": 1595535029503862, - "dur": 4, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum#id=27#::_ZN5Eigen8internal15EigenMetaKernelINS_15TensorEvaluatorIKNS_14TensorAssignOpINS_9TensorMapINS_6TensorIfLi1ELi1ElEELi16ENS_11MakePointerEEEKNS_19TensorCwiseBinaryOpINS0_20scalar_difference_opIffEEKS8_KNS9_INS0_17scalar_product_opIKfSE_EEKNS_20TensorBroadcastingOpIKNS_5arrayIlLm1EEEKNS_17TensorReshapingOpIKNS_5SizesIJLl1EEEEKNS4_INS_15TensorFixedSizeISE_NSL_IJEEELi1ElEELi16ES7_EEEEEESC_EEEEEENS_9GpuDeviceEEElEEvT_T0_", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1595535029416286, - "dur": 27, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack#id=27#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1595535029416319, - "dur": 32, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack#id=27#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1595535029416360, - "dur": 39, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack#id=27#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1595535029416411, - "dur": 16, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack#id=27#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1595535029416432, - "dur": 15, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack#id=27#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 2, - "ts": 1595535029416452, - "dur": 16, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack#id=27#::MemcpyDtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029444149, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029445880, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029458635, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029460528, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029475837, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029477730, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 9, - "tid": 1, - "ts": 1595535029493002, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul#id=27#::MemcpyHtoD", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029376192, - "dur": 14420, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 1, - "ts": 1595535029376191, - "dur": 14423, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 2, - "ts": 1595535029376190, - "dur": 14424, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 3, - "ts": 1595535029376188, - "dur": 14427, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029390655, - "dur": 11351, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 1, - "ts": 1595535029390655, - "dur": 11353, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 2, - "ts": 1595535029390654, - "dur": 11354, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 3, - "ts": 1595535029390653, - "dur": 11356, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029402040, - "dur": 18752, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 1, - "ts": 1595535029402039, - "dur": 18754, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 2, - "ts": 1595535029402039, - "dur": 18755, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 3, - "ts": 1595535029402038, - "dur": 18758, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029420840, - "dur": 16372, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 1, - "ts": 1595535029420839, - "dur": 16374, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 2, - "ts": 1595535029420839, - "dur": 16375, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 3, - "ts": 1595535029420838, - "dur": 16378, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029437252, - "dur": 15026, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 1, - "ts": 1595535029437252, - "dur": 15028, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 2, - "ts": 1595535029437251, - "dur": 15029, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 3, - "ts": 1595535029437250, - "dur": 15032, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029452315, - "dur": 12376, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 1, - "ts": 1595535029452314, - "dur": 12378, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 2, - "ts": 1595535029452314, - "dur": 12379, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 3, - "ts": 1595535029452313, - "dur": 12382, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029464739, - "dur": 10092, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 1, - "ts": 1595535029464737, - "dur": 10095, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 2, - "ts": 1595535029464737, - "dur": 10096, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 3, - "ts": 1595535029464736, - "dur": 10098, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029474866, - "dur": 13699, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 1, - "ts": 1595535029474865, - "dur": 13702, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 2, - "ts": 1595535029474865, - "dur": 13702, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 3, - "ts": 1595535029474864, - "dur": 13706, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029488609, - "dur": 14160, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 1, - "ts": 1595535029488608, - "dur": 14163, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 2, - "ts": 1595535029488608, - "dur": 14164, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 3, - "ts": 1595535029488606, - "dur": 14167, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 4, - "ts": 1595535029376256, - "dur": 14, - "args": { - "name": "random_uniform_7/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 4, - "ts": 1595535029488820, - "dur": 9, - "args": { - "name": "random_uniform_8/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029502868, - "dur": 6, - "args": { - "name": "random_uniform_5/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029502894, - "dur": 2, - "args": { - "name": "random_uniform_7/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029502901, - "dur": 2, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029502910, - "dur": 4, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029502919, - "dur": 2, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029360347, - "dur": 26554, - "args": { - "name": "OctreeBatch:OctreeBatch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029390768, - "dur": 8, - "args": { - "name": "random_uniform_5/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029390782, - "dur": 1, - "args": { - "name": "random_uniform_7/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029390785, - "dur": 0, - "args": { - "name": "random_uniform_8/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029390789, - "dur": 2, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029390794, - "dur": 2, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029390803, - "dur": 4, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029390811, - "dur": 1899, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029392725, - "dur": 26843, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029419582, - "dur": 41315, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029464862, - "dur": 1295, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029466171, - "dur": 17950, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 6, - "ts": 1595535029365824, - "dur": 21827, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 6, - "ts": 1595535029390805, - "dur": 8, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 6, - "ts": 1595535029390826, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 6, - "ts": 1595535029420985, - "dur": 12, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 6, - "ts": 1595535029421015, - "dur": 7, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 6, - "ts": 1595535029437363, - "dur": 3, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 6, - "ts": 1595535029437374, - "dur": 1, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 6, - "ts": 1595535029437380, - "dur": 1610, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 6, - "ts": 1595535029439010, - "dur": 24220, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 6, - "ts": 1595535029463238, - "dur": 26904, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 7, - "ts": 1595535029402216, - "dur": 1412, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 7, - "ts": 1595535029403653, - "dur": 25204, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 7, - "ts": 1595535029428866, - "dur": 24778, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 7, - "ts": 1595535029464836, - "dur": 24, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 7, - "ts": 1595535029464869, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 7, - "ts": 1595535029464875, - "dur": 12, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 7, - "ts": 1595535029474952, - "dur": 10, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 7, - "ts": 1595535029474983, - "dur": 3, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 7, - "ts": 1595535029474989, - "dur": 6, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029488735, - "dur": 13, - "args": { - "name": "random_uniform_7/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029488759, - "dur": 4, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 8, - "ts": 1595535029360282, - "dur": 8, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 8, - "ts": 1595535029415763, - "dur": 208, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_2:LogicalAnd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 8, - "ts": 1595535029416002, - "dur": 13, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_2/_54:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 8, - "ts": 1595535029416567, - "dur": 141, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Cast:Cast", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 8, - "ts": 1595535029417295, - "dur": 8, - "args": { - "name": "summary_train/lr:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 8, - "ts": 1595535029417316, - "dur": 23, - "args": { - "name": "summary_train/Merge/MergeSummary:MergeSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 8, - "ts": 1595535029452466, - "dur": 14, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 8, - "ts": 1595535029452506, - "dur": 5, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 8, - "ts": 1595535029464830, - "dur": 24, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 7, - "ts": 1595535029488763, - "dur": 13, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029376231, - "dur": 12, - "args": { - "name": "random_uniform_5/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029376250, - "dur": 1, - "args": { - "name": "random_uniform_8/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029376254, - "dur": 1, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029376259, - "dur": 3, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029376267, - "dur": 1, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029376298, - "dur": 4, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029402182, - "dur": 4, - "args": { - "name": "random_uniform_5/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029402198, - "dur": 2, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029402206, - "dur": 2, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029402215, - "dur": 2, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 10, - "ts": 1595535029402211, - "dur": 9, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029402233, - "dur": 4, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029417121, - "dur": 18, - "args": { - "name": "summary_train/loss:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029417172, - "dur": 4, - "args": { - "name": "summary_train/total_loss:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029437357, - "dur": 13, - "args": { - "name": "random_uniform_7/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029452463, - "dur": 1305, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029453784, - "dur": 24681, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 8, - "ts": 1595535029478476, - "dur": 23217, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 1, - "ts": 1595535029502921, - "dur": 8, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029502956, - "dur": 3, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029502961, - "dur": 7, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029360316, - "dur": 137, - "args": { - "name": "IteratorGetNext/_8:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029363258, - "dur": 133, - "args": { - "name": "ocnn_resnet/OctreeProperty:OctreeProperty", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029363419, - "dur": 10, - "args": { - "name": "ocnn_resnet/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029372568, - "dur": 19, - "args": { - "name": "summary_train/regularizer:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 10, - "ts": 1595535029452424, - "dur": 4, - "args": { - "name": "random_uniform_5/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 10, - "ts": 1595535029452453, - "dur": 4, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 2, - "ts": 1595535029502895, - "dur": 13, - "args": { - "name": "random_uniform_8/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 2, - "ts": 1595535029502917, - "dur": 3, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 2, - "ts": 1595535029502928, - "dur": 4, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029360212, - "dur": 13, - "args": { - "name": "solver/global_step:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029360255, - "dur": 4, - "args": { - "name": "solver/global_step/read/_10:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029360319, - "dur": 1, - "args": { - "name": "IteratorGetNext/_4:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029376282, - "dur": 14, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029376327, - "dur": 2, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029376333, - "dur": 12, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029390797, - "dur": 16, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029402192, - "dur": 11, - "args": { - "name": "random_uniform_8/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029415758, - "dur": 255, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and:LogicalAnd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029416034, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and/_50:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029416428, - "dur": 82, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch:DynamicStitch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029416535, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch/_38:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029416721, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum:Maximum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029416750, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv:FloorDiv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029417056, - "dur": 12, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Assert/data_0/_48:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029417104, - "dur": 15, - "args": { - "name": "summary_train/accu:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029420949, - "dur": 13, - "args": { - "name": "random_uniform_7/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029420971, - "dur": 4, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029420997, - "dur": 5, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 10, - "ts": 1595535029452466, - "dur": 14, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 10, - "ts": 1595535029452509, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 10, - "ts": 1595535029452517, - "dur": 11, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 10, - "ts": 1595535029464830, - "dur": 24, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 9, - "ts": 1595535029488763, - "dur": 13, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029488793, - "dur": 5, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 5, - "ts": 1595535029488802, - "dur": 8, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029402216, - "dur": 12, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029402245, - "dur": 8, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029415724, - "dur": 150, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_1:LogicalAnd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029415903, - "dur": 7, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_1/_52:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029416085, - "dur": 152, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_3:LogicalAnd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029416257, - "dur": 208, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029416485, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_3/_56:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029416494, - "dur": 68, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Cast:Cast", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029416571, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c/_40:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029416769, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Cast/_36:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029416915, - "dur": 13, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/num_true_conds:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029416943, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/LessEqual:LessEqual", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029416960, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029416971, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Assert/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029416981, - "dur": 1, - "args": { - "name": "ConstantFoldingCtrl/solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch_1:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029416992, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/control_dependency:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417004, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Merge:Merge", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417018, - "dur": 23, - "args": { - "name": "ConstantFoldingCtrl/solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch_0/_45:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417046, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417059, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417069, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/cond/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417078, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417087, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417095, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/Switch/Switch:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417105, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417115, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/Switch/Switch:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417125, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/Switch_1:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417134, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/Switch/Switch:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417148, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/Switch/Switch:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417170, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/cond/Switch/Switch:Switch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417182, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge:Merge", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029417213, - "dur": 68, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge/_62:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029420929, - "dur": 8, - "args": { - "name": "random_uniform_5/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029420946, - "dur": 1, - "args": { - "name": "random_uniform_8/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029420951, - "dur": 1, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029420958, - "dur": 3, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029420965, - "dur": 1, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029420974, - "dur": 3, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029452450, - "dur": 3, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029464804, - "dur": 3, - "args": { - "name": "random_uniform_5/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029464813, - "dur": 1, - "args": { - "name": "random_uniform_7/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029464818, - "dur": 1, - "args": { - "name": "random_uniform_8/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029464824, - "dur": 2, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029464833, - "dur": 2, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029464840, - "dur": 1, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 10, - "ts": 1595535029474955, - "dur": 1674, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 10, - "ts": 1595535029476646, - "dur": 26862, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029360259, - "dur": 11, - "args": { - "name": "Iterator::Model::Prefetch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029360255, - "dur": 19, - "args": { - "name": "Iterator::Model", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029390829, - "dur": 25, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029390866, - "dur": 6, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029402211, - "dur": 9, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029420990, - "dur": 1227, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029422244, - "dur": 22647, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029444901, - "dur": 29191, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029474900, - "dur": 6, - "args": { - "name": "random_uniform_5/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029474928, - "dur": 1, - "args": { - "name": "random_uniform_7/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029474933, - "dur": 1, - "args": { - "name": "random_uniform_8/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029474937, - "dur": 1, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029474943, - "dur": 2, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029474949, - "dur": 1, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029474958, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029474964, - "dur": 17, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029488752, - "dur": 6, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029376288, - "dur": 1612, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029377923, - "dur": 25336, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029403270, - "dur": 26805, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029437338, - "dur": 6, - "args": { - "name": "random_uniform_5/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029437350, - "dur": 1, - "args": { - "name": "random_uniform_8/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029437353, - "dur": 1, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029437357, - "dur": 1, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029437364, - "dur": 0, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029437370, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029437376, - "dur": 1, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029437382, - "dur": 4, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029452426, - "dur": 3, - "args": { - "name": "random_uniform_7/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029452434, - "dur": 1, - "args": { - "name": "random_uniform_8/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029452458, - "dur": 3, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 11, - "ts": 1595535029488760, - "dur": 14, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 7, - "ts": 1595535029488790, - "dur": 5, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360121, - "dur": 6, - "args": { - "name": "_SOURCE:NoOp", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360194, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360214, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360222, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360237, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360269, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360277, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360284, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360290, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360298, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360308, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360314, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360321, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360328, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360334, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360341, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360348, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360362, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360368, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360375, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360381, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360388, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360394, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360400, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360405, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360411, - "dur": 2, - "args": { - "name": "ocnn_resnet/fc2/dense/bias:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360418, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360424, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360430, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360436, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360441, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360447, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360455, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360461, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360467, - "dur": 4, - "args": { - "name": "ocnn_resnet/fc2/dense/kernel:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360475, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360481, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360487, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360492, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360498, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360503, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360509, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360515, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360520, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360526, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360532, - "dur": 0, - "args": { - "name": "ocnn_resnet/fc2/flatten/strided_slice/stack_2:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360536, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360542, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360548, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360553, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360559, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360565, - "dur": 2, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360571, - "dur": 1, - "args": { - "name": "ocnn_resnet/global_average/Mean/reduction_indices:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360576, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360581, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360587, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360593, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360599, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360606, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360611, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360618, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360624, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360630, - "dur": 2, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360636, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360642, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360649, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360654, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360660, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360665, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360671, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360677, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360683, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360689, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360694, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360700, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360706, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360712, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360717, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360723, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360728, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360734, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360740, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360745, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360752, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360757, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360763, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360769, - "dur": 1, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360775, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360780, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360786, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360794, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360801, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360806, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360812, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360818, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360824, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360830, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360836, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360841, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360847, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360853, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360859, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360865, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360870, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360876, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360882, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360888, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360894, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360899, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360905, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360911, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360919, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360926, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360932, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360938, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360944, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360949, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360955, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360961, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360967, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360973, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360979, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360985, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360990, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029360996, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361002, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361007, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361013, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361019, - "dur": 2, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361025, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361031, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361037, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361043, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361050, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361056, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361061, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361067, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361073, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361078, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361084, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361090, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361096, - "dur": 1, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361101, - "dur": 1, - "args": { - "name": "ocnn_resnet/global_average/octree_full_voxel/transpose/perm:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361106, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361112, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361118, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361124, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361130, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361135, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361141, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361147, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361153, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361158, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361164, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361171, - "dur": 0, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/Const:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361176, - "dur": 0, - "args": { - "name": "ocnn_resnet/Reshape/shape:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361180, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361186, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361192, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_variance:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361198, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361204, - "dur": 1, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Const:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361209, - "dur": 0, - "args": { - "name": "ocnn_resnet/global_average/octree_full_voxel/Reshape/shape:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361214, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361221, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361227, - "dur": 0, - "args": { - "name": "loss/Reshape/shape:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361231, - "dur": 1, - "args": { - "name": "loss/l2_regularizer/mul/y:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361236, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361241, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361247, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361252, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361257, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361263, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361268, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361273, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361278, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361294, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361300, - "dur": 2, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361305, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361310, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361315, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361319, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361324, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361329, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361334, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361339, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361344, - "dur": 1, - "args": { - "name": "ocnn_resnet/fc2/dense/kernel/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361349, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361355, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361360, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361365, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361369, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361374, - "dur": 1, - "args": { - "name": "ocnn_resnet/fc2/dense/bias/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361380, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361385, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361390, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361395, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361401, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361405, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361410, - "dur": 1, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361416, - "dur": 1, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361420, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361426, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361430, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361435, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361440, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361445, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361450, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361455, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361461, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361466, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361471, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361477, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361482, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361487, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361492, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361497, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361502, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361508, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361513, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361518, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361523, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361529, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361534, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361542, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361547, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361552, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361557, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361562, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361567, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361572, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361577, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361582, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361587, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361592, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361597, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361602, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361607, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361614, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361620, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361625, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361631, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361636, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361640, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361645, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361650, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361656, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361661, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361666, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361671, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029361676, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/Momentum:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363098, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363112, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363118, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363123, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363129, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363134, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363140, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363147, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363153, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363159, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363165, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363171, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363177, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363183, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363189, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363195, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363201, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363206, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363211, - "dur": 0, - "args": { - "name": "ocnn_resnet/fc2/dense/bias/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363216, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363240, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363249, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363255, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363261, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363266, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363270, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363283, - "dur": 1, - "args": { - "name": "ocnn_resnet/fc2/dense/kernel/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363290, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363298, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363304, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363308, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363313, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363319, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363324, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363330, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363335, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363340, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363345, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363351, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363356, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363361, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363367, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363371, - "dur": 0, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363376, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363381, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363386, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363391, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363396, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363402, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363407, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363413, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363419, - "dur": 0, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363424, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363430, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363435, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363440, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363444, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363450, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363455, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363461, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363470, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363475, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363480, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363486, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363493, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363497, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363502, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363507, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363512, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363518, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363523, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363528, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363533, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363539, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363545, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363550, - "dur": 0, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363555, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363560, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363565, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363570, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363575, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363580, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363585, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363590, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363595, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363599, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363605, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363610, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363615, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363620, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363626, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363630, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363635, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363640, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363645, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363651, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363656, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363660, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363665, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363670, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363676, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363681, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363686, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363691, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363696, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363701, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363706, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363711, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363716, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363721, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363725, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363731, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363736, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363741, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363746, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363751, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363756, - "dur": 0, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363762, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363767, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363772, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363777, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363782, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363787, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363791, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363796, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363801, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363806, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363811, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363817, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363822, - "dur": 0, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363827, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363831, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363836, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363843, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363849, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363854, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363858, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363863, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363868, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363874, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363879, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363884, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363889, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363894, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_variance/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363898, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363903, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363909, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read:Identity", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363913, - "dur": 62, - "args": { - "name": "loss/l2_regularizer/L2Loss_24:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363981, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_14:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029363999, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_5:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364017, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_9:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364033, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_55:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364049, - "dur": 22, - "args": { - "name": "loss/l2_regularizer/L2Loss_54:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364076, - "dur": 22, - "args": { - "name": "loss/l2_regularizer/L2Loss_45:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364103, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_13:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364120, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_4:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364136, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_81:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364163, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_67:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364179, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_73:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364196, - "dur": 23, - "args": { - "name": "loss/l2_regularizer/L2Loss_63:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364223, - "dur": 22, - "args": { - "name": "loss/l2_regularizer/L2Loss_78:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364250, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_88:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364268, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_80:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364284, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_72:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364310, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_62:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364325, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_87:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364341, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_61:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364357, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_86:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364374, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_79:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364390, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_71:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364406, - "dur": 22, - "args": { - "name": "loss/l2_regularizer/L2Loss_60:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364433, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_85:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364450, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_77:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364466, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_70:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364482, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_66:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364508, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_44:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364524, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_68:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364540, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_53:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364555, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_43:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364571, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_35:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364587, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_48:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364614, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_2:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364629, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_12:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364645, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_29:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364661, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_52:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364677, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_38:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364693, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_34:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364709, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_51:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364736, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_23:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364751, - "dur": 22, - "args": { - "name": "loss/l2_regularizer/L2Loss_6:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364778, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_18:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364794, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_50:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364811, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_41:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364828, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_36:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364853, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_57:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364879, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_20:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364896, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_11:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364912, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_1:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364929, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_28:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364946, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_49:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364962, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_40:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029364978, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_33:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365003, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_26:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365020, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_19:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365036, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_10:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365052, - "dur": 23, - "args": { - "name": "loss/l2_regularizer/L2Loss_84:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365079, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_27:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365095, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_56:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365111, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_47:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365127, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_37:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365143, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_32:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365159, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_58:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365175, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_69:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365200, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_8:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365217, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_46:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365233, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_39:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365258, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss_42:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365284, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_76:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365300, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_22:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365316, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_17:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365332, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_7:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365348, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365374, - "dur": 140, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv:OctreeConv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365531, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_21:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365552, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_31:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365569, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_83:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365587, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_65:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365604, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_16:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365622, - "dur": 24, - "args": { - "name": "loss/l2_regularizer/L2Loss_30:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365651, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_59:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365668, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_82:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365685, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_74:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365703, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_64:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365719, - "dur": 23, - "args": { - "name": "loss/l2_regularizer/L2Loss_75:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365747, - "dur": 22, - "args": { - "name": "loss/l2_regularizer/L2Loss_15:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365774, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_25:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365792, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_3:L2Loss", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365809, - "dur": 67, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029365894, - "dur": 113, - "args": { - "name": "loss/l2_regularizer/AddN:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366074, - "dur": 14, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366096, - "dur": 16, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366118, - "dur": 17, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366144, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366164, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366174, - "dur": 12, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366192, - "dur": 11, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366207, - "dur": 47, - "args": { - "name": "loss/l2_regularizer/mul/_6:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366257, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366294, - "dur": 16, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366321, - "dur": 11, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366339, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366346, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366354, - "dur": 36, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366401, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366420, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366438, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029366455, - "dur": 6746, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373217, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373239, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373257, - "dur": 34, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373305, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373327, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373346, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373364, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373382, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373398, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373406, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373424, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373441, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373467, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373485, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373502, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373509, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373515, - "dur": 29, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373556, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_5_0/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373581, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373599, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373615, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373633, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373650, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373666, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373673, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373690, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373706, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373729, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373735, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373741, - "dur": 27, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373779, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373799, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373816, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029373833, - "dur": 9052, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029382906, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029382929, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029382946, - "dur": 34, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029382993, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383015, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383034, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383053, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383070, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383086, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383093, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383111, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383128, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383155, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383172, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383190, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383196, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383202, - "dur": 29, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383243, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_1/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383266, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383289, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383305, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383323, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383340, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383355, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383362, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383380, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383397, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383421, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383427, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383433, - "dur": 28, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383472, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383490, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383508, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029383523, - "dur": 9060, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392601, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392622, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392638, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392682, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392702, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392718, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392735, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392749, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392767, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392784, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392800, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392807, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392823, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392840, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392864, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392870, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392876, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392913, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392929, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392945, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_2/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392966, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392983, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029392998, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029393015, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029393032, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029393047, - "dur": 7185, - "args": { - "name": "ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool:OctreeMaxPool", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400244, - "dur": 238, - "args": { - "name": "ocnn_resnet/max_pool_5/octree_max_pool/OctreePad:OctreePad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400490, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400498, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400523, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400543, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400548, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400553, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400558, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400563, - "dur": 33, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400607, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400642, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400661, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400677, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400693, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400709, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400725, - "dur": 28, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400758, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400774, - "dur": 206, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029400991, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401009, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401024, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401043, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401059, - "dur": 30, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401100, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401118, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401134, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401150, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401166, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401182, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401188, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401204, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401219, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401242, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401260, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401276, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401282, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401288, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401325, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401346, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401362, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401378, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401393, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401411, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401426, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401432, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401450, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401467, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401488, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401494, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401499, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401534, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401551, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401567, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 15, - "ts": 1595535029401583, - "dur": 2573, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404169, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404190, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404207, - "dur": 33, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404252, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404273, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404291, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404308, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404326, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404342, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404348, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404366, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404382, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404406, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404425, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404442, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404449, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404454, - "dur": 29, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404495, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404517, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404535, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404551, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404568, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404585, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404601, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404607, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404624, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404641, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404662, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404668, - "dur": 0, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404673, - "dur": 27, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404710, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404728, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404746, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029404761, - "dur": 2523, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407312, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407333, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407350, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407391, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407411, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407428, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407446, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407462, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407479, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407495, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407512, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407519, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407537, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407554, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407578, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407584, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407590, - "dur": 27, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407629, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407647, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407663, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_2/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407684, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407701, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407717, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407733, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407750, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029407767, - "dur": 2429, - "args": { - "name": "ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool:OctreeMaxPool", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410204, - "dur": 113, - "args": { - "name": "ocnn_resnet/max_pool_4/octree_max_pool/OctreePad:OctreePad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410325, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410332, - "dur": 28, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410367, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410372, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410378, - "dur": 30, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410418, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410436, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410452, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410468, - "dur": 88, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410566, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410585, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410601, - "dur": 27, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410638, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410658, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410674, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410690, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410706, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410721, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410728, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410744, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410759, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410785, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410802, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410819, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410825, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410831, - "dur": 27, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410868, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_0/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410887, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410903, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410918, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410934, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410949, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410964, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410970, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029410986, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411001, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411023, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411028, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411033, - "dur": 25, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411068, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411085, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411101, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411116, - "dur": 266, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411393, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411413, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411429, - "dur": 30, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411470, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411491, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411509, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411525, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411542, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411559, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411565, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411583, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411600, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411625, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411643, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411660, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411667, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411673, - "dur": 30, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411713, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_1/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411734, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411751, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411767, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411784, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411801, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411818, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411825, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411841, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411858, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411880, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411886, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411892, - "dur": 27, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411929, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411947, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411964, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029411979, - "dur": 212, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv:OctreeConv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412202, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412221, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412238, - "dur": 30, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412280, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412299, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412316, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412333, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412349, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412366, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412394, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412410, - "dur": 2, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/Squeeze:Squeeze", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412417, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412433, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412449, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412471, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412477, - "dur": 1, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims_1:ExpandDims", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412483, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm:FusedBatchNorm", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412519, - "dur": 11, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412535, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412550, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_2/add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412568, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412585, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412600, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_2/Relu:Relu", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412616, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412632, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg:AssignSub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029412656, - "dur": 384, - "args": { - "name": "ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool:OctreeMaxPool", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413050, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/transpose_grad/InvertPermutation:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413060, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413073, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413083, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413093, - "dur": 1, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413102, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413110, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum/y:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413118, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413127, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413135, - "dur": 0, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413142, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/mod:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413149, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413157, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413165, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413174, - "dur": 0, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape/shape:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413181, - "dur": 0, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/range:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413188, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413196, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413204, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413212, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413219, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413229, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413237, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413245, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413253, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413262, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413271, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413279, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_10:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413288, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413296, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413304, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413311, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413319, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_6:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413327, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413335, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413343, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_7:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413350, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413358, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_8:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413365, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413373, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413380, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_9:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413388, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413395, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413403, - "dur": 1, - "args": { - "name": "solver/Momentum/momentum:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413419, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413426, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413434, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413442, - "dur": 0, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_3:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413449, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Shape_1:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413457, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413464, - "dur": 0, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_2:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413471, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413480, - "dur": 0, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/n_true_conds:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413487, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413496, - "dur": 0, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_1:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413504, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413512, - "dur": 0, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Const:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413519, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413527, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413534, - "dur": 0, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413541, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413549, - "dur": 0, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_4:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413556, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413563, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413571, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_5:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413578, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413585, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413593, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413601, - "dur": 45, - "args": { - "name": "ocnn_resnet/max_pool_3/octree_max_pool/OctreePad:OctreePad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413656, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413661, - "dur": 1, - "args": { - "name": "solver/gradients/add_grad/tuple/control_dependency:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413667, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413674, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413680, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413685, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413690, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413696, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_4:Greater", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413707, - "dur": 2, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3:LessEqual", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413714, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_3:Greater", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413719, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_2:LessEqual", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413723, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413729, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413734, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_2:Greater", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413740, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1:LessEqual", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413744, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_1:Greater", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413749, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual:LessEqual", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413754, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_4:LessEqual", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413760, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater:Greater", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413765, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413771, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413776, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/Reshape_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413784, - "dur": 2, - "args": { - "name": "ocnn_resnet/global_average/octree_full_voxel/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413791, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill/_34:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413797, - "dur": 1, - "args": { - "name": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413815, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_4/_12:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413818, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3/_18:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413820, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_3/_16:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413825, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_2/_22:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413827, - "dur": 0, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_2/_20:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413829, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1/_26:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413833, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_1/_24:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413835, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual/_28:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413837, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_4/_14:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413840, - "dur": 1, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater/_30:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413842, - "dur": 25, - "args": { - "name": "ocnn_resnet/global_average/octree_full_voxel/transpose:Transpose", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413933, - "dur": 33, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_85_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413973, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_78_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029413993, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_74_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414012, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_76_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414029, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_70_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414046, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_65_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414064, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_60_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414081, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_1_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414099, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_25_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414117, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_22_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414134, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_2_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414151, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_12_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414169, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_6_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414189, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_7_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414207, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_26_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414224, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_66_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414241, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_61_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414257, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_72_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414276, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_27_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414294, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_64_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414311, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_67_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414328, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_82_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414345, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_86_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414361, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_73_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414378, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_77_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414395, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_71_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414412, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_68_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414429, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_62_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414446, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_83_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414462, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_79_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414479, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_28_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414496, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_69_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414513, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_63_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414532, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_13_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414549, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_87_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414566, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_88_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414584, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_24_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414603, - "dur": 39, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_80_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414648, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_23_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414665, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_75_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414682, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_14_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414700, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_8_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414717, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_3_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414734, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414752, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_59_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414770, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_29_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414787, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_15_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414805, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_18_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414823, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_43_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414840, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_9_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414857, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_4_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414873, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_55_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414890, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_51_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414907, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_45_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414925, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_21_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414943, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_16_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414960, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_19_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414977, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_31_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029414994, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_10_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415011, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_5_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415029, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_56_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415045, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_52_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415062, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_46_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415079, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_49_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415096, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_35_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415113, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_17_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415129, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_84_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415146, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_11_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415162, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_54_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415180, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_57_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415198, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_53_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415214, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_47_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415231, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_50_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415248, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_44_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415264, - "dur": 19, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_20_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415289, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_36_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415307, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_32_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415323, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_58_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415341, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_48_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415357, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_42_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415374, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_39_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415392, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_37_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415410, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_81_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415428, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_33_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415447, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_40_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415464, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_38_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415481, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_34_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415498, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_41_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029415515, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_30_grad/mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416138, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416155, - "dur": 120, - "args": { - "name": "ocnn_resnet/global_average/Mean:Mean", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416283, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Prod:Size", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416292, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2/_32:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416297, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Prod_1:Size", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416306, - "dur": 1, - "args": { - "name": "ocnn_resnet/fc2/flatten/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416410, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum_1:Maximum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416422, - "dur": 10, - "args": { - "name": "ocnn_resnet/fc2/flatten/strided_slice:StridedSlice", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416438, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1:FloorDiv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416447, - "dur": 4, - "args": { - "name": "ocnn_resnet/fc2/flatten/Reshape/shape:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416457, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1/_42:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416461, - "dur": 1, - "args": { - "name": "ocnn_resnet/fc2/flatten/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416548, - "dur": 37, - "args": { - "name": "ocnn_resnet/fc2/dense/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416594, - "dur": 145, - "args": { - "name": "ocnn_resnet/fc2/dense/BiasAdd:BiasAdd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416747, - "dur": 2, - "args": { - "name": "solver/gradients/loss/Reshape_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416761, - "dur": 1, - "args": { - "name": "loss/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416770, - "dur": 1, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416782, - "dur": 39, - "args": { - "name": "loss/mse_loss/mean_squared_error/SquaredDifference:SquaredDifference", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416829, - "dur": 10, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416846, - "dur": 2, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416856, - "dur": 1, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416873, - "dur": 1, - "args": { - "name": "loss/mse_loss/mean_squared_error/Mul:Snapshot", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416879, - "dur": 2, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/BroadcastGradientArgs:BroadcastGradientArgs", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416888, - "dur": 21, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like:Fill", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416917, - "dur": 2, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Shape:Shape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416927, - "dur": 21, - "args": { - "name": "loss/mse_loss/mean_squared_error/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416955, - "dur": 1, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights:Snapshot", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416961, - "dur": 18, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029416986, - "dur": 18, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan:DivNoNan", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417011, - "dur": 13, - "args": { - "name": "loss/mse_loss/mean_squared_error/value:DivNoNan", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417031, - "dur": 1, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417037, - "dur": 16, - "args": { - "name": "add:Add", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417060, - "dur": 39, - "args": { - "name": "loss/mse_loss/mean_squared_error/value/_58:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417104, - "dur": 21, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile:Tile", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417134, - "dur": 33, - "args": { - "name": "add/_60:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417171, - "dur": 1, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Mul:Snapshot", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417180, - "dur": 2, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417188, - "dur": 1, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417211, - "dur": 20, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/sub:Sub", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417240, - "dur": 2, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/scalar:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417247, - "dur": 36, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417289, - "dur": 15, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417312, - "dur": 1, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417318, - "dur": 1, - "args": { - "name": "solver/gradients/loss/Reshape_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417325, - "dur": 28, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad:BiasAddGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417360, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417389, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417415, - "dur": 17, - "args": { - "name": "solver/gradients/AddN:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417438, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417447, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_1:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417467, - "dur": 29, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417504, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Tile:Tile", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417535, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417566, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/truediv:RealDiv", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417590, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/transpose_grad/transpose:Transpose", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417618, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/Reshape_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417625, - "dur": 48, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreePad_grad/OctreeDepad:OctreeDepad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417684, - "dur": 47, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool:OctreeMaxUnpool", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417742, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417769, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Sum_1:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417776, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417782, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Reshape_1:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417788, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417794, - "dur": 64, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417876, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417883, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_2:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417905, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_3:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417926, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417953, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029417988, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418031, - "dur": 23, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418061, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418067, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_4:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418088, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418108, - "dur": 23, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418138, - "dur": 49, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418204, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_5:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418226, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_6:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418247, - "dur": 142, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418404, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418441, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418472, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418494, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_7:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418515, - "dur": 50, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418584, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418616, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418624, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_8:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418645, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_9:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418665, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418695, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418722, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418755, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418786, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_10:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418807, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418814, - "dur": 23, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418845, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_11:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418865, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418887, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Sum_1:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418894, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418900, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Reshape_1:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418907, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418914, - "dur": 49, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418979, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029418987, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_12:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029419008, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_13:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029419028, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029419051, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029419081, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029419113, - "dur": 23, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029419144, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029419151, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_14:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029419172, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029419192, - "dur": 23, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029419223, - "dur": 48, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029419299, - "dur": 809, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420121, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_15:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420144, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_16:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420161, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_17:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420179, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420198, - "dur": 23, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420229, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420256, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420284, - "dur": 44, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420343, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420350, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_18:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420370, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_19:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420387, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420414, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420437, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420464, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420490, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_20:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420508, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420514, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420541, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_21:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420559, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420577, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Sum_1:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420583, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420588, - "dur": 0, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Reshape_1:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420593, - "dur": 0, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420599, - "dur": 42, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420655, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420661, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_22:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420679, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_23:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420697, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420717, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420742, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420770, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420796, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420802, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_24:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420819, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420837, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420864, - "dur": 42, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029420921, - "dur": 1188, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422124, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_25:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422146, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_26:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422163, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_27:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422180, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422200, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422228, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422256, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422283, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422343, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422350, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_28:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422367, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_29:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422385, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422411, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422433, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422461, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422488, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_30:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422507, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422514, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422541, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_31:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029422559, - "dur": 873, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreePad_grad/OctreeDepad:OctreeDepad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423442, - "dur": 40, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool:OctreeMaxUnpool", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423494, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423517, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Sum_1:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423523, - "dur": 0, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423528, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Reshape_1:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423534, - "dur": 0, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423540, - "dur": 47, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423602, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423609, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_32:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423628, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_33:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423646, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423669, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423691, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423720, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423747, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423753, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_34:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423770, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423788, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423815, - "dur": 41, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029423871, - "dur": 796, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424680, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_35:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424703, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_36:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424720, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424738, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_37:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424756, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424785, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424812, - "dur": 43, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424870, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424899, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424905, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_38:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424924, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_39:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424943, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424964, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029424988, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425016, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425042, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425048, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_40:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425065, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_41:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425082, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425109, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425128, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Sum_1:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425133, - "dur": 0, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425139, - "dur": 0, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Reshape_1:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425144, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425150, - "dur": 42, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425208, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425214, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_42:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425232, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_43:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425250, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425270, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425292, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425321, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425347, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425353, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_44:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425370, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425388, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425414, - "dur": 42, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029425470, - "dur": 5216, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430704, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_45:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430728, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_46:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430745, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430764, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_47:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430781, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430809, - "dur": 19, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430836, - "dur": 44, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430895, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430923, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430931, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_48:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430948, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_49:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430965, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029430987, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431009, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431037, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431064, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431069, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_50:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431086, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_51:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431104, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431130, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431148, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431154, - "dur": 0, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Sum_1:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431159, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431165, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Reshape_1:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431171, - "dur": 40, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431228, - "dur": 41, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431292, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431298, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_54:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431318, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_55:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431335, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431341, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_52:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431358, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_53:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431375, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431397, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431419, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431448, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431474, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431493, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431515, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431543, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431568, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431574, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_57:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431591, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431596, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_56:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431614, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431641, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431659, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431686, - "dur": 42, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029431743, - "dur": 7403, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439165, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_58:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439189, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_59:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439206, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439224, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_60:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439242, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439272, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439305, - "dur": 48, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439368, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439396, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439404, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_61:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439421, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_62:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439439, - "dur": 58, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439505, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439531, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439560, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439588, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439595, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_63:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439613, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_64:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439631, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029439658, - "dur": 4811, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreePad_grad/OctreeDepad:OctreeDepad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444480, - "dur": 62, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool:OctreeMaxUnpool", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444553, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444576, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Sum_1:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444584, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444590, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Reshape_1:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444596, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444603, - "dur": 49, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444669, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444676, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_65:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444697, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_66:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444716, - "dur": 48, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444772, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444797, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444830, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444859, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444867, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_67:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444886, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444905, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444932, - "dur": 43, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029444990, - "dur": 1950, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029446953, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_68:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029446975, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_69:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029446992, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447012, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_70:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447031, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447061, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447088, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447150, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447179, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447186, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_71:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447204, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_72:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447222, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447272, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447307, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447334, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447361, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447368, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_73:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447386, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_74:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447404, - "dur": 19, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447429, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447448, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Sum_1:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447455, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447460, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Reshape_1:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447466, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447473, - "dur": 44, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447533, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447540, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_75:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447558, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_76:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447575, - "dur": 40, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447621, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447645, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447674, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447700, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447707, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_77:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447725, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447744, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447772, - "dur": 42, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 14, - "ts": 1595535029447830, - "dur": 13794, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461642, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_78:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461667, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_79:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461684, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461703, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_80:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461721, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461751, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461779, - "dur": 47, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461842, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461871, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461879, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_81:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461897, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_82:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461915, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461966, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029461991, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462020, - "dur": 30, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462057, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462063, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_83:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462081, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_84:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462098, - "dur": 19, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462124, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462141, - "dur": 2, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Sum_1:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462149, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Sum:Sum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462154, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Reshape_1:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462160, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462167, - "dur": 41, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462222, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462230, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_85:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462247, - "dur": 10, - "args": { - "name": "solver/gradients/AddN_86:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462263, - "dur": 37, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462306, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462329, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462356, - "dur": 18, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462381, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462389, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_87:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462406, - "dur": 11, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462424, - "dur": 19, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462450, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029462503, - "dur": 16321, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029478842, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_88:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029478866, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_89:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029478884, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029478903, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_90:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029478922, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029478953, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029478981, - "dur": 47, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479045, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479074, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479081, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_91:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479098, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_92:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479116, - "dur": 47, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479169, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1:MatMul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479195, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479224, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479250, - "dur": 1, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape:Reshape", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479257, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_93:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479281, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_94:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479302, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479328, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/Relu_grad/ReluGrad:ReluGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479349, - "dur": 44, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:FusedBatchNormGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 12, - "ts": 1595535029479410, - "dur": 15575, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:OctreeConvGrad", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 4, - "ts": 1595535029495003, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_95:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 4, - "ts": 1595535029495024, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_96:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 4, - "ts": 1595535029495041, - "dur": 10, - "args": { - "name": "solver/gradients/AddN_97:AddN", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 4, - "ts": 1595535029495058, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 4, - "ts": 1595535029495085, - "dur": 19, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 4, - "ts": 1595535029495111, - "dur": 19, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/ApplyMomentum:ApplyMomentum", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 4, - "ts": 1595535029495137, - "dur": 0, - "args": { - "name": "solver/Momentum/update:NoOp", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 4, - "ts": 1595535029495146, - "dur": 3, - "args": { - "name": "solver/Momentum/update/_64:Const", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 4, - "ts": 1595535029495154, - "dur": 33, - "args": { - "name": "solver/Momentum/update/_65:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 0, - "ts": 1595535029503923, - "dur": 2, - "args": { - "name": "solver/Momentum:AssignAdd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 16, - "ts": 1595535029360305, - "dur": 2, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 16, - "ts": 1595535029402194, - "dur": 13, - "args": { - "name": "random_uniform_7/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 17, - "ts": 1595535029376282, - "dur": 14, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029488724, - "dur": 24, - "args": { - "name": "random_uniform_5/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 11, - "tid": 13, - "ts": 1595535029488761, - "dur": 1351, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "NoOp", - "pid": 13, - "tid": 0, - "ts": 1595535029360112, - "dur": 32, - "args": { - "name": "_SOURCE", - "op": "NoOp" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360192, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360212, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360221, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360236, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360268, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360276, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360283, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360289, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029360297, - "dur": 9, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360308, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360313, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360320, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360327, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360333, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029360339, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360347, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360361, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360368, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360374, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360380, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360386, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360393, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360399, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360405, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360410, - "dur": 6, - "args": { - "name": "ocnn_resnet/fc2/dense/bias", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360417, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360423, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360429, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360435, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360441, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360446, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360454, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360460, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360466, - "dur": 7, - "args": { - "name": "ocnn_resnet/fc2/dense/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360474, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360480, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360486, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360492, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360497, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360503, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360508, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360514, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360520, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360525, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029360531, - "dur": 3, - "args": { - "name": "ocnn_resnet/fc2/flatten/strided_slice/stack_2", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360535, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360541, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360547, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360553, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360558, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360564, - "dur": 4, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029360570, - "dur": 3, - "args": { - "name": "ocnn_resnet/global_average/Mean/reduction_indices", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360575, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360580, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360586, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360592, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360598, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360605, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360610, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360617, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029360623, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360629, - "dur": 4, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360635, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360641, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360647, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360653, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360659, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360665, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360670, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360676, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360682, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360688, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360693, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360699, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360705, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360711, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360716, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360722, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360727, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360733, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360739, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360744, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360751, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360756, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360762, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360768, - "dur": 4, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360774, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360780, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360785, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360794, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360800, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360805, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360811, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360817, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360823, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360829, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360835, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360840, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360846, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360852, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360858, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360863, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360869, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360875, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360881, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360887, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360893, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360898, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360904, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029360910, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360919, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360925, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360930, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360937, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360943, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360948, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360954, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360960, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360966, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360972, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360978, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360984, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360990, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029360995, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361001, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361006, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361012, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361018, - "dur": 4, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361024, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361030, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361036, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361042, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361048, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361055, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361060, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361066, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361072, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361077, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361084, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361089, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361095, - "dur": 4, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029361101, - "dur": 3, - "args": { - "name": "ocnn_resnet/global_average/octree_full_voxel/transpose/perm", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361105, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361111, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361117, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361123, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361129, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361134, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361140, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361146, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361152, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361158, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361164, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029361170, - "dur": 4, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/Const", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029361175, - "dur": 3, - "args": { - "name": "ocnn_resnet/Reshape/shape", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361179, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361184, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361191, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361197, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029361203, - "dur": 4, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Const", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029361208, - "dur": 4, - "args": { - "name": "ocnn_resnet/global_average/octree_full_voxel/Reshape/shape", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361213, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361220, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029361226, - "dur": 3, - "args": { - "name": "loss/Reshape/shape", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029361230, - "dur": 4, - "args": { - "name": "loss/l2_regularizer/mul/y", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361235, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361240, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361246, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361251, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361256, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361262, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361267, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361272, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361277, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361282, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361299, - "dur": 4, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361304, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361309, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361314, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361319, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361323, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361328, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361333, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361339, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361343, - "dur": 4, - "args": { - "name": "ocnn_resnet/fc2/dense/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361348, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361354, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361359, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361364, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361369, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 1, - "ts": 1595535029361373, - "dur": 4, - "args": { - "name": "ocnn_resnet/fc2/dense/bias/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361379, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361384, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361389, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361395, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361399, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361404, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361409, - "dur": 5, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361415, - "dur": 4, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361420, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361425, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361430, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361435, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361440, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361444, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361449, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361454, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361460, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361465, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361470, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361476, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361481, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361486, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361492, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361497, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361502, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361506, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361512, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361518, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361522, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361528, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361533, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361541, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361546, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361551, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361556, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361561, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361566, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361571, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361576, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361581, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361586, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361592, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361596, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361601, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361606, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361613, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361618, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361624, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361629, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361635, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 1, - "ts": 1595535029361639, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361644, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361649, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361655, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361660, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361665, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361670, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 13, - "tid": 0, - "ts": 1595535029361675, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363094, - "dur": 12, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363110, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363117, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363122, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363128, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363133, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363138, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363146, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363152, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363158, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363164, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363170, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363176, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363182, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363188, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363194, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363200, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363205, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363210, - "dur": 3, - "args": { - "name": "ocnn_resnet/fc2/dense/bias/read", - "op": "Identity", - "input0": "ocnn_resnet/fc2/dense/bias" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363215, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363239, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363248, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363254, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363259, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363265, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363269, - "dur": 10, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363281, - "dur": 6, - "args": { - "name": "ocnn_resnet/fc2/dense/kernel/read", - "op": "Identity", - "input0": "ocnn_resnet/fc2/dense/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363289, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363297, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363303, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363307, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363312, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363317, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363323, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363328, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363334, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363339, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363344, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363349, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363355, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363360, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363366, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363370, - "dur": 4, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363375, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363380, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363385, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363390, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363395, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363401, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363406, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeProperty", - "pid": 13, - "tid": 1, - "ts": 1595535029363252, - "dur": 149, - "args": { - "name": "ocnn_resnet/OctreeProperty", - "op": "OctreeProperty", - "input0": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 0 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 1, - "ts": 1595535029363252, - "id": 0 - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363412, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363417, - "dur": 4, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363423, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363428, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363434, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 1, - "ts": 1595535029363416, - "dur": 21, - "args": { - "name": "ocnn_resnet/Reshape", - "op": "Reshape", - "input0": "ocnn_resnet/OctreeProperty", - "input1": "ocnn_resnet/Reshape/shape" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/Reshape/shape", - "pid": 13, - "tid": 0, - "ts": 1595535029361178, - "id": 1 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/Reshape/shape", - "pid": 13, - "tid": 1, - "ts": 1595535029363416, - "id": 1 - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363439, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363443, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363448, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363454, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363459, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363469, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363474, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363479, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363485, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363491, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363496, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363501, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363506, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363511, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363517, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363522, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363527, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363532, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363537, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363543, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363549, - "dur": 4, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363554, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363559, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363564, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363569, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363574, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363579, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363584, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363589, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363594, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363598, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363604, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363609, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363614, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363619, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363625, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363629, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363634, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363639, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363644, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363650, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363655, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363659, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363664, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363669, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363674, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363680, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363685, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363690, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363695, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363700, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363705, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363710, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363715, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363719, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363724, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363729, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363735, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363740, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363745, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363750, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363754, - "dur": 5, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363761, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363766, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363771, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363776, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363781, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363786, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363790, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363795, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363800, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363805, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363810, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363816, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363821, - "dur": 3, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363825, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363830, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363835, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363842, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363848, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363852, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363857, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363862, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363867, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363873, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363878, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363883, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363888, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363893, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363897, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363902, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029363907, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029363912, - "dur": 66, - "args": { - "name": "loss/l2_regularizer/L2Loss_24", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029363980, - "dur": 17, - "args": { - "name": "loss/l2_regularizer/L2Loss_14", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029363998, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_5", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364016, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_9", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364032, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_55", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364049, - "dur": 25, - "args": { - "name": "loss/l2_regularizer/L2Loss_54", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364075, - "dur": 26, - "args": { - "name": "loss/l2_regularizer/L2Loss_45", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364102, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_13", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364119, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_4", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364135, - "dur": 25, - "args": { - "name": "loss/l2_regularizer/L2Loss_81", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364162, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_67", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364178, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_73", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364195, - "dur": 26, - "args": { - "name": "loss/l2_regularizer/L2Loss_63", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364222, - "dur": 25, - "args": { - "name": "loss/l2_regularizer/L2Loss_78", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364250, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_88", - "op": "L2Loss", - "input0": "ocnn_resnet/fc2/dense/bias/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364267, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_80", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364283, - "dur": 24, - "args": { - "name": "loss/l2_regularizer/L2Loss_72", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364309, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_62", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364325, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_87", - "op": "L2Loss", - "input0": "ocnn_resnet/fc2/dense/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364340, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_61", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364356, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_86", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364373, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_79", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364389, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_71", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364405, - "dur": 25, - "args": { - "name": "loss/l2_regularizer/L2Loss_60", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364432, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_85", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364449, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_77", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364465, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_70", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364481, - "dur": 25, - "args": { - "name": "loss/l2_regularizer/L2Loss_66", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364507, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_44", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364523, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_68", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364539, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_53", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364554, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_43", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364570, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_35", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364586, - "dur": 25, - "args": { - "name": "loss/l2_regularizer/L2Loss_48", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364612, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_2", - "op": "L2Loss", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364629, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_12", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364645, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_29", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364661, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_52", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364676, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_38", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364692, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_34", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364708, - "dur": 25, - "args": { - "name": "loss/l2_regularizer/L2Loss_51", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364734, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_23", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364751, - "dur": 24, - "args": { - "name": "loss/l2_regularizer/L2Loss_6", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364777, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_18", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364793, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_50", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364810, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_41", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364827, - "dur": 24, - "args": { - "name": "loss/l2_regularizer/L2Loss_36", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364852, - "dur": 25, - "args": { - "name": "loss/l2_regularizer/L2Loss_57", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364878, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_20", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364895, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_11", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364911, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_1", - "op": "L2Loss", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364928, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_28", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364944, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_49", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364961, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_40", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029364977, - "dur": 24, - "args": { - "name": "loss/l2_regularizer/L2Loss_33", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365002, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_26", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365019, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_19", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365035, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_10", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365051, - "dur": 26, - "args": { - "name": "loss/l2_regularizer/L2Loss_84", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365079, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_27", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365094, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_56", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365110, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_47", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365126, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_37", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365142, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_32", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365158, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_58", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365174, - "dur": 24, - "args": { - "name": "loss/l2_regularizer/L2Loss_69", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365200, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_8", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365216, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_46", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365232, - "dur": 24, - "args": { - "name": "loss/l2_regularizer/L2Loss_39", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365257, - "dur": 25, - "args": { - "name": "loss/l2_regularizer/L2Loss_42", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365283, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_76", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365299, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_22", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365315, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_17", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365331, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_7", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365347, - "dur": 24, - "args": { - "name": "loss/l2_regularizer/L2Loss", - "op": "L2Loss", - "input0": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 13, - "tid": 0, - "ts": 1595535029365373, - "dur": 146, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn_resnet/Reshape", - "input1": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/Reshape", - "pid": 13, - "tid": 1, - "ts": 1595535029363437, - "id": 2 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029365373, - "id": 2 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 3 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029365373, - "id": 3 - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365530, - "dur": 19, - "args": { - "name": "loss/l2_regularizer/L2Loss_21", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365551, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_31", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365568, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_83", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365586, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_65", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365603, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_16", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365621, - "dur": 26, - "args": { - "name": "loss/l2_regularizer/L2Loss_30", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365650, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_59", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365667, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_82", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365684, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_74", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365702, - "dur": 14, - "args": { - "name": "loss/l2_regularizer/L2Loss_64", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365718, - "dur": 26, - "args": { - "name": "loss/l2_regularizer/L2Loss_75", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365746, - "dur": 26, - "args": { - "name": "loss/l2_regularizer/L2Loss_15", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365773, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/L2Loss_25", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 13, - "tid": 0, - "ts": 1595535029365791, - "dur": 15, - "args": { - "name": "loss/l2_regularizer/L2Loss_3", - "op": "L2Loss", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029365808, - "dur": 75, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029365890, - "dur": 174, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN", - "input0": "loss/l2_regularizer/L2Loss", - "input1": "loss/l2_regularizer/L2Loss_1", - "input2": "loss/l2_regularizer/L2Loss_10", - "input3": "loss/l2_regularizer/L2Loss_11", - "input4": "loss/l2_regularizer/L2Loss_12", - "input5": "loss/l2_regularizer/L2Loss_13", - "input6": "loss/l2_regularizer/L2Loss_14", - "input7": "loss/l2_regularizer/L2Loss_15", - "input8": "loss/l2_regularizer/L2Loss_16", - "input9": "loss/l2_regularizer/L2Loss_17", - "input10": "loss/l2_regularizer/L2Loss_18", - "input11": "loss/l2_regularizer/L2Loss_19", - "input12": "loss/l2_regularizer/L2Loss_2", - "input13": "loss/l2_regularizer/L2Loss_20", - "input14": "loss/l2_regularizer/L2Loss_21", - "input15": "loss/l2_regularizer/L2Loss_22", - "input16": "loss/l2_regularizer/L2Loss_23", - "input17": "loss/l2_regularizer/L2Loss_24", - "input18": "loss/l2_regularizer/L2Loss_25", - "input19": "loss/l2_regularizer/L2Loss_26", - "input20": "loss/l2_regularizer/L2Loss_27", - "input21": "loss/l2_regularizer/L2Loss_28", - "input22": "loss/l2_regularizer/L2Loss_29", - "input23": "loss/l2_regularizer/L2Loss_3", - "input24": "loss/l2_regularizer/L2Loss_30", - "input25": "loss/l2_regularizer/L2Loss_31", - "input26": "loss/l2_regularizer/L2Loss_32", - "input27": "loss/l2_regularizer/L2Loss_33", - "input28": "loss/l2_regularizer/L2Loss_34", - "input29": "loss/l2_regularizer/L2Loss_35", - "input30": "loss/l2_regularizer/L2Loss_36", - "input31": "loss/l2_regularizer/L2Loss_37", - "input32": "loss/l2_regularizer/L2Loss_38", - "input33": "loss/l2_regularizer/L2Loss_39", - "input34": "loss/l2_regularizer/L2Loss_4", - "input35": "loss/l2_regularizer/L2Loss_40", - "input36": "loss/l2_regularizer/L2Loss_41", - "input37": "loss/l2_regularizer/L2Loss_42", - "input38": "loss/l2_regularizer/L2Loss_43", - "input39": "loss/l2_regularizer/L2Loss_44", - "input40": "loss/l2_regularizer/L2Loss_45", - "input41": "loss/l2_regularizer/L2Loss_46", - "input42": "loss/l2_regularizer/L2Loss_47", - "input43": "loss/l2_regularizer/L2Loss_48", - "input44": "loss/l2_regularizer/L2Loss_49", - "input45": "loss/l2_regularizer/L2Loss_5", - "input46": "loss/l2_regularizer/L2Loss_50", - "input47": "loss/l2_regularizer/L2Loss_51", - "input48": "loss/l2_regularizer/L2Loss_52", - "input49": "loss/l2_regularizer/L2Loss_53", - "input50": "loss/l2_regularizer/L2Loss_54", - "input51": "loss/l2_regularizer/L2Loss_55", - "input52": "loss/l2_regularizer/L2Loss_56", - "input53": "loss/l2_regularizer/L2Loss_57", - "input54": "loss/l2_regularizer/L2Loss_58", - "input55": "loss/l2_regularizer/L2Loss_59", - "input56": "loss/l2_regularizer/L2Loss_6", - "input57": "loss/l2_regularizer/L2Loss_60", - "input58": "loss/l2_regularizer/L2Loss_61", - "input59": "loss/l2_regularizer/L2Loss_62", - "input60": "loss/l2_regularizer/L2Loss_63", - "input61": "loss/l2_regularizer/L2Loss_64", - "input62": "loss/l2_regularizer/L2Loss_65", - "input63": "loss/l2_regularizer/L2Loss_66", - "input64": "loss/l2_regularizer/L2Loss_67", - "input65": "loss/l2_regularizer/L2Loss_68", - "input66": "loss/l2_regularizer/L2Loss_69", - "input67": "loss/l2_regularizer/L2Loss_7", - "input68": "loss/l2_regularizer/L2Loss_70", - "input69": "loss/l2_regularizer/L2Loss_71", - "input70": "loss/l2_regularizer/L2Loss_72", - "input71": "loss/l2_regularizer/L2Loss_73", - "input72": "loss/l2_regularizer/L2Loss_74", - "input73": "loss/l2_regularizer/L2Loss_75", - "input74": "loss/l2_regularizer/L2Loss_76", - "input75": "loss/l2_regularizer/L2Loss_77", - "input76": "loss/l2_regularizer/L2Loss_78", - "input77": "loss/l2_regularizer/L2Loss_79", - "input78": "loss/l2_regularizer/L2Loss_8", - "input79": "loss/l2_regularizer/L2Loss_80", - "input80": "loss/l2_regularizer/L2Loss_81", - "input81": "loss/l2_regularizer/L2Loss_82", - "input82": "loss/l2_regularizer/L2Loss_83", - "input83": "loss/l2_regularizer/L2Loss_84", - "input84": "loss/l2_regularizer/L2Loss_85", - "input85": "loss/l2_regularizer/L2Loss_86", - "input86": "loss/l2_regularizer/L2Loss_87", - "input87": "loss/l2_regularizer/L2Loss_88", - "input88": "loss/l2_regularizer/L2Loss_9" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029366072, - "dur": 20, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029366095, - "dur": 20, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029366117, - "dur": 22, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029366143, - "dur": 18, - "args": { - "name": "loss/l2_regularizer/mul", - "op": "Mul", - "input0": "loss/l2_regularizer/AddN", - "input1": "loss/l2_regularizer/mul/y" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029366163, - "dur": 8, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/conv1/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029366173, - "dur": 15, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029366191, - "dur": 14, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029366256, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029366292, - "dur": 26, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029366320, - "dur": 16, - "args": { - "name": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029366338, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029366345, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029366352, - "dur": 43, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029366399, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029366419, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029366437, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 13, - "tid": 0, - "ts": 1595535029366454, - "dur": 6753, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 4 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029366454, - "id": 4 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029373215, - "dur": 21, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029373238, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029373255, - "dur": 42, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029373303, - "dur": 21, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029373326, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029373345, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029373363, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029373381, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029373397, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029373406, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029373423, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029373440, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029373466, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029373484, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029373501, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029373508, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029373514, - "dur": 36, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 13, - "tid": 0, - "ts": 1595535029373555, - "dur": 21, - "args": { - "name": "ocnn_resnet/resblock_5_0/add", - "op": "Add", - "input0": "ocnn_resnet/conv1/conv_bn_relu/Relu", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029373580, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029373598, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029373614, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_0/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_0/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029373632, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029373649, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029373665, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_5_0/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029373672, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029373689, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029373705, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029373728, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029373734, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029373740, - "dur": 34, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029373778, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029373798, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029373815, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 13, - "tid": 0, - "ts": 1595535029373832, - "dur": 9062, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 5 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029373832, - "id": 5 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029382904, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029382928, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029382945, - "dur": 42, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029382992, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029383014, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029383033, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029383052, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029383069, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029383085, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029383093, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029383110, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029383127, - "dur": 22, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029383154, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029383171, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029383189, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029383195, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029383201, - "dur": 36, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 13, - "tid": 0, - "ts": 1595535029383241, - "dur": 21, - "args": { - "name": "ocnn_resnet/resblock_5_1/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_5_0/Relu", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029383265, - "dur": 21, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029383288, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029383304, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_1/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_1/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029383322, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029383339, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029383354, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_5_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029383361, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029383379, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029383396, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029383420, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029383426, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029383432, - "dur": 35, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029383471, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029383489, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029383507, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 13, - "tid": 0, - "ts": 1595535029383522, - "dur": 9069, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 6 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029383522, - "id": 6 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029392600, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029392621, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029392637, - "dur": 38, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029392680, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029392701, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029392718, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029392734, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029392748, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029392766, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029392783, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029392799, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029392806, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029392822, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029392839, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029392863, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029392869, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029392875, - "dur": 32, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029392912, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029392928, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 13, - "tid": 0, - "ts": 1595535029392944, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_5_2/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_5_1/Relu", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029392965, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029392982, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029392997, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_5_2/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029393014, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029393030, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool", - "pid": 13, - "tid": 0, - "ts": 1595535029393046, - "dur": 7191, - "args": { - "name": "ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool", - "input0": "ocnn_resnet/resblock_5_2/Relu", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 7 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029393046, - "id": 7 - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad", - "pid": 13, - "tid": 0, - "ts": 1595535029400243, - "dur": 243, - "args": { - "name": "ocnn_resnet/max_pool_5/octree_max_pool/OctreePad", - "op": "OctreePad", - "input0": "ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 8 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029400243, - "id": 8 - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029400489, - "dur": 7, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/max_pool_5/octree_max_pool/OctreePad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029400497, - "dur": 21, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029400522, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029400542, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029400548, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029400552, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029400557, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029400562, - "dur": 39, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029400606, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029400641, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029400660, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029400676, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029400692, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029400708, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029400724, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029400757, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 13, - "tid": 0, - "ts": 1595535029400773, - "dur": 211, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 9 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029400773, - "id": 9 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029400989, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029401008, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029401023, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029401042, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029401058, - "dur": 37, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029401099, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029401116, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029401133, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029401149, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029401165, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029401181, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029401188, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029401203, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029401218, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029401241, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029401259, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029401275, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029401281, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029401287, - "dur": 32, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 13, - "tid": 0, - "ts": 1595535029401324, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_4_0/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029401345, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029401361, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029401377, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_0/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_0/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029401393, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029401410, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029401425, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_4_0/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029401431, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029401449, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029401465, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029401487, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029401493, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029401498, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029401533, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029401551, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029401566, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 13, - "tid": 0, - "ts": 1595535029401583, - "dur": 2579, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 10 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029401583, - "id": 10 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029404168, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029404189, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029404206, - "dur": 40, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029404251, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029404272, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029404290, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029404307, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029404325, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029404341, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029404348, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029404365, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029404381, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029404405, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029404424, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029404441, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029404447, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029404453, - "dur": 36, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 13, - "tid": 0, - "ts": 1595535029404494, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_4_1/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_4_0/Relu", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029404516, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029404534, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029404550, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_1/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_1/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029404567, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029404584, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029404599, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_4_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029404606, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029404623, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029404640, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029404661, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029404666, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029404672, - "dur": 33, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029404709, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029404727, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029404744, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 13, - "tid": 0, - "ts": 1595535029404760, - "dur": 2529, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 11 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029404760, - "id": 11 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029407311, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029407332, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029407349, - "dur": 37, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029407390, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029407410, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029407427, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029407445, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029407461, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029407478, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029407494, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029407511, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029407518, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029407536, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029407553, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029407577, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029407583, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029407588, - "dur": 35, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029407627, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029407646, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 13, - "tid": 0, - "ts": 1595535029407662, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_4_2/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_4_1/Relu", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029407683, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029407700, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029407716, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_4_2/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_4_2/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029407732, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029407749, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool", - "pid": 13, - "tid": 0, - "ts": 1595535029407766, - "dur": 2433, - "args": { - "name": "ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool", - "input0": "ocnn_resnet/resblock_4_2/Relu", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 12 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029407766, - "id": 12 - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad", - "pid": 13, - "tid": 0, - "ts": 1595535029410203, - "dur": 118, - "args": { - "name": "ocnn_resnet/max_pool_4/octree_max_pool/OctreePad", - "op": "OctreePad", - "input0": "ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 13 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029410203, - "id": 13 - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029410324, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/max_pool_4/octree_max_pool/OctreePad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029410331, - "dur": 32, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029410366, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029410372, - "dur": 3, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029410377, - "dur": 36, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029410417, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029410435, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029410451, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 13, - "tid": 0, - "ts": 1595535029410467, - "dur": 93, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 14 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029410467, - "id": 14 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029410565, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029410584, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029410600, - "dur": 34, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029410637, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029410657, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029410673, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029410689, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029410705, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029410720, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029410727, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029410743, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029410758, - "dur": 23, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029410784, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029410801, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029410818, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029410824, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029410830, - "dur": 32, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 13, - "tid": 0, - "ts": 1595535029410866, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_3_0/add", - "op": "Add", - "input0": "ocnn_resnet/max_pool_4/octree_max_pool/OctreePad", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029410886, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029410902, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029410918, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_0/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029410933, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029410948, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029410963, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_3_0/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029410969, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029410985, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029411000, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029411022, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029411027, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029411032, - "dur": 31, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029411067, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029411084, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029411100, - "dur": 13, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 13, - "tid": 0, - "ts": 1595535029411115, - "dur": 271, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 15 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029411115, - "id": 15 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029411392, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029411412, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029411428, - "dur": 36, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029411469, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029411490, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029411507, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029411524, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029411541, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029411558, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029411565, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029411582, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029411599, - "dur": 21, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029411624, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029411642, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029411659, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029411666, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029411671, - "dur": 37, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 13, - "tid": 0, - "ts": 1595535029411712, - "dur": 17, - "args": { - "name": "ocnn_resnet/resblock_3_1/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_3_0/Relu", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029411733, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029411750, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029411766, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_1/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029411783, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029411800, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029411816, - "dur": 6, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_3_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029411823, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029411840, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029411857, - "dur": 19, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029411879, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029411885, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029411891, - "dur": 33, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029411928, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029411946, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029411963, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 13, - "tid": 0, - "ts": 1595535029411978, - "dur": 217, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 16 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029411978, - "id": 16 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029412201, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029412220, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029412237, - "dur": 37, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029412278, - "dur": 18, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029412298, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029412315, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029412332, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029412348, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029412365, - "dur": 26, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029412393, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 13, - "tid": 0, - "ts": 1595535029412409, - "dur": 5, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/Squeeze", - "op": "Squeeze", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029412416, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029412432, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029412448, - "dur": 20, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/read", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029412470, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ExpandDims", - "pid": 13, - "tid": 0, - "ts": 1595535029412476, - "dur": 4, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims_1", - "op": "ExpandDims", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 13, - "tid": 0, - "ts": 1595535029412482, - "dur": 32, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/read", - "input2": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029412518, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_variance/read", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029412534, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_mean/read", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 13, - "tid": 0, - "ts": 1595535029412549, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_3_2/add", - "op": "Add", - "input0": "ocnn_resnet/resblock_3_1/Relu", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029412567, - "dur": 15, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029412584, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 13, - "tid": 0, - "ts": 1595535029412599, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/Relu", - "op": "Relu", - "input0": "ocnn_resnet/resblock_3_2/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029412615, - "dur": 14, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_variance", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 13, - "tid": 0, - "ts": 1595535029412631, - "dur": 16, - "args": { - "name": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/moving_mean", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool", - "pid": 13, - "tid": 0, - "ts": 1595535029412655, - "dur": 390, - "args": { - "name": "ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool", - "input0": "ocnn_resnet/resblock_3_2/Relu", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 17 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029412655, - "id": 17 - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413049, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/transpose_grad/InvertPermutation", - "op": "Const", - "input0": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413059, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu", - "input1": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413073, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413082, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm", - "input1": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413092, - "dur": 4, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1", - "op": "Shape", - "input0": "IteratorGetNext/_9", - "input1": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 18 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029413092, - "id": 18 - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413101, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm", - "input1": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413109, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum/y", - "op": "Const", - "input0": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413117, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413126, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_1/Relu", - "input1": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413134, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape_1", - "op": "Const", - "input0": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413141, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/mod", - "op": "Const", - "input0": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413148, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu", - "input1": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413157, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413164, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm", - "input1": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413173, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape/shape", - "op": "Const", - "input0": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413180, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/range", - "op": "Const", - "input0": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413187, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu", - "input1": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413195, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413203, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413211, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu", - "input1": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413219, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_0/Relu", - "input1": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413228, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm", - "input1": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413236, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413244, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/max_pool_5/octree_max_pool/OctreePad", - "input1": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413252, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm", - "input1": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413261, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm", - "input1": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413270, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu", - "input1": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413278, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_10", - "op": "Const", - "input0": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input1": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413287, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413295, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_1/Relu", - "input1": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413303, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_0/Relu", - "input1": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413311, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413318, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_6", - "op": "Const", - "input0": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input1": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413326, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm", - "input1": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413335, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm", - "input1": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413343, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_7", - "op": "Const", - "input0": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input1": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413350, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413357, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_8", - "op": "Const", - "input0": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413364, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu", - "input1": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413372, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413380, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_9", - "op": "Const", - "input0": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input1": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413387, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu", - "input1": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413395, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413403, - "dur": 11, - "args": { - "name": "solver/Momentum/momentum", - "op": "Const", - "input0": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413418, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413425, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu", - "input1": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413433, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413441, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_3", - "op": "Const", - "input0": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input1": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413448, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Shape_1", - "op": "Shape", - "input0": "ocnn_resnet/conv1/conv_bn_relu/Relu", - "input1": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413456, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_1/Relu", - "input1": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413464, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_2", - "op": "Const", - "input0": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input1": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413471, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm", - "input1": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413480, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/n_true_conds", - "op": "Const", - "input0": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413486, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm", - "input1": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413495, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_1", - "op": "Const", - "input0": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input1": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413503, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413511, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Const", - "op": "Const", - "input0": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413518, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413526, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413533, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const", - "op": "Const", - "input0": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input1": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413540, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu", - "input1": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413548, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_4", - "op": "Const", - "input0": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413555, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413563, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413570, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_5", - "op": "Const", - "input0": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input1": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413577, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul", - "input1": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413585, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/max_pool_4/octree_max_pool/OctreePad", - "input1": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413592, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/resblock_3_0/Relu", - "input1": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad", - "pid": 13, - "tid": 0, - "ts": 1595535029413600, - "dur": 49, - "args": { - "name": "ocnn_resnet/max_pool_3/octree_max_pool/OctreePad", - "op": "OctreePad", - "input0": "ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 19 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029413600, - "id": 19 - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413655, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill", - "op": "Const", - "input0": "^solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum/y" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413660, - "dur": 4, - "args": { - "name": "solver/gradients/add_grad/tuple/control_dependency", - "op": "Const", - "input0": "^solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 13, - "tid": 0, - "ts": 1595535029413666, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Shape", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 13, - "tid": 0, - "ts": 1595535029413673, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 13, - "tid": 0, - "ts": 1595535029413679, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Shape", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 13, - "tid": 0, - "ts": 1595535029413684, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 13, - "tid": 0, - "ts": 1595535029413690, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Shape", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 13, - "tid": 0, - "ts": 1595535029413695, - "dur": 9, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_4", - "op": "Greater", - "input0": "solver/global_step/read/_11", - "input1": "solver/step_lr/PiecewiseConstant/Const_3" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 15, - "tid": 0, - "ts": 1595535029360249, - "id": 20 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1595535029413695, - "id": 20 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 13, - "tid": 0, - "ts": 1595535029413706, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3", - "op": "LessEqual", - "input0": "solver/global_step/read/_11", - "input1": "solver/step_lr/PiecewiseConstant/Const_3" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 15, - "tid": 0, - "ts": 1595535029360249, - "id": 21 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1595535029413706, - "id": 21 - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 13, - "tid": 0, - "ts": 1595535029413713, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_3", - "op": "Greater", - "input0": "solver/global_step/read/_11", - "input1": "solver/step_lr/PiecewiseConstant/Const_2" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 15, - "tid": 0, - "ts": 1595535029360249, - "id": 22 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1595535029413713, - "id": 22 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 13, - "tid": 0, - "ts": 1595535029413718, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_2", - "op": "LessEqual", - "input0": "solver/global_step/read/_11", - "input1": "solver/step_lr/PiecewiseConstant/Const_2" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 15, - "tid": 0, - "ts": 1595535029360249, - "id": 23 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1595535029413718, - "id": 23 - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 13, - "tid": 0, - "ts": 1595535029413722, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Shape", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 13, - "tid": 0, - "ts": 1595535029413728, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Shape", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 13, - "tid": 0, - "ts": 1595535029413733, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_2", - "op": "Greater", - "input0": "solver/global_step/read/_11", - "input1": "solver/step_lr/PiecewiseConstant/Const_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 15, - "tid": 0, - "ts": 1595535029360249, - "id": 24 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1595535029413733, - "id": 24 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 13, - "tid": 0, - "ts": 1595535029413739, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1", - "op": "LessEqual", - "input0": "solver/global_step/read/_11", - "input1": "solver/step_lr/PiecewiseConstant/Const_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 15, - "tid": 0, - "ts": 1595535029360249, - "id": 25 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1595535029413739, - "id": 25 - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 13, - "tid": 0, - "ts": 1595535029413744, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_1", - "op": "Greater", - "input0": "solver/global_step/read/_11", - "input1": "solver/step_lr/PiecewiseConstant/Const" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 15, - "tid": 0, - "ts": 1595535029360249, - "id": 26 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1595535029413744, - "id": 26 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 13, - "tid": 0, - "ts": 1595535029413749, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual", - "op": "LessEqual", - "input0": "solver/global_step/read/_11", - "input1": "solver/step_lr/PiecewiseConstant/Const" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 15, - "tid": 0, - "ts": 1595535029360249, - "id": 27 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1595535029413749, - "id": 27 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 13, - "tid": 0, - "ts": 1595535029413754, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_4", - "op": "LessEqual", - "input0": "solver/global_step/read/_11", - "input1": "solver/step_lr/PiecewiseConstant/Const_4" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 15, - "tid": 0, - "ts": 1595535029360249, - "id": 28 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1595535029413754, - "id": 28 - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 13, - "tid": 0, - "ts": 1595535029413759, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater", - "op": "Greater", - "input0": "solver/global_step/read/_11", - "input1": "solver/step_lr/PiecewiseConstant/Const_4" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 15, - "tid": 0, - "ts": 1595535029360249, - "id": 29 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 13, - "tid": 0, - "ts": 1595535029413759, - "id": 29 - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 13, - "tid": 0, - "ts": 1595535029413764, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Shape", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 13, - "tid": 0, - "ts": 1595535029413770, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Shape", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029413775, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/Reshape_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/max_pool_3/octree_max_pool/OctreePad", - "input1": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029413784, - "dur": 4, - "args": { - "name": "ocnn_resnet/global_average/octree_full_voxel/Reshape", - "op": "Reshape", - "input0": "ocnn_resnet/max_pool_3/octree_max_pool/OctreePad", - "input1": "ocnn_resnet/global_average/octree_full_voxel/Reshape/shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413796, - "dur": 10, - "args": { - "name": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24", - "op": "Const", - "input0": "^loss/l2_regularizer/AddN", - "input1": "^solver/gradients/add_grad/tuple/control_dependency" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Transpose", - "pid": 13, - "tid": 0, - "ts": 1595535029413842, - "dur": 30, - "args": { - "name": "ocnn_resnet/global_average/octree_full_voxel/transpose", - "op": "Transpose", - "input0": "ocnn_resnet/global_average/octree_full_voxel/Reshape", - "input1": "ocnn_resnet/global_average/octree_full_voxel/transpose/perm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029413932, - "dur": 38, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_85_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029413972, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_78_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029413990, - "dur": 19, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_74_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414010, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_76_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414028, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_70_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414045, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_65_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414063, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_60_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414080, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_1_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414098, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_25_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414116, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_22_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414133, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_2_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414150, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_12_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414168, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_6_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414188, - "dur": 17, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_7_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414206, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_26_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414223, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_66_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414240, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_61_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414256, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_72_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414275, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_27_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414293, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_64_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414310, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_67_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414327, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_82_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414344, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_86_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414361, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_73_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414377, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_77_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414394, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_71_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414411, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_68_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414428, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_62_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414445, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_83_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414461, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_79_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414478, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_28_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414495, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_69_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414512, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_63_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414531, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_13_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414548, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_87_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/fc2/dense/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414565, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_88_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/fc2/dense/bias/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414583, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_24_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414602, - "dur": 43, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_80_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414646, - "dur": 17, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_23_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414664, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_75_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414681, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_14_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414699, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_8_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414716, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_3_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414733, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414751, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_59_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414769, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_29_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414786, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_15_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414804, - "dur": 17, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_18_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414822, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_43_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414839, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_9_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414855, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_4_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414872, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_55_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414889, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_51_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414906, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_45_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414924, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_21_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414942, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_16_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414959, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_19_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414976, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_31_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029414993, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_10_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415010, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_5_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415027, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_56_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415044, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_52_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415061, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_46_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415078, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_49_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415095, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_35_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415112, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_17_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415128, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_84_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415145, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_11_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415161, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_54_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415179, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_57_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415197, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_53_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415213, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_47_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415230, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_50_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415247, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_44_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415263, - "dur": 23, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_20_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415288, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_36_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415306, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_32_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415322, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_58_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415339, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_48_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415356, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_42_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415373, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_39_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415391, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_37_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415408, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_81_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415427, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_33_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415445, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_40_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415463, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_38_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415480, - "dur": 15, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_34_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415497, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_41_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029415514, - "dur": 16, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_30_grad/mul", - "op": "Mul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_24" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd", - "pid": 13, - "tid": 0, - "ts": 1595535029415703, - "dur": 189, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_1", - "op": "LogicalAnd", - "input0": "solver/step_lr/PiecewiseConstant/Greater_2/_21", - "input1": "solver/step_lr/PiecewiseConstant/LessEqual_2/_23" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd", - "pid": 13, - "tid": 1, - "ts": 1595535029415757, - "dur": 232, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_2", - "op": "LogicalAnd", - "input0": "solver/step_lr/PiecewiseConstant/Greater_3/_17", - "input1": "solver/step_lr/PiecewiseConstant/LessEqual_3/_19" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_3", - "pid": 13, - "tid": 0, - "ts": 1595535029413717, - "id": 30 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_3", - "pid": 13, - "tid": 1, - "ts": 1595535029415757, - "id": 30 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3", - "pid": 13, - "tid": 0, - "ts": 1595535029413711, - "id": 31 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3", - "pid": 13, - "tid": 1, - "ts": 1595535029415757, - "id": 31 - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd", - "pid": 13, - "tid": 2, - "ts": 1595535029415749, - "dur": 277, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and", - "op": "LogicalAnd", - "input0": "solver/step_lr/PiecewiseConstant/Greater_1/_25", - "input1": "solver/step_lr/PiecewiseConstant/LessEqual_1/_27" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_1", - "pid": 13, - "tid": 0, - "ts": 1595535029413747, - "id": 32 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_1", - "pid": 13, - "tid": 2, - "ts": 1595535029415749, - "id": 32 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1", - "pid": 13, - "tid": 0, - "ts": 1595535029413742, - "id": 33 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1", - "pid": 13, - "tid": 2, - "ts": 1595535029415749, - "id": 33 - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029416136, - "dur": 10, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2", - "op": "Shape", - "input0": "ocnn_resnet/global_average/octree_full_voxel/transpose", - "input1": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input31": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input55": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd", - "pid": 13, - "tid": 1, - "ts": 1595535029416081, - "dur": 166, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_3", - "op": "LogicalAnd", - "input0": "solver/step_lr/PiecewiseConstant/Greater_4/_13", - "input1": "solver/step_lr/PiecewiseConstant/LessEqual_4/_15" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_4", - "pid": 13, - "tid": 0, - "ts": 1595535029413704, - "id": 34 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_4", - "pid": 13, - "tid": 1, - "ts": 1595535029416081, - "id": 34 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_4", - "pid": 13, - "tid": 0, - "ts": 1595535029413757, - "id": 35 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_4", - "pid": 13, - "tid": 1, - "ts": 1595535029416081, - "id": 35 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mean", - "pid": 13, - "tid": 0, - "ts": 1595535029416154, - "dur": 125, - "args": { - "name": "ocnn_resnet/global_average/Mean", - "op": "Mean", - "input0": "ocnn_resnet/global_average/octree_full_voxel/transpose", - "input1": "ocnn_resnet/global_average/Mean/reduction_indices" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Size", - "pid": 13, - "tid": 0, - "ts": 1595535029416282, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Prod", - "op": "Size", - "input0": "ocnn_resnet/global_average/octree_full_voxel/transpose", - "input1": "^solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Size", - "pid": 13, - "tid": 0, - "ts": 1595535029416296, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Prod_1", - "op": "Size", - "input0": "ocnn_resnet/global_average/Mean", - "input1": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input42": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input54": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input56": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029416305, - "dur": 5, - "args": { - "name": "ocnn_resnet/fc2/flatten/Shape", - "op": "Shape", - "input0": "ocnn_resnet/global_average/Mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Maximum", - "pid": 13, - "tid": 0, - "ts": 1595535029416409, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum_1", - "op": "Maximum", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Prod_1", - "input1": "solver/step_lr/PiecewiseConstant/case/n_true_conds" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "StridedSlice", - "pid": 13, - "tid": 0, - "ts": 1595535029416421, - "dur": 14, - "args": { - "name": "ocnn_resnet/fc2/flatten/strided_slice", - "op": "StridedSlice", - "input0": "ocnn_resnet/fc2/flatten/Shape", - "input1": "loss/mse_loss/mean_squared_error/num_present/Const", - "input2": "ocnn_resnet/fc2/flatten/strided_slice/stack_2", - "input3": "ocnn_resnet/fc2/flatten/strided_slice/stack_2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FloorDiv", - "pid": 13, - "tid": 0, - "ts": 1595535029416437, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1", - "op": "FloorDiv", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Prod", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack", - "pid": 13, - "tid": 0, - "ts": 1595535029416447, - "dur": 8, - "args": { - "name": "ocnn_resnet/fc2/flatten/Reshape/shape", - "op": "Pack", - "input0": "ocnn_resnet/fc2/flatten/strided_slice", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1/dim" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029416460, - "dur": 5, - "args": { - "name": "ocnn_resnet/fc2/flatten/Reshape", - "op": "Reshape", - "input0": "ocnn_resnet/global_average/Mean", - "input1": "ocnn_resnet/fc2/flatten/Reshape/shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack", - "pid": 13, - "tid": 1, - "ts": 1595535029416253, - "dur": 225, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack", - "input0": "solver/step_lr/PiecewiseConstant/LessEqual/_29", - "input1": "solver/step_lr/PiecewiseConstant/Greater/_31", - "input2": "solver/step_lr/PiecewiseConstant/and", - "input3": "solver/step_lr/PiecewiseConstant/and_1", - "input4": "solver/step_lr/PiecewiseConstant/and_2", - "input5": "solver/step_lr/PiecewiseConstant/and_3" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual", - "pid": 13, - "tid": 0, - "ts": 1595535029413752, - "id": 36 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual", - "pid": 13, - "tid": 1, - "ts": 1595535029416253, - "id": 36 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater", - "pid": 13, - "tid": 0, - "ts": 1595535029413763, - "id": 37 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater", - "pid": 13, - "tid": 1, - "ts": 1595535029416253, - "id": 37 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and", - "pid": 13, - "tid": 2, - "ts": 1595535029416026, - "id": 38 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and", - "pid": 13, - "tid": 1, - "ts": 1595535029416253, - "id": 38 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_1", - "pid": 13, - "tid": 0, - "ts": 1595535029415892, - "id": 39 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_1", - "pid": 13, - "tid": 1, - "ts": 1595535029416253, - "id": 39 - }, - { - "ph": "X", - "cat": "Op", - "name": "DynamicStitch", - "pid": 13, - "tid": 2, - "ts": 1595535029416423, - "dur": 99, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch", - "op": "DynamicStitch", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/range", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/mod", - "input2": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2/_33", - "input3": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill/_35" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/range", - "pid": 13, - "tid": 0, - "ts": 1595535029413183, - "id": 40 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/range", - "pid": 13, - "tid": 2, - "ts": 1595535029416423, - "id": 40 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/mod", - "pid": 13, - "tid": 0, - "ts": 1595535029413144, - "id": 41 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/mod", - "pid": 13, - "tid": 2, - "ts": 1595535029416423, - "id": 41 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2", - "pid": 13, - "tid": 0, - "ts": 1595535029416146, - "id": 42 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2", - "pid": 13, - "tid": 2, - "ts": 1595535029416423, - "id": 42 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill", - "pid": 13, - "tid": 0, - "ts": 1595535029413658, - "id": 43 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Fill", - "pid": 13, - "tid": 2, - "ts": 1595535029416423, - "id": 43 - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast", - "pid": 13, - "tid": 0, - "ts": 1595535029416492, - "dur": 75, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Cast", - "op": "Cast", - "input0": "solver/step_lr/PiecewiseConstant/case/preds_c" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "pid": 13, - "tid": 1, - "ts": 1595535029416478, - "id": 44 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "pid": 13, - "tid": 0, - "ts": 1595535029416492, - "id": 44 - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 1, - "ts": 1595535029416546, - "dur": 44, - "args": { - "name": "ocnn_resnet/fc2/dense/MatMul", - "op": "MatMul", - "input0": "ocnn_resnet/fc2/flatten/Reshape", - "input1": "ocnn_resnet/fc2/dense/kernel/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/fc2/flatten/Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029416465, - "id": 45 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/fc2/flatten/Reshape", - "pid": 13, - "tid": 1, - "ts": 1595535029416546, - "id": 45 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/fc2/dense/kernel/read", - "pid": 13, - "tid": 0, - "ts": 1595535029363287, - "id": 46 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/fc2/dense/kernel/read", - "pid": 13, - "tid": 1, - "ts": 1595535029416546, - "id": 46 - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast", - "pid": 13, - "tid": 2, - "ts": 1595535029416563, - "dur": 157, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Cast", - "op": "Cast", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1/_43" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1", - "pid": 13, - "tid": 0, - "ts": 1595535029416444, - "id": 47 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv_1", - "pid": 13, - "tid": 2, - "ts": 1595535029416563, - "id": 47 - }, - { - "ph": "X", - "cat": "Op", - "name": "BiasAdd", - "pid": 13, - "tid": 0, - "ts": 1595535029416593, - "dur": 149, - "args": { - "name": "ocnn_resnet/fc2/dense/BiasAdd", - "op": "BiasAdd", - "input0": "ocnn_resnet/fc2/dense/MatMul", - "input1": "ocnn_resnet/fc2/dense/bias/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/fc2/dense/MatMul", - "pid": 13, - "tid": 1, - "ts": 1595535029416590, - "id": 48 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/fc2/dense/MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029416593, - "id": 48 - }, - { - "ph": "X", - "cat": "Op", - "name": "Maximum", - "pid": 13, - "tid": 1, - "ts": 1595535029416717, - "dur": 26, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum", - "op": "Maximum", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch/_39", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum/y" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch", - "pid": 13, - "tid": 2, - "ts": 1595535029416522, - "id": 49 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch", - "pid": 13, - "tid": 1, - "ts": 1595535029416717, - "id": 49 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum/y", - "pid": 13, - "tid": 0, - "ts": 1595535029413113, - "id": 50 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum/y", - "pid": 13, - "tid": 1, - "ts": 1595535029416717, - "id": 50 - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029416745, - "dur": 6, - "args": { - "name": "solver/gradients/loss/Reshape_grad/Shape", - "op": "Shape", - "input0": "ocnn_resnet/fc2/dense/BiasAdd", - "input1": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input24": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input32": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input53": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FloorDiv", - "pid": 13, - "tid": 1, - "ts": 1595535029416748, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv", - "op": "FloorDiv", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Maximum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2", - "pid": 13, - "tid": 0, - "ts": 1595535029416146, - "id": 51 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Shape_2", - "pid": 13, - "tid": 1, - "ts": 1595535029416748, - "id": 51 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029416760, - "dur": 6, - "args": { - "name": "loss/Reshape", - "op": "Reshape", - "input0": "ocnn_resnet/fc2/dense/BiasAdd", - "input1": "loss/Reshape/shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029416769, - "dur": 6, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape", - "op": "Shape", - "input0": "loss/Reshape", - "input1": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input5": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input9": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input11": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input16": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input17": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input18": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input26": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input29": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input33": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input35": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input36": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input41": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input44": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input45": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input48": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "SquaredDifference", - "pid": 13, - "tid": 0, - "ts": 1595535029416781, - "dur": 43, - "args": { - "name": "loss/mse_loss/mean_squared_error/SquaredDifference", - "op": "SquaredDifference", - "input0": "IteratorGetNext/_9", - "input1": "loss/Reshape" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 52 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029416781, - "id": 52 - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 13, - "tid": 0, - "ts": 1595535029416827, - "dur": 16, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029416845, - "dur": 6, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape", - "op": "Shape", - "input0": "loss/mse_loss/mean_squared_error/SquaredDifference", - "input1": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input2": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input4": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input10": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input12": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input13": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input14": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input15": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input19": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input20": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input21": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input22": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input23": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input25": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input27": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input28": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input30": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input34": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input37": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input38": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input39": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input40": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input43": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input46": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input47": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input49": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input50": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input51": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input52": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input57": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029416856, - "dur": 13, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Shape", - "op": "Shape", - "input0": "loss/mse_loss/mean_squared_error/SquaredDifference" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Snapshot", - "pid": 13, - "tid": 0, - "ts": 1595535029416872, - "dur": 4, - "args": { - "name": "loss/mse_loss/mean_squared_error/Mul", - "op": "Snapshot", - "input0": "loss/mse_loss/mean_squared_error/SquaredDifference" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 13, - "tid": 0, - "ts": 1595535029416878, - "dur": 6, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Fill", - "pid": 13, - "tid": 0, - "ts": 1595535029416887, - "dur": 26, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like", - "op": "Fill", - "input0": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Shape", - "input1": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029416915, - "dur": 6, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Shape", - "op": "Shape", - "input0": "loss/mse_loss/mean_squared_error/Mul", - "input1": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input3": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input6": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input11": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input12": "^ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input13": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input14": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input15": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input16": "^ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input17": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input18": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input19": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input20": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input21": "^ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input22": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input23": "^ocnn_resnet/conv1/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input24": "^ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input25": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input26": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg", - "input27": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input28": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input29": "^ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input30": "^ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input31": "^ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input32": "^ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input33": "^ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input34": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input35": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input36": "^ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/AssignMovingAvg", - "input37": "^ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input38": "^ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input39": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg", - "input40": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input41": "^ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input42": "^ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input43": "^ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input44": "^ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/AssignMovingAvg", - "input45": "^ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/AssignMovingAvg_1", - "input46": "^ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/AssignMovingAvg_1", - "input47": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input48": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg", - "input49": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input50": "^ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input51": "^ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/AssignMovingAvg", - "input52": "^ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input53": "^ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/AssignMovingAvg", - "input54": "^ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input55": "^ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input56": "^ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input57": "^ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/AssignMovingAvg_1", - "input58": "^ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 1, - "ts": 1595535029416910, - "dur": 27, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/num_true_conds", - "op": "Sum", - "input0": "solver/step_lr/PiecewiseConstant/case/Cast/_37", - "input1": "solver/step_lr/PiecewiseConstant/case/Const" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/Cast", - "pid": 13, - "tid": 0, - "ts": 1595535029416567, - "id": 53 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/Cast", - "pid": 13, - "tid": 1, - "ts": 1595535029416910, - "id": 53 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/Const", - "pid": 13, - "tid": 0, - "ts": 1595535029413514, - "id": 54 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/Const", - "pid": 13, - "tid": 1, - "ts": 1595535029416910, - "id": 54 - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029416926, - "dur": 25, - "args": { - "name": "loss/mse_loss/mean_squared_error/Sum", - "op": "Sum", - "input0": "loss/mse_loss/mean_squared_error/Mul", - "input1": "loss/mse_loss/mean_squared_error/num_present/Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 13, - "tid": 1, - "ts": 1595535029416941, - "dur": 14, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/LessEqual", - "op": "LessEqual", - "input0": "solver/step_lr/PiecewiseConstant/case/num_true_conds", - "input1": "solver/step_lr/PiecewiseConstant/case/n_true_conds" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/n_true_conds", - "pid": 13, - "tid": 0, - "ts": 1595535029413483, - "id": 55 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/n_true_conds", - "pid": 13, - "tid": 1, - "ts": 1595535029416941, - "id": 55 - }, - { - "ph": "X", - "cat": "Op", - "name": "Snapshot", - "pid": 13, - "tid": 0, - "ts": 1595535029416954, - "dur": 4, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights", - "op": "Snapshot", - "input0": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 0, - "ts": 1595535029416959, - "dur": 7, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/case/LessEqual", - "input1": "solver/step_lr/PiecewiseConstant/case/LessEqual" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/LessEqual", - "pid": 13, - "tid": 1, - "ts": 1595535029416955, - "id": 56 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/LessEqual", - "pid": 13, - "tid": 0, - "ts": 1595535029416959, - "id": 56 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/LessEqual", - "pid": 13, - "tid": 1, - "ts": 1595535029416955, - "id": 57 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/LessEqual", - "pid": 13, - "tid": 0, - "ts": 1595535029416959, - "id": 57 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 0, - "ts": 1595535029416970, - "dur": 7, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Assert/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/case/preds_c/_41", - "input1": "solver/step_lr/PiecewiseConstant/case/LessEqual" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "pid": 13, - "tid": 1, - "ts": 1595535029416478, - "id": 58 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "pid": 13, - "tid": 0, - "ts": 1595535029416970, - "id": 58 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/LessEqual", - "pid": 13, - "tid": 1, - "ts": 1595535029416955, - "id": 59 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/LessEqual", - "pid": 13, - "tid": 0, - "ts": 1595535029416970, - "id": 59 - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 1, - "ts": 1595535029416960, - "dur": 22, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present", - "op": "Sum", - "input0": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights", - "input1": "loss/mse_loss/mean_squared_error/num_present/Const" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights", - "pid": 13, - "tid": 0, - "ts": 1595535029416958, - "id": 60 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights", - "pid": 13, - "tid": 1, - "ts": 1595535029416960, - "id": 60 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/num_present/Const", - "pid": 13, - "tid": 0, - "ts": 1595535029361174, - "id": 61 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/num_present/Const", - "pid": 13, - "tid": 1, - "ts": 1595535029416960, - "id": 61 - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029416979, - "dur": 7, - "args": { - "name": "ConstantFoldingCtrl/solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch_1", - "op": "Identity", - "input0": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029416990, - "dur": 9, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/control_dependency", - "op": "Const", - "input0": "^ConstantFoldingCtrl/solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DivNoNan", - "pid": 13, - "tid": 1, - "ts": 1595535029416985, - "dur": 23, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan", - "op": "DivNoNan", - "input0": "solver/gradients/add_grad/tuple/control_dependency", - "input1": "loss/mse_loss/mean_squared_error/num_present" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/add_grad/tuple/control_dependency", - "pid": 13, - "tid": 0, - "ts": 1595535029413664, - "id": 62 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/add_grad/tuple/control_dependency", - "pid": 13, - "tid": 1, - "ts": 1595535029416985, - "id": 62 - }, - { - "ph": "X", - "cat": "Op", - "name": "Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029417003, - "dur": 11, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Merge", - "op": "Merge", - "input0": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/control_dependency_1", - "input1": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/control_dependency" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DivNoNan", - "pid": 13, - "tid": 1, - "ts": 1595535029417010, - "dur": 18, - "args": { - "name": "loss/mse_loss/mean_squared_error/value", - "op": "DivNoNan", - "input0": "loss/mse_loss/mean_squared_error/Sum", - "input1": "loss/mse_loss/mean_squared_error/num_present" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029416951, - "id": 63 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/Sum", - "pid": 13, - "tid": 1, - "ts": 1595535029417010, - "id": 63 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029417030, - "dur": 4, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape/shape", - "input2": "^loss/mse_loss/mean_squared_error/Sum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan", - "pid": 13, - "tid": 1, - "ts": 1595535029417008, - "id": 64 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan", - "pid": 13, - "tid": 0, - "ts": 1595535029417030, - "id": 64 - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 13, - "tid": 0, - "ts": 1595535029417044, - "dur": 9, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "op": "Identity", - "input0": "solver/step_lr/PiecewiseConstant/LessEqual", - "input1": "^solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Merge" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 13, - "tid": 1, - "ts": 1595535029417036, - "dur": 21, - "args": { - "name": "add", - "op": "Add", - "input0": "loss/l2_regularizer/mul", - "input1": "loss/mse_loss/mean_squared_error/value" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/l2_regularizer/mul", - "pid": 13, - "tid": 0, - "ts": 1595535029366161, - "id": 65 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/l2_regularizer/mul", - "pid": 13, - "tid": 1, - "ts": 1595535029417036, - "id": 65 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 0, - "ts": 1595535029417057, - "dur": 7, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_8", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 0, - "ts": 1595535029417067, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_9", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 0, - "ts": 1595535029417076, - "dur": 7, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_10", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 0, - "ts": 1595535029417085, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_6", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 0, - "ts": 1595535029417094, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/and_1/_53", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 0, - "ts": 1595535029417103, - "dur": 7, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_5", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 0, - "ts": 1595535029417113, - "dur": 8, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/and/_51", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and", - "pid": 13, - "tid": 2, - "ts": 1595535029416026, - "id": 66 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and", - "pid": 13, - "tid": 0, - "ts": 1595535029417113, - "id": 66 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 0, - "ts": 1595535029417124, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_7", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Tile", - "pid": 13, - "tid": 1, - "ts": 1595535029417103, - "dur": 28, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile", - "op": "Tile", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Shape" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029417034, - "id": 67 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape", - "pid": 13, - "tid": 1, - "ts": 1595535029417103, - "id": 67 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Shape", - "pid": 13, - "tid": 0, - "ts": 1595535029416921, - "id": 68 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Shape", - "pid": 13, - "tid": 1, - "ts": 1595535029417103, - "id": 68 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 0, - "ts": 1595535029417133, - "dur": 10, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Greater", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 0, - "ts": 1595535029417146, - "dur": 20, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/and_2/_55", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_2", - "pid": 13, - "tid": 1, - "ts": 1595535029415989, - "id": 69 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_2", - "pid": 13, - "tid": 0, - "ts": 1595535029417146, - "id": 69 - }, - { - "ph": "X", - "cat": "Op", - "name": "Snapshot", - "pid": 13, - "tid": 0, - "ts": 1595535029417170, - "dur": 7, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Mul", - "op": "Snapshot", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile", - "pid": 13, - "tid": 1, - "ts": 1595535029417131, - "id": 70 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile", - "pid": 13, - "tid": 0, - "ts": 1595535029417170, - "id": 70 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 13, - "tid": 1, - "ts": 1595535029417168, - "dur": 9, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/and_3/_57", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 13, - "tid": 0, - "ts": 1595535029417053, - "id": 71 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 13, - "tid": 1, - "ts": 1595535029417168, - "id": 71 - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029417179, - "dur": 5, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Mul", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417181, - "dur": 23, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "op": "Merge", - "input0": "solver/step_lr/PiecewiseConstant/case/cond/cond/Merge", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/Switch_1:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029417187, - "dur": 20, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Sum", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 13, - "tid": 0, - "ts": 1595535029417210, - "dur": 26, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/sub", - "op": "Sub", - "input0": "loss/Reshape", - "input1": "IteratorGetNext/_9", - "input2": "^solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 72 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029417210, - "id": 72 - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029417238, - "dur": 6, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/scalar", - "op": "Const", - "input0": "^solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029417246, - "dur": 39, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Mul", - "op": "Mul", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/scalar" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 13, - "tid": 0, - "ts": 1595535029417288, - "dur": 20, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/mul_1", - "op": "Mul", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Mul", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029417310, - "dur": 5, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/mul_1", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029417317, - "dur": 5, - "args": { - "name": "solver/gradients/loss/Reshape_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Sum", - "input1": "solver/gradients/loss/Reshape_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BiasAddGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029417324, - "dur": 32, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad", - "op": "BiasAddGrad", - "input0": "solver/gradients/loss/Reshape_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029417359, - "dur": 26, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/fc2/flatten/Reshape", - "input1": "solver/gradients/loss/Reshape_grad/Reshape", - "input2": "^solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029417388, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/loss/Reshape_grad/Reshape", - "input1": "ocnn_resnet/fc2/dense/kernel/read", - "input2": "^solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029417413, - "dur": 22, - "args": { - "name": "solver/gradients/AddN", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_88_grad/mul", - "input1": "solver/gradients/ocnn_resnet/fc2/dense/BiasAdd_grad/BiasAddGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029417437, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch/_39", - "input2": "^solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch", - "pid": 13, - "tid": 2, - "ts": 1595535029416522, - "id": 73 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/DynamicStitch", - "pid": 13, - "tid": 0, - "ts": 1595535029417437, - "id": 73 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029417446, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_1", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_87_grad/mul", - "input1": "solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul_1", - "input2": "^solver/gradients/ocnn_resnet/fc2/dense/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029417465, - "dur": 35, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/fc2/dense/bias", - "input1": "ocnn_resnet/fc2/dense/bias/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/fc2/dense/bias/Momentum", - "pid": 13, - "tid": 1, - "ts": 1595535029361377, - "id": 74 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/fc2/dense/bias/Momentum", - "pid": 13, - "tid": 0, - "ts": 1595535029417465, - "id": 74 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 75 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029417465, - "id": 75 - }, - { - "ph": "X", - "cat": "Op", - "name": "Tile", - "pid": 13, - "tid": 0, - "ts": 1595535029417502, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Tile", - "op": "Tile", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Reshape", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv", - "pid": 13, - "tid": 1, - "ts": 1595535029416760, - "id": 76 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/floordiv", - "pid": 13, - "tid": 0, - "ts": 1595535029417502, - "id": 76 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029417533, - "dur": 30, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/fc2/dense/kernel", - "input1": "ocnn_resnet/fc2/dense/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_1", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 77 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029417533, - "id": 77 - }, - { - "ph": "X", - "cat": "Op", - "name": "RealDiv", - "pid": 13, - "tid": 0, - "ts": 1595535029417565, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/truediv", - "op": "RealDiv", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Tile", - "input1": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Cast" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Cast", - "pid": 13, - "tid": 2, - "ts": 1595535029416720, - "id": 78 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn_resnet/global_average/Mean_grad/Cast", - "pid": 13, - "tid": 0, - "ts": 1595535029417565, - "id": 78 - }, - { - "ph": "X", - "cat": "Op", - "name": "Transpose", - "pid": 13, - "tid": 0, - "ts": 1595535029417589, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/transpose_grad/transpose", - "op": "Transpose", - "input0": "solver/gradients/ocnn_resnet/global_average/Mean_grad/truediv", - "input1": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/transpose_grad/InvertPermutation" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029417617, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/Reshape_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/transpose_grad/transpose", - "input1": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/Reshape_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad", - "pid": 13, - "tid": 0, - "ts": 1595535029417625, - "dur": 53, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad", - "input0": "solver/gradients/ocnn_resnet/global_average/octree_full_voxel/Reshape_grad/Reshape", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 79 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029417625, - "id": 79 - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool", - "pid": 13, - "tid": 0, - "ts": 1595535029417683, - "dur": 54, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool", - "input0": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreePad_grad/OctreeDepad", - "input1": "ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool:1", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 80 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029417683, - "id": 80 - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029417741, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/max_pool_3/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "input1": "ocnn_resnet/resblock_3_2/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029417767, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Sum_1", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/BroadcastGradientArgs:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029417775, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029417781, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Reshape_1", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Sum_1", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029417787, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Sum", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029417793, - "dur": 76, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Reshape", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm:4", - "input5": "^solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029417875, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029417882, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_2", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_85_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029417904, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_3", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_86_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029417924, - "dur": 26, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029417952, - "dur": 29, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029417986, - "dur": 41, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_2", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 81 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029417986, - "id": 81 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029418029, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_3", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 82 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029418029, - "id": 82 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029418059, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029418067, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_4", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_84_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029418086, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029418106, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_4", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 83 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029418106, - "id": 83 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029418136, - "dur": 61, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029418203, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_5", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_82_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029418225, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_6", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_83_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029418245, - "dur": 150, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 84 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029418245, - "id": 84 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029418402, - "dur": 35, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_5", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 85 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029418402, - "id": 85 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029418439, - "dur": 30, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_6", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 86 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029418439, - "id": 86 - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029418471, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029418492, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_7", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_81_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029418513, - "dur": 62, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029418582, - "dur": 30, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights", - "input1": "ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_7", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 87 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029418582, - "id": 87 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029418615, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029418623, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_8", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_79_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029418644, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_9", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_80_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029418663, - "dur": 27, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029418694, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029418720, - "dur": 31, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_8", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 88 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029418720, - "id": 88 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029418753, - "dur": 29, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_9", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 89 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029418753, - "id": 89 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029418785, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_10", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_78_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029418806, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029418813, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_10", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 90 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029418813, - "id": 90 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029418844, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_11", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "solver/gradients/ocnn_resnet/resblock_3_2/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029418864, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_11", - "input1": "ocnn_resnet/resblock_3_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029418886, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Sum_1", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/BroadcastGradientArgs:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029418893, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029418899, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Reshape_1", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Sum_1", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029418906, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Sum", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029418912, - "dur": 60, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Reshape", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm:4", - "input5": "^solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029418977, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029418985, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_12", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_76_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029419007, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_13", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_77_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029419026, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029419050, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029419079, - "dur": 31, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_12", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 91 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029419079, - "id": 91 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029419112, - "dur": 29, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_13", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 92 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029419112, - "id": 92 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029419143, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029419150, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_14", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_75_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029419171, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029419191, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_14", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 93 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029419191, - "id": 93 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029419221, - "dur": 70, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029419297, - "dur": 817, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 94 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029419297, - "id": 94 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029420119, - "dur": 21, - "args": { - "name": "solver/gradients/AddN_15", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_73_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029420143, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_16", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_74_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029420160, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_17", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_72_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029420178, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029420196, - "dur": 29, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_15", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 95 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029420196, - "id": 95 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029420227, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_16", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 96 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029420227, - "id": 96 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029420255, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights", - "input1": "ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_17", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 97 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029420255, - "id": 97 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029420282, - "dur": 55, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029420342, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029420350, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_18", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_70_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029420368, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_19", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_71_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029420386, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029420413, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029420435, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_18", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 98 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029420435, - "id": 98 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029420463, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_19", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 99 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029420463, - "id": 99 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029420489, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_20", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_69_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029420507, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029420513, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_20", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 100 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029420513, - "id": 100 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029420540, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_21", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "solver/gradients/ocnn_resnet/resblock_3_1/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029420558, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_21", - "input1": "ocnn_resnet/resblock_3_0/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029420576, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Sum_1", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/BroadcastGradientArgs:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029420582, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029420587, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Reshape_1", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Sum_1", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029420593, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Sum", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029420598, - "dur": 51, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Reshape", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm:4", - "input5": "^solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029420654, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029420661, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_22", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_67_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029420679, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_23", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_68_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029420696, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029420716, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029420740, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_22", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 101 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029420740, - "id": 101 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029420768, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_23", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 102 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029420768, - "id": 102 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029420795, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029420801, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_24", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_66_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029420818, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029420836, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_24", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 103 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029420836, - "id": 103 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029420863, - "dur": 52, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029420920, - "dur": 1197, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 104 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029420920, - "id": 104 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029422123, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_25", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_64_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029422145, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_26", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_65_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029422162, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_27", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_63_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029422179, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029422198, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_25", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 105 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029422198, - "id": 105 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029422227, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_26", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 106 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029422227, - "id": 106 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029422254, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights", - "input1": "ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_27", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 107 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029422254, - "id": 107 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029422282, - "dur": 55, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029422341, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029422349, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_28", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_61_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029422367, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_29", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_62_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029422384, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029422409, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029422431, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_28", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 108 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029422431, - "id": 108 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029422459, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_29", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 109 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029422459, - "id": 109 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029422487, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_30", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_60_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029422506, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029422512, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_30", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 110 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029422512, - "id": 110 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029422540, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_31", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "solver/gradients/ocnn_resnet/resblock_3_0/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad", - "pid": 13, - "tid": 0, - "ts": 1595535029422558, - "dur": 879, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad", - "input0": "solver/gradients/AddN_31", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 111 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029422558, - "id": 111 - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool", - "pid": 13, - "tid": 0, - "ts": 1595535029423441, - "dur": 47, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool", - "input0": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreePad_grad/OctreeDepad", - "input1": "ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool:1", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 112 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029423441, - "id": 112 - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029423493, - "dur": 21, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/max_pool_4/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "input1": "ocnn_resnet/resblock_4_2/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029423516, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Sum_1", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/BroadcastGradientArgs:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029423523, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029423528, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Reshape_1", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Sum_1", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029423533, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Sum", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029423539, - "dur": 56, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm:4", - "input5": "^solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029423601, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029423608, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_32", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_58_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029423627, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_33", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_59_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029423645, - "dur": 21, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029423668, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029423690, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_32", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 113 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029423690, - "id": 113 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029423719, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_33", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 114 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029423719, - "id": 114 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029423745, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029423752, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_34", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_57_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029423769, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029423787, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_34", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 115 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029423787, - "id": 115 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029423814, - "dur": 51, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029423870, - "dur": 803, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 116 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029423870, - "id": 116 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029424679, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_35", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_55_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029424702, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_36", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_56_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029424719, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029424737, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_37", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_54_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029424755, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_35", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 117 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029424755, - "id": 117 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029424783, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_36", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 118 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029424783, - "id": 118 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029424810, - "dur": 54, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029424869, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights", - "input1": "ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_37", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 119 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029424869, - "id": 119 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029424897, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029424904, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_38", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_52_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029424923, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_39", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_53_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029424942, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029424963, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029424986, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_38", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 120 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029424986, - "id": 120 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029425014, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_39", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/Momentum", - "pid": 13, - "tid": 1, - "ts": 1595535029361643, - "id": 121 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/Momentum", - "pid": 13, - "tid": 0, - "ts": 1595535029425014, - "id": 121 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 122 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029425014, - "id": 122 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029425041, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029425047, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_40", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_51_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029425064, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_41", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "solver/gradients/ocnn_resnet/resblock_4_2/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029425081, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_40", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 123 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029425081, - "id": 123 - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029425108, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_41", - "input1": "ocnn_resnet/resblock_4_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029425127, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Sum_1", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/BroadcastGradientArgs:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029425133, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029425138, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Reshape_1", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Sum_1", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029425143, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Sum", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029425149, - "dur": 52, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm:4", - "input5": "^solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029425206, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029425213, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_42", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_49_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029425231, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_43", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_50_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029425249, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029425269, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029425291, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_42", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 124 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029425291, - "id": 124 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029425319, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_43", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 125 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029425319, - "id": 125 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029425346, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029425352, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_44", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_48_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029425369, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029425386, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_44", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 126 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029425386, - "id": 126 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029425413, - "dur": 52, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029425469, - "dur": 5225, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 127 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029425469, - "id": 127 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029430702, - "dur": 22, - "args": { - "name": "solver/gradients/AddN_45", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_46_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029430726, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_46", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_47_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029430744, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029430763, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_47", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_45_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029430780, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_45", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 128 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029430780, - "id": 128 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029430808, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_46", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 129 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029430808, - "id": 129 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029430835, - "dur": 54, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029430894, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights", - "input1": "ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_47", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 130 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029430894, - "id": 130 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029430922, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029430930, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_48", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_43_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029430947, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_49", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_44_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029430964, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029430986, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029431008, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_48", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 131 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029431008, - "id": 131 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029431035, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_49", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 132 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029431035, - "id": 132 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029431062, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029431068, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_50", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_42_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029431085, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_51", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "solver/gradients/ocnn_resnet/resblock_4_1/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029431102, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_50", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 133 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029431102, - "id": 133 - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029431129, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_51", - "input1": "ocnn_resnet/resblock_4_0/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029431147, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029431153, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Sum_1", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/BroadcastGradientArgs:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029431159, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Sum", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029431164, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Reshape_1", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Sum_1", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029431170, - "dur": 51, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Reshape_1", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm:4", - "input5": "^solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029431226, - "dur": 59, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm:4", - "input5": "^solver/gradients/ocnn_resnet/resblock_4_0/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029431290, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029431297, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_54", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_40_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029431317, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_55", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_41_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029431334, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029431340, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_52", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_37_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029431357, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_53", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_38_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029431374, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029431396, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029431418, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_54", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 134 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029431418, - "id": 134 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029431447, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_55", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 135 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029431447, - "id": 135 - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029431473, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029431492, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029431514, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_52", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 136 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029431514, - "id": 136 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029431541, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_53", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 137 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029431541, - "id": 137 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029431567, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029431573, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_57", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_39_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029431590, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029431595, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_56", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_36_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029431612, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_57", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 138 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029431612, - "id": 138 - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029431639, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029431657, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_56", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 139 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029431657, - "id": 139 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029431685, - "dur": 52, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029431742, - "dur": 7413, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 140 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029431742, - "id": 140 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029439163, - "dur": 22, - "args": { - "name": "solver/gradients/AddN_58", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_34_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029439187, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_59", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_35_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029439205, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029439224, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_60", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_33_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029439241, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_58", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 141 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029439241, - "id": 141 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029439271, - "dur": 30, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_59", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 142 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029439271, - "id": 142 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029439303, - "dur": 58, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029439366, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights", - "input1": "ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_60", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 143 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029439366, - "id": 143 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029439395, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029439403, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_61", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_31_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029439420, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_62", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_32_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029439438, - "dur": 64, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029439504, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029439529, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_61", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 144 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029439529, - "id": 144 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029439559, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_62", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 145 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029439559, - "id": 145 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029439587, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029439594, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_63", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_30_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029439612, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_64", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "solver/gradients/ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/Squeeze_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029439629, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_63", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 146 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029439629, - "id": 146 - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad", - "pid": 13, - "tid": 0, - "ts": 1595535029439656, - "dur": 4818, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad", - "input0": "solver/gradients/AddN_64", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 147 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029439656, - "id": 147 - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool", - "pid": 13, - "tid": 0, - "ts": 1595535029444478, - "dur": 70, - "args": { - "name": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool", - "input0": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreePad_grad/OctreeDepad", - "input1": "ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool:1", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 148 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029444478, - "id": 148 - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029444552, - "dur": 21, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/max_pool_5/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "input1": "ocnn_resnet/resblock_5_2/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029444575, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Sum_1", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/BroadcastGradientArgs:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029444583, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029444589, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Reshape_1", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Sum_1", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029444595, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Sum", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029444602, - "dur": 60, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Reshape", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm:4", - "input5": "^solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029444668, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029444675, - "dur": 19, - "args": { - "name": "solver/gradients/AddN_65", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_28_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029444696, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_66", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_29_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029444715, - "dur": 53, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029444771, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029444795, - "dur": 31, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_65", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 149 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029444795, - "id": 149 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029444828, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_66", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 150 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029444828, - "id": 150 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029444857, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029444866, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_67", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_27_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029444885, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029444904, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_67", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 151 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029444904, - "id": 151 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029444931, - "dur": 53, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029444988, - "dur": 1958, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 152 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029444988, - "id": 152 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029446951, - "dur": 21, - "args": { - "name": "solver/gradients/AddN_68", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_25_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029446974, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_69", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_26_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029446991, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029447011, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_70", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_24_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029447029, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_68", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 153 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029447029, - "id": 153 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029447059, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_69", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 154 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029447059, - "id": 154 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029447087, - "dur": 56, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029447148, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights", - "input1": "ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_70", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 155 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029447148, - "id": 155 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029447177, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029447185, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_71", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_22_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029447203, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_72", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_23_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029447221, - "dur": 48, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029447271, - "dur": 28, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029447305, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_71", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 156 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029447305, - "id": 156 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029447333, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_72", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 157 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029447333, - "id": 157 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029447359, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Shape_1", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029447367, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_73", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_21_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029447385, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_74", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "solver/gradients/ocnn_resnet/resblock_5_2/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029447402, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_73", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 158 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029447402, - "id": 158 - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029447428, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_74", - "input1": "ocnn_resnet/resblock_5_1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029447447, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Sum_1", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/BroadcastGradientArgs:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029447454, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029447460, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Reshape_1", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Sum_1", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029447465, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Sum", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029447472, - "dur": 54, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Reshape", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm:4", - "input5": "^solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029447532, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029447539, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_75", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_19_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029447557, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_76", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_20_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029447574, - "dur": 44, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029447620, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029447644, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_75", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 159 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029447644, - "id": 159 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029447672, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_76", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 160 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029447672, - "id": 160 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029447699, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029447706, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_77", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_18_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029447724, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029447743, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_77", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 161 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029447743, - "id": 161 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029447770, - "dur": 54, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029447828, - "dur": 13804, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 162 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029447828, - "id": 162 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029461640, - "dur": 23, - "args": { - "name": "solver/gradients/AddN_78", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_16_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029461666, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_79", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_17_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029461683, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029461702, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_80", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_15_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029461719, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_78", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 163 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029461719, - "id": 163 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029461749, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_79", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 164 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029461749, - "id": 164 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029461778, - "dur": 57, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029461840, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights", - "input1": "ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_80", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 165 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029461840, - "id": 165 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029461869, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029461878, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_81", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_13_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029461896, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_82", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_14_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029461914, - "dur": 49, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029461965, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029461990, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_81", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 166 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029461990, - "id": 166 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029462019, - "dur": 35, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_82", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 167 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029462019, - "id": 167 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029462056, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Shape_1", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029462063, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_83", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_12_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029462080, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_84", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "solver/gradients/ocnn_resnet/resblock_5_1/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029462097, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_83", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 168 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029462097, - "id": 168 - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029462122, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_84", - "input1": "ocnn_resnet/resblock_5_0/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029462141, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Sum_1", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/BroadcastGradientArgs:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 13, - "tid": 0, - "ts": 1595535029462148, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029462153, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Reshape_1", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Sum_1", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029462159, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Sum", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029462165, - "dur": 51, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Reshape", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm:4", - "input5": "^solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029462221, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029462229, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_85", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_10_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029462246, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_86", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_11_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029462262, - "dur": 41, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029462305, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029462328, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_85", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 169 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029462328, - "id": 169 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029462355, - "dur": 23, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_86", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 170 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029462355, - "id": 170 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029462380, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Shape", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029462388, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_87", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_9_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029462405, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029462423, - "dur": 23, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_87", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 171 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029462423, - "id": 171 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029462448, - "dur": 49, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029462502, - "dur": 16331, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/Relu", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 172 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029462502, - "id": 172 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029478840, - "dur": 23, - "args": { - "name": "solver/gradients/AddN_88", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_7_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029478865, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_89", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_8_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029478883, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029478902, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_90", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_6_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029478920, - "dur": 30, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_88", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 173 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029478920, - "id": 173 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029478952, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_89", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 174 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029478952, - "id": 174 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029478979, - "dur": 59, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims_1", - "input2": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/read", - "input3": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029479043, - "dur": 28, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights", - "input1": "ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_90", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 175 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029479043, - "id": 175 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029479073, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029479080, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_91", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_4_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029479097, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_92", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_5_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029479115, - "dur": 51, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 13, - "tid": 0, - "ts": 1595535029479168, - "dur": 20, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/read", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/ExpandDims_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029479193, - "dur": 27, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_91", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 176 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029479193, - "id": 176 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029479222, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_92", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 177 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029479222, - "id": 177 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029479249, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Shape_1", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029479257, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_93", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_3_grad/mul", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029479280, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_94", - "op": "AddN", - "input0": "solver/gradients/ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/Squeeze_grad/Reshape", - "input1": "solver/gradients/ocnn_resnet/resblock_5_0/add_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029479300, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights", - "input1": "ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_93", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 178 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029479300, - "id": 178 - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029479327, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/AddN_94", - "input1": "ocnn_resnet/conv1/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029479348, - "dur": 55, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 13, - "tid": 0, - "ts": 1595535029479408, - "dur": 15587, - "args": { - "name": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn_resnet/Reshape", - "input1": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn_resnet/Reshape", - "pid": 13, - "tid": 1, - "ts": 1595535029363437, - "id": 179 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn_resnet/Reshape", - "pid": 13, - "tid": 0, - "ts": 1595535029479408, - "id": 179 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360293, - "id": 180 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 13, - "tid": 0, - "ts": 1595535029479408, - "id": 180 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029495001, - "dur": 20, - "args": { - "name": "solver/gradients/AddN_95", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_1_grad/mul", - "input1": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029495023, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_96", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_2_grad/mul", - "input1": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 13, - "tid": 0, - "ts": 1595535029495040, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_97", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_grad/mul", - "input1": "solver/gradients/ocnn_resnet/conv1/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029495057, - "dur": 25, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_95", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 181 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029495057, - "id": 181 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029495084, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_96", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 182 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029495084, - "id": 182 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 13, - "tid": 0, - "ts": 1595535029495110, - "dur": 24, - "args": { - "name": "solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights", - "input1": "ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_97", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 183 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 0, - "ts": 1595535029495110, - "id": 183 - }, - { - "ph": "X", - "cat": "Op", - "name": "NoOp", - "pid": 13, - "tid": 0, - "ts": 1595535029495136, - "dur": 3, - "args": { - "name": "solver/Momentum/update", - "op": "NoOp", - "input0": "^solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input1": "^solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input2": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "input3": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input4": "^solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "input5": "^solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "input6": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "input7": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input8": "^solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input9": "^solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "input10": "^solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input11": "^solver/Momentum/update_ocnn_resnet/fc2/dense/bias/ApplyMomentum", - "input12": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input13": "^solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input14": "^solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input15": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "input16": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input17": "^solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "input18": "^solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "input19": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input20": "^solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input21": "^solver/Momentum/update_ocnn_resnet/fc2/dense/kernel/ApplyMomentum", - "input22": "^solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "input23": "^solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input24": "^solver/Momentum/update_ocnn_resnet/resblock_3_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input25": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "input26": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input27": "^solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "input28": "^solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "input29": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "input30": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/beta/ApplyMomentum", - "input31": "^solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "input32": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "input33": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input34": "^solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "input35": "^solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "input36": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/batch_normalization/gamma/ApplyMomentum", - "input37": "^solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "input38": "^solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input39": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "input40": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "input41": "^solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input42": "^solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "input43": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "input44": "^solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "input45": "^solver/Momentum/update_ocnn_resnet/resblock_4_1/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input46": "^solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "input47": "^solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input48": "^solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "input49": "^solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "input50": "^solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "input51": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "input52": "^solver/Momentum/update_ocnn_resnet/resblock_4_1/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "input53": "^solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "input54": "^solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "input55": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "input56": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "input57": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "input58": "^solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "input59": "^solver/Momentum/update_ocnn_resnet/resblock_3_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "input60": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "input61": "^solver/Momentum/update_ocnn_resnet/resblock_4_0/1x1x1_c/conv2d_1x1/weights/ApplyMomentum", - "input62": "^solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "input63": "^solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "input64": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "input65": "^solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "input66": "^solver/Momentum/update_ocnn_resnet/conv1/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input67": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input68": "^solver/Momentum/update_ocnn_resnet/resblock_3_1/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "input69": "^solver/Momentum/update_ocnn_resnet/resblock_4_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "input70": "^solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input71": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "input72": "^solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/conv2d_1x1/weights/ApplyMomentum", - "input73": "^solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "input74": "^solver/Momentum/update_ocnn_resnet/resblock_3_0/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "input75": "^solver/Momentum/update_ocnn_resnet/resblock_3_1/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input76": "^solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_a/batch_normalization/beta/ApplyMomentum", - "input77": "^solver/Momentum/update_ocnn_resnet/resblock_5_1/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input78": "^solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "input79": "^solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input80": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/1x1x1_b/conv2d_1x1/weights/ApplyMomentum", - "input81": "^solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/beta/ApplyMomentum", - "input82": "^solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/batch_normalization/gamma/ApplyMomentum", - "input83": "^solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input84": "^solver/Momentum/update_ocnn_resnet/resblock_5_2/3x3x3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input85": "^solver/Momentum/update_ocnn_resnet/resblock_4_2/3x3x3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input86": "^solver/Momentum/update_ocnn_resnet/resblock_5_0/3x3x3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input87": "^solver/Momentum/update_ocnn_resnet/resblock_5_1/1x1x1_b/batch_normalization/gamma/ApplyMomentum", - "input88": "^solver/Momentum/update_ocnn_resnet/resblock_5_2/1x1x1_a/conv2d_1x1/weights/ApplyMomentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 13, - "tid": 0, - "ts": 1595535029495146, - "dur": 5, - "args": { - "name": "solver/Momentum/update/_64", - "op": "Const", - "input0": "^solver/Momentum/update" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "NoOp", - "pid": 15, - "tid": 0, - "ts": 1595535029360114, - "dur": 6, - "args": { - "name": "_SOURCE", - "op": "NoOp" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 15, - "tid": 0, - "ts": 1595535029360157, - "dur": 10, - "args": { - "name": "summary_train/lr/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 15, - "tid": 0, - "ts": 1595535029360171, - "dur": 19, - "args": { - "name": "summary_train/regularizer/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 15, - "tid": 0, - "ts": 1595535029360192, - "dur": 2, - "args": { - "name": "summary_train/total_loss/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 15, - "tid": 0, - "ts": 1595535029360196, - "dur": 2, - "args": { - "name": "summary_train/accu/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 15, - "tid": 0, - "ts": 1595535029360200, - "dur": 3, - "args": { - "name": "summary_train/loss/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OneShotIterator", - "pid": 15, - "tid": 1, - "ts": 1595535029360191, - "dur": 23, - "args": { - "name": "points_dataset/OneShotIterator", - "op": "OneShotIterator" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 15, - "tid": 0, - "ts": 1595535029360208, - "dur": 27, - "args": { - "name": "solver/global_step", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 15, - "tid": 0, - "ts": 1595535029360243, - "dur": 6, - "args": { - "name": "solver/global_step/read", - "op": "Identity", - "input0": "solver/global_step" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "IteratorGetNext", - "pid": 15, - "tid": 1, - "ts": 1595535029360222, - "dur": 71, - "args": { - "name": "IteratorGetNext", - "op": "IteratorGetNext", - "input0": "points_dataset/OneShotIterator" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 15, - "tid": 0, - "ts": 1595535029372566, - "dur": 31, - "args": { - "name": "summary_train/regularizer", - "op": "ScalarSummary", - "input0": "summary_train/regularizer/tags", - "input1": "loss/l2_regularizer/mul/_7" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/l2_regularizer/mul", - "pid": 13, - "tid": 0, - "ts": 1595535029366161, - "id": 184 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/l2_regularizer/mul", - "pid": 15, - "tid": 0, - "ts": 1595535029372566, - "id": 184 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 15, - "tid": 0, - "ts": 1595535029417102, - "dur": 23, - "args": { - "name": "summary_train/accu", - "op": "ScalarSummary", - "input0": "summary_train/accu/tags", - "input1": "loss/mse_loss/mean_squared_error/value/_59" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/value", - "pid": 13, - "tid": 1, - "ts": 1595535029417028, - "id": 185 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/value", - "pid": 15, - "tid": 0, - "ts": 1595535029417102, - "id": 185 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 15, - "tid": 1, - "ts": 1595535029417116, - "dur": 45, - "args": { - "name": "summary_train/loss", - "op": "ScalarSummary", - "input0": "summary_train/loss/tags", - "input1": "loss/mse_loss/mean_squared_error/value/_59" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "summary_train/loss/tags", - "pid": 15, - "tid": 0, - "ts": 1595535029360203, - "id": 186 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "summary_train/loss/tags", - "pid": 15, - "tid": 1, - "ts": 1595535029417116, - "id": 186 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/value", - "pid": 13, - "tid": 1, - "ts": 1595535029417028, - "id": 187 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/value", - "pid": 15, - "tid": 1, - "ts": 1595535029417116, - "id": 187 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 15, - "tid": 0, - "ts": 1595535029417171, - "dur": 12, - "args": { - "name": "summary_train/total_loss", - "op": "ScalarSummary", - "input0": "summary_train/total_loss/tags", - "input1": "add/_61" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "add", - "pid": 13, - "tid": 1, - "ts": 1595535029417057, - "id": 188 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "add", - "pid": 15, - "tid": 0, - "ts": 1595535029417171, - "id": 188 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 15, - "tid": 0, - "ts": 1595535029417293, - "dur": 17, - "args": { - "name": "summary_train/lr", - "op": "ScalarSummary", - "input0": "summary_train/lr/tags", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/Merge/_63" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 13, - "tid": 1, - "ts": 1595535029417204, - "id": 189 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 15, - "tid": 0, - "ts": 1595535029417293, - "id": 189 - }, - { - "ph": "X", - "cat": "Op", - "name": "MergeSummary", - "pid": 15, - "tid": 0, - "ts": 1595535029417314, - "dur": 33, - "args": { - "name": "summary_train/Merge/MergeSummary", - "op": "MergeSummary", - "input0": "summary_train/loss", - "input1": "summary_train/accu", - "input2": "summary_train/regularizer", - "input3": "summary_train/total_loss", - "input4": "summary_train/lr" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "summary_train/loss", - "pid": 15, - "tid": 1, - "ts": 1595535029417161, - "id": 190 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "summary_train/loss", - "pid": 15, - "tid": 0, - "ts": 1595535029417314, - "id": 190 - }, - { - "ph": "X", - "cat": "Op", - "name": "_Retval", - "pid": 15, - "tid": 0, - "ts": 1595535029417351, - "dur": 3, - "args": { - "name": "_retval_summary_train/Merge/MergeSummary_0_0", - "op": "_Retval", - "input0": "summary_train/Merge/MergeSummary" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 15, - "tid": 0, - "ts": 1595535029503907, - "dur": 4, - "args": { - "name": "solver/Momentum/update/_67", - "op": "Identity", - "input0": "solver/Momentum/update/_66" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 15, - "tid": 0, - "ts": 1595535029503916, - "dur": 4, - "args": { - "name": "solver/Momentum/value", - "op": "Const", - "input0": "^solver/Momentum/update/_67" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignAdd", - "pid": 15, - "tid": 0, - "ts": 1595535029503922, - "dur": 6, - "args": { - "name": "solver/Momentum", - "op": "AssignAdd", - "input0": "solver/global_step", - "input1": "solver/Momentum/value" - } - } - ] -} \ No newline at end of file diff --git a/tensorflow/script/logs/pdbbind/resnet_points_20200805_reg_6/timeline.json b/tensorflow/script/logs/pdbbind/resnet_points_20200805_reg_6/timeline.json deleted file mode 100644 index 187ddd7..0000000 --- a/tensorflow/script/logs/pdbbind/resnet_points_20200805_reg_6/timeline.json +++ /dev/null @@ -1,12929 +0,0 @@ -{ - "traceEvents": [ - { - "name": "process_name", - "ph": "M", - "pid": 0, - "args": { - "name": "Allocators" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 1, - "args": { - "name": "/host:CPU Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 2, - "args": { - "name": "/host:CPU Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 3, - "args": { - "name": "/job:localhost/replica:0/task:0/device:GPU:0 Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 4, - "args": { - "name": "/job:localhost/replica:0/task:0/device:GPU:0 Tensors" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 5, - "args": { - "name": "/job:localhost/replica:0/task:0/device:CPU:0 Compute" - } - }, - { - "name": "process_name", - "ph": "M", - "pid": 6, - "args": { - "name": "/job:localhost/replica:0/task:0/device:CPU:0 Tensors" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868487252, - "dur": 3, - "args": { - "name": "Iterator::Model::Prefetch", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868487248, - "dur": 26, - "args": { - "name": "Iterator::Model", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868495744, - "dur": 13, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868495789, - "dur": 4, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868495804, - "dur": 12, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868512611, - "dur": 10, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868542183, - "dur": 8, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868542206, - "dur": 6, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868554590, - "dur": 13, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868554616, - "dur": 6, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868557428, - "dur": 4, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868557439, - "dur": 1, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868557446, - "dur": 1, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868557458, - "dur": 2, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868592030, - "dur": 11, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868592060, - "dur": 9, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868598786, - "dur": 9, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868598803, - "dur": 3, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868598815, - "dur": 5, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868598823, - "dur": 6, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868505288, - "dur": 34776, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868540244, - "dur": 13, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Assert/data_0/_58:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868540433, - "dur": 15, - "args": { - "name": "summary_train/lr:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868540548, - "dur": 3, - "args": { - "name": "summary_train/rmse:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868540601, - "dur": 2, - "args": { - "name": "summary_train/total_loss:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868540612, - "dur": 17, - "args": { - "name": "summary_train/Merge/MergeSummary:MergeSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868554593, - "dur": 5, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868557454, - "dur": 4, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868564395, - "dur": 6, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868592016, - "dur": 1534, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868530687, - "dur": 11, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868530713, - "dur": 3, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868530723, - "dur": 6, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868533577, - "dur": 4, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868533589, - "dur": 1833, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868535437, - "dur": 36694, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868516720, - "dur": 4, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868535813, - "dur": 13, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868535839, - "dur": 4, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868535846, - "dur": 9, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868540548, - "dur": 12, - "args": { - "name": "summary_train/loss:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868542162, - "dur": 7, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868542179, - "dur": 3, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868542189, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868554573, - "dur": 5, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868554586, - "dur": 3, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868557422, - "dur": 3, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868557432, - "dur": 629, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868558081, - "dur": 20270, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868509966, - "dur": 10, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868509990, - "dur": 1, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868509996, - "dur": 3, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868510007, - "dur": 22, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868510033, - "dur": 1, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868512582, - "dur": 5, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868512612, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868512619, - "dur": 11, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868516668, - "dur": 6, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868516683, - "dur": 1650, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868518348, - "dur": 21950, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868540312, - "dur": 48384, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868495773, - "dur": 7, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868495790, - "dur": 2, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868498126, - "dur": 1251, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868499390, - "dur": 21519, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868520921, - "dur": 33373, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868554533, - "dur": 9, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868554546, - "dur": 17, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868554566, - "dur": 1266, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868555845, - "dur": 19357, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 6, - "ts": 1596804868511623, - "dur": 49926, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 6, - "ts": 1596804868562391, - "dur": 9, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 6, - "ts": 1596804868562407, - "dur": 1258, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 6, - "ts": 1596804868563675, - "dur": 29422, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 7, - "ts": 1596804868498177, - "dur": 13, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 7, - "ts": 1596804868516713, - "dur": 12, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 7, - "ts": 1596804868516737, - "dur": 5, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 7, - "ts": 1596804868516745, - "dur": 8, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 7, - "ts": 1596804868521361, - "dur": 12, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 7, - "ts": 1596804868535820, - "dur": 3, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 7, - "ts": 1596804868538983, - "dur": 10, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1/_70:_HostSend", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 7, - "ts": 1596804868542176, - "dur": 1281, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 7, - "ts": 1596804868543479, - "dur": 23354, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 7, - "ts": 1596804868566843, - "dur": 27703, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 8, - "ts": 1596804868562424, - "dur": 14, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 8, - "ts": 1596804868564370, - "dur": 6, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 8, - "ts": 1596804868564385, - "dur": 3, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 8, - "ts": 1596804868564405, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868584702, - "dur": 14, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868588135, - "dur": 8, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868588152, - "dur": 2, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868512537, - "dur": 6, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868512558, - "dur": 2, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868512568, - "dur": 11, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868512585, - "dur": 2, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868516679, - "dur": 20, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868516706, - "dur": 2, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868516715, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868516723, - "dur": 2, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868521313, - "dur": 536, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868521868, - "dur": 23004, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868544886, - "dur": 37863, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868584655, - "dur": 11, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868584673, - "dur": 3, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868584686, - "dur": 6, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868588154, - "dur": 4, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868592024, - "dur": 4, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868592034, - "dur": 9, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 0, - "ts": 1596804868598884, - "dur": 4, - "args": { - "name": "solver/Momentum:AssignAdd", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868513039, - "dur": 38039, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868557453, - "dur": 3, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868557465, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868557470, - "dur": 5, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868562418, - "dur": 3, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868584676, - "dur": 4, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868584688, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868592001, - "dur": 4, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868592010, - "dur": 1, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868592016, - "dur": 1, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868592024, - "dur": 1, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868592028, - "dur": 1, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868598803, - "dur": 5, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 1, - "ts": 1596804868598815, - "dur": 5, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868562444, - "dur": 7, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868562467, - "dur": 3, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868562475, - "dur": 10, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868564366, - "dur": 6, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868564383, - "dur": 4, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 8, - "ts": 1596804868564409, - "dur": 2, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 8, - "ts": 1596804868564419, - "dur": 8, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 8, - "ts": 1596804868584670, - "dur": 606, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868495705, - "dur": 23, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868495754, - "dur": 26, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868495800, - "dur": 17, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868495856, - "dur": 17, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868498109, - "dur": 5, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868498122, - "dur": 1, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868498128, - "dur": 2, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868498136, - "dur": 2, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868498141, - "dur": 1, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868498147, - "dur": 0, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868498151, - "dur": 1, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868498176, - "dur": 13, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868509996, - "dur": 1432, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868511447, - "dur": 23126, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868534586, - "dur": 25068, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868562397, - "dur": 3, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868562407, - "dur": 2, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868562416, - "dur": 2, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868564386, - "dur": 1319, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868565726, - "dur": 20291, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868487197, - "dur": 14, - "args": { - "name": "solver/global_step:VariableV2", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868487249, - "dur": 4, - "args": { - "name": "solver/global_step/read/_8:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868487306, - "dur": 2, - "args": { - "name": "IteratorGetNext/_4:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868487313, - "dur": 1, - "args": { - "name": "IteratorGetNext/_68:_Send", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868495746, - "dur": 7941, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868503718, - "dur": 43053, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868490267, - "dur": 36515, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868530727, - "dur": 2, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868530733, - "dur": 1, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868533608, - "dur": 3, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868533634, - "dur": 1, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868533638, - "dur": 7, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868535772, - "dur": 3, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868535783, - "dur": 1798, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868537593, - "dur": 22096, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868494051, - "dur": 1503, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868494050, - "dur": 1532, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 16, - "ts": 1596804868494049, - "dur": 1534, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 17, - "ts": 1596804868494046, - "dur": 1555, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868495648, - "dur": 2325, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868495646, - "dur": 2328, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 16, - "ts": 1596804868495646, - "dur": 2329, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 17, - "ts": 1596804868495644, - "dur": 2332, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868507214, - "dur": 2658, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868507213, - "dur": 2661, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 16, - "ts": 1596804868507212, - "dur": 2663, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 17, - "ts": 1596804868507205, - "dur": 2673, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868509923, - "dur": 2526, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868509922, - "dur": 2529, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 16, - "ts": 1596804868509922, - "dur": 2531, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 17, - "ts": 1596804868509921, - "dur": 2534, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868512551, - "dur": 3971, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868512550, - "dur": 3973, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 16, - "ts": 1596804868512548, - "dur": 3976, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 17, - "ts": 1596804868512547, - "dur": 3979, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868519513, - "dur": 1646, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868519512, - "dur": 1649, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 16, - "ts": 1596804868519507, - "dur": 1654, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 17, - "ts": 1596804868519506, - "dur": 1658, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868527013, - "dur": 3579, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868527012, - "dur": 3582, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 16, - "ts": 1596804868527011, - "dur": 3584, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 17, - "ts": 1596804868527001, - "dur": 3596, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868530643, - "dur": 2808, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868530642, - "dur": 2810, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 16, - "ts": 1596804868530642, - "dur": 2812, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 17, - "ts": 1596804868530641, - "dur": 2815, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868533483, - "dur": 2192, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868533482, - "dur": 2194, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 16, - "ts": 1596804868533481, - "dur": 2195, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 17, - "ts": 1596804868533481, - "dur": 2198, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868540169, - "dur": 1924, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868540167, - "dur": 1926, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 16, - "ts": 1596804868540167, - "dur": 1928, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 17, - "ts": 1596804868540164, - "dur": 1932, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868551223, - "dur": 3232, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868551218, - "dur": 3239, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868551217, - "dur": 3241, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 16, - "ts": 1596804868551215, - "dur": 3246, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868554505, - "dur": 2795, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868554504, - "dur": 2797, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868554503, - "dur": 2799, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 16, - "ts": 1596804868554503, - "dur": 2801, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868559742, - "dur": 2580, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868559741, - "dur": 2582, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868559740, - "dur": 2584, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868559739, - "dur": 2587, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868562355, - "dur": 1932, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868562355, - "dur": 1934, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868562354, - "dur": 1935, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868562353, - "dur": 1937, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868581748, - "dur": 2823, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868581747, - "dur": 2826, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868581746, - "dur": 2828, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868581743, - "dur": 2832, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868584617, - "dur": 3431, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868584617, - "dur": 3433, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868584616, - "dur": 3434, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 13, - "ts": 1596804868584615, - "dur": 3437, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868588761, - "dur": 3164, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868588760, - "dur": 3167, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 8, - "ts": 1596804868588757, - "dur": 3170, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 9, - "ts": 1596804868588755, - "dur": 3173, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868594645, - "dur": 4092, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap[0]::TFRecord", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868594633, - "dur": 4105, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat::FlatMap", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 4, - "ts": 1596804868594633, - "dur": 4107, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle::ForeverRepeat", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 5, - "ts": 1596804868594631, - "dur": 4110, - "args": { - "name": "Iterator::Model::Prefetch::ParallelMap::MapAndBatch::Shuffle", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 18, - "ts": 1596804868502159, - "dur": 26, - "args": { - "name": "summary_train/regularizer:ScalarSummary", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 18, - "ts": 1596804868510041, - "dur": 12, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 18, - "ts": 1596804868510066, - "dur": 6, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 18, - "ts": 1596804868510076, - "dur": 11, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 18, - "ts": 1596804868521337, - "dur": 19, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 18, - "ts": 1596804868521369, - "dur": 6, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 18, - "ts": 1596804868521380, - "dur": 10, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 18, - "ts": 1596804868530735, - "dur": 25, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 18, - "ts": 1596804868530772, - "dur": 4, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 18, - "ts": 1596804868530779, - "dur": 10, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 17, - "ts": 1596804868554596, - "dur": 12, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 17, - "ts": 1596804868554627, - "dur": 9, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868584672, - "dur": 13, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868588151, - "dur": 6, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868588166, - "dur": 5, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 10, - "ts": 1596804868588175, - "dur": 9, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 2, - "ts": 1596804868598819, - "dur": 7, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 19, - "ts": 1596804868510027, - "dur": 2, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 19, - "ts": 1596804868512524, - "dur": 7, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 19, - "ts": 1596804868512549, - "dur": 1473, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 19, - "ts": 1596804868514035, - "dur": 32646, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 18, - "ts": 1596804868546693, - "dur": 49710, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868598795, - "dur": 7, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 3, - "ts": 1596804868598809, - "dur": 2, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 20, - "ts": 1596804868521289, - "dur": 7, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 20, - "ts": 1596804868521307, - "dur": 1, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 20, - "ts": 1596804868521314, - "dur": 2, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 20, - "ts": 1596804868521324, - "dur": 5, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 20, - "ts": 1596804868521332, - "dur": 1, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 20, - "ts": 1596804868530699, - "dur": 4, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 20, - "ts": 1596804868530709, - "dur": 433, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 20, - "ts": 1596804868531157, - "dur": 19243, - "args": { - "name": "TransformPoints:TransformPoints", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 19, - "ts": 1596804868550412, - "dur": 31234, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868588147, - "dur": 6, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 11, - "ts": 1596804868588162, - "dur": 5, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868496433, - "dur": 35321, - "args": { - "name": "PointsToOctree:PointsToOctree", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868533577, - "dur": 6, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868533590, - "dur": 2, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868533600, - "dur": 3, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868533607, - "dur": 1, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868533634, - "dur": 1, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868535782, - "dur": 5, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868535810, - "dur": 2, - "args": { - "name": "random_uniform_1:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868535818, - "dur": 2, - "args": { - "name": "mul_1:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868535823, - "dur": 1, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868542165, - "dur": 5, - "args": { - "name": "random_uniform_4/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868542177, - "dur": 2, - "args": { - "name": "random_uniform:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868542186, - "dur": 2, - "args": { - "name": "mul:Mul", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 21, - "ts": 1596804868542192, - "dur": 1, - "args": { - "name": "random_uniform_6:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 15, - "ts": 1596804868564389, - "dur": 5, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868584690, - "dur": 6, - "args": { - "name": "random_uniform_2:RandomUniformInt", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 14, - "ts": 1596804868584709, - "dur": 9, - "args": { - "name": "stack:Pack", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868588131, - "dur": 5, - "args": { - "name": "random_uniform_3/RandomUniform:RandomUniform", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "unknown", - "pid": 1, - "tid": 12, - "ts": 1596804868588142, - "dur": 1269, - "args": { - "name": "ParseSingleExample/ParseSingleExample:ParseSingleExample", - "op": "unknown" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "NoOp", - "pid": 3, - "tid": 0, - "ts": 1596804868487066, - "dur": 33, - "args": { - "name": "_SOURCE", - "op": "NoOp" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487127, - "dur": 39, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487180, - "dur": 11, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487195, - "dur": 8, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487208, - "dur": 9, - "args": { - "name": "ocnn/fc1/dense/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487223, - "dur": 7, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/Const_1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487233, - "dur": 10, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487246, - "dur": 7, - "args": { - "name": "ocnn/fc1/batch_normalization/AssignMovingAvg_1/decay", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487256, - "dur": 8, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487267, - "dur": 9, - "args": { - "name": "ocnn/fc2/dense/bias", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487279, - "dur": 7, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487289, - "dur": 8, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487299, - "dur": 8, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487310, - "dur": 8, - "args": { - "name": "ocnn/fc1/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487321, - "dur": 8, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487332, - "dur": 8, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487343, - "dur": 8, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487354, - "dur": 6, - "args": { - "name": "ocnn/fc1/batch_normalization/AssignMovingAvg/decay", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487363, - "dur": 8, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487374, - "dur": 8, - "args": { - "name": "ocnn/fc2/dense/kernel", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487385, - "dur": 6, - "args": { - "name": "ocnn/full_voxel/octree_full_voxel/transpose/perm", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487394, - "dur": 7, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487404, - "dur": 8, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487414, - "dur": 8, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487425, - "dur": 8, - "args": { - "name": "ocnn/fc1/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487435, - "dur": 8, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487445, - "dur": 8, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487456, - "dur": 8, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487466, - "dur": 8, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487477, - "dur": 8, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487487, - "dur": 8, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487498, - "dur": 7, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487507, - "dur": 6, - "args": { - "name": "ocnn/fc1/flatten/Reshape/shape/1", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487517, - "dur": 8, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/gamma", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487528, - "dur": 8, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487539, - "dur": 7, - "args": { - "name": "ocnn/full_voxel/dropout/dropout/truediv", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487548, - "dur": 7, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Const", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487557, - "dur": 8, - "args": { - "name": "ocnn/fc1/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487568, - "dur": 7, - "args": { - "name": "ocnn/fc2/dense/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487578, - "dur": 8, - "args": { - "name": "ocnn/fc1/dense/kernel/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487588, - "dur": 6, - "args": { - "name": "ocnn/fc1/flatten/strided_slice/stack_2", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487596, - "dur": 8, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487607, - "dur": 6, - "args": { - "name": "ocnn/Reshape/shape", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487616, - "dur": 6, - "args": { - "name": "ocnn/full_voxel/dropout/dropout/rate", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487625, - "dur": 8, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/moving_mean", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487635, - "dur": 7, - "args": { - "name": "loss/l2_regularizer/mul/y", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487644, - "dur": 8, - "args": { - "name": "ocnn/fc2/dense/bias/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868487654, - "dur": 8, - "args": { - "name": "ocnn/fc1/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868498410, - "dur": 28, - "args": { - "name": "ocnn/fc1/batch_normalization/moments/variance/reduction_indices", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868498445, - "dur": 4, - "args": { - "name": "ocnn/full_voxel/octree_full_voxel/Reshape/shape", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868498451, - "dur": 13, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/beta", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868498466, - "dur": 7, - "args": { - "name": "ocnn/fc1/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868498475, - "dur": 7, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/moving_variance", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868498484, - "dur": 6, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868498492, - "dur": 6, - "args": { - "name": "ocnn/fc1/batch_normalization/beta/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868498516, - "dur": 7, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868498525, - "dur": 7, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/octree_conv/weights", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868498535, - "dur": 4, - "args": { - "name": "loss/Reshape/shape", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868498541, - "dur": 6, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/octree_conv/weights/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 3, - "tid": 0, - "ts": 1596804868498553, - "dur": 6, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/gamma/Momentum", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498620, - "dur": 7, - "args": { - "name": "ocnn/fc1/dense/kernel/read", - "op": "Identity", - "input0": "ocnn/fc1/dense/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498631, - "dur": 4, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498639, - "dur": 4, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498645, - "dur": 5, - "args": { - "name": "ocnn/fc2/dense/bias/read", - "op": "Identity", - "input0": "ocnn/fc2/dense/bias" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498653, - "dur": 5, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498663, - "dur": 5, - "args": { - "name": "ocnn/fc1/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn/fc1/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498670, - "dur": 4, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498676, - "dur": 5, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498684, - "dur": 4, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498691, - "dur": 5, - "args": { - "name": "ocnn/fc2/dense/kernel/read", - "op": "Identity", - "input0": "ocnn/fc2/dense/kernel" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498698, - "dur": 5, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498705, - "dur": 4, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498712, - "dur": 4, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498718, - "dur": 4, - "args": { - "name": "ocnn/fc1/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn/fc1/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498725, - "dur": 4, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498732, - "dur": 5, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn/depth_5/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498739, - "dur": 4, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498746, - "dur": 4, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/gamma/read", - "op": "Identity", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/gamma" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498752, - "dur": 5, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn/depth_6/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498760, - "dur": 5, - "args": { - "name": "ocnn/fc1/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn/fc1/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498767, - "dur": 4, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498774, - "dur": 6, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/moving_mean/read", - "op": "Identity", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/moving_mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498784, - "dur": 7, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/beta/read", - "op": "Identity", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/beta" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498795, - "dur": 7, - "args": { - "name": "ocnn/fc1/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn/fc1/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498805, - "dur": 5, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/moving_variance/read", - "op": "Identity", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/moving_variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498812, - "dur": 4, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn/depth_3/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868498819, - "dur": 4, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/octree_conv/weights/read", - "op": "Identity", - "input0": "ocnn/depth_4/conv_bn_relu/octree_conv/weights" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868498826, - "dur": 69, - "args": { - "name": "loss/l2_regularizer/L2Loss_12", - "op": "L2Loss", - "input0": "ocnn/fc1/dense/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868498897, - "dur": 13, - "args": { - "name": "loss/l2_regularizer/L2Loss_5", - "op": "L2Loss", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868498913, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_16", - "op": "L2Loss", - "input0": "ocnn/fc2/dense/bias/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868498926, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_1", - "op": "L2Loss", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868498939, - "dur": 12, - "args": { - "name": "loss/l2_regularizer/L2Loss_10", - "op": "L2Loss", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868498953, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_15", - "op": "L2Loss", - "input0": "ocnn/fc2/dense/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868498966, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_4", - "op": "L2Loss", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868498978, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_13", - "op": "L2Loss", - "input0": "ocnn/fc1/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868498991, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_8", - "op": "L2Loss", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868499004, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_3", - "op": "L2Loss", - "input0": "ocnn/depth_5/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868499016, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_7", - "op": "L2Loss", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868499028, - "dur": 21, - "args": { - "name": "loss/l2_regularizer/L2Loss", - "op": "L2Loss", - "input0": "ocnn/depth_6/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868499051, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_14", - "op": "L2Loss", - "input0": "ocnn/fc1/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868499064, - "dur": 10, - "args": { - "name": "loss/l2_regularizer/L2Loss_11", - "op": "L2Loss", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868499077, - "dur": 11, - "args": { - "name": "loss/l2_regularizer/L2Loss_2", - "op": "L2Loss", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/beta/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868499090, - "dur": 18, - "args": { - "name": "loss/l2_regularizer/L2Loss_9", - "op": "L2Loss", - "input0": "ocnn/depth_3/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "L2Loss", - "pid": 3, - "tid": 0, - "ts": 1596804868499111, - "dur": 18, - "args": { - "name": "loss/l2_regularizer/L2Loss_6", - "op": "L2Loss", - "input0": "ocnn/depth_4/conv_bn_relu/octree_conv/weights/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868499132, - "dur": 40, - "args": { - "name": "loss/l2_regularizer/AddN", - "op": "AddN", - "input0": "loss/l2_regularizer/L2Loss", - "input1": "loss/l2_regularizer/L2Loss_1", - "input2": "loss/l2_regularizer/L2Loss_10", - "input3": "loss/l2_regularizer/L2Loss_11", - "input4": "loss/l2_regularizer/L2Loss_12", - "input5": "loss/l2_regularizer/L2Loss_13", - "input6": "loss/l2_regularizer/L2Loss_14", - "input7": "loss/l2_regularizer/L2Loss_15", - "input8": "loss/l2_regularizer/L2Loss_16", - "input9": "loss/l2_regularizer/L2Loss_2", - "input10": "loss/l2_regularizer/L2Loss_3", - "input11": "loss/l2_regularizer/L2Loss_4", - "input12": "loss/l2_regularizer/L2Loss_5", - "input13": "loss/l2_regularizer/L2Loss_6", - "input14": "loss/l2_regularizer/L2Loss_7", - "input15": "loss/l2_regularizer/L2Loss_8", - "input16": "loss/l2_regularizer/L2Loss_9" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868499177, - "dur": 16, - "args": { - "name": "loss/l2_regularizer/mul", - "op": "Mul", - "input0": "loss/l2_regularizer/AddN", - "input1": "loss/l2_regularizer/mul/y" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeProperty", - "pid": 3, - "tid": 0, - "ts": 1596804868502136, - "dur": 81, - "args": { - "name": "ocnn/OctreeProperty", - "op": "OctreeProperty", - "input0": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 0 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868502136, - "id": 0 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868502236, - "dur": 12, - "args": { - "name": "ocnn/Reshape", - "op": "Reshape", - "input0": "ocnn/OctreeProperty", - "input1": "ocnn/Reshape/shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 3, - "tid": 0, - "ts": 1596804868502252, - "dur": 266, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn/Reshape", - "input1": "ocnn/depth_6/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 1 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868502252, - "id": 1 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 3, - "tid": 0, - "ts": 1596804868502528, - "dur": 82, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn/depth_6/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn/depth_6/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn/depth_3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn/depth_3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 3, - "tid": 0, - "ts": 1596804868502619, - "dur": 19, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868502642, - "dur": 17, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868502662, - "dur": 11, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool", - "pid": 3, - "tid": 0, - "ts": 1596804868502676, - "dur": 30901, - "args": { - "name": "ocnn/depth_6/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool", - "input0": "ocnn/depth_6/conv_bn_relu/Relu", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 2 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868502676, - "id": 2 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868533600, - "dur": 57, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868533662, - "dur": 13, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad", - "pid": 3, - "tid": 0, - "ts": 1596804868533678, - "dur": 56, - "args": { - "name": "ocnn/depth_6/octree_max_pool/OctreePad", - "op": "OctreePad", - "input0": "ocnn/depth_6/octree_max_pool/OctreeMaxPool", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 3 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868533678, - "id": 3 - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 3, - "tid": 0, - "ts": 1596804868533740, - "dur": 27, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 3, - "tid": 0, - "ts": 1596804868533770, - "dur": 13, - "args": { - "name": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 3, - "tid": 0, - "ts": 1596804868533786, - "dur": 136, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn/depth_6/octree_max_pool/OctreePad", - "input1": "ocnn/depth_5/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 4 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868533786, - "id": 4 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 3, - "tid": 0, - "ts": 1596804868533931, - "dur": 86, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn/depth_5/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn/depth_5/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn/depth_5/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn/depth_3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn/depth_3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 3, - "tid": 0, - "ts": 1596804868534026, - "dur": 20, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868534051, - "dur": 18, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn/depth_5/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868534073, - "dur": 10, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn/depth_5/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool", - "pid": 3, - "tid": 0, - "ts": 1596804868534086, - "dur": 2135, - "args": { - "name": "ocnn/depth_5/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool", - "input0": "ocnn/depth_5/conv_bn_relu/Relu", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 5 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868534086, - "id": 5 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868536231, - "dur": 22, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868536257, - "dur": 12, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad", - "pid": 3, - "tid": 0, - "ts": 1596804868536272, - "dur": 38, - "args": { - "name": "ocnn/depth_5/octree_max_pool/OctreePad", - "op": "OctreePad", - "input0": "ocnn/depth_5/octree_max_pool/OctreeMaxPool", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 6 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868536272, - "id": 6 - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 3, - "tid": 0, - "ts": 1596804868536317, - "dur": 23, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 3, - "tid": 0, - "ts": 1596804868536345, - "dur": 15, - "args": { - "name": "ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 3, - "tid": 0, - "ts": 1596804868536363, - "dur": 95, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn/depth_5/octree_max_pool/OctreePad", - "input1": "ocnn/depth_4/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 7 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868536363, - "id": 7 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 3, - "tid": 0, - "ts": 1596804868536466, - "dur": 77, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn/depth_4/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn/depth_4/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn/depth_4/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn/depth_3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn/depth_3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 3, - "tid": 0, - "ts": 1596804868536550, - "dur": 15, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868536568, - "dur": 13, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn/depth_4/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868536585, - "dur": 11, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn/depth_4/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool", - "pid": 3, - "tid": 0, - "ts": 1596804868536599, - "dur": 489, - "args": { - "name": "ocnn/depth_4/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool", - "input0": "ocnn/depth_4/conv_bn_relu/Relu", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 8 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868536599, - "id": 8 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868537094, - "dur": 12, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868537109, - "dur": 11, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad", - "pid": 3, - "tid": 0, - "ts": 1596804868537122, - "dur": 39, - "args": { - "name": "ocnn/depth_4/octree_max_pool/OctreePad", - "op": "OctreePad", - "input0": "ocnn/depth_4/octree_max_pool/OctreeMaxPool", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 9 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868537122, - "id": 9 - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 3, - "tid": 0, - "ts": 1596804868537166, - "dur": 13, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 3, - "tid": 0, - "ts": 1596804868537181, - "dur": 11, - "args": { - "name": "ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConv", - "pid": 3, - "tid": 0, - "ts": 1596804868537195, - "dur": 91, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/octree_conv/OctreeConv", - "op": "OctreeConv", - "input0": "ocnn/depth_4/octree_max_pool/OctreePad", - "input1": "ocnn/depth_3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 10 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868537195, - "id": 10 - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNorm", - "pid": 3, - "tid": 0, - "ts": 1596804868537293, - "dur": 41, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/FusedBatchNorm", - "op": "FusedBatchNorm", - "input0": "ocnn/depth_3/conv_bn_relu/octree_conv/OctreeConv", - "input1": "ocnn/depth_3/conv_bn_relu/batch_normalization/gamma/read", - "input2": "ocnn/depth_3/conv_bn_relu/batch_normalization/beta/read", - "input3": "ocnn/depth_3/conv_bn_relu/batch_normalization/Const_1", - "input4": "ocnn/depth_3/conv_bn_relu/batch_normalization/Const_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 3, - "tid": 0, - "ts": 1596804868537340, - "dur": 12, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/Relu", - "op": "Relu", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/FusedBatchNorm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868537354, - "dur": 11, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "op": "Sub", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/moving_variance/read", - "input1": "ocnn/depth_3/conv_bn_relu/batch_normalization/FusedBatchNorm:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868537367, - "dur": 10, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "op": "Sub", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/moving_mean/read", - "input1": "ocnn/depth_3/conv_bn_relu/batch_normalization/FusedBatchNorm:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxPool", - "pid": 3, - "tid": 0, - "ts": 1596804868537379, - "dur": 299, - "args": { - "name": "ocnn/depth_3/octree_max_pool/OctreeMaxPool", - "op": "OctreeMaxPool", - "input0": "ocnn/depth_3/conv_bn_relu/Relu", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 11 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868537379, - "id": 11 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868537683, - "dur": 12, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub_1", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868537698, - "dur": 10, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg/sub_1", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreePad", - "pid": 3, - "tid": 0, - "ts": 1596804868537711, - "dur": 27, - "args": { - "name": "ocnn/depth_3/octree_max_pool/OctreePad", - "op": "OctreePad", - "input0": "ocnn/depth_3/octree_max_pool/OctreeMaxPool", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 12 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868537711, - "id": 12 - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 3, - "tid": 0, - "ts": 1596804868537743, - "dur": 14, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/moving_variance", - "input1": "ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 3, - "tid": 0, - "ts": 1596804868537759, - "dur": 12, - "args": { - "name": "ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/moving_mean", - "input1": "ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868537773, - "dur": 7, - "args": { - "name": "ocnn/full_voxel/octree_full_voxel/Reshape", - "op": "Reshape", - "input0": "ocnn/depth_3/octree_max_pool/OctreePad", - "input1": "ocnn/full_voxel/octree_full_voxel/Reshape/shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Transpose", - "pid": 3, - "tid": 0, - "ts": 1596804868537782, - "dur": 23, - "args": { - "name": "ocnn/full_voxel/octree_full_voxel/transpose", - "op": "Transpose", - "input0": "ocnn/full_voxel/octree_full_voxel/Reshape", - "input1": "ocnn/full_voxel/octree_full_voxel/transpose/perm" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868537810, - "dur": 11, - "args": { - "name": "ocnn/full_voxel/dropout/dropout/Shape", - "op": "Shape", - "input0": "ocnn/full_voxel/octree_full_voxel/transpose" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "RandomUniform", - "pid": 3, - "tid": 0, - "ts": 1596804868537823, - "dur": 17, - "args": { - "name": "ocnn/full_voxel/dropout/dropout/random_uniform/RandomUniform", - "op": "RandomUniform", - "input0": "ocnn/full_voxel/dropout/dropout/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Snapshot", - "pid": 3, - "tid": 0, - "ts": 1596804868537845, - "dur": 5, - "args": { - "name": "ocnn/full_voxel/dropout/dropout/random_uniform/mul", - "op": "Snapshot", - "input0": "ocnn/full_voxel/dropout/dropout/random_uniform/RandomUniform" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "GreaterEqual", - "pid": 3, - "tid": 0, - "ts": 1596804868537852, - "dur": 19, - "args": { - "name": "ocnn/full_voxel/dropout/dropout/GreaterEqual", - "op": "GreaterEqual", - "input0": "ocnn/full_voxel/dropout/dropout/random_uniform/mul", - "input1": "ocnn/full_voxel/dropout/dropout/rate" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast", - "pid": 3, - "tid": 0, - "ts": 1596804868537875, - "dur": 17, - "args": { - "name": "ocnn/full_voxel/dropout/dropout/Cast", - "op": "Cast", - "input0": "ocnn/full_voxel/dropout/dropout/GreaterEqual" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868537896, - "dur": 15, - "args": { - "name": "ocnn/full_voxel/dropout/dropout/mul", - "op": "Mul", - "input0": "ocnn/full_voxel/dropout/dropout/truediv", - "input1": "ocnn/full_voxel/dropout/dropout/Cast" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868537915, - "dur": 14, - "args": { - "name": "ocnn/full_voxel/dropout/dropout/mul_1", - "op": "Mul", - "input0": "ocnn/full_voxel/dropout/dropout/mul", - "input1": "ocnn/full_voxel/octree_full_voxel/transpose" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868537932, - "dur": 6, - "args": { - "name": "ocnn/fc1/flatten/Shape", - "op": "Shape", - "input0": "ocnn/full_voxel/dropout/dropout/mul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "StridedSlice", - "pid": 3, - "tid": 0, - "ts": 1596804868537941, - "dur": 15, - "args": { - "name": "ocnn/fc1/flatten/strided_slice", - "op": "StridedSlice", - "input0": "ocnn/fc1/flatten/Shape", - "input1": "ocnn/fc1/batch_normalization/moments/variance/reduction_indices", - "input2": "ocnn/fc1/flatten/strided_slice/stack_2", - "input3": "ocnn/fc1/flatten/strided_slice/stack_2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack", - "pid": 3, - "tid": 0, - "ts": 1596804868537960, - "dur": 9, - "args": { - "name": "ocnn/fc1/flatten/Reshape/shape", - "op": "Pack", - "input0": "ocnn/fc1/flatten/strided_slice", - "input1": "ocnn/fc1/flatten/Reshape/shape/1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868537972, - "dur": 5, - "args": { - "name": "ocnn/fc1/flatten/Reshape", - "op": "Reshape", - "input0": "ocnn/full_voxel/dropout/dropout/mul_1", - "input1": "ocnn/fc1/flatten/Reshape/shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 3, - "tid": 0, - "ts": 1596804868537979, - "dur": 25, - "args": { - "name": "ocnn/fc1/dense/MatMul", - "op": "MatMul", - "input0": "ocnn/fc1/flatten/Reshape", - "input1": "ocnn/fc1/dense/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mean", - "pid": 3, - "tid": 0, - "ts": 1596804868538007, - "dur": 23, - "args": { - "name": "ocnn/fc1/batch_normalization/moments/mean", - "op": "Mean", - "input0": "ocnn/fc1/dense/MatMul", - "input1": "ocnn/fc1/batch_normalization/moments/variance/reduction_indices" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "SquaredDifference", - "pid": 3, - "tid": 0, - "ts": 1596804868538033, - "dur": 18, - "args": { - "name": "ocnn/fc1/batch_normalization/moments/SquaredDifference", - "op": "SquaredDifference", - "input0": "ocnn/fc1/batch_normalization/moments/mean", - "input1": "ocnn/fc1/dense/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 3, - "tid": 0, - "ts": 1596804868538054, - "dur": 9, - "args": { - "name": "ocnn/fc1/batch_normalization/moments/Squeeze", - "op": "Squeeze", - "input0": "ocnn/fc1/batch_normalization/moments/mean" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mean", - "pid": 3, - "tid": 0, - "ts": 1596804868538065, - "dur": 13, - "args": { - "name": "ocnn/fc1/batch_normalization/moments/variance", - "op": "Mean", - "input0": "ocnn/fc1/batch_normalization/moments/SquaredDifference", - "input1": "ocnn/fc1/batch_normalization/moments/variance/reduction_indices" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868538081, - "dur": 12, - "args": { - "name": "ocnn/fc1/batch_normalization/AssignMovingAvg/sub", - "op": "Sub", - "input0": "ocnn/fc1/batch_normalization/moving_mean/read", - "input1": "ocnn/fc1/batch_normalization/moments/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Squeeze", - "pid": 3, - "tid": 0, - "ts": 1596804868538095, - "dur": 5, - "args": { - "name": "ocnn/fc1/batch_normalization/moments/Squeeze_1", - "op": "Squeeze", - "input0": "ocnn/fc1/batch_normalization/moments/variance" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868538103, - "dur": 11, - "args": { - "name": "ocnn/fc1/batch_normalization/AssignMovingAvg/mul", - "op": "Mul", - "input0": "ocnn/fc1/batch_normalization/AssignMovingAvg/decay", - "input1": "ocnn/fc1/batch_normalization/AssignMovingAvg/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868538116, - "dur": 12, - "args": { - "name": "ocnn/fc1/batch_normalization/AssignMovingAvg_1/sub", - "op": "Sub", - "input0": "ocnn/fc1/batch_normalization/moving_variance/read", - "input1": "ocnn/fc1/batch_normalization/moments/Squeeze_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 3, - "tid": 0, - "ts": 1596804868538131, - "dur": 13, - "args": { - "name": "ocnn/fc1/batch_normalization/batchnorm/add", - "op": "Add", - "input0": "loss/l2_regularizer/mul/y", - "input1": "ocnn/fc1/batch_normalization/moments/Squeeze_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 3, - "tid": 0, - "ts": 1596804868538148, - "dur": 13, - "args": { - "name": "ocnn/fc1/batch_normalization/AssignMovingAvg", - "op": "AssignSub", - "input0": "ocnn/fc1/batch_normalization/moving_mean", - "input1": "ocnn/fc1/batch_normalization/AssignMovingAvg/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868538163, - "dur": 11, - "args": { - "name": "ocnn/fc1/batch_normalization/AssignMovingAvg_1/mul", - "op": "Mul", - "input0": "ocnn/fc1/batch_normalization/AssignMovingAvg_1/decay", - "input1": "ocnn/fc1/batch_normalization/AssignMovingAvg_1/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Rsqrt", - "pid": 3, - "tid": 0, - "ts": 1596804868538176, - "dur": 13, - "args": { - "name": "ocnn/fc1/batch_normalization/batchnorm/Rsqrt", - "op": "Rsqrt", - "input0": "ocnn/fc1/batch_normalization/batchnorm/add" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignSub", - "pid": 3, - "tid": 0, - "ts": 1596804868538192, - "dur": 13, - "args": { - "name": "ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "op": "AssignSub", - "input0": "ocnn/fc1/batch_normalization/moving_variance", - "input1": "ocnn/fc1/batch_normalization/AssignMovingAvg_1/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868538214, - "dur": 12, - "args": { - "name": "ocnn/fc1/batch_normalization/batchnorm/mul", - "op": "Mul", - "input0": "ocnn/fc1/batch_normalization/batchnorm/Rsqrt", - "input1": "ocnn/fc1/batch_normalization/gamma/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538230, - "dur": 7, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_10", - "op": "Const", - "input0": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538240, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_6", - "op": "Const", - "input0": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538248, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_7", - "op": "Const", - "input0": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538255, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_8", - "op": "Const", - "input0": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538262, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_5", - "op": "Const", - "input0": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538269, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_9", - "op": "Const", - "input0": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538275, - "dur": 7, - "args": { - "name": "solver/Momentum/momentum", - "op": "Const", - "input0": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868538285, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn/full_voxel/octree_full_voxel/Reshape_grad/Shape", - "op": "Shape", - "input0": "ocnn/depth_3/octree_max_pool/OctreePad", - "input1": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn/fc1/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538295, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/Squeeze_grad/Shape", - "op": "Const", - "input0": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538303, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn/full_voxel/octree_full_voxel/transpose_grad/InvertPermutation", - "op": "Const", - "input0": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868538310, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_grad/Shape", - "op": "Shape", - "input0": "ocnn/full_voxel/octree_full_voxel/transpose", - "input1": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input10": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538319, - "dur": 3, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape_1", - "op": "Const", - "input0": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868538327, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/flatten/Reshape_grad/Shape", - "op": "Shape", - "input0": "ocnn/full_voxel/dropout/dropout/mul_1", - "input1": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn/fc1/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538335, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Maximum_1", - "op": "Const", - "input0": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868538341, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Shape_2", - "op": "Shape", - "input0": "ocnn/fc1/dense/MatMul", - "input1": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538352, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Maximum/y", - "op": "Const", - "input0": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538360, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Maximum/y", - "op": "Const", - "input0": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538366, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/range", - "op": "Const", - "input0": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868538373, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Shape_2", - "op": "Shape", - "input0": "ocnn/fc1/batch_normalization/moments/SquaredDifference", - "input1": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "NoOp", - "pid": 3, - "tid": 0, - "ts": 1596804868538382, - "dur": 2, - "args": { - "name": "GroupCrossDeviceControlEdges_0/solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1", - "op": "NoOp", - "input0": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538387, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/n_true_conds", - "op": "Const", - "input0": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/fc1/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538394, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Const", - "op": "Const", - "input0": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538400, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_4", - "op": "Const", - "input0": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538407, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_3", - "op": "Const", - "input0": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538413, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Shape_1", - "op": "Const", - "input0": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538420, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_2", - "op": "Const", - "input0": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input3": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538426, - "dur": 4, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape/shape", - "op": "Const", - "input0": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input1": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538433, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const", - "op": "Const", - "input0": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/fc1/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538439, - "dur": 3, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Const_1", - "op": "Const", - "input0": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input1": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/fc1/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868538446, - "dur": 12, - "args": { - "name": "ocnn/fc1/batch_normalization/batchnorm/mul_2", - "op": "Mul", - "input0": "ocnn/fc1/batch_normalization/batchnorm/mul", - "input1": "ocnn/fc1/batch_normalization/moments/Squeeze" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868538461, - "dur": 15, - "args": { - "name": "ocnn/fc1/batch_normalization/batchnorm/mul_1", - "op": "Mul", - "input0": "ocnn/fc1/batch_normalization/batchnorm/mul", - "input1": "ocnn/fc1/dense/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 3, - "tid": 0, - "ts": 1596804868538478, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_grad/Shape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538489, - "dur": 5, - "args": { - "name": "solver/gradients/add_grad/tuple/control_dependency", - "op": "Const", - "input0": "^solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Size", - "pid": 3, - "tid": 0, - "ts": 1596804868538497, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Prod", - "op": "Size", - "input0": "ocnn/fc1/dense/MatMul", - "input1": "^solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Shape_2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 3, - "tid": 0, - "ts": 1596804868538504, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Shape_2", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/Squeeze_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538520, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Fill", - "op": "Const", - "input0": "^solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Maximum/y" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538527, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Fill", - "op": "Const", - "input0": "^solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Maximum/y" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Size", - "pid": 3, - "tid": 0, - "ts": 1596804868538533, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Prod", - "op": "Size", - "input0": "ocnn/fc1/batch_normalization/moments/SquaredDifference", - "input1": "^solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Shape_2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538548, - "dur": 5, - "args": { - "name": "GroupCrossDeviceControlEdges_0/solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1/_10", - "op": "Const", - "input0": "^GroupCrossDeviceControlEdges_0/solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 3, - "tid": 0, - "ts": 1596804868538555, - "dur": 8, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_4", - "op": "LessEqual", - "input0": "solver/global_step/read/_9", - "input1": "solver/step_lr/PiecewiseConstant/Const_4" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 5, - "tid": 0, - "ts": 1596804868487243, - "id": 13 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 3, - "tid": 0, - "ts": 1596804868538555, - "id": 13 - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 3, - "tid": 0, - "ts": 1596804868538566, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater", - "op": "Greater", - "input0": "solver/global_step/read/_9", - "input1": "solver/step_lr/PiecewiseConstant/Const_4" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 5, - "tid": 0, - "ts": 1596804868487243, - "id": 14 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 3, - "tid": 0, - "ts": 1596804868538566, - "id": 14 - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 3, - "tid": 0, - "ts": 1596804868538575, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_4", - "op": "Greater", - "input0": "solver/global_step/read/_9", - "input1": "solver/step_lr/PiecewiseConstant/Const_3" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 5, - "tid": 0, - "ts": 1596804868487243, - "id": 15 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 3, - "tid": 0, - "ts": 1596804868538575, - "id": 15 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 3, - "tid": 0, - "ts": 1596804868538582, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3", - "op": "LessEqual", - "input0": "solver/global_step/read/_9", - "input1": "solver/step_lr/PiecewiseConstant/Const_3" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 5, - "tid": 0, - "ts": 1596804868487243, - "id": 16 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 3, - "tid": 0, - "ts": 1596804868538582, - "id": 16 - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 3, - "tid": 0, - "ts": 1596804868538590, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Shape_2", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 3, - "tid": 0, - "ts": 1596804868538600, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_3", - "op": "Greater", - "input0": "solver/global_step/read/_9", - "input1": "solver/step_lr/PiecewiseConstant/Const_2" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 5, - "tid": 0, - "ts": 1596804868487243, - "id": 17 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 3, - "tid": 0, - "ts": 1596804868538600, - "id": 17 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 3, - "tid": 0, - "ts": 1596804868538607, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_2", - "op": "LessEqual", - "input0": "solver/global_step/read/_9", - "input1": "solver/step_lr/PiecewiseConstant/Const_2" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 5, - "tid": 0, - "ts": 1596804868487243, - "id": 18 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 3, - "tid": 0, - "ts": 1596804868538607, - "id": 18 - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 3, - "tid": 0, - "ts": 1596804868538614, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_1", - "op": "Greater", - "input0": "solver/global_step/read/_9", - "input1": "solver/step_lr/PiecewiseConstant/Const" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 5, - "tid": 0, - "ts": 1596804868487243, - "id": 19 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 3, - "tid": 0, - "ts": 1596804868538614, - "id": 19 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 3, - "tid": 0, - "ts": 1596804868538622, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual", - "op": "LessEqual", - "input0": "solver/global_step/read/_9", - "input1": "solver/step_lr/PiecewiseConstant/Const" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 5, - "tid": 0, - "ts": 1596804868487243, - "id": 20 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 3, - "tid": 0, - "ts": 1596804868538622, - "id": 20 - }, - { - "ph": "X", - "cat": "Op", - "name": "Greater", - "pid": 3, - "tid": 0, - "ts": 1596804868538630, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/Greater_2", - "op": "Greater", - "input0": "solver/global_step/read/_9", - "input1": "solver/step_lr/PiecewiseConstant/Const_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 5, - "tid": 0, - "ts": 1596804868487243, - "id": 21 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 3, - "tid": 0, - "ts": 1596804868538630, - "id": 21 - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 3, - "tid": 0, - "ts": 1596804868538638, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1", - "op": "LessEqual", - "input0": "solver/global_step/read/_9", - "input1": "solver/step_lr/PiecewiseConstant/Const_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 5, - "tid": 0, - "ts": 1596804868487243, - "id": 22 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step/read", - "pid": 3, - "tid": 0, - "ts": 1596804868538638, - "id": 22 - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868538645, - "dur": 13, - "args": { - "name": "ocnn/fc1/batch_normalization/batchnorm/sub", - "op": "Sub", - "input0": "ocnn/fc1/batch_normalization/beta/read", - "input1": "ocnn/fc1/batch_normalization/batchnorm/mul_2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868538661, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Shape", - "op": "Shape", - "input0": "ocnn/fc1/batch_normalization/batchnorm/mul_1", - "input1": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538670, - "dur": 7, - "args": { - "name": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15", - "op": "Const", - "input0": "^loss/l2_regularizer/AddN", - "input1": "^solver/gradients/add_grad/tuple/control_dependency" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FloorDiv", - "pid": 3, - "tid": 0, - "ts": 1596804868538683, - "dur": 8, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/floordiv_1", - "op": "FloorDiv", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Prod", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Maximum_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FloorDiv", - "pid": 3, - "tid": 0, - "ts": 1596804868538787, - "dur": 25, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/floordiv_1", - "op": "FloorDiv", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Prod", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Maximum_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 3, - "tid": 0, - "ts": 1596804868538905, - "dur": 21, - "args": { - "name": "ocnn/fc1/batch_normalization/batchnorm/add_1", - "op": "Add", - "input0": "ocnn/fc1/batch_normalization/batchnorm/mul_1", - "input1": "ocnn/fc1/batch_normalization/batchnorm/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 3, - "tid": 0, - "ts": 1596804868538929, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Shape", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868538941, - "dur": 14, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_13_grad/mul", - "op": "Mul", - "input0": "ocnn/fc1/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868538958, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_1_grad/mul", - "op": "Mul", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868538972, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_2_grad/mul", - "op": "Mul", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868538987, - "dur": 13, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_5_grad/mul", - "op": "Mul", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539003, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_10_grad/mul", - "op": "Mul", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539018, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_8_grad/mul", - "op": "Mul", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539032, - "dur": 12, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_6_grad/mul", - "op": "Mul", - "input0": "ocnn/depth_4/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539046, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_9_grad/mul", - "op": "Mul", - "input0": "ocnn/depth_3/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539066, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_15_grad/mul", - "op": "Mul", - "input0": "ocnn/fc2/dense/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539080, - "dur": 10, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_7_grad/mul", - "op": "Mul", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539093, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_11_grad/mul", - "op": "Mul", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539106, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_16_grad/mul", - "op": "Mul", - "input0": "ocnn/fc2/dense/bias/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539120, - "dur": 10, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_14_grad/mul", - "op": "Mul", - "input0": "ocnn/fc1/batch_normalization/beta/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539133, - "dur": 10, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_3_grad/mul", - "op": "Mul", - "input0": "ocnn/depth_5/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539146, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_12_grad/mul", - "op": "Mul", - "input0": "ocnn/fc1/dense/kernel/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539161, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_grad/mul", - "op": "Mul", - "input0": "ocnn/depth_6/conv_bn_relu/octree_conv/weights/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539174, - "dur": 11, - "args": { - "name": "solver/gradients/loss/l2_regularizer/L2Loss_4_grad/mul", - "op": "Mul", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/gamma/read", - "input1": "solver/gradients/loss/l2_regularizer/AddN_grad/tuple/control_dependency_15" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DynamicStitch", - "pid": 3, - "tid": 0, - "ts": 1596804868539247, - "dur": 72, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/DynamicStitch", - "op": "DynamicStitch", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/range", - "input1": "solver/step_lr/PiecewiseConstant/case/Const", - "input2": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Shape_2/_31", - "input3": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Fill/_33" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DynamicStitch", - "pid": 3, - "tid": 1, - "ts": 1596804868539315, - "dur": 72, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/DynamicStitch", - "op": "DynamicStitch", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/range", - "input1": "solver/step_lr/PiecewiseConstant/case/Const", - "input2": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Shape_2/_35", - "input3": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Fill/_37" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/range", - "pid": 3, - "tid": 0, - "ts": 1596804868538370, - "id": 23 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/range", - "pid": 3, - "tid": 1, - "ts": 1596804868539315, - "id": 23 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538397, - "id": 24 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/Const", - "pid": 3, - "tid": 1, - "ts": 1596804868539315, - "id": 24 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Shape_2", - "pid": 3, - "tid": 0, - "ts": 1596804868538378, - "id": 25 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Shape_2", - "pid": 3, - "tid": 1, - "ts": 1596804868539315, - "id": 25 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Fill", - "pid": 3, - "tid": 0, - "ts": 1596804868538530, - "id": 26 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Fill", - "pid": 3, - "tid": 1, - "ts": 1596804868539315, - "id": 26 - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd", - "pid": 3, - "tid": 0, - "ts": 1596804868539438, - "dur": 41, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_3", - "op": "LogicalAnd", - "input0": "solver/step_lr/PiecewiseConstant/Greater_4/_15", - "input1": "solver/step_lr/PiecewiseConstant/LessEqual_4/_17" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Maximum", - "pid": 3, - "tid": 1, - "ts": 1596804868539478, - "dur": 34, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Maximum", - "op": "Maximum", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/DynamicStitch/_45", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Maximum/y" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/DynamicStitch", - "pid": 3, - "tid": 0, - "ts": 1596804868539319, - "id": 27 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/DynamicStitch", - "pid": 3, - "tid": 1, - "ts": 1596804868539478, - "id": 27 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Maximum/y", - "pid": 3, - "tid": 0, - "ts": 1596804868538356, - "id": 28 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Maximum/y", - "pid": 3, - "tid": 1, - "ts": 1596804868539478, - "id": 28 - }, - { - "ph": "X", - "cat": "Op", - "name": "FloorDiv", - "pid": 3, - "tid": 0, - "ts": 1596804868539517, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/floordiv", - "op": "FloorDiv", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Shape_2", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Maximum" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Maximum", - "pid": 3, - "tid": 1, - "ts": 1596804868539512, - "id": 29 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Maximum", - "pid": 3, - "tid": 0, - "ts": 1596804868539517, - "id": 29 - }, - { - "ph": "X", - "cat": "Op", - "name": "Maximum", - "pid": 3, - "tid": 0, - "ts": 1596804868539539, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Maximum", - "op": "Maximum", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/DynamicStitch/_49", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Maximum/y" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/DynamicStitch", - "pid": 3, - "tid": 1, - "ts": 1596804868539387, - "id": 30 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/DynamicStitch", - "pid": 3, - "tid": 0, - "ts": 1596804868539539, - "id": 30 - }, - { - "ph": "X", - "cat": "Op", - "name": "FloorDiv", - "pid": 3, - "tid": 0, - "ts": 1596804868539549, - "dur": 25, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/floordiv", - "op": "FloorDiv", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Shape_2", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Maximum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd", - "pid": 3, - "tid": 1, - "ts": 1596804868539569, - "dur": 34, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_2", - "op": "LogicalAnd", - "input0": "solver/step_lr/PiecewiseConstant/Greater_3/_19", - "input1": "solver/step_lr/PiecewiseConstant/LessEqual_3/_21" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_3", - "pid": 3, - "tid": 0, - "ts": 1596804868538605, - "id": 31 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_3", - "pid": 3, - "tid": 1, - "ts": 1596804868539569, - "id": 31 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3", - "pid": 3, - "tid": 0, - "ts": 1596804868538588, - "id": 32 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_3", - "pid": 3, - "tid": 1, - "ts": 1596804868539569, - "id": 32 - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd", - "pid": 3, - "tid": 0, - "ts": 1596804868539669, - "dur": 23, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and_1", - "op": "LogicalAnd", - "input0": "solver/step_lr/PiecewiseConstant/Greater_2/_23", - "input1": "solver/step_lr/PiecewiseConstant/LessEqual_2/_25" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Relu", - "pid": 3, - "tid": 0, - "ts": 1596804868539713, - "dur": 25, - "args": { - "name": "ocnn/fc1/Relu", - "op": "Relu", - "input0": "ocnn/fc1/batch_normalization/batchnorm/add_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LogicalAnd", - "pid": 3, - "tid": 1, - "ts": 1596804868539715, - "dur": 41, - "args": { - "name": "solver/step_lr/PiecewiseConstant/and", - "op": "LogicalAnd", - "input0": "solver/step_lr/PiecewiseConstant/Greater_1/_27", - "input1": "solver/step_lr/PiecewiseConstant/LessEqual_1/_29" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_1", - "pid": 3, - "tid": 0, - "ts": 1596804868538620, - "id": 33 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/Greater_1", - "pid": 3, - "tid": 1, - "ts": 1596804868539715, - "id": 33 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1", - "pid": 3, - "tid": 0, - "ts": 1596804868538643, - "id": 34 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual_1", - "pid": 3, - "tid": 1, - "ts": 1596804868539715, - "id": 34 - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack", - "pid": 3, - "tid": 0, - "ts": 1596804868539762, - "dur": 93, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/preds_c", - "op": "Pack", - "input0": "solver/step_lr/PiecewiseConstant/LessEqual/_39", - "input1": "solver/step_lr/PiecewiseConstant/Greater/_41", - "input2": "solver/step_lr/PiecewiseConstant/and", - "input3": "solver/step_lr/PiecewiseConstant/and_1", - "input4": "solver/step_lr/PiecewiseConstant/and_2", - "input5": "solver/step_lr/PiecewiseConstant/and_3" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and", - "pid": 3, - "tid": 1, - "ts": 1596804868539756, - "id": 35 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and", - "pid": 3, - "tid": 0, - "ts": 1596804868539762, - "id": 35 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_2", - "pid": 3, - "tid": 1, - "ts": 1596804868539603, - "id": 36 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_2", - "pid": 3, - "tid": 0, - "ts": 1596804868539762, - "id": 36 - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast", - "pid": 3, - "tid": 1, - "ts": 1596804868539784, - "dur": 91, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Cast", - "op": "Cast", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/floordiv_1/_43" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/floordiv_1", - "pid": 3, - "tid": 0, - "ts": 1596804868538691, - "id": 37 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/floordiv_1", - "pid": 3, - "tid": 1, - "ts": 1596804868539784, - "id": 37 - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast", - "pid": 3, - "tid": 0, - "ts": 1596804868539865, - "dur": 30, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Cast", - "op": "Cast", - "input0": "solver/step_lr/PiecewiseConstant/case/preds_c" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 1, - "ts": 1596804868539891, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Shape", - "op": "Shape", - "input0": "ocnn/fc1/Relu", - "input1": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn/fc1/Relu", - "pid": 3, - "tid": 0, - "ts": 1596804868539738, - "id": 38 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn/fc1/Relu", - "pid": 3, - "tid": 1, - "ts": 1596804868539891, - "id": 38 - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast", - "pid": 3, - "tid": 2, - "ts": 1596804868539891, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Cast", - "op": "Cast", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/floordiv_1/_47" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/floordiv_1", - "pid": 3, - "tid": 0, - "ts": 1596804868538812, - "id": 39 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/floordiv_1", - "pid": 3, - "tid": 2, - "ts": 1596804868539891, - "id": 39 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868539908, - "dur": 25, - "args": { - "name": "ocnn/fc1/dropout/dropout/mul", - "op": "Mul", - "input0": "ocnn/fc1/Relu", - "input1": "ocnn/full_voxel/dropout/dropout/truediv" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868539936, - "dur": 7, - "args": { - "name": "ocnn/fc1/dropout/dropout/Shape", - "op": "Shape", - "input0": "ocnn/fc1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 3, - "tid": 0, - "ts": 1596804868539947, - "dur": 9, - "args": { - "name": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Shape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Shape", - "pid": 3, - "tid": 1, - "ts": 1596804868539903, - "id": 40 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868539947, - "id": 40 - }, - { - "ph": "X", - "cat": "Op", - "name": "RandomUniform", - "pid": 3, - "tid": 0, - "ts": 1596804868539960, - "dur": 24, - "args": { - "name": "ocnn/fc1/dropout/dropout/random_uniform/RandomUniform", - "op": "RandomUniform", - "input0": "ocnn/fc1/dropout/dropout/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Snapshot", - "pid": 3, - "tid": 0, - "ts": 1596804868539988, - "dur": 5, - "args": { - "name": "ocnn/fc1/dropout/dropout/random_uniform/mul", - "op": "Snapshot", - "input0": "ocnn/fc1/dropout/dropout/random_uniform/RandomUniform" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "GreaterEqual", - "pid": 3, - "tid": 0, - "ts": 1596804868539997, - "dur": 22, - "args": { - "name": "ocnn/fc1/dropout/dropout/GreaterEqual", - "op": "GreaterEqual", - "input0": "ocnn/fc1/dropout/dropout/random_uniform/mul", - "input1": "ocnn/full_voxel/dropout/dropout/rate" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Cast", - "pid": 3, - "tid": 0, - "ts": 1596804868540023, - "dur": 30, - "args": { - "name": "ocnn/fc1/dropout/dropout/Cast", - "op": "Cast", - "input0": "ocnn/fc1/dropout/dropout/GreaterEqual" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868540057, - "dur": 14, - "args": { - "name": "ocnn/fc1/dropout/dropout/mul_1", - "op": "Mul", - "input0": "ocnn/fc1/dropout/dropout/Cast", - "input1": "ocnn/fc1/dropout/dropout/mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 3, - "tid": 1, - "ts": 1596804868540053, - "dur": 23, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/num_true_conds", - "op": "Sum", - "input0": "solver/step_lr/PiecewiseConstant/case/Cast/_51", - "input1": "solver/step_lr/PiecewiseConstant/case/Const" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/Cast", - "pid": 3, - "tid": 0, - "ts": 1596804868539895, - "id": 41 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/Cast", - "pid": 3, - "tid": 1, - "ts": 1596804868540053, - "id": 41 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/Const", - "pid": 3, - "tid": 0, - "ts": 1596804868538397, - "id": 42 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/Const", - "pid": 3, - "tid": 1, - "ts": 1596804868540053, - "id": 42 - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868540074, - "dur": 16, - "args": { - "name": "ocnn/fc2/flatten/Shape", - "op": "Shape", - "input0": "ocnn/fc1/dropout/dropout/mul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "LessEqual", - "pid": 3, - "tid": 0, - "ts": 1596804868540094, - "dur": 13, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/LessEqual", - "op": "LessEqual", - "input0": "solver/step_lr/PiecewiseConstant/case/num_true_conds", - "input1": "solver/step_lr/PiecewiseConstant/case/n_true_conds" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/num_true_conds", - "pid": 3, - "tid": 1, - "ts": 1596804868540076, - "id": 43 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/num_true_conds", - "pid": 3, - "tid": 0, - "ts": 1596804868540094, - "id": 43 - }, - { - "ph": "X", - "cat": "Op", - "name": "StridedSlice", - "pid": 3, - "tid": 1, - "ts": 1596804868540094, - "dur": 17, - "args": { - "name": "ocnn/fc2/flatten/strided_slice", - "op": "StridedSlice", - "input0": "ocnn/fc2/flatten/Shape", - "input1": "ocnn/fc1/batch_normalization/moments/variance/reduction_indices", - "input2": "ocnn/fc1/flatten/strided_slice/stack_2", - "input3": "ocnn/fc1/flatten/strided_slice/stack_2" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn/fc2/flatten/Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868540090, - "id": 44 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn/fc2/flatten/Shape", - "pid": 3, - "tid": 1, - "ts": 1596804868540094, - "id": 44 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn/fc1/batch_normalization/moments/variance/reduction_indices", - "pid": 3, - "tid": 0, - "ts": 1596804868498438, - "id": 45 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn/fc1/batch_normalization/moments/variance/reduction_indices", - "pid": 3, - "tid": 1, - "ts": 1596804868540094, - "id": 45 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn/fc1/flatten/strided_slice/stack_2", - "pid": 3, - "tid": 0, - "ts": 1596804868487594, - "id": 46 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn/fc1/flatten/strided_slice/stack_2", - "pid": 3, - "tid": 1, - "ts": 1596804868540094, - "id": 46 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn/fc1/flatten/strided_slice/stack_2", - "pid": 3, - "tid": 0, - "ts": 1596804868487594, - "id": 47 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn/fc1/flatten/strided_slice/stack_2", - "pid": 3, - "tid": 1, - "ts": 1596804868540094, - "id": 47 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540111, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/case/LessEqual", - "input1": "solver/step_lr/PiecewiseConstant/case/LessEqual" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540120, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Assert/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/case/preds_c/_53", - "input1": "solver/step_lr/PiecewiseConstant/case/LessEqual" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Pack", - "pid": 3, - "tid": 1, - "ts": 1596804868540115, - "dur": 11, - "args": { - "name": "ocnn/fc2/flatten/Reshape/shape", - "op": "Pack", - "input0": "ocnn/fc2/flatten/strided_slice", - "input1": "ocnn/fc1/flatten/Reshape/shape/1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn/fc1/flatten/Reshape/shape/1", - "pid": 3, - "tid": 0, - "ts": 1596804868487513, - "id": 48 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn/fc1/flatten/Reshape/shape/1", - "pid": 3, - "tid": 1, - "ts": 1596804868540115, - "id": 48 - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 0, - "ts": 1596804868540128, - "dur": 6, - "args": { - "name": "ConstantFoldingCtrl/solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch_1", - "op": "Identity", - "input0": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 1, - "ts": 1596804868540129, - "dur": 7, - "args": { - "name": "ocnn/fc2/flatten/Reshape", - "op": "Reshape", - "input0": "ocnn/fc1/dropout/dropout/mul_1", - "input1": "ocnn/fc2/flatten/Reshape/shape" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn/fc1/dropout/dropout/mul_1", - "pid": 3, - "tid": 0, - "ts": 1596804868540071, - "id": 49 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn/fc1/dropout/dropout/mul_1", - "pid": 3, - "tid": 1, - "ts": 1596804868540129, - "id": 49 - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868540139, - "dur": 10, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/control_dependency", - "op": "Const", - "input0": "^ConstantFoldingCtrl/solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Switch_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Merge", - "pid": 3, - "tid": 0, - "ts": 1596804868540154, - "dur": 14, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Merge", - "op": "Merge", - "input0": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/control_dependency_1", - "input1": "solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/control_dependency" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 3, - "tid": 1, - "ts": 1596804868540139, - "dur": 32, - "args": { - "name": "ocnn/fc2/dense/MatMul", - "op": "MatMul", - "input0": "ocnn/fc2/flatten/Reshape", - "input1": "ocnn/fc2/dense/kernel/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn/fc2/dense/kernel/read", - "pid": 3, - "tid": 0, - "ts": 1596804868498696, - "id": 50 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn/fc2/dense/kernel/read", - "pid": 3, - "tid": 1, - "ts": 1596804868540139, - "id": 50 - }, - { - "ph": "X", - "cat": "Op", - "name": "BiasAdd", - "pid": 3, - "tid": 0, - "ts": 1596804868540174, - "dur": 30, - "args": { - "name": "ocnn/fc2/dense/BiasAdd", - "op": "BiasAdd", - "input0": "ocnn/fc2/dense/MatMul", - "input1": "ocnn/fc2/dense/bias/read" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn/fc2/dense/MatMul", - "pid": 3, - "tid": 1, - "ts": 1596804868540171, - "id": 51 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn/fc2/dense/MatMul", - "pid": 3, - "tid": 0, - "ts": 1596804868540174, - "id": 51 - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868540207, - "dur": 7, - "args": { - "name": "solver/gradients/loss/Reshape_grad/Shape", - "op": "Shape", - "input0": "ocnn/fc2/dense/BiasAdd", - "input1": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input2": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input6": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868540218, - "dur": 6, - "args": { - "name": "loss/Reshape", - "op": "Reshape", - "input0": "ocnn/fc2/dense/BiasAdd", - "input1": "loss/Reshape/shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868540228, - "dur": 6, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape", - "op": "Shape", - "input0": "loss/Reshape", - "input1": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input5": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 3, - "tid": 1, - "ts": 1596804868540230, - "dur": 9, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "op": "Identity", - "input0": "solver/step_lr/PiecewiseConstant/LessEqual", - "input1": "^solver/step_lr/PiecewiseConstant/case/Assert/AssertGuard/Merge" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual", - "pid": 3, - "tid": 0, - "ts": 1596804868538628, - "id": 52 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/LessEqual", - "pid": 3, - "tid": 1, - "ts": 1596804868540230, - "id": 52 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540245, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/and_3/_67", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 1, - "ts": 1596804868540239, - "id": 53 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 0, - "ts": 1596804868540245, - "id": 53 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540256, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_5", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 1, - "ts": 1596804868540239, - "id": 54 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 0, - "ts": 1596804868540256, - "id": 54 - }, - { - "ph": "X", - "cat": "Op", - "name": "SquaredDifference", - "pid": 3, - "tid": 2, - "ts": 1596804868540239, - "dur": 24, - "args": { - "name": "loss/mse_loss/mean_squared_error/SquaredDifference", - "op": "SquaredDifference", - "input0": "IteratorGetNext/_69", - "input1": "loss/Reshape" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 55 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 2, - "ts": 1596804868540239, - "id": 55 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868540224, - "id": 56 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/Reshape", - "pid": 3, - "tid": 2, - "ts": 1596804868540239, - "id": 56 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540266, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/and/_61", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and", - "pid": 3, - "tid": 1, - "ts": 1596804868539756, - "id": 57 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and", - "pid": 3, - "tid": 0, - "ts": 1596804868540266, - "id": 57 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 1, - "ts": 1596804868540239, - "id": 58 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 0, - "ts": 1596804868540266, - "id": 58 - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 3, - "tid": 1, - "ts": 1596804868540268, - "dur": 14, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1/_71" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868540234, - "id": 59 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape", - "pid": 3, - "tid": 1, - "ts": 1596804868540268, - "id": 59 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1", - "pid": 5, - "tid": 0, - "ts": 1596804868538977, - "id": 60 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1", - "pid": 3, - "tid": 1, - "ts": 1596804868540268, - "id": 60 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540273, - "dur": 14, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/and_1/_63", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 1, - "ts": 1596804868540239, - "id": 61 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 0, - "ts": 1596804868540273, - "id": 61 - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 1, - "ts": 1596804868540287, - "dur": 6, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape", - "op": "Shape", - "input0": "loss/mse_loss/mean_squared_error/SquaredDifference", - "input1": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input4": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input7": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input8": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input9": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input10": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/SquaredDifference", - "pid": 3, - "tid": 2, - "ts": 1596804868540263, - "id": 62 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/SquaredDifference", - "pid": 3, - "tid": 1, - "ts": 1596804868540287, - "id": 62 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540290, - "dur": 6, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Greater", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 1, - "ts": 1596804868540239, - "id": 63 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 0, - "ts": 1596804868540290, - "id": 63 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540298, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_6", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 1, - "ts": 1596804868540239, - "id": 64 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 0, - "ts": 1596804868540298, - "id": 64 - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 1, - "ts": 1596804868540297, - "dur": 6, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Shape", - "op": "Shape", - "input0": "loss/mse_loss/mean_squared_error/SquaredDifference" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/SquaredDifference", - "pid": 3, - "tid": 2, - "ts": 1596804868540263, - "id": 65 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/SquaredDifference", - "pid": 3, - "tid": 1, - "ts": 1596804868540297, - "id": 65 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540305, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_7", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 1, - "ts": 1596804868540239, - "id": 66 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 0, - "ts": 1596804868540305, - "id": 66 - }, - { - "ph": "X", - "cat": "Op", - "name": "Snapshot", - "pid": 3, - "tid": 1, - "ts": 1596804868540307, - "dur": 5, - "args": { - "name": "loss/mse_loss/mean_squared_error/Mul", - "op": "Snapshot", - "input0": "loss/mse_loss/mean_squared_error/SquaredDifference" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/SquaredDifference", - "pid": 3, - "tid": 2, - "ts": 1596804868540263, - "id": 67 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/SquaredDifference", - "pid": 3, - "tid": 1, - "ts": 1596804868540307, - "id": 67 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540311, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/Switch/Switch", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/and_2/_65", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_2", - "pid": 3, - "tid": 1, - "ts": 1596804868539603, - "id": 68 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/and_2", - "pid": 3, - "tid": 0, - "ts": 1596804868540311, - "id": 68 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 1, - "ts": 1596804868540239, - "id": 69 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 0, - "ts": 1596804868540311, - "id": 69 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540318, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_10", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 1, - "ts": 1596804868540239, - "id": 70 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 0, - "ts": 1596804868540318, - "id": 70 - }, - { - "ph": "X", - "cat": "Op", - "name": "BroadcastGradientArgs", - "pid": 3, - "tid": 1, - "ts": 1596804868540315, - "dur": 9, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/BroadcastGradientArgs", - "op": "BroadcastGradientArgs", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape_1" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape_1", - "pid": 3, - "tid": 0, - "ts": 1596804868538322, - "id": 71 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape_1", - "pid": 3, - "tid": 1, - "ts": 1596804868540315, - "id": 71 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540323, - "dur": 4, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_8", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 1, - "ts": 1596804868540239, - "id": 72 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 0, - "ts": 1596804868540323, - "id": 72 - }, - { - "ph": "X", - "cat": "Op", - "name": "Switch", - "pid": 3, - "tid": 0, - "ts": 1596804868540329, - "dur": 5, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/cond/cond/cond/cond/cond/Switch_1", - "op": "Switch", - "input0": "solver/step_lr/PiecewiseConstant/Const_9", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/pred_id" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 1, - "ts": 1596804868540239, - "id": 73 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/pred_id", - "pid": 3, - "tid": 0, - "ts": 1596804868540329, - "id": 73 - }, - { - "ph": "X", - "cat": "Op", - "name": "Merge", - "pid": 3, - "tid": 0, - "ts": 1596804868540337, - "dur": 15, - "args": { - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "op": "Merge", - "input0": "solver/step_lr/PiecewiseConstant/case/cond/cond/Merge", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/Switch_1:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Fill", - "pid": 3, - "tid": 1, - "ts": 1596804868540327, - "dur": 27, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like", - "op": "Fill", - "input0": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Shape", - "input1": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Const" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Const", - "pid": 3, - "tid": 0, - "ts": 1596804868487555, - "id": 74 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like/Const", - "pid": 3, - "tid": 1, - "ts": 1596804868540327, - "id": 74 - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868540358, - "dur": 7, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Shape", - "op": "Shape", - "input0": "loss/mse_loss/mean_squared_error/Mul", - "input1": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input2": "^ocnn/fc1/batch_normalization/AssignMovingAvg", - "input3": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input4": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input5": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input6": "^ocnn/depth_4/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input7": "^ocnn/depth_5/conv_bn_relu/batch_normalization/AssignMovingAvg_1", - "input8": "^ocnn/fc1/batch_normalization/AssignMovingAvg_1", - "input9": "^ocnn/depth_6/conv_bn_relu/batch_normalization/AssignMovingAvg", - "input10": "^ocnn/depth_3/conv_bn_relu/batch_normalization/AssignMovingAvg" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/Mul", - "pid": 3, - "tid": 1, - "ts": 1596804868540312, - "id": 75 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868540358, - "id": 75 - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 3, - "tid": 0, - "ts": 1596804868540369, - "dur": 29, - "args": { - "name": "loss/mse_loss/mean_squared_error/Sum", - "op": "Sum", - "input0": "loss/mse_loss/mean_squared_error/Mul", - "input1": "ocnn/fc1/batch_normalization/moments/variance/reduction_indices" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/Mul", - "pid": 3, - "tid": 1, - "ts": 1596804868540312, - "id": 76 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868540369, - "id": 76 - }, - { - "ph": "X", - "cat": "Op", - "name": "Snapshot", - "pid": 3, - "tid": 0, - "ts": 1596804868540401, - "dur": 5, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights", - "op": "Snapshot", - "input0": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like", - "pid": 3, - "tid": 1, - "ts": 1596804868540354, - "id": 77 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights/ones_like", - "pid": 3, - "tid": 0, - "ts": 1596804868540401, - "id": 77 - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 3, - "tid": 0, - "ts": 1596804868540409, - "dur": 15, - "args": { - "name": "loss/mse_loss/mean_squared_error/num_present", - "op": "Sum", - "input0": "loss/mse_loss/mean_squared_error/num_present/broadcast_weights", - "input1": "ocnn/fc1/batch_normalization/moments/variance/reduction_indices" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DivNoNan", - "pid": 3, - "tid": 0, - "ts": 1596804868540428, - "dur": 18, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan", - "op": "DivNoNan", - "input0": "solver/gradients/add_grad/tuple/control_dependency", - "input1": "loss/mse_loss/mean_squared_error/num_present" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "DivNoNan", - "pid": 3, - "tid": 0, - "ts": 1596804868540449, - "dur": 12, - "args": { - "name": "loss/mse_loss/mean_squared_error/value", - "op": "DivNoNan", - "input0": "loss/mse_loss/mean_squared_error/Sum", - "input1": "loss/mse_loss/mean_squared_error/num_present" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868540464, - "dur": 5, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/value_grad/div_no_nan", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape/shape", - "input2": "^loss/mse_loss/mean_squared_error/Sum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Add", - "pid": 3, - "tid": 0, - "ts": 1596804868540472, - "dur": 15, - "args": { - "name": "add", - "op": "Add", - "input0": "loss/l2_regularizer/mul", - "input1": "loss/mse_loss/mean_squared_error/value" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Tile", - "pid": 3, - "tid": 0, - "ts": 1596804868540536, - "dur": 22, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile", - "op": "Tile", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Reshape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Snapshot", - "pid": 3, - "tid": 0, - "ts": 1596804868540594, - "dur": 7, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Mul", - "op": "Snapshot", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Sum_grad/Tile" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 3, - "tid": 0, - "ts": 1596804868540604, - "dur": 5, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Mul", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/BroadcastGradientArgs" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/BroadcastGradientArgs", - "pid": 3, - "tid": 1, - "ts": 1596804868540324, - "id": 78 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/BroadcastGradientArgs", - "pid": 3, - "tid": 0, - "ts": 1596804868540604, - "id": 78 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868540613, - "dur": 5, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Sum", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape", - "pid": 3, - "tid": 1, - "ts": 1596804868540293, - "id": 79 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868540613, - "id": 79 - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868540621, - "dur": 15, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/sub", - "op": "Sub", - "input0": "loss/Reshape", - "input1": "IteratorGetNext/_69", - "input2": "^solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 80 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868540621, - "id": 80 - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868540639, - "dur": 6, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/scalar", - "op": "Const", - "input0": "^solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868540648, - "dur": 13, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Mul", - "op": "Mul", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/Mul_grad/Reshape", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/scalar" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868540664, - "dur": 13, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/mul_1", - "op": "Mul", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Mul", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 3, - "tid": 0, - "ts": 1596804868540681, - "dur": 5, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/mul_1", - "input1": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/BroadcastGradientArgs" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/BroadcastGradientArgs", - "pid": 3, - "tid": 1, - "ts": 1596804868540282, - "id": 81 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/BroadcastGradientArgs", - "pid": 3, - "tid": 0, - "ts": 1596804868540681, - "id": 81 - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868540689, - "dur": 5, - "args": { - "name": "solver/gradients/loss/Reshape_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Sum", - "input1": "solver/gradients/loss/Reshape_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "BiasAddGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868540697, - "dur": 29, - "args": { - "name": "solver/gradients/ocnn/fc2/dense/BiasAdd_grad/BiasAddGrad", - "op": "BiasAddGrad", - "input0": "solver/gradients/loss/Reshape_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 3, - "tid": 0, - "ts": 1596804868540730, - "dur": 24, - "args": { - "name": "solver/gradients/ocnn/fc2/dense/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn/fc2/flatten/Reshape", - "input1": "solver/gradients/loss/Reshape_grad/Reshape", - "input2": "^solver/gradients/ocnn/fc2/dense/BiasAdd_grad/BiasAddGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "ocnn/fc2/flatten/Reshape", - "pid": 3, - "tid": 1, - "ts": 1596804868540136, - "id": 82 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "ocnn/fc2/flatten/Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868540730, - "id": 82 - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 3, - "tid": 0, - "ts": 1596804868540758, - "dur": 21, - "args": { - "name": "solver/gradients/ocnn/fc2/dense/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/loss/Reshape_grad/Reshape", - "input1": "ocnn/fc2/dense/kernel/read", - "input2": "^solver/gradients/ocnn/fc2/dense/BiasAdd_grad/BiasAddGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868540782, - "dur": 17, - "args": { - "name": "solver/gradients/AddN", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_16_grad/mul", - "input1": "solver/gradients/ocnn/fc2/dense/BiasAdd_grad/BiasAddGrad" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868540802, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn/fc1/dropout/dropout/mul_1_grad/Mul", - "op": "Mul", - "input0": "ocnn/full_voxel/dropout/dropout/truediv", - "input1": "solver/gradients/ocnn/fc2/dense/MatMul_grad/MatMul", - "input2": "^solver/gradients/ocnn/fc2/dense/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868540819, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_1", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_15_grad/mul", - "input1": "solver/gradients/ocnn/fc2/dense/MatMul_grad/MatMul_1", - "input2": "^solver/gradients/ocnn/fc2/dense/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868540837, - "dur": 26, - "args": { - "name": "solver/Momentum/update_ocnn/fc2/dense/bias/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/fc2/dense/bias", - "input1": "ocnn/fc2/dense/bias/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868540866, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Mul", - "op": "Mul", - "input0": "ocnn/fc1/dropout/dropout/Cast", - "input1": "solver/gradients/ocnn/fc1/dropout/dropout/mul_1_grad/Mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868540882, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn/fc2/dense/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/fc2/dense/kernel", - "input1": "ocnn/fc2/dense/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_1", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 3, - "tid": 0, - "ts": 1596804868540905, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Mul", - "input1": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868540914, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Sum", - "input1": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Shape" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Shape", - "pid": 3, - "tid": 1, - "ts": 1596804868539903, - "id": 83 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Shape", - "pid": 3, - "tid": 0, - "ts": 1596804868540914, - "id": 83 - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868540922, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn/fc1/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn/fc1/dropout/dropout/mul_grad/Reshape", - "input1": "ocnn/fc1/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 3, - "tid": 0, - "ts": 1596804868540940, - "dur": 19, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Sum_1", - "op": "Sum", - "input0": "solver/gradients/ocnn/fc1/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/BroadcastGradientArgs:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 3, - "tid": 0, - "ts": 1596804868540962, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn/fc1/Relu_grad/ReluGrad", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868540970, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Reshape_1", - "op": "Reshape", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Sum_1", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868540978, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Sum", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "NoOp", - "pid": 3, - "tid": 0, - "ts": 1596804868540986, - "dur": 3, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/tuple/group_deps", - "op": "NoOp", - "input0": "^solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Reshape", - "input1": "^solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Reshape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Neg", - "pid": 3, - "tid": 0, - "ts": 1596804868540992, - "dur": 15, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/sub_grad/Neg", - "op": "Neg", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Reshape_1", - "input1": "^solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/tuple/group_deps" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868541010, - "dur": 17, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Mul", - "op": "Mul", - "input0": "ocnn/fc1/batch_normalization/batchnorm/mul", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Reshape", - "input2": "^solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/tuple/group_deps" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868541029, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Mul_1", - "op": "Mul", - "input0": "ocnn/fc1/dense/MatMul", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Reshape", - "input2": "^solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/tuple/group_deps" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868541044, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_2_grad/Mul_1", - "op": "Mul", - "input0": "ocnn/fc1/batch_normalization/moments/Squeeze", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/sub_grad/Neg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868541060, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_2_grad/Mul", - "op": "Mul", - "input0": "ocnn/fc1/batch_normalization/batchnorm/mul", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/sub_grad/Neg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868541075, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_2", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_14_grad/mul", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Reshape_1", - "input2": "^solver/gradients/ocnn/fc1/batch_normalization/batchnorm/sub_grad/Neg" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 3, - "tid": 0, - "ts": 1596804868541090, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Mul", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 3, - "tid": 0, - "ts": 1596804868541098, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Sum_1", - "op": "Sum", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Mul_1", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/BroadcastGradientArgs:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868541117, - "dur": 7, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_2_grad/Mul", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/DynamicStitch/_45", - "input2": "^solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_2_grad/Mul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868541127, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn/fc1/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/fc1/batch_normalization/beta", - "input1": "ocnn/fc1/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_2", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868541151, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Sum", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Shape_2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868541159, - "dur": 4, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Reshape_1", - "op": "Reshape", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Sum_1", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/add_1_grad/Shape_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Tile", - "pid": 3, - "tid": 0, - "ts": 1596804868541166, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Tile", - "op": "Tile", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Reshape", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/floordiv" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868541187, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_3", - "op": "AddN", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Reshape_1", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_2_grad/Mul_1", - "input2": "^solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Reshape", - "input3": "^solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_2_grad/Mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "RealDiv", - "pid": 3, - "tid": 0, - "ts": 1596804868541206, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/truediv", - "op": "RealDiv", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Tile", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Cast" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Cast", - "pid": 3, - "tid": 1, - "ts": 1596804868539875, - "id": 84 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Cast", - "pid": 3, - "tid": 0, - "ts": 1596804868541206, - "id": 84 - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868541226, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_grad/Mul_1", - "op": "Mul", - "input0": "ocnn/fc1/batch_normalization/batchnorm/Rsqrt", - "input1": "solver/gradients/AddN_3" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868541241, - "dur": 12, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_grad/Mul", - "op": "Mul", - "input0": "ocnn/fc1/batch_normalization/gamma/read", - "input1": "solver/gradients/AddN_3" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "RsqrtGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868541256, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/Rsqrt_grad/RsqrtGrad", - "op": "RsqrtGrad", - "input0": "ocnn/fc1/batch_normalization/batchnorm/Rsqrt", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_grad/Mul", - "input2": "^solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_grad/Mul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868541276, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_4", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_13_grad/mul", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_grad/Mul_1", - "input2": "^solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_grad/Mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868541291, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/Rsqrt_grad/RsqrtGrad", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/DynamicStitch/_49" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/DynamicStitch", - "pid": 3, - "tid": 1, - "ts": 1596804868539387, - "id": 85 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/DynamicStitch", - "pid": 3, - "tid": 0, - "ts": 1596804868541291, - "id": 85 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868541300, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn/fc1/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/fc1/batch_normalization/gamma", - "input1": "ocnn/fc1/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_4", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Tile", - "pid": 3, - "tid": 0, - "ts": 1596804868541323, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Tile", - "op": "Tile", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Reshape", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/floordiv" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "RealDiv", - "pid": 3, - "tid": 0, - "ts": 1596804868541342, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/truediv", - "op": "RealDiv", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Tile", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Cast" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Cast", - "pid": 3, - "tid": 2, - "ts": 1596804868539910, - "id": 86 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/Cast", - "pid": 3, - "tid": 0, - "ts": 1596804868541342, - "id": 86 - }, - { - "ph": "X", - "cat": "Op", - "name": "Sub", - "pid": 3, - "tid": 0, - "ts": 1596804868541360, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/sub", - "op": "Sub", - "input0": "ocnn/fc1/dense/MatMul", - "input1": "ocnn/fc1/batch_normalization/moments/mean", - "input2": "^solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/truediv" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868541379, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/scalar", - "op": "Const", - "input0": "^solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/truediv" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868541387, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/Mul", - "op": "Mul", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/scalar", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/variance_grad/truediv" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868541403, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/mul_1", - "op": "Mul", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/Mul", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/sub" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 3, - "tid": 0, - "ts": 1596804868541419, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/mul_1", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868541427, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/Sum", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/Shape_2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868541435, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_5", - "op": "AddN", - "input0": "solver/gradients/ocnn/fc1/batch_normalization/batchnorm/mul_1_grad/Reshape", - "input1": "solver/gradients/ocnn/fc1/batch_normalization/moments/SquaredDifference_grad/Reshape", - "input2": "solver/gradients/ocnn/fc1/batch_normalization/moments/mean_grad/truediv" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 3, - "tid": 0, - "ts": 1596804868541456, - "dur": 23, - "args": { - "name": "solver/gradients/ocnn/fc1/dense/MatMul_grad/MatMul_1", - "op": "MatMul", - "input0": "ocnn/fc1/flatten/Reshape", - "input1": "solver/gradients/AddN_5" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "MatMul", - "pid": 3, - "tid": 0, - "ts": 1596804868541487, - "dur": 18, - "args": { - "name": "solver/gradients/ocnn/fc1/dense/MatMul_grad/MatMul", - "op": "MatMul", - "input0": "solver/gradients/AddN_5", - "input1": "ocnn/fc1/dense/kernel/read" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868541512, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn/fc1/flatten/Reshape_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn/fc1/dense/MatMul_grad/MatMul", - "input1": "solver/gradients/ocnn/fc1/flatten/Reshape_grad/Shape", - "input2": "^solver/gradients/ocnn/fc1/dense/MatMul_grad/MatMul_1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868541520, - "dur": 14, - "args": { - "name": "solver/gradients/AddN_6", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_12_grad/mul", - "input1": "solver/gradients/ocnn/fc1/dense/MatMul_grad/MatMul_1", - "input2": "^solver/gradients/ocnn/fc1/dense/MatMul_grad/MatMul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868541537, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_1_grad/Mul", - "op": "Mul", - "input0": "ocnn/full_voxel/dropout/dropout/truediv", - "input1": "solver/gradients/ocnn/fc1/flatten/Reshape_grad/Reshape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868541554, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn/fc1/dense/kernel/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/fc1/dense/kernel", - "input1": "ocnn/fc1/dense/kernel/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_6", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Mul", - "pid": 3, - "tid": 0, - "ts": 1596804868541578, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_grad/Mul", - "op": "Mul", - "input0": "ocnn/full_voxel/dropout/dropout/Cast", - "input1": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_1_grad/Mul" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Sum", - "pid": 3, - "tid": 0, - "ts": 1596804868541596, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_grad/Sum", - "op": "Sum", - "input0": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_grad/Mul", - "input1": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_grad/BroadcastGradientArgs" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868541604, - "dur": 5, - "args": { - "name": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_grad/Sum", - "input1": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Transpose", - "pid": 3, - "tid": 0, - "ts": 1596804868541613, - "dur": 22, - "args": { - "name": "solver/gradients/ocnn/full_voxel/octree_full_voxel/transpose_grad/transpose", - "op": "Transpose", - "input0": "solver/gradients/ocnn/full_voxel/dropout/dropout/mul_grad/Reshape", - "input1": "solver/gradients/ocnn/full_voxel/octree_full_voxel/transpose_grad/InvertPermutation" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Reshape", - "pid": 3, - "tid": 0, - "ts": 1596804868541652, - "dur": 6, - "args": { - "name": "solver/gradients/ocnn/full_voxel/octree_full_voxel/Reshape_grad/Reshape", - "op": "Reshape", - "input0": "solver/gradients/ocnn/full_voxel/octree_full_voxel/transpose_grad/transpose", - "input1": "solver/gradients/ocnn/full_voxel/octree_full_voxel/Reshape_grad/Shape" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad", - "pid": 3, - "tid": 0, - "ts": 1596804868541662, - "dur": 50, - "args": { - "name": "solver/gradients/ocnn/depth_3/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad", - "input0": "solver/gradients/ocnn/full_voxel/octree_full_voxel/Reshape_grad/Reshape", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 87 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868541662, - "id": 87 - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool", - "pid": 3, - "tid": 0, - "ts": 1596804868541719, - "dur": 47, - "args": { - "name": "solver/gradients/ocnn/depth_3/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool", - "input0": "solver/gradients/ocnn/depth_3/octree_max_pool/OctreePad_grad/OctreeDepad", - "input1": "ocnn/depth_3/octree_max_pool/OctreeMaxPool:1", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 88 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868541719, - "id": 88 - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868541773, - "dur": 16, - "args": { - "name": "solver/gradients/ocnn/depth_3/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn/depth_3/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "input1": "ocnn/depth_3/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868541793, - "dur": 75, - "args": { - "name": "solver/gradients/ocnn/depth_3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn/depth_3/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn/depth_3/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn/depth_3/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn/depth_3/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn/depth_3/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868541876, - "dur": 127, - "args": { - "name": "solver/gradients/ocnn/depth_3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn/depth_4/octree_max_pool/OctreePad", - "input1": "ocnn/depth_3/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn/depth_3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 89 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868541876, - "id": 89 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868542012, - "dur": 17, - "args": { - "name": "solver/gradients/AddN_7", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_10_grad/mul", - "input1": "solver/gradients/ocnn/depth_3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868542033, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_8", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_11_grad/mul", - "input1": "solver/gradients/ocnn/depth_3/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad", - "pid": 3, - "tid": 0, - "ts": 1596804868542049, - "dur": 708, - "args": { - "name": "solver/gradients/ocnn/depth_4/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad", - "input0": "solver/gradients/ocnn/depth_3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 90 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868542049, - "id": 90 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868542763, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_9", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_9_grad/mul", - "input1": "solver/gradients/ocnn/depth_3/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868542781, - "dur": 22, - "args": { - "name": "solver/Momentum/update_ocnn/depth_3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn/depth_3/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_7", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868542806, - "dur": 17, - "args": { - "name": "solver/Momentum/update_ocnn/depth_3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/depth_3/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn/depth_3/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_8", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool", - "pid": 3, - "tid": 0, - "ts": 1596804868542825, - "dur": 39, - "args": { - "name": "solver/gradients/ocnn/depth_4/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool", - "input0": "solver/gradients/ocnn/depth_4/octree_max_pool/OctreePad_grad/OctreeDepad", - "input1": "ocnn/depth_4/octree_max_pool/OctreeMaxPool:1", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 91 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868542825, - "id": 91 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868542870, - "dur": 19, - "args": { - "name": "solver/Momentum/update_ocnn/depth_3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/depth_3/conv_bn_relu/octree_conv/weights", - "input1": "ocnn/depth_3/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_9", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868542892, - "dur": 13, - "args": { - "name": "solver/gradients/ocnn/depth_4/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn/depth_4/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "input1": "ocnn/depth_4/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868542908, - "dur": 54, - "args": { - "name": "solver/gradients/ocnn/depth_4/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn/depth_4/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn/depth_4/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn/depth_4/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn/depth_4/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn/depth_4/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868542969, - "dur": 140, - "args": { - "name": "solver/gradients/ocnn/depth_4/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn/depth_5/octree_max_pool/OctreePad", - "input1": "ocnn/depth_4/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn/depth_4/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 92 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868542969, - "id": 92 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868543116, - "dur": 16, - "args": { - "name": "solver/gradients/AddN_10", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_7_grad/mul", - "input1": "solver/gradients/ocnn/depth_4/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868543135, - "dur": 11, - "args": { - "name": "solver/gradients/AddN_11", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_8_grad/mul", - "input1": "solver/gradients/ocnn/depth_4/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad", - "pid": 3, - "tid": 0, - "ts": 1596804868543149, - "dur": 1179, - "args": { - "name": "solver/gradients/ocnn/depth_5/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad", - "input0": "solver/gradients/ocnn/depth_4/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 93 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868543149, - "id": 93 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868544335, - "dur": 18, - "args": { - "name": "solver/gradients/AddN_12", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_6_grad/mul", - "input1": "solver/gradients/ocnn/depth_4/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868544356, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn/depth_4/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn/depth_4/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_10", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868544380, - "dur": 17, - "args": { - "name": "solver/Momentum/update_ocnn/depth_4/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/depth_4/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn/depth_4/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_11", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool", - "pid": 3, - "tid": 0, - "ts": 1596804868544400, - "dur": 43, - "args": { - "name": "solver/gradients/ocnn/depth_5/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool", - "input0": "solver/gradients/ocnn/depth_5/octree_max_pool/OctreePad_grad/OctreeDepad", - "input1": "ocnn/depth_5/octree_max_pool/OctreeMaxPool:1", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 94 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868544400, - "id": 94 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868544449, - "dur": 18, - "args": { - "name": "solver/Momentum/update_ocnn/depth_4/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/depth_4/conv_bn_relu/octree_conv/weights", - "input1": "ocnn/depth_4/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_12", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868544471, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn/depth_5/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn/depth_5/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "input1": "ocnn/depth_5/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868544488, - "dur": 55, - "args": { - "name": "solver/gradients/ocnn/depth_5/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn/depth_5/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn/depth_5/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn/depth_5/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn/depth_5/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn/depth_5/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868544550, - "dur": 13, - "args": { - "name": "solver/gradients/AddN_14", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_5_grad/mul", - "input1": "solver/gradients/ocnn/depth_5/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868544566, - "dur": 338, - "args": { - "name": "solver/gradients/ocnn/depth_5/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn/depth_6/octree_max_pool/OctreePad", - "input1": "ocnn/depth_5/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn/depth_5/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 95 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868544566, - "id": 95 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868544911, - "dur": 15, - "args": { - "name": "solver/gradients/AddN_13", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_4_grad/mul", - "input1": "solver/gradients/ocnn/depth_5/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868544929, - "dur": 19, - "args": { - "name": "solver/Momentum/update_ocnn/depth_5/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn/depth_5/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_14", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeDepad", - "pid": 3, - "tid": 0, - "ts": 1596804868544950, - "dur": 3704, - "args": { - "name": "solver/gradients/ocnn/depth_6/octree_max_pool/OctreePad_grad/OctreeDepad", - "op": "OctreeDepad", - "input0": "solver/gradients/ocnn/depth_5/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "input1": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 96 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868544950, - "id": 96 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868548665, - "dur": 21, - "args": { - "name": "solver/gradients/AddN_15", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_3_grad/mul", - "input1": "solver/gradients/ocnn/depth_5/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868548689, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn/depth_5/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/depth_5/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn/depth_5/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_13", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeMaxUnpool", - "pid": 3, - "tid": 0, - "ts": 1596804868548713, - "dur": 45, - "args": { - "name": "solver/gradients/ocnn/depth_6/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "op": "OctreeMaxUnpool", - "input0": "solver/gradients/ocnn/depth_6/octree_max_pool/OctreePad_grad/OctreeDepad", - "input1": "ocnn/depth_6/octree_max_pool/OctreeMaxPool:1", - "input2": "IteratorGetNext/_5" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 97 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868548713, - "id": 97 - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868548765, - "dur": 20, - "args": { - "name": "solver/Momentum/update_ocnn/depth_5/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/depth_5/conv_bn_relu/octree_conv/weights", - "input1": "ocnn/depth_5/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_15", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ReluGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868548788, - "dur": 14, - "args": { - "name": "solver/gradients/ocnn/depth_6/conv_bn_relu/Relu_grad/ReluGrad", - "op": "ReluGrad", - "input0": "solver/gradients/ocnn/depth_6/octree_max_pool/OctreeMaxPool_grad/OctreeMaxUnpool", - "input1": "ocnn/depth_6/conv_bn_relu/Relu" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "FusedBatchNormGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868548805, - "dur": 56, - "args": { - "name": "solver/gradients/ocnn/depth_6/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad", - "op": "FusedBatchNormGrad", - "input0": "solver/gradients/ocnn/depth_6/conv_bn_relu/Relu_grad/ReluGrad", - "input1": "ocnn/depth_6/conv_bn_relu/octree_conv/OctreeConv", - "input2": "ocnn/depth_6/conv_bn_relu/batch_normalization/gamma/read", - "input3": "ocnn/depth_6/conv_bn_relu/batch_normalization/FusedBatchNorm:3", - "input4": "ocnn/depth_6/conv_bn_relu/batch_normalization/FusedBatchNorm:4" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OctreeConvGrad", - "pid": 3, - "tid": 0, - "ts": 1596804868548869, - "dur": 1408, - "args": { - "name": "solver/gradients/ocnn/depth_6/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad", - "op": "OctreeConvGrad", - "input0": "ocnn/Reshape", - "input1": "ocnn/depth_6/conv_bn_relu/octree_conv/weights/read", - "input2": "IteratorGetNext/_5", - "input3": "solver/gradients/ocnn/depth_6/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 98 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext", - "pid": 3, - "tid": 0, - "ts": 1596804868548869, - "id": 98 - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868550291, - "dur": 22, - "args": { - "name": "solver/gradients/AddN_16", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_1_grad/mul", - "input1": "solver/gradients/ocnn/depth_6/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868550316, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_17", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_2_grad/mul", - "input1": "solver/gradients/ocnn/depth_6/conv_bn_relu/batch_normalization/FusedBatchNorm_grad/FusedBatchNormGrad:2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AddN", - "pid": 3, - "tid": 0, - "ts": 1596804868550330, - "dur": 12, - "args": { - "name": "solver/gradients/AddN_18", - "op": "AddN", - "input0": "solver/gradients/loss/l2_regularizer/L2Loss_grad/mul", - "input1": "solver/gradients/ocnn/depth_6/conv_bn_relu/octree_conv/OctreeConv_grad/OctreeConvGrad:1" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868550344, - "dur": 21, - "args": { - "name": "solver/Momentum/update_ocnn/depth_6/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/gamma", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/gamma/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_16", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868550368, - "dur": 17, - "args": { - "name": "solver/Momentum/update_ocnn/depth_6/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/depth_6/conv_bn_relu/batch_normalization/beta", - "input1": "ocnn/depth_6/conv_bn_relu/batch_normalization/beta/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_17", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "ApplyMomentum", - "pid": 3, - "tid": 0, - "ts": 1596804868550388, - "dur": 17, - "args": { - "name": "solver/Momentum/update_ocnn/depth_6/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "op": "ApplyMomentum", - "input0": "ocnn/depth_6/conv_bn_relu/octree_conv/weights", - "input1": "ocnn/depth_6/conv_bn_relu/octree_conv/weights/Momentum", - "input2": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "input3": "solver/gradients/AddN_18", - "input4": "solver/Momentum/momentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "NoOp", - "pid": 3, - "tid": 0, - "ts": 1596804868550408, - "dur": 3, - "args": { - "name": "solver/Momentum/update", - "op": "NoOp", - "input0": "^solver/Momentum/update_ocnn/depth_4/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input1": "^solver/Momentum/update_ocnn/depth_5/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input2": "^solver/Momentum/update_ocnn/depth_3/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input3": "^solver/Momentum/update_ocnn/depth_6/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input4": "^solver/Momentum/update_ocnn/fc1/batch_normalization/gamma/ApplyMomentum", - "input5": "^solver/Momentum/update_ocnn/depth_4/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input6": "^solver/Momentum/update_ocnn/depth_5/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input7": "^solver/Momentum/update_ocnn/fc1/dense/kernel/ApplyMomentum", - "input8": "^solver/Momentum/update_ocnn/depth_3/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input9": "^solver/Momentum/update_ocnn/depth_5/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input10": "^solver/Momentum/update_ocnn/fc2/dense/bias/ApplyMomentum", - "input11": "^solver/Momentum/update_ocnn/depth_3/conv_bn_relu/batch_normalization/gamma/ApplyMomentum", - "input12": "^solver/Momentum/update_ocnn/depth_6/conv_bn_relu/batch_normalization/beta/ApplyMomentum", - "input13": "^solver/Momentum/update_ocnn/fc2/dense/kernel/ApplyMomentum", - "input14": "^solver/Momentum/update_ocnn/depth_6/conv_bn_relu/octree_conv/weights/ApplyMomentum", - "input15": "^solver/Momentum/update_ocnn/fc1/batch_normalization/beta/ApplyMomentum", - "input16": "^solver/Momentum/update_ocnn/depth_4/conv_bn_relu/batch_normalization/gamma/ApplyMomentum" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 3, - "tid": 0, - "ts": 1596804868550417, - "dur": 7, - "args": { - "name": "solver/Momentum/update/_78", - "op": "Const", - "input0": "^solver/Momentum/update" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "NoOp", - "pid": 5, - "tid": 0, - "ts": 1596804868487075, - "dur": 7, - "args": { - "name": "_SOURCE", - "op": "NoOp" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 5, - "tid": 0, - "ts": 1596804868487167, - "dur": 11, - "args": { - "name": "summary_train/total_loss/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "OneShotIterator", - "pid": 5, - "tid": 1, - "ts": 1596804868487143, - "dur": 34, - "args": { - "name": "points_dataset/OneShotIterator", - "op": "OneShotIterator" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 5, - "tid": 0, - "ts": 1596804868487188, - "dur": 4, - "args": { - "name": "summary_train/loss/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 5, - "tid": 0, - "ts": 1596804868487195, - "dur": 4, - "args": { - "name": "summary_train/regularizer/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 5, - "tid": 0, - "ts": 1596804868487202, - "dur": 3, - "args": { - "name": "summary_train/rmse/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 5, - "tid": 0, - "ts": 1596804868487208, - "dur": 2, - "args": { - "name": "summary_train/lr/tags", - "op": "Const" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "VariableV2", - "pid": 5, - "tid": 1, - "ts": 1596804868487192, - "dur": 37, - "args": { - "name": "solver/global_step", - "op": "VariableV2" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 5, - "tid": 0, - "ts": 1596804868487237, - "dur": 6, - "args": { - "name": "solver/global_step/read", - "op": "Identity", - "input0": "solver/global_step" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step", - "pid": 5, - "tid": 1, - "ts": 1596804868487229, - "id": 99 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step", - "pid": 5, - "tid": 0, - "ts": 1596804868487237, - "id": 99 - }, - { - "ph": "X", - "cat": "Op", - "name": "IteratorGetNext", - "pid": 5, - "tid": 2, - "ts": 1596804868487205, - "dur": 91, - "args": { - "name": "IteratorGetNext", - "op": "IteratorGetNext", - "input0": "points_dataset/OneShotIterator" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "points_dataset/OneShotIterator", - "pid": 5, - "tid": 1, - "ts": 1596804868487177, - "id": 100 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "points_dataset/OneShotIterator", - "pid": 5, - "tid": 2, - "ts": 1596804868487205, - "id": 100 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 5, - "tid": 0, - "ts": 1596804868502154, - "dur": 56, - "args": { - "name": "summary_train/regularizer", - "op": "ScalarSummary", - "input0": "summary_train/regularizer/tags", - "input1": "loss/l2_regularizer/mul/_7" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/l2_regularizer/mul", - "pid": 3, - "tid": 0, - "ts": 1596804868499193, - "id": 101 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/l2_regularizer/mul", - "pid": 5, - "tid": 0, - "ts": 1596804868502154, - "id": 101 - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 5, - "tid": 0, - "ts": 1596804868538932, - "dur": 13, - "args": { - "name": "GroupCrossDeviceControlEdges_0/solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1/_13", - "op": "Identity", - "input0": "GroupCrossDeviceControlEdges_0/solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1/_12" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Shape", - "pid": 5, - "tid": 0, - "ts": 1596804868538956, - "dur": 21, - "args": { - "name": "solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1", - "op": "Shape", - "input0": "IteratorGetNext:1", - "input1": "^GroupCrossDeviceControlEdges_0/solver/gradients/loss/mse_loss/mean_squared_error/SquaredDifference_grad/Shape_1/_13" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "IteratorGetNext:1", - "pid": 5, - "tid": 2, - "ts": 1596804868487296, - "id": 102 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "IteratorGetNext:1", - "pid": 5, - "tid": 0, - "ts": 1596804868538956, - "id": 102 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 5, - "tid": 0, - "ts": 1596804868540432, - "dur": 25, - "args": { - "name": "summary_train/lr", - "op": "ScalarSummary", - "input0": "summary_train/lr/tags", - "input1": "solver/step_lr/PiecewiseConstant/case/cond/Merge/_77" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 3, - "tid": 0, - "ts": 1596804868540352, - "id": 103 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/step_lr/PiecewiseConstant/case/cond/Merge", - "pid": 5, - "tid": 0, - "ts": 1596804868540432, - "id": 103 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 5, - "tid": 0, - "ts": 1596804868540547, - "dur": 7, - "args": { - "name": "summary_train/rmse", - "op": "ScalarSummary", - "input0": "summary_train/rmse/tags", - "input1": "loss/mse_loss/mean_squared_error/value/_73" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/value", - "pid": 3, - "tid": 0, - "ts": 1596804868540461, - "id": 104 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/value", - "pid": 5, - "tid": 0, - "ts": 1596804868540547, - "id": 104 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 5, - "tid": 1, - "ts": 1596804868540545, - "dur": 22, - "args": { - "name": "summary_train/loss", - "op": "ScalarSummary", - "input0": "summary_train/loss/tags", - "input1": "loss/mse_loss/mean_squared_error/value/_73" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "summary_train/loss/tags", - "pid": 5, - "tid": 0, - "ts": 1596804868487192, - "id": 105 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "summary_train/loss/tags", - "pid": 5, - "tid": 1, - "ts": 1596804868540545, - "id": 105 - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/value", - "pid": 3, - "tid": 0, - "ts": 1596804868540461, - "id": 106 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "loss/mse_loss/mean_squared_error/value", - "pid": 5, - "tid": 1, - "ts": 1596804868540545, - "id": 106 - }, - { - "ph": "X", - "cat": "Op", - "name": "ScalarSummary", - "pid": 5, - "tid": 0, - "ts": 1596804868540600, - "dur": 7, - "args": { - "name": "summary_train/total_loss", - "op": "ScalarSummary", - "input0": "summary_train/total_loss/tags", - "input1": "add/_75" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "add", - "pid": 3, - "tid": 0, - "ts": 1596804868540487, - "id": 107 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "add", - "pid": 5, - "tid": 0, - "ts": 1596804868540600, - "id": 107 - }, - { - "ph": "X", - "cat": "Op", - "name": "MergeSummary", - "pid": 5, - "tid": 0, - "ts": 1596804868540611, - "dur": 24, - "args": { - "name": "summary_train/Merge/MergeSummary", - "op": "MergeSummary", - "input0": "summary_train/loss", - "input1": "summary_train/rmse", - "input2": "summary_train/regularizer", - "input3": "summary_train/total_loss", - "input4": "summary_train/lr" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "summary_train/loss", - "pid": 5, - "tid": 1, - "ts": 1596804868540567, - "id": 108 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "summary_train/loss", - "pid": 5, - "tid": 0, - "ts": 1596804868540611, - "id": 108 - }, - { - "ph": "X", - "cat": "Op", - "name": "_Retval", - "pid": 5, - "tid": 0, - "ts": 1596804868540639, - "dur": 2, - "args": { - "name": "_retval_summary_train/Merge/MergeSummary_0_0", - "op": "_Retval", - "input0": "summary_train/Merge/MergeSummary" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Identity", - "pid": 5, - "tid": 0, - "ts": 1596804868598844, - "dur": 14, - "args": { - "name": "solver/Momentum/update/_81", - "op": "Identity", - "input0": "solver/Momentum/update/_80" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "Const", - "pid": 5, - "tid": 0, - "ts": 1596804868598871, - "dur": 8, - "args": { - "name": "solver/Momentum/value", - "op": "Const", - "input0": "^solver/Momentum/update/_81" - } - }, - { - "ph": "X", - "cat": "Op", - "name": "AssignAdd", - "pid": 5, - "tid": 0, - "ts": 1596804868598883, - "dur": 11, - "args": { - "name": "solver/Momentum", - "op": "AssignAdd", - "input0": "solver/global_step", - "input1": "solver/Momentum/value" - } - }, - { - "ph": "s", - "cat": "DataFlow", - "name": "solver/global_step", - "pid": 5, - "tid": 1, - "ts": 1596804868487229, - "id": 109 - }, - { - "ph": "t", - "cat": "DataFlow", - "name": "solver/global_step", - "pid": 5, - "tid": 0, - "ts": 1596804868598883, - "id": 109 - } - ] -} \ No newline at end of file diff --git a/tensorflow/script/network_ae.py b/tensorflow/script/network_ae.py deleted file mode 100644 index 188767a..0000000 --- a/tensorflow/script/network_ae.py +++ /dev/null @@ -1,234 +0,0 @@ -import tensorflow as tf -from ocnn import * - - -class AutoEncoderOcnn: - def __init__(self, flags): - self.flags = flags - - def octree_encoder(self, octree, training, reuse=False): - flags = self.flags - depth, nout = flags.depth, flags.nout - channel = [4, nout, 128, 64, 32, 16, 8] - with tf.variable_scope('ocnn_encoder', reuse=reuse): - with tf.variable_scope('signal_gt'): - data = octree_property(octree, property_name="feature", dtype=tf.float32, - depth=depth, channel=flags.channel) - data = tf.reshape(data, [1, flags.channel, -1, 1]) - - for d in range(depth, 1, -1): - with tf.variable_scope('depth_%d' % d): - data = octree_conv_bn_relu(data, octree, d, channel[d], training) - data, _ = octree_max_pool(data, octree, d) - - with tf.variable_scope('depth_1'): - data = downsample(data, channel[1], training) - - with tf.variable_scope('code'): - code = conv2d_bn(data, channel[1], kernel_size=1, stride=1, training=training) - code = tf.nn.tanh(code) - return code - - def octree_decoder(self, code, octree, training, reuse=False): - flags = self.flags - depth = flags.depth - channel = [512, 256, 128, 64, 32, 16, 8] - with tf.variable_scope('ocnn_decoder', reuse=reuse): - label_gt = [None]*10 - with tf.variable_scope('label_gt'): - for d in range(2, depth + 1): - label = octree_property(octree, property_name="split", dtype=tf.float32, - depth=d, channel=1) - label_gt[d] = tf.reshape(tf.cast(label, dtype=tf.int32), [-1]) - - with tf.variable_scope('signal_gt'): - signal_gt = octree_property(octree, property_name="feature", dtype=tf.float32, - depth=depth, channel=flags.channel) - signal_gt = tf.reshape(signal_gt, [1, flags.channel, -1, 1]) - - data = code - with tf.variable_scope('depth_1'): - data = upsample(data, channel[1], training) - - loss = []; accu = []; - for d in range(2, depth + 1): - with tf.variable_scope('depth_%d' % d): - data = octree_upsample(data, octree, d-1, channel[d], training) - data = octree_conv_bn_relu(data, octree, d, channel[d], training) - - with tf.variable_scope('predict_%d' % d): - logit, label = predict_label(data, 2, 32, training) - - with tf.variable_scope('loss_%d' % d): - logit = tf.transpose(tf.squeeze(logit, [0,3])) # (1, C, H, 1) -> (H, C) - loss.append(softmax_loss(logit, label_gt[d], num_class=2)) - accu.append(label_accuracy(label, label_gt[d])) - - if d == depth: - with tf.variable_scope('regress_%d' % d): - signal = predict_signal(data, flags.channel, 32, training) - loss.append(regress_loss(signal, signal_gt)) - - return loss, accu - - def octree_decode_shape(self, code, training, reuse=False): - flags = self.flags - depth = flags.depth - channel = [512, 256, 128, 64, 32, 16, 8] - with tf.variable_scope('ocnn_decoder', reuse=reuse): - with tf.variable_scope('octree_0'): - displace = False if flags.channel < 4 else True - octree = octree_new(batch_size=1, channel=flags.channel, has_displace=displace) - with tf.variable_scope('octree_1'): - octree = octree_grow(octree, target_depth=1, full_octree=True) - with tf.variable_scope('octree_2'): - octree = octree_grow(octree, target_depth=2, full_octree=True) - - data = code - with tf.variable_scope('depth_1'): - data = upsample(data, channel[1], training) - - for d in range(2, depth + 1): - with tf.variable_scope('depth_%d' % d): - data = octree_upsample(data, octree, d-1, channel[d], training) - data = octree_conv_bn_relu(data, octree, d, channel[d], training) - - with tf.variable_scope('predict_%d' % d): - _, label = predict_label(data, 2, 32, training) - - with tf.variable_scope('octree_%d' % d, reuse=True): - octree = octree_update(octree, label, depth=d, mask=1) - # octree = octree_update(octree, label_gt[d], depth=d, mask=1) - if d < depth: - with tf.variable_scope('octree_%d' % (d+1)): - octree = octree_grow(octree, target_depth=d+1, full_octree=False) - else: - with tf.variable_scope('regress_%d' % d): - signal = predict_signal(data, flags.channel, 32, training) - signal = normalize_signal(signal) - signal = octree_mask(signal, label, mask=0) - with tf.variable_scope('octree_%d' % d, reuse=True): - octree = octree_set_property(octree, signal, property_name="feature", depth=depth) - return octree - -class AutoEncoderResnet: - def __init__(self, flags): - self.flags = flags - - def octree_encoder(self, octree, training, reuse=False): - flags = self.flags - depth, nout = flags.depth, flags.nout - channels = [4, nout, 256, 256, 128, 64, 32, 16] - with tf.variable_scope('ocnn_encoder', reuse=reuse): - with tf.variable_scope('signal_gt'): - data = octree_property(octree, property_name="feature", dtype=tf.float32, - depth=depth, channel=flags.channel) - data = tf.reshape(data, [1, flags.channel, -1, 1]) - - with tf.variable_scope("front"): - data = octree_conv_bn_relu(data, octree, depth, channels[depth], training) - - for d in range(depth, 2, -1): - for i in range(0, flags.resblock_num): - with tf.variable_scope('resblock_%d_%d' % (d, i)): - data = octree_resblock(data, octree, d, channels[d], 1, training) - with tf.variable_scope('down_%d' % d): - data = octree_conv_bn_relu(data, octree, d, channels[d-1], training, - stride=2, kernel_size=[2]) - - with tf.variable_scope('code'): - # code = conv2d_bn(data, channels[1], kernel_size=1, stride=1, training=training) - code = octree_conv1x1_bn(data, flags.nout, training=training) - code = tf.nn.tanh(code) - return code - - def octree_decoder(self, code, octree, training, reuse=False): - flags = self.flags - depth = flags.depth - channels = [4, 64, 256, 256, 128, 64, 32, 16] - with tf.variable_scope('ocnn_decoder', reuse=reuse): - data = code - loss, accu = [], [] - for d in range(2, depth + 1): - for i in range(0, flags.resblock_num): - with tf.variable_scope('resblock_%d_%d' % (d, i)): - data = octree_resblock(data, octree, d, channels[d], 1, training) - - with tf.variable_scope('predict_%d' % d): - logit, label = predict_label(data, 2, 32, training) - logit = tf.transpose(tf.squeeze(logit, [0,3])) # (1, C, H, 1) -> (H, C) - - with tf.variable_scope('loss_%d' % d): - with tf.variable_scope('label_gt'): - label_gt = octree_property(octree, property_name="split", - dtype=tf.float32, depth=d, channel=1) - label_gt = tf.reshape(tf.cast(label_gt, dtype=tf.int32), [-1]) - loss.append(softmax_loss(logit, label_gt, num_class=2)) - accu.append(label_accuracy(label, label_gt)) - - if d == depth: - with tf.variable_scope('regress_%d' % d): - signal = predict_signal(data, flags.channel, 32, training) - - with tf.variable_scope('loss_regress'): - with tf.variable_scope('signal_gt'): - signal_gt = octree_property(octree, property_name="feature", - dtype=tf.float32, depth=depth, channel=flags.channel) - signal_gt = tf.reshape(signal_gt, [1, flags.channel, -1, 1]) - loss.append(regress_loss(signal, signal_gt)) - - if d < depth: - with tf.variable_scope('up_%d' % d): - data = octree_deconv_bn_relu(data, octree, d, channels[d-1], training, - stride=2, kernel_size=[2]) - return loss, accu - - def octree_decode_shape(self, code, training, reuse=False): - flags = self.flags - depth = flags.depth - channels = [4, 64, 256, 256, 128, 64, 32, 16] - with tf.variable_scope('ocnn_decoder', reuse=reuse): - with tf.variable_scope('octree_0'): - displace = False if flags.channel < 4 else True - octree = octree_new(batch_size=1, channel=flags.channel, has_displace=displace) - with tf.variable_scope('octree_1'): - octree = octree_grow(octree, target_depth=1, full_octree=True) - with tf.variable_scope('octree_2'): - octree = octree_grow(octree, target_depth=2, full_octree=True) - - data = code - for d in range(2, depth + 1): - for i in range(0, flags.resblock_num): - with tf.variable_scope('resblock_%d_%d' % (d, i)): - data = octree_resblock(data, octree, d, channels[d], 1, training) - - with tf.variable_scope('predict_%d' % d): - _, label = predict_label(data, 2, 32, training) - - with tf.variable_scope('octree_%d' % d, reuse=True): - octree = octree_update(octree, label, depth=d, mask=1) - if d < depth: - with tf.variable_scope('octree_%d' % (d+1)): - octree = octree_grow(octree, target_depth=d+1, full_octree=False) - else: - with tf.variable_scope('regress_%d' % d): - signal = predict_signal(data, flags.channel, 32, training) - signal = normalize_signal(signal) - signal = octree_mask(signal, label, mask=0) - with tf.variable_scope('octree_%d' % d, reuse=True): - octree = octree_set_property(octree, signal, property_name="feature", depth=depth) - - if d < depth: - with tf.variable_scope('up_%d' % d): - data = octree_deconv_bn_relu(data, octree, d, channels[d-1], training, - stride=2, kernel_size=[2]) - return octree - - -def make_autoencoder(flags): - if flags.name == 'ocnn': - return AutoEncoderOcnn(flags) - elif flags.name == 'resnet': - return AutoEncoderResnet(flags) - else: - pass diff --git a/tensorflow/script/network_cls.py b/tensorflow/script/network_cls.py index 6998788..8bf7279 100644 --- a/tensorflow/script/network_cls.py +++ b/tensorflow/script/network_cls.py @@ -5,8 +5,7 @@ # octree-based resnet55 def network_resnet(octree, flags, training=True, reuse=None): depth = flags.depth - full_depth = 1 - channels = [2048, 1024, 512, 256, 128, 64, 32, 16, 8] #[2048, 1024, 512, 256, 256, 128, 64, 32, 16] + channels = [2048, 1024, 512, 256, 128, 64, 32, 16, 8] with tf.variable_scope("ocnn_resnet", reuse=reuse): data = octree_property(octree, property_name="feature", dtype=tf.float32, depth=depth, channel=flags.channel) @@ -15,7 +14,7 @@ def network_resnet(octree, flags, training=True, reuse=None): with tf.variable_scope("conv1"): data = octree_conv_bn_relu(data, octree, depth, channels[depth], training) - for d in range(depth, full_depth, -1): + for d in range(depth, 2, -1): for i in range(0, flags.resblock_num): with tf.variable_scope('resblock_%d_%d' % (d, i)): data = octree_resblock(data, octree, d, channels[d], 1, training) @@ -23,10 +22,9 @@ def network_resnet(octree, flags, training=True, reuse=None): data, _ = octree_max_pool(data, octree, d) with tf.variable_scope("global_average"): - data = octree_full_voxel(data, depth=full_depth) + data = octree_full_voxel(data, depth=2) data = tf.reduce_mean(data, 2) - - + if flags.dropout[0]: data = tf.layers.dropout(data, rate=0.5, training=training) @@ -112,40 +110,10 @@ def network_cnn_grids(grids, flags, training=True, reuse=None): return logit - -# # qq add for test -# def network_ocnn_with_input(octree, flags, training=True, reuse=None): -# depth = flags.depth -# channels = [2048, 1024, 512, 256, 128, 64, 32, 16, 8] -# with tf.variable_scope("ocnn", reuse=reuse): -# data = octree_property(octree, property_name="feature", dtype=tf.float32, -# depth=depth, channel=flags.channel) -# data = tf.reshape(data, [1, flags.channel, -1, 1]) -# feature = data -# -# for d in range(depth, 2, -1): -# with tf.variable_scope('depth_%d' % d): -# data = octree_conv_bn_relu(data, octree, d, channels[d], training) -# data, _ = octree_max_pool(data, octree, d) -# -# with tf.variable_scope("full_voxel"): -# data = octree_full_voxel(data, depth=2) -# data = tf.layers.dropout(data, rate=0.5, training=training) -# -# with tf.variable_scope("fc1"): -# data = fc_bn_relu(data, channels[2], training=training) -# data = tf.layers.dropout(data, rate=0.5, training=training) -# -# with tf.variable_scope("fc2"): -# logit = dense(data, flags.nout, use_bias=True) -# -# return logit, feature - - -# def cls_network(octree, flags, training, reuse=False): -# if flags.name.lower() == 'ocnn': -# return network_ocnn(octree, flags, training, reuse) -# elif flags.name.lower() == 'resnet': -# return network_resnet(octree, flags, training, reuse) -# else: -# print('Error, no network: ' + flags.name) +def cls_network(octree, flags, training, reuse=False): + if flags.name.lower() == 'ocnn': + return network_ocnn(octree, flags, training, reuse) + elif flags.name.lower() == 'resnet': + return network_resnet(octree, flags, training, reuse) + else: + print('Error, no network: ' + flags.name) diff --git a/tensorflow/script/network_completion.py b/tensorflow/script/network_completion.py deleted file mode 100644 index ae1a9a3..0000000 --- a/tensorflow/script/network_completion.py +++ /dev/null @@ -1,138 +0,0 @@ -import tensorflow as tf -from ocnn import * - - -def get_input_signal(octree, depth, channel): - signal = octree_property( - octree, property_name='feature', dtype=tf.float32, - depth=depth, channel=channel) - signal = tf.reshape(signal, [1, channel, -1, 1]) - return signal - - -def get_split_label(octree, depth): - label = octree_property( - octree, property_name='split', dtype=tf.float32, - depth=depth, channel=1) - label = tf.reshape(tf.cast(label, dtype=tf.int32), [-1]) - return label - - -class CompletionResnet: - def __init__(self, flags): - self.flags = flags - self.channels = [4, 512, 512, 256, 128, 64, 32, 16] - - def octree_encoder(self, octree, training, reuse=False): - flags, channels = self.flags, self.channels - depth, convd = flags.depth, [None] * 10 - - with tf.variable_scope('ocnn_encoder', reuse=reuse): - with tf.variable_scope('signal_gt'): - data = get_input_signal(octree, depth, flags.channel) - - with tf.variable_scope("front_%d" % depth): - convd[depth] = octree_conv_bn_relu( - data, octree, depth, channels[depth], training) - - for d in range(depth, 1, -1): - for i in range(0, flags.resblock_num): - with tf.variable_scope('resblock_%d_%d' % (d, i)): - convd[d] = octree_resblock( - convd[d], octree, d, channels[d], 1, training) - - if d > 2: - with tf.variable_scope('down_%d' % d): - convd[d-1] = octree_conv_bn_relu( - convd[d], octree, d, channels[d-1], training, - stride=2, kernel_size=[2]) - return convd - - def octree_decoder(self, convd, octree0, octree1, training, reuse=False): - flags, channels = self.flags, self.channels - depth, deconv = flags.depth, convd[2] - loss, accu = [], [] - - with tf.variable_scope('ocnn_decoder', reuse=reuse): - for d in range(2, depth + 1): - if d > 2: - with tf.variable_scope('up_%d' % d): - deconv = octree_deconv_bn_relu( - deconv, octree1, d-1, channels[d], training, - stride=2, kernel_size=[2]) - if flags.skip_connections: - skip, _ = octree_align(convd[d], octree0, octree1, d) - deconv = deconv + skip - - for i in range(0, flags.resblock_num): - with tf.variable_scope('resblock_%d_%d' % (d, i)): - deconv = octree_resblock( - deconv, octree1, d, channels[d], 1, training) - - with tf.variable_scope('predict_%d' % d): - logit, label = predict_label(deconv, 2, 32, training) - # (1, C, H, 1) -> (H, C) - logit = tf.transpose(tf.squeeze(logit, [0, 3])) - - with tf.variable_scope('loss_%d' % d): - with tf.variable_scope('label_gt'): - label_gt = get_split_label(octree1, d) - loss.append(softmax_loss(logit, label_gt, num_class=2)) - accu.append(label_accuracy(label, label_gt)) - - if d == depth: - with tf.variable_scope('regress_%d' % d): - signal = predict_signal(deconv, flags.channel, 32, training) - - with tf.variable_scope('loss_regress'): - with tf.variable_scope('signal_gt'): - signal_gt = get_input_signal(octree1, depth, flags.channel) - loss.append(regress_loss(signal, signal_gt)) - return loss, accu - - def decode_shape(self, convd, octree0, training, reuse=False): - flags, channels = self.flags, self.channels - depth, deconv = flags.depth, convd[2] - - with tf.variable_scope('ocnn_decoder', reuse=reuse): - # init the octree - with tf.variable_scope('octree_0'): - dis = False if flags.channel < 4 else True - octree = octree_new(1, channel=flags.channel, has_displace=dis) - with tf.variable_scope('octree_1'): - octree = octree_grow(octree, target_depth=1, full_octree=True) - with tf.variable_scope('octree_2'): - octree = octree_grow(octree, target_depth=2, full_octree=True) - - for d in range(2, depth + 1): - if d > 2: - with tf.variable_scope('up_%d' % d): - deconv = octree_deconv_bn_relu( - deconv, octree, d-1, channels[d], training, - stride=2, kernel_size=[2]) - if flags.skip_connections: - skip, _ = octree_align(convd[d], octree0, octree, d) - deconv = deconv + skip - - for i in range(0, flags.resblock_num): - with tf.variable_scope('resblock_%d_%d' % (d, i)): - deconv = octree_resblock( - deconv, octree, d, channels[d], 1, training) - - with tf.variable_scope('predict_%d' % d): - _, label = predict_label(deconv, 2, 32, training) - - with tf.variable_scope('octree_%d' % d): - octree = octree_update(octree, label, depth=d, mask=1) - if d < depth: - with tf.variable_scope('octree_%d' % (d+1)): - octree = octree_grow(octree, target_depth=d+1, full_octree=False) - else: - with tf.variable_scope('regress_%d' % d): - signal = predict_signal(deconv, flags.channel, 32, training) - signal = normalize_signal(signal) - signal = octree_mask(signal, label, mask=0) - with tf.variable_scope('octree_%d' % d): - octree = octree_set_property( - octree, signal, property_name="feature", depth=depth) - return octree diff --git a/tensorflow/script/network_factory.py b/tensorflow/script/network_factory.py index 9e39293..265c6f5 100644 --- a/tensorflow/script/network_factory.py +++ b/tensorflow/script/network_factory.py @@ -1,7 +1,8 @@ import tensorflow as tf from network_cls import network_ocnn, network_resnet, network_cnn_grids, network_resnet_grids -# from network_cls import network_ocnn_with_input # qq add for test - +from network_unet import network_unet +from network_hrnet import HRNet +# from network_unet_scannet import network_unet34 def cls_network(octree, flags, training, reuse=False): if flags.name.lower() == 'ocnn': @@ -12,12 +13,5 @@ def cls_network(octree, flags, training, reuse=False): return network_cnn_grids(octree, flags, training, reuse) elif flags.name.lower() == 'resnet_grids': return network_resnet_grids(octree, flags, training, reuse) - - # elif flags.name.lower() == 'ocnn_input_logit': - # return network_ocnn_with_input(octree, flags, training, reuse) else: print('Error, no network: ' + flags.name) - - - - \ No newline at end of file diff --git a/tensorflow/script/ocnn.py b/tensorflow/script/ocnn.py index b0ce49c..3c9effb 100644 --- a/tensorflow/script/ocnn.py +++ b/tensorflow/script/ocnn.py @@ -24,8 +24,8 @@ def get_variables_with_name(name=None, without=None, train_only=True, verbose=Fa def dense(inputs, nout, use_bias=False): inputs = tf.layers.flatten(inputs) - fc = tf.layers.dense(inputs, nout, use_bias=use_bias, - kernel_initializer=tf.contrib.layers.xavier_initializer()) + fc = tf.layers.dense(inputs, nout, use_bias=use_bias, + kernel_initializer=tf.contrib.layers.xavier_initializer()) return fc @@ -38,11 +38,10 @@ def fc_bn_relu(inputs, nout, training): bn = batch_norm(fc, training) return tf.nn.relu(bn) - def conv2d(inputs, nout, kernel_size, stride, padding='SAME', data_format='channels_first'): return tf.layers.conv2d(inputs, nout, kernel_size=kernel_size, strides=stride, - padding=padding, data_format=data_format, use_bias=False, - kernel_initializer=tf.contrib.layers.xavier_initializer()) + padding=padding, data_format=data_format, use_bias=False, + kernel_initializer=tf.contrib.layers.xavier_initializer()) def conv3d(inputs, nout, kernel_size, stride, padding='SAME', data_format='channels_first'): return tf.layers.conv3d(inputs, nout, kernel_size=kernel_size, strides=stride, @@ -52,36 +51,35 @@ def conv3d(inputs, nout, kernel_size, stride, padding='SAME', data_format='chann def octree_conv1x1(inputs, nout, use_bias=False): outputs = tf.layers.conv2d(inputs, nout, kernel_size=1, strides=1, - data_format='channels_first', use_bias=use_bias, - kernel_initializer=tf.contrib.layers.xavier_initializer()) + data_format='channels_first', use_bias=use_bias, + kernel_initializer=tf.contrib.layers.xavier_initializer()) return outputs def octree_conv1x1(inputs, nout, use_bias=False): with tf.variable_scope('conv2d_1x1'): inputs = tf.squeeze(inputs, axis=[0, 3]) # (1, C, H, 1) -> (C, H) - weights = tf.get_variable('weights', shape=[nout, int(inputs.shape[0])], - dtype=tf.float32, initializer=tf.contrib.layers.xavier_initializer()) + weights = tf.get_variable('weights', shape=[nout, int(inputs.shape[0])], + dtype=tf.float32, initializer=tf.contrib.layers.xavier_initializer()) outputs = tf.matmul(weights, inputs) # (C, H) -> (nout, H) if use_bias: - bias = tf.get_variable('bias', shape=[nout, 1], dtype=tf.float32, - initializer=tf.contrib.layers.xavier_initializer()) + bias = tf.get_variable('bias', shape=[nout, 1], dtype=tf.float32, + initializer=tf.contrib.layers.xavier_initializer()) outputs = bias + outputs outputs = tf.expand_dims(tf.expand_dims(outputs, axis=0), axis=-1) return outputs -def octree_conv1x1_bn(inputs, nout, training, bn=True): +def octree_conv1x1_bn(inputs, nout, training): conv = octree_conv1x1(inputs, nout, use_bias=False) - if bn: - return batch_norm(conv, training) - else: - return conv + return batch_norm(conv, training) + -def octree_conv1x1_bn_relu(inputs, nout, training, bn = True): - conv = octree_conv1x1_bn(inputs, nout, training, bn) +def octree_conv1x1_bn_relu(inputs, nout, training): + conv = octree_conv1x1_bn(inputs, nout, training) return tf.nn.relu(conv) + def conv2d_bn(inputs, nout, kernel_size, stride, training): conv = conv2d(inputs, nout, kernel_size, stride) return batch_norm(conv, training) @@ -105,22 +103,23 @@ def conv3d_bn_relu(inputs, nout, kernel_size, stride, training): def upsample(data, channel, training): deconv = tf.layers.conv2d_transpose(data, channel, kernel_size=[8, 1], - strides=[8, 1], data_format='channels_first', use_bias=False, - kernel_initializer=tf.contrib.layers.xavier_initializer()) + strides=[8, 1], data_format='channels_first', use_bias=False, + kernel_initializer=tf.contrib.layers.xavier_initializer()) bn = tf.layers.batch_normalization(deconv, axis=1, training=training) return tf.nn.relu(bn) + def downsample(data, channel, training): deconv = tf.layers.conv2d(data, channel, kernel_size=[8, 1], - strides=[8, 1], data_format='channels_first', use_bias=False, - kernel_initializer=tf.contrib.layers.xavier_initializer()) + strides=[8, 1], data_format='channels_first', use_bias=False, + kernel_initializer=tf.contrib.layers.xavier_initializer()) bn = tf.layers.batch_normalization(deconv, axis=1, training=training) return tf.nn.relu(bn) def avg_pool2d(inputs, data_format='NCHW'): return tf.nn.avg_pool2d(inputs, ksize=[1, 2, 2, 1], strides=[1, 2, 2, 1], - padding='SAME', data_format=data_format) + padding='SAME', data_format=data_format) def max_pool3d(inputs, data_format='NCDHW'): return tf.nn.max_pool3d(inputs, ksize=[1,1,2,2,2], strides=[1,1,2,2,2], @@ -134,7 +133,7 @@ def avg_pool3d(inputs, data_format='NCDHW'): def global_pool(inputs, data_format='channels_first'): axis = [2, 3] if data_format == 'channels_first' else [1, 2] return tf.reduce_mean(inputs, axis=axis) - + # !!! Deprecated def octree_upsample(data, octree, depth, channel, training): @@ -143,8 +142,9 @@ def octree_upsample(data, octree, depth, channel, training): up = upsample(depad, channel, training) return up + def octree_upsample(data, octree, depth, channel, training): - up = octree_deconv_bn_relu(data, octree, depth, channel, training, + up = octree_deconv_bn_relu(data, octree, depth, channel, training, kernel_size=[2], stride=2, fast_mode=False) return up @@ -155,51 +155,51 @@ def octree_downsample(data, octree, depth, channel, training): pad = octree_pad(down, octree, depth) return pad - def octree_conv_bn(data, octree, depth, channel, training, kernel_size=[3], - stride=1, fast_mode=False, bn=True): + stride=1, fast_mode=False): if fast_mode == True: conv = octree_conv_fast(data, octree, depth, channel, kernel_size, stride) else: - conv = octree_conv_memory(data, octree, depth, channel, kernel_size, stride) - if bn: - return tf.layers.batch_normalization(conv, axis=1, training=training) - else: - return conv + conv = octree_conv_memory( + data, octree, depth, channel, kernel_size, stride) + return tf.layers.batch_normalization(conv, axis=1, training=training) + def octree_conv_bn_relu(data, octree, depth, channel, training, kernel_size=[3], - stride=1, fast_mode=False, bn = True): + stride=1, fast_mode=False): with tf.variable_scope('conv_bn_relu'): conv_bn = octree_conv_bn(data, octree, depth, channel, training, kernel_size, - stride, fast_mode, bn) + stride, fast_mode) rl = tf.nn.relu(conv_bn) return rl def octree_conv_bn_leakyrelu(data, octree, depth, channel, training): - cb = octree_conv_bn(data, octree, depth, channel, training) + cb = octree_conv_bn(data, octree, depth, channel, training) return tf.nn.leaky_relu(cb, alpha=0.2) def octree_deconv_bn(data, octree, depth, channel, training, kernel_size=[3], stride=1, fast_mode=False): if fast_mode == True: - conv = octree_deconv_fast(data, octree, depth, channel, kernel_size, stride) + conv = octree_deconv_fast( + data, octree, depth, channel, kernel_size, stride) else: - conv = octree_deconv_memory(data, octree, depth, channel, kernel_size, stride) + conv = octree_deconv_memory( + data, octree, depth, channel, kernel_size, stride) return tf.layers.batch_normalization(conv, axis=1, training=training) def octree_deconv_bn_relu(data, octree, depth, channel, training, kernel_size=[3], stride=1, fast_mode=False): with tf.variable_scope('deconv_bn_relu'): - conv_bn = octree_deconv_bn(data, octree, depth, channel, training, kernel_size, + conv_bn = octree_deconv_bn(data, octree, depth, channel, training, kernel_size, stride, fast_mode) rl = tf.nn.relu(conv_bn) return rl -def octree_resblock(data, octree, depth, num_out, stride, training, bottleneck=4, bn=True): +def octree_resblock(data, octree, depth, num_out, stride, training, bottleneck=4): num_in = int(data.shape[1]) channelb = int(num_out / bottleneck) if stride == 2: @@ -207,22 +207,20 @@ def octree_resblock(data, octree, depth, num_out, stride, training, bottleneck=4 depth = depth - 1 with tf.variable_scope("1x1x1_a"): - block = octree_conv1x1_bn_relu(data, channelb, training=training, bn=bn) + block1 = octree_conv1x1_bn_relu(data, channelb, training=training) with tf.variable_scope("3x3x3"): - block = octree_conv_bn_relu(block, octree, depth, channelb, training, bn=bn) + block2 = octree_conv_bn_relu(block1, octree, depth, channelb, training) with tf.variable_scope("1x1x1_b"): - block = octree_conv1x1_bn(block, num_out, training=training, bn=bn) - + block3 = octree_conv1x1_bn(block2, num_out, training=training) + block4 = data if num_in != num_out: with tf.variable_scope("1x1x1_c"): - block4 = octree_conv1x1_bn(data, num_out, training=training, bn=bn) - return tf.nn.relu(block + block4) - else: - return tf.nn.relu(block + data) + block4 = octree_conv1x1_bn(data, num_out, training=training) + return tf.nn.relu(block3 + block4) def grids_resblock(grids, num_out, stride, training, bottleneck=4): num_in = int(grids.shape[1]) @@ -248,21 +246,28 @@ def grids_resblock(grids, num_out, stride, training, bottleneck=4): return tf.nn.relu(block + grids) - def octree_resblock2(data, octree, depth, num_out, training): + num_in = int(data.shape[1]) with tf.variable_scope("conv_1"): conv = octree_conv_bn_relu(data, octree, depth, num_out/4, training) with tf.variable_scope("conv_2"): conv = octree_conv_bn(conv, octree, depth, num_out, training) - out = tf.nn.relu(conv + data) + + link = data + if num_in != num_out: + with tf.variable_scope("conv_1x1"): + link = octree_conv1x1_bn(data, num_out, training=training) + + out = tf.nn.relu(conv + link) return out + def predict_module(data, num_output, num_hidden, training): # MLP with one hidden layer with tf.variable_scope('conv1'): conv = octree_conv1x1_bn_relu(data, num_hidden, training) with tf.variable_scope('conv2'): - logit= octree_conv1x1(conv, num_output, use_bias=True) + logit = octree_conv1x1(conv, num_output, use_bias=True) return logit @@ -270,7 +275,7 @@ def predict_label(data, num_output, num_hidden, training): logit = predict_module(data, num_output, num_hidden, training) # prob = tf.nn.softmax(logit, axis=1) # logit (1, num_output, ?, 1) label = tf.argmax(logit, axis=1, output_type=tf.int32) # predict (1, ?, 1) - label = tf.reshape(label, [-1]) # flatten + label = tf.reshape(label, [-1]) # flatten return logit, label @@ -278,11 +283,12 @@ def predict_signal(data, num_output, num_hidden, training): return tf.nn.tanh(predict_module(data, num_output, num_hidden, training)) -def softmax_loss(logit, label_gt, num_class, label_smoothing=0.0): +def softmax_loss(logit, label_gt, num_class, label_smoothing=0.0): with tf.name_scope('softmax_loss'): label_gt = tf.cast(label_gt, tf.int32) onehot = tf.one_hot(label_gt, depth=num_class) - loss = tf.losses.softmax_cross_entropy(onehot, logit, label_smoothing=label_smoothing) + loss = tf.losses.softmax_cross_entropy( + onehot, logit, label_smoothing=label_smoothing) return loss @@ -323,9 +329,20 @@ def normalize_signal(data): output = tf.nn.l2_normalize(data, axis=1) return output + +def average_tensors(tower_tensors): + avg_tensors = [] + with tf.name_scope('avg_tensors'): + for tensors in tower_tensors: + tensors = [tf.expand_dims(tensor, 0) for tensor in tensors] + avg_tensor = tf.concat(tensors, axis=0) + avg_tensor = tf.reduce_mean(avg_tensor, 0) + avg_tensors.append(avg_tensor) + return avg_tensors + -def build_solver(total_loss, learning_rate_handle): - with tf.name_scope('solver'): +def solver_single_gpu(total_loss, learning_rate_handle, gpu_num=1): + with tf.variable_scope('solver'): update_ops = tf.get_collection(tf.GraphKeys.UPDATE_OPS) with tf.control_dependencies(update_ops): global_step = tf.Variable(0, trainable=False, name='global_step') @@ -335,6 +352,42 @@ def build_solver(total_loss, learning_rate_handle): return solver, lr +def solver_multiple_gpus(total_loss, learning_rate_handle, gpu_num): + tower_grads, variables = [], [] + with tf.device('/cpu:0'): + with tf.variable_scope('solver'): + global_step = tf.Variable(0, trainable=False, name='global_step') + lr = learning_rate_handle(global_step) + opt = tf.train.MomentumOptimizer(lr, 0.9) + + for i in range(gpu_num): + with tf.device('/gpu:%d' % i): + with tf.name_scope('device_b%d' % i): + grads_and_vars = opt.compute_gradients(total_loss[i]) + grads, variables = zip(*grads_and_vars) + tower_grads.append(grads) + + update_ops = tf.get_collection(tf.GraphKeys.UPDATE_OPS) + # !!! Only get the update_ops defined on `device_0` to avoid the sync + # between different GPUs to speed up the training process. !!! + update_ops = [op for op in update_ops if 'device_0' in op.name] + assert update_ops, 'The update ops of BN are empty, check the namescope \'device_0\'' + with tf.device('/cpu:0'): + with tf.name_scope('sync_and_apply_grad'): + with tf.control_dependencies(update_ops): + tower_grads = list(zip(*tower_grads)) + avg_grads = average_tensors(tower_grads) + grads_and_vars = list(zip(avg_grads, variables)) + solver = opt.apply_gradients(grads_and_vars, global_step=global_step) + return solver, lr + + +def build_solver(total_loss, learning_rate_handle, gpu_num=1): + assert (gpu_num > 0) + the_solver = solver_single_gpu if gpu_num == 1 else solver_multiple_gpus + return the_solver(total_loss, learning_rate_handle, gpu_num) + + def summary_train(names, tensors): with tf.name_scope('summary_train'): summaries = [] @@ -378,7 +431,7 @@ def loss_functions_reg(logit, label_gt, num_class, weight_decay, var_name, label return [loss, accu, regularizer] def loss_functions_seg(logit, label_gt, num_class, weight_decay, var_name, mask=-1): - with tf.name_scope('loss_seg'): + with tf.name_scope('loss_seg'): label_mask = label_gt > mask # filter label -1 masked_logit = tf.boolean_mask(logit, label_mask) masked_label = tf.boolean_mask(label_gt, label_mask) @@ -392,10 +445,11 @@ def loss_functions_seg(logit, label_gt, num_class, weight_decay, var_name, mask= def get_seg_label(octree, depth): with tf.name_scope('seg_label'): label = octree_property(octree, property_name='label', dtype=tf.float32, - depth=depth, channel=1) + depth=depth, channel=1) label = tf.reshape(tf.cast(label, tf.int32), [-1]) return label + def run_k_iterations(sess, k, tensors): num = len(tensors) avg_results = [0] * num @@ -403,7 +457,7 @@ def run_k_iterations(sess, k, tensors): iter_results = sess.run(tensors) for j in range(num): avg_results[j] += iter_results[j] - + for j in range(num): avg_results[j] /= k return avg_results @@ -418,7 +472,7 @@ def tf_IoU_per_shape(pred, label, class_num, mask=-1): IoU, valid_part_num, esp = 0.0, 0.0, 1.0e-10 for k in range(class_num): pk, lk = tf.equal(pred, k), tf.equal(label, k) - # pk, lk = pred == k, label == k # why can this not output the right results? + # pk, lk = pred == k, label == k # why can this not output the right results? intsc = tf.reduce_sum(tf.cast(pk & lk, dtype=tf.float32)) union = tf.reduce_sum(tf.cast(pk | lk, dtype=tf.float32)) valid = tf.cast(tf.reduce_any(lk), dtype=tf.float32) @@ -430,8 +484,8 @@ def tf_IoU_per_shape(pred, label, class_num, mask=-1): class Optimizer: def __init__(self, stype='SGD', var_list=None, mul=1.0): - self.stype = stype # TODO: support more optimizers - self.mul = mul # used to modulate the global learning rate + self.stype = stype # TODO: support more optimizers + self.mul = mul # used to modulate the global learning rate self.var_list = var_list def __call__(self, total_loss, learning_rate): @@ -444,3 +498,26 @@ def __call__(self, total_loss, learning_rate): .minimize(total_loss, global_step=global_step, var_list=self.var_list) return solver, lr + + + +def octree2points(octree, depth, pts_channel=4, output_normal=False): + with tf.name_scope('octree2points'): + signal = octree_signal(octree, depth, 4) # normal and displacement + signal = tf.transpose(tf.squeeze(signal, [0, 3])) # (1, C, H, 1) -> (H, C) + xyz = octree_xyz(octree, depth) + xyz = tf.cast(xyz, dtype=tf.float32) + + mask = octree_child(octree, depth) > -1 + signal = tf.boolean_mask(signal, mask) + xyz = tf.boolean_mask(xyz, mask) + + c = 3.0 ** 0.5 / 2.0 + normal, dis = tf.split(signal, [3, 1], axis=1) + pts, idx = tf.split(xyz, [3, 1], axis=1) + pts = (pts + 0.5) + normal * (dis * c) + if pts_channel == 4: + pts = tf.concat([pts, idx], axis=1) + output = pts if not output_normal else (pts, normal) + return output + diff --git a/tensorflow/script/ocnn_lrp_results/.DS_Store b/tensorflow/script/ocnn_lrp_results/.DS_Store deleted file mode 100644 index 28220a5..0000000 Binary files a/tensorflow/script/ocnn_lrp_results/.DS_Store and /dev/null differ diff --git a/tensorflow/script/ocnn_lrp_results/1w40.ply b/tensorflow/script/ocnn_lrp_results/1w40.ply deleted file mode 100644 index 731e45c..0000000 --- a/tensorflow/script/ocnn_lrp_results/1w40.ply +++ /dev/null @@ -1,6420 +0,0 @@ -ply -format ascii 1.0 -element vertex 6408 -property float x -property float y -property float z -property float nx -property float ny -property float nz -element face 0 -property list uchar int vertex_indices -end_header -26.714399999999998 -9.897999 4.151300000000001 -8293.66 -8293.66 -8293.66 -26.714399999999998 -8.897999 4.151300000000001 1107.19 1107.19 1107.19 -27.714399999999998 -9.897999 4.151300000000001 29839.7 29839.7 29839.7 -27.714399999999998 -8.897999 4.151300000000001 33071.3 33071.3 33071.3 -28.714399999999998 -9.897999 4.151300000000001 18160.8 18160.8 18160.8 -28.714399999999998 -8.897999 3.151300000000001 -202119.0 -202119.0 -202119.0 -28.714399999999998 -8.897999 4.151300000000001 15987.1 15987.1 15987.1 -24.714399999999998 -8.897999 10.1513 -4700.26 -4700.26 -4700.26 -24.714399999999998 -8.897999 11.1513 -16907.8 -16907.8 -16907.8 -24.714399999999998 -8.897999 12.1513 15861.1 15861.1 15861.1 -26.714399999999998 -10.897999 5.151300000000001 -13225.8 -13225.8 -13225.8 -26.714399999999998 -10.897999 6.151300000000001 -9787.9 -9787.9 -9787.9 -25.714399999999998 -9.897999 5.151300000000001 78856.0 78856.0 78856.0 -25.714399999999998 -9.897999 6.151300000000001 -12789.5 -12789.5 -12789.5 -25.714399999999998 -8.897999 5.151300000000001 -33762.7 -33762.7 -33762.7 -25.714399999999998 -8.897999 6.151300000000001 -13025.4 -13025.4 -13025.4 -26.714399999999998 -9.897999 5.151300000000001 67975.9 67975.9 67975.9 -26.714399999999998 -9.897999 6.151300000000001 44146.7 44146.7 44146.7 -26.714399999999998 -8.897999 5.151300000000001 -6108.07 -6108.07 -6108.07 -25.714399999999998 -8.897999 7.151300000000001 8981.25 8981.25 8981.25 -26.714399999999998 -9.897999 7.151300000000001 -14483.5 -14483.5 -14483.5 -26.714399999999998 -8.897999 7.151300000000001 28447.7 28447.7 28447.7 -26.714399999999998 -8.897999 8.1513 1939.48 1939.48 1939.48 -27.714399999999998 -10.897999 5.151300000000001 3734.94 3734.94 3734.94 -27.714399999999998 -10.897999 6.151300000000001 18725.2 18725.2 18725.2 -28.714399999999998 -10.897999 5.151300000000001 -30593.6 -30593.6 -30593.6 -28.714399999999998 -10.897999 6.151300000000001 -4597.5 -4597.5 -4597.5 -27.714399999999998 -9.897999 5.151300000000001 201908.0 201908.0 201908.0 -27.714399999999998 -9.897999 6.151300000000001 6287.53 6287.53 6287.53 -28.714399999999998 -9.897999 5.151300000000001 88659.0 88659.0 88659.0 -28.714399999999998 -9.897999 6.151300000000001 6522.8 6522.8 6522.8 -28.714399999999998 -8.897999 6.151300000000001 14282.5 14282.5 14282.5 -27.714399999999998 -9.897999 7.151300000000001 21256.3 21256.3 21256.3 -27.714399999999998 -9.897999 8.1513 -1125.39 -1125.39 -1125.39 -27.714399999999998 -8.897999 7.151300000000001 9404.6 9404.6 9404.6 -27.714399999999998 -8.897999 8.1513 124.039 124.039 124.039 -28.714399999999998 -9.897999 7.151300000000001 8749.34 8749.34 8749.34 -28.714399999999998 -9.897999 8.1513 -1128.17 -1128.17 -1128.17 -28.714399999999998 -8.897999 7.151300000000001 7179.74 7179.74 7179.74 -28.714399999999998 -8.897999 8.1513 147.228 147.228 147.228 -25.714399999999998 -9.897999 10.1513 4231.86 4231.86 4231.86 -25.714399999999998 -8.897999 9.1513 876.213 876.213 876.213 -25.714399999999998 -8.897999 10.1513 -1199.66 -1199.66 -1199.66 -26.714399999999998 -9.897999 9.1513 2696.29 2696.29 2696.29 -26.714399999999998 -9.897999 10.1513 5769.29 5769.29 5769.29 -26.714399999999998 -8.897999 9.1513 104.33 104.33 104.33 -26.714399999999998 -8.897999 10.1513 -3281.17 -3281.17 -3281.17 -25.714399999999998 -9.897999 11.1513 5147.64 5147.64 5147.64 -25.714399999999998 -9.897999 12.1513 4595.94 4595.94 4595.94 -25.714399999999998 -8.897999 11.1513 4178.74 4178.74 4178.74 -25.714399999999998 -8.897999 12.1513 7152.18 7152.18 7152.18 -26.714399999999998 -9.897999 11.1513 558.601 558.601 558.601 -26.714399999999998 -9.897999 12.1513 -3956.71 -3956.71 -3956.71 -26.714399999999998 -8.897999 12.1513 -7550.96 -7550.96 -7550.96 -28.714399999999998 -10.897999 12.1513 2431.42 2431.42 2431.42 -27.714399999999998 -9.897999 9.1513 545.873 545.873 545.873 -27.714399999999998 -9.897999 10.1513 -8274.53 -8274.53 -8274.53 -27.714399999999998 -8.897999 9.1513 1702.1 1702.1 1702.1 -27.714399999999998 -8.897999 10.1513 -2257.29 -2257.29 -2257.29 -28.714399999999998 -9.897999 9.1513 1147.54 1147.54 1147.54 -28.714399999999998 -9.897999 10.1513 -1903.47 -1903.47 -1903.47 -27.714399999999998 -9.897999 11.1513 -948.06 -948.06 -948.06 -27.714399999999998 -9.897999 12.1513 -6369.05 -6369.05 -6369.05 -27.714399999999998 -8.897999 11.1513 -1025.99 -1025.99 -1025.99 -27.714399999999998 -8.897999 12.1513 -483.39 -483.39 -483.39 -28.714399999999998 -9.897999 11.1513 3877.1 3877.1 3877.1 -28.714399999999998 -9.897999 12.1513 -10439.1 -10439.1 -10439.1 -28.714399999999998 -8.897999 11.1513 5041.61 5041.61 5041.61 -28.714399999999998 -8.897999 12.1513 -9581.5 -9581.5 -9581.5 -26.714399999999998 -7.897999 4.151300000000001 6455.75 6455.75 6455.75 -27.714399999999998 -7.897999 4.151300000000001 -5308.67 -5308.67 -5308.67 -27.714399999999998 -6.897999 4.151300000000001 -526.62 -526.62 -526.62 -28.714399999999998 -7.897999 3.151300000000001 722.541 722.541 722.541 -28.714399999999998 -7.897999 4.151300000000001 -12844.0 -12844.0 -12844.0 -28.714399999999998 -6.897999 3.151300000000001 327.412 327.412 327.412 -28.714399999999998 -6.897999 4.151300000000001 1761.1 1761.1 1761.1 -24.714399999999998 -7.897999 9.1513 889.953 889.953 889.953 -24.714399999999998 -7.897999 10.1513 -826.417 -826.417 -826.417 -24.714399999999998 -6.897999 9.1513 563.392 563.392 563.392 -24.714399999999998 -6.897999 10.1513 -503.266 -503.266 -503.266 -24.714399999999998 -7.897999 11.1513 -4004.17 -4004.17 -4004.17 -24.714399999999998 -7.897999 12.1513 978.25 978.25 978.25 -24.714399999999998 -6.897999 11.1513 5126.29 5126.29 5126.29 -24.714399999999998 -6.897999 12.1513 -9659.21 -9659.21 -9659.21 -24.714399999999998 -5.897999 10.1513 984.639 984.639 984.639 -24.714399999999998 -4.897999 10.1513 282.422 282.422 282.422 -24.714399999999998 -5.897999 11.1513 2381.4 2381.4 2381.4 -24.714399999999998 -5.897999 12.1513 4329.48 4329.48 4329.48 -24.714399999999998 -4.897999 11.1513 -501.519 -501.519 -501.519 -24.714399999999998 -4.897999 12.1513 -2061.38 -2061.38 -2061.38 -22.714399999999998 -2.897999 6.151300000000001 62.5938 62.5938 62.5938 -21.714399999999998 -2.897999 7.151300000000001 -509.672 -509.672 -509.672 -21.714399999999998 -2.897999 8.1513 13477.3 13477.3 13477.3 -22.714399999999998 -2.897999 7.151300000000001 -23627.1 -23627.1 -23627.1 -22.714399999999998 -2.897999 8.1513 21619.3 21619.3 21619.3 -22.714399999999998 -1.897999 6.151300000000001 -93.9568 -93.9568 -93.9568 -22.714399999999998 -0.897999 6.151300000000001 114.188 114.188 114.188 -21.714399999999998 -1.897999 7.151300000000001 -13975.6 -13975.6 -13975.6 -21.714399999999998 -1.897999 8.1513 30423.0 30423.0 30423.0 -21.714399999999998 -0.897999 7.151300000000001 1086.86 1086.86 1086.86 -21.714399999999998 -0.897999 8.1513 20894.6 20894.6 20894.6 -22.714399999999998 -1.897999 7.151300000000001 -28838.2 -28838.2 -28838.2 -22.714399999999998 -1.897999 8.1513 4772.13 4772.13 4772.13 -22.714399999999998 -0.897999 7.151300000000001 -12131.5 -12131.5 -12131.5 -22.714399999999998 -0.897999 8.1513 -22520.1 -22520.1 -22520.1 -23.714399999999998 -2.897999 6.151300000000001 -63.0695 -63.0695 -63.0695 -24.714399999999998 -2.897999 6.151300000000001 1294.14 1294.14 1294.14 -23.714399999999998 -3.897999 7.151300000000001 109.998 109.998 109.998 -23.714399999999998 -3.897999 8.1513 -595.358 -595.358 -595.358 -23.714399999999998 -2.897999 7.151300000000001 953.523 953.523 953.523 -23.714399999999998 -2.897999 8.1513 185.136 185.136 185.136 -24.714399999999998 -3.897999 7.151300000000001 -651.376 -651.376 -651.376 -24.714399999999998 -3.897999 8.1513 48.1437 48.1437 48.1437 -24.714399999999998 -2.897999 7.151300000000001 -127.133 -127.133 -127.133 -24.714399999999998 -2.897999 8.1513 449.118 449.118 449.118 -23.714399999999998 -1.897999 6.151300000000001 -510.596 -510.596 -510.596 -23.714399999999998 -0.897999 6.151300000000001 -528.473 -528.473 -528.473 -24.714399999999998 -1.897999 6.151300000000001 -2857.53 -2857.53 -2857.53 -24.714399999999998 -0.897999 6.151300000000001 -14944.0 -14944.0 -14944.0 -23.714399999999998 -0.897999 7.151300000000001 -437.623 -437.623 -437.623 -23.714399999999998 -0.897999 8.1513 89.5238 89.5238 89.5238 -24.714399999999998 -0.897999 7.151300000000001 18080.8 18080.8 18080.8 -22.714399999999998 -2.897999 9.1513 6396.71 6396.71 6396.71 -22.714399999999998 -1.897999 9.1513 15449.6 15449.6 15449.6 -22.714399999999998 -0.897999 9.1513 -10772.1 -10772.1 -10772.1 -22.714399999999998 -0.897999 10.1513 -820.611 -820.611 -820.611 -22.714399999999998 -0.897999 11.1513 1069.09 1069.09 1069.09 -23.714399999999998 -2.897999 9.1513 428.915 428.915 428.915 -23.714399999999998 -2.897999 10.1513 530.469 530.469 530.469 -24.714399999999998 -3.897999 9.1513 -1055.24 -1055.24 -1055.24 -24.714399999999998 -3.897999 10.1513 -2766.95 -2766.95 -2766.95 -24.714399999999998 -2.897999 9.1513 889.478 889.478 889.478 -24.714399999999998 -2.897999 10.1513 -1138.05 -1138.05 -1138.05 -23.714399999999998 -2.897999 11.1513 -6.25883 -6.25883 -6.25883 -24.714399999999998 -3.897999 11.1513 1840.3 1840.3 1840.3 -24.714399999999998 -3.897999 12.1513 1264.37 1264.37 1264.37 -24.714399999999998 -2.897999 11.1513 740.421 740.421 740.421 -24.714399999999998 -2.897999 12.1513 -236.623 -236.623 -236.623 -23.714399999999998 -1.897999 9.1513 97.2608 97.2608 97.2608 -23.714399999999998 -1.897999 10.1513 -59.7798 -59.7798 -59.7798 -23.714399999999998 -0.897999 9.1513 -99.8413 -99.8413 -99.8413 -23.714399999999998 -0.897999 10.1513 -269.371 -269.371 -269.371 -23.714399999999998 -1.897999 11.1513 -89.7868 -89.7868 -89.7868 -23.714399999999998 -1.897999 12.1513 85.1826 85.1826 85.1826 -23.714399999999998 -0.897999 11.1513 -48.6799 -48.6799 -48.6799 -23.714399999999998 -0.897999 12.1513 -266.735 -266.735 -266.735 -24.714399999999998 -1.897999 11.1513 260.8 260.8 260.8 -24.714399999999998 -1.897999 12.1513 517.014 517.014 517.014 -24.714399999999998 -0.897999 11.1513 334.014 334.014 334.014 -25.714399999999998 -7.897999 5.151300000000001 -3635.64 -3635.64 -3635.64 -25.714399999999998 -7.897999 6.151300000000001 6794.55 6794.55 6794.55 -26.714399999999998 -7.897999 5.151300000000001 -34012.4 -34012.4 -34012.4 -26.714399999999998 -7.897999 6.151300000000001 -23671.2 -23671.2 -23671.2 -26.714399999999998 -6.897999 5.151300000000001 -4500.29 -4500.29 -4500.29 -26.714399999999998 -6.897999 6.151300000000001 -2446.63 -2446.63 -2446.63 -25.714399999999998 -7.897999 8.1513 105.927 105.927 105.927 -25.714399999999998 -6.897999 7.151300000000001 -2025.39 -2025.39 -2025.39 -25.714399999999998 -6.897999 8.1513 -456.809 -456.809 -456.809 -26.714399999999998 -7.897999 7.151300000000001 -6501.76 -6501.76 -6501.76 -26.714399999999998 -7.897999 8.1513 5638.91 5638.91 5638.91 -26.714399999999998 -6.897999 7.151300000000001 -2977.85 -2977.85 -2977.85 -26.714399999999998 -6.897999 8.1513 -4016.42 -4016.42 -4016.42 -26.714399999999998 -5.897999 6.151300000000001 -2190.62 -2190.62 -2190.62 -25.714399999999998 -5.897999 7.151300000000001 -884.98 -884.98 -884.98 -25.714399999999998 -5.897999 8.1513 83.2209 83.2209 83.2209 -26.714399999999998 -5.897999 7.151300000000001 -104.791 -104.791 -104.791 -26.714399999999998 -5.897999 8.1513 -4779.59 -4779.59 -4779.59 -26.714399999999998 -4.897999 7.151300000000001 -583.264 -583.264 -583.264 -26.714399999999998 -4.897999 8.1513 -163.386 -163.386 -163.386 -27.714399999999998 -7.897999 5.151300000000001 -10162.9 -10162.9 -10162.9 -27.714399999999998 -7.897999 6.151300000000001 -39870.9 -39870.9 -39870.9 -27.714399999999998 -6.897999 5.151300000000001 -1873.8 -1873.8 -1873.8 -27.714399999999998 -6.897999 6.151300000000001 388.637 388.637 388.637 -28.714399999999998 -6.897999 5.151300000000001 2902.51 2902.51 2902.51 -27.714399999999998 -7.897999 7.151300000000001 -12116.0 -12116.0 -12116.0 -27.714399999999998 -6.897999 7.151300000000001 -1840.12 -1840.12 -1840.12 -27.714399999999998 -5.897999 5.151300000000001 -4890.62 -4890.62 -4890.62 -27.714399999999998 -5.897999 6.151300000000001 297.493 297.493 297.493 -27.714399999999998 -4.897999 6.151300000000001 -5339.42 -5339.42 -5339.42 -28.714399999999998 -5.897999 5.151300000000001 73.75 73.75 73.75 -28.714399999999998 -5.897999 6.151300000000001 221.477 221.477 221.477 -28.714399999999998 -4.897999 5.151300000000001 204.398 204.398 204.398 -28.714399999999998 -4.897999 6.151300000000001 -1945.17 -1945.17 -1945.17 -27.714399999999998 -5.897999 7.151300000000001 -1000.98 -1000.98 -1000.98 -27.714399999999998 -5.897999 8.1513 -4038.56 -4038.56 -4038.56 -27.714399999999998 -4.897999 7.151300000000001 -2583.85 -2583.85 -2583.85 -27.714399999999998 -4.897999 8.1513 3734.53 3734.53 3734.53 -28.714399999999998 -5.897999 7.151300000000001 2131.82 2131.82 2131.82 -28.714399999999998 -5.897999 8.1513 -90.7308 -90.7308 -90.7308 -28.714399999999998 -4.897999 7.151300000000001 -2346.91 -2346.91 -2346.91 -28.714399999999998 -4.897999 8.1513 -1490.15 -1490.15 -1490.15 -25.714399999999998 -7.897999 9.1513 990.909 990.909 990.909 -25.714399999999998 -7.897999 10.1513 -1097.33 -1097.33 -1097.33 -25.714399999999998 -6.897999 9.1513 706.853 706.853 706.853 -25.714399999999998 -6.897999 10.1513 832.85 832.85 832.85 -26.714399999999998 -7.897999 9.1513 9779.47 9779.47 9779.47 -26.714399999999998 -6.897999 9.1513 -2035.45 -2035.45 -2035.45 -25.714399999999998 -7.897999 12.1513 11771.0 11771.0 11771.0 -25.714399999999998 -6.897999 11.1513 -7432.4 -7432.4 -7432.4 -25.714399999999998 -6.897999 12.1513 15152.6 15152.6 15152.6 -26.714399999999998 -7.897999 12.1513 281714.0 281714.0 281714.0 -26.714399999999998 -6.897999 12.1513 -352159.0 -352159.0 -352159.0 -25.714399999999998 -5.897999 9.1513 -1009.53 -1009.53 -1009.53 -25.714399999999998 -5.897999 10.1513 1327.89 1327.89 1327.89 -25.714399999999998 -4.897999 9.1513 -3524.75 -3524.75 -3524.75 -25.714399999999998 -4.897999 10.1513 -3438.58 -3438.58 -3438.58 -26.714399999999998 -5.897999 9.1513 -1752.08 -1752.08 -1752.08 -26.714399999999998 -4.897999 9.1513 -8599.35 -8599.35 -8599.35 -26.714399999999998 -4.897999 10.1513 2789.83 2789.83 2789.83 -25.714399999999998 -5.897999 12.1513 9269.68 9269.68 9269.68 -26.714399999999998 -5.897999 12.1513 -465361.0 -465361.0 -465361.0 -28.714399999999998 -7.897999 10.1513 853.025 853.025 853.025 -28.714399999999998 -6.897999 9.1513 566.923 566.923 566.923 -28.714399999999998 -6.897999 10.1513 -96.5482 -96.5482 -96.5482 -27.714399999999998 -7.897999 11.1513 -23453.1 -23453.1 -23453.1 -27.714399999999998 -7.897999 12.1513 225260.0 225260.0 225260.0 -27.714399999999998 -6.897999 12.1513 665978.0 665978.0 665978.0 -28.714399999999998 -7.897999 11.1513 -156710.0 -156710.0 -156710.0 -28.714399999999998 -7.897999 12.1513 289467.0 289467.0 289467.0 -28.714399999999998 -6.897999 11.1513 -316558.0 -316558.0 -316558.0 -28.714399999999998 -6.897999 12.1513 -58020.3 -58020.3 -58020.3 -27.714399999999998 -5.897999 9.1513 939.896 939.896 939.896 -27.714399999999998 -4.897999 9.1513 796.048 796.048 796.048 -27.714399999999998 -4.897999 10.1513 -5434.9 -5434.9 -5434.9 -28.714399999999998 -5.897999 9.1513 -715.905 -715.905 -715.905 -28.714399999999998 -5.897999 10.1513 1590.48 1590.48 1590.48 -28.714399999999998 -4.897999 9.1513 -408.432 -408.432 -408.432 -28.714399999999998 -4.897999 10.1513 3139.09 3139.09 3139.09 -27.714399999999998 -5.897999 12.1513 200560.0 200560.0 200560.0 -27.714399999999998 -4.897999 12.1513 -280.635 -280.635 -280.635 -25.714399999999998 -2.897999 6.151300000000001 721.217 721.217 721.217 -25.714399999999998 -3.897999 7.151300000000001 32.1389 32.1389 32.1389 -25.714399999999998 -3.897999 8.1513 7943.0 7943.0 7943.0 -25.714399999999998 -2.897999 7.151300000000001 2844.91 2844.91 2844.91 -25.714399999999998 -2.897999 8.1513 8459.94 8459.94 8459.94 -26.714399999999998 -3.897999 7.151300000000001 3474.26 3474.26 3474.26 -26.714399999999998 -3.897999 8.1513 2749.12 2749.12 2749.12 -26.714399999999998 -2.897999 7.151300000000001 -5034.06 -5034.06 -5034.06 -26.714399999999998 -2.897999 8.1513 9171.23 9171.23 9171.23 -25.714399999999998 -1.897999 6.151300000000001 489.956 489.956 489.956 -25.714399999999998 -0.897999 6.151300000000001 47274.7 47274.7 47274.7 -25.714399999999998 -1.897999 7.151300000000001 1237.78 1237.78 1237.78 -25.714399999999998 -1.897999 8.1513 5392.06 5392.06 5392.06 -25.714399999999998 -0.897999 7.151300000000001 -16753.7 -16753.7 -16753.7 -25.714399999999998 -0.897999 8.1513 -61931.6 -61931.6 -61931.6 -26.714399999999998 -1.897999 7.151300000000001 -1584.23 -1584.23 -1584.23 -26.714399999999998 -1.897999 8.1513 1650.12 1650.12 1650.12 -26.714399999999998 -0.897999 7.151300000000001 339.154 339.154 339.154 -26.714399999999998 -0.897999 8.1513 -933.12 -933.12 -933.12 -27.714399999999998 -2.897999 6.151300000000001 2038.81 2038.81 2038.81 -28.714399999999998 -3.897999 6.151300000000001 -1584.8 -1584.8 -1584.8 -28.714399999999998 -2.897999 5.151300000000001 -1481.51 -1481.51 -1481.51 -28.714399999999998 -2.897999 6.151300000000001 -4964.41 -4964.41 -4964.41 -27.714399999999998 -3.897999 7.151300000000001 1277.82 1277.82 1277.82 -27.714399999999998 -3.897999 8.1513 -548.229 -548.229 -548.229 -27.714399999999998 -2.897999 7.151300000000001 584.903 584.903 584.903 -28.714399999999998 -3.897999 7.151300000000001 -1030.56 -1030.56 -1030.56 -28.714399999999998 -2.897999 7.151300000000001 7291.25 7291.25 7291.25 -28.714399999999998 -1.897999 5.151300000000001 -5199.67 -5199.67 -5199.67 -28.714399999999998 -1.897999 6.151300000000001 -6337.56 -6337.56 -6337.56 -28.714399999999998 -0.897999 5.151300000000001 8929.63 8929.63 8929.63 -28.714399999999998 -0.897999 6.151300000000001 297.87 297.87 297.87 -27.714399999999998 -1.897999 7.151300000000001 6.72943 6.72943 6.72943 -27.714399999999998 -1.897999 8.1513 1471.25 1471.25 1471.25 -28.714399999999998 -1.897999 7.151300000000001 -5464.05 -5464.05 -5464.05 -28.714399999999998 -1.897999 8.1513 -100.682 -100.682 -100.682 -28.714399999999998 -0.897999 7.151300000000001 -7198.09 -7198.09 -7198.09 -28.714399999999998 -0.897999 8.1513 -426.504 -426.504 -426.504 -25.714399999999998 -3.897999 9.1513 -1278.48 -1278.48 -1278.48 -25.714399999999998 -3.897999 10.1513 -8999.66 -8999.66 -8999.66 -25.714399999999998 -2.897999 9.1513 1068.13 1068.13 1068.13 -26.714399999999998 -3.897999 9.1513 -6184.11 -6184.11 -6184.11 -26.714399999999998 -3.897999 10.1513 -11873.0 -11873.0 -11873.0 -26.714399999999998 -2.897999 9.1513 9492.11 9492.11 9492.11 -26.714399999999998 -2.897999 10.1513 5439.0 5439.0 5439.0 -25.714399999999998 -3.897999 11.1513 1282.02 1282.02 1282.02 -25.714399999999998 -3.897999 12.1513 2427.83 2427.83 2427.83 -25.714399999999998 -2.897999 11.1513 -2398.12 -2398.12 -2398.12 -25.714399999999998 -2.897999 12.1513 -832.253 -832.253 -832.253 -26.714399999999998 -3.897999 11.1513 3022.29 3022.29 3022.29 -26.714399999999998 -3.897999 12.1513 688.089 688.089 688.089 -26.714399999999998 -2.897999 11.1513 4505.97 4505.97 4505.97 -26.714399999999998 -2.897999 12.1513 235.647 235.647 235.647 -26.714399999999998 -1.897999 9.1513 -5766.72 -5766.72 -5766.72 -26.714399999999998 -1.897999 10.1513 -3485.13 -3485.13 -3485.13 -26.714399999999998 -0.897999 9.1513 1072.4 1072.4 1072.4 -26.714399999999998 -0.897999 10.1513 -68.6131 -68.6131 -68.6131 -26.714399999999998 -1.897999 12.1513 -116.539 -116.539 -116.539 -27.714399999999998 -3.897999 9.1513 514.248 514.248 514.248 -27.714399999999998 -3.897999 10.1513 -2573.43 -2573.43 -2573.43 -27.714399999999998 -2.897999 9.1513 5728.93 5728.93 5728.93 -27.714399999999998 -2.897999 10.1513 4327.92 4327.92 4327.92 -28.714399999999998 -3.897999 9.1513 -659.659 -659.659 -659.659 -28.714399999999998 -3.897999 10.1513 -308.144 -308.144 -308.144 -28.714399999999998 -2.897999 9.1513 -10.153 -10.153 -10.153 -28.714399999999998 -2.897999 10.1513 738.013 738.013 738.013 -27.714399999999998 -3.897999 11.1513 470.826 470.826 470.826 -27.714399999999998 -3.897999 12.1513 245.256 245.256 245.256 -27.714399999999998 -2.897999 11.1513 2017.27 2017.27 2017.27 -27.714399999999998 -2.897999 12.1513 285.669 285.669 285.669 -28.714399999999998 -3.897999 11.1513 1033.88 1033.88 1033.88 -28.714399999999998 -2.897999 11.1513 -59.5847 -59.5847 -59.5847 -28.714399999999998 -2.897999 12.1513 257.536 257.536 257.536 -27.714399999999998 -1.897999 9.1513 -5209.29 -5209.29 -5209.29 -27.714399999999998 -1.897999 10.1513 -2903.35 -2903.35 -2903.35 -27.714399999999998 -0.897999 10.1513 3522.46 3522.46 3522.46 -28.714399999999998 -1.897999 9.1513 -3910.25 -3910.25 -3910.25 -28.714399999999998 -1.897999 10.1513 4057.05 4057.05 4057.05 -28.714399999999998 -0.897999 10.1513 8112.23 8112.23 8112.23 -27.714399999999998 -1.897999 12.1513 919.97 919.97 919.97 -28.714399999999998 -1.897999 11.1513 -7747.16 -7747.16 -7747.16 -28.714399999999998 -1.897999 12.1513 588.133 588.133 588.133 -28.714399999999998 -0.897999 11.1513 -6694.81 -6694.81 -6694.81 -28.714399999999998 -0.897999 12.1513 332.891 332.891 332.891 -29.714399999999998 -9.897999 3.151300000000001 -123027.0 -123027.0 -123027.0 -29.714399999999998 -9.897999 4.151300000000001 -65612.0 -65612.0 -65612.0 -29.714399999999998 -8.897999 3.151300000000001 -72017.5 -72017.5 -72017.5 -29.714399999999998 -8.897999 4.151300000000001 81775.6 81775.6 81775.6 -30.714399999999998 -9.897999 3.151300000000001 14849.9 14849.9 14849.9 -30.714399999999998 -9.897999 4.151300000000001 -27963.4 -27963.4 -27963.4 -30.714399999999998 -8.897999 3.151300000000001 27688.3 27688.3 27688.3 -30.714399999999998 -8.897999 4.151300000000001 -28430.5 -28430.5 -28430.5 -31.714399999999998 -8.897999 4.151300000000001 7531.62 7531.62 7531.62 -30.714399999999998 -12.897999 11.1513 9784.94 9784.94 9784.94 -30.714399999999998 -12.897999 12.1513 12989.7 12989.7 12989.7 -32.7144 -12.897999 9.1513 -27586.9 -27586.9 -27586.9 -32.7144 -12.897999 10.1513 -33327.2 -33327.2 -33327.2 -31.714399999999998 -12.897999 11.1513 -56769.7 -56769.7 -56769.7 -31.714399999999998 -12.897999 12.1513 -50915.8 -50915.8 -50915.8 -32.7144 -12.897999 11.1513 -48574.5 -48574.5 -48574.5 -32.7144 -12.897999 12.1513 -24044.9 -24044.9 -24044.9 -29.714399999999998 -9.897999 5.151300000000001 -61090.9 -61090.9 -61090.9 -29.714399999999998 -9.897999 6.151300000000001 16390.8 16390.8 16390.8 -29.714399999999998 -8.897999 6.151300000000001 -17091.2 -17091.2 -17091.2 -30.714399999999998 -9.897999 5.151300000000001 12411.6 12411.6 12411.6 -30.714399999999998 -9.897999 6.151300000000001 -2469.09 -2469.09 -2469.09 -30.714399999999998 -8.897999 5.151300000000001 -127.892 -127.892 -127.892 -30.714399999999998 -8.897999 6.151300000000001 -4817.55 -4817.55 -4817.55 -29.714399999999998 -9.897999 8.1513 -1450.18 -1450.18 -1450.18 -29.714399999999998 -8.897999 7.151300000000001 -18424.5 -18424.5 -18424.5 -29.714399999999998 -8.897999 8.1513 1529.75 1529.75 1529.75 -30.714399999999998 -8.897999 7.151300000000001 -7945.34 -7945.34 -7945.34 -30.714399999999998 -8.897999 8.1513 -491.183 -491.183 -491.183 -31.714399999999998 -10.897999 8.1513 -127.594 -127.594 -127.594 -32.7144 -11.897999 8.1513 -11041.7 -11041.7 -11041.7 -32.7144 -10.897999 7.151300000000001 -168.018 -168.018 -168.018 -32.7144 -10.897999 8.1513 640.02 640.02 640.02 -31.714399999999998 -8.897999 5.151300000000001 -13063.2 -13063.2 -13063.2 -31.714399999999998 -8.897999 6.151300000000001 -2737.68 -2737.68 -2737.68 -31.714399999999998 -9.897999 8.1513 -334.086 -334.086 -334.086 -31.714399999999998 -8.897999 7.151300000000001 -591.05 -591.05 -591.05 -31.714399999999998 -8.897999 8.1513 298.159 298.159 298.159 -32.7144 -9.897999 8.1513 2135.01 2135.01 2135.01 -32.7144 -8.897999 7.151300000000001 445.676 445.676 445.676 -32.7144 -8.897999 8.1513 809.55 809.55 809.55 -29.714399999999998 -11.897999 10.1513 16434.1 16434.1 16434.1 -29.714399999999998 -10.897999 10.1513 20987.4 20987.4 20987.4 -30.714399999999998 -11.897999 10.1513 35846.2 35846.2 35846.2 -30.714399999999998 -10.897999 10.1513 3782.29 3782.29 3782.29 -29.714399999999998 -11.897999 11.1513 6787.36 6787.36 6787.36 -29.714399999999998 -11.897999 12.1513 268.897 268.897 268.897 -29.714399999999998 -10.897999 11.1513 -6926.43 -6926.43 -6926.43 -29.714399999999998 -10.897999 12.1513 -27781.8 -27781.8 -27781.8 -30.714399999999998 -11.897999 11.1513 -1248.21 -1248.21 -1248.21 -30.714399999999998 -11.897999 12.1513 11139.1 11139.1 11139.1 -29.714399999999998 -9.897999 9.1513 -2096.02 -2096.02 -2096.02 -29.714399999999998 -9.897999 10.1513 1852.17 1852.17 1852.17 -29.714399999999998 -8.897999 9.1513 356.584 356.584 356.584 -29.714399999999998 -8.897999 10.1513 525.595 525.595 525.595 -30.714399999999998 -9.897999 10.1513 916.247 916.247 916.247 -30.714399999999998 -8.897999 9.1513 -1308.87 -1308.87 -1308.87 -30.714399999999998 -8.897999 10.1513 1822.65 1822.65 1822.65 -29.714399999999998 -9.897999 11.1513 -1774.32 -1774.32 -1774.32 -29.714399999999998 -9.897999 12.1513 -1471.63 -1471.63 -1471.63 -29.714399999999998 -8.897999 11.1513 -1483.89 -1483.89 -1483.89 -29.714399999999998 -8.897999 12.1513 2099.73 2099.73 2099.73 -30.714399999999998 -9.897999 11.1513 1605.62 1605.62 1605.62 -30.714399999999998 -8.897999 11.1513 289.712 289.712 289.712 -31.714399999999998 -11.897999 9.1513 -31306.9 -31306.9 -31306.9 -31.714399999999998 -11.897999 10.1513 8943.17 8943.17 8943.17 -31.714399999999998 -10.897999 9.1513 -3578.37 -3578.37 -3578.37 -31.714399999999998 -10.897999 10.1513 -4226.32 -4226.32 -4226.32 -32.7144 -11.897999 9.1513 13698.7 13698.7 13698.7 -32.7144 -11.897999 10.1513 32878.8 32878.8 32878.8 -32.7144 -10.897999 10.1513 -1665.75 -1665.75 -1665.75 -31.714399999999998 -11.897999 11.1513 25495.1 25495.1 25495.1 -32.7144 -11.897999 11.1513 -23047.4 -23047.4 -23047.4 -32.7144 -10.897999 11.1513 4344.48 4344.48 4344.48 -32.7144 -10.897999 12.1513 2752.69 2752.69 2752.69 -31.714399999999998 -9.897999 9.1513 -2617.02 -2617.02 -2617.02 -31.714399999999998 -9.897999 10.1513 -2788.41 -2788.41 -2788.41 -31.714399999999998 -8.897999 9.1513 275.895 275.895 275.895 -31.714399999999998 -8.897999 10.1513 339.221 339.221 339.221 -32.7144 -9.897999 9.1513 -356.912 -356.912 -356.912 -32.7144 -9.897999 10.1513 755.438 755.438 755.438 -32.7144 -8.897999 9.1513 -447.754 -447.754 -447.754 -32.7144 -8.897999 10.1513 3396.39 3396.39 3396.39 -31.714399999999998 -9.897999 11.1513 -5303.67 -5303.67 -5303.67 -31.714399999999998 -8.897999 11.1513 2032.99 2032.99 2032.99 -32.7144 -9.897999 11.1513 5531.6 5531.6 5531.6 -32.7144 -9.897999 12.1513 231.018 231.018 231.018 -32.7144 -8.897999 11.1513 22.2856 22.2856 22.2856 -32.7144 -8.897999 12.1513 1973.55 1973.55 1973.55 -33.7144 -12.897999 6.151300000000001 6111.45 6111.45 6111.45 -34.7144 -12.897999 6.151300000000001 -11785.6 -11785.6 -11785.6 -33.7144 -12.897999 7.151300000000001 -3396.14 -3396.14 -3396.14 -33.7144 -12.897999 8.1513 605.256 605.256 605.256 -34.7144 -12.897999 7.151300000000001 6161.39 6161.39 6161.39 -34.7144 -12.897999 8.1513 3879.64 3879.64 3879.64 -35.7144 -12.897999 6.151300000000001 -3089.18 -3089.18 -3089.18 -35.7144 -12.897999 7.151300000000001 -5576.6 -5576.6 -5576.6 -35.7144 -12.897999 8.1513 -3069.87 -3069.87 -3069.87 -33.7144 -12.897999 9.1513 7259.51 7259.51 7259.51 -33.7144 -12.897999 10.1513 -1009.07 -1009.07 -1009.07 -34.7144 -12.897999 10.1513 3817.54 3817.54 3817.54 -33.7144 -12.897999 12.1513 -8502.84 -8502.84 -8502.84 -33.7144 -11.897999 5.151300000000001 1314.75 1314.75 1314.75 -33.7144 -11.897999 6.151300000000001 190.151 190.151 190.151 -33.7144 -10.897999 5.151300000000001 2677.55 2677.55 2677.55 -33.7144 -10.897999 6.151300000000001 -1785.7 -1785.7 -1785.7 -34.7144 -11.897999 5.151300000000001 1574.31 1574.31 1574.31 -34.7144 -11.897999 6.151300000000001 1343.07 1343.07 1343.07 -34.7144 -10.897999 5.151300000000001 721.366 721.366 721.366 -34.7144 -10.897999 6.151300000000001 -2724.28 -2724.28 -2724.28 -33.7144 -11.897999 7.151300000000001 -1783.26 -1783.26 -1783.26 -33.7144 -11.897999 8.1513 190.398 190.398 190.398 -33.7144 -10.897999 7.151300000000001 852.725 852.725 852.725 -33.7144 -10.897999 8.1513 -1245.46 -1245.46 -1245.46 -34.7144 -11.897999 8.1513 3339.65 3339.65 3339.65 -33.7144 -9.897999 6.151300000000001 833.066 833.066 833.066 -34.7144 -9.897999 6.151300000000001 -4057.09 -4057.09 -4057.09 -34.7144 -8.897999 6.151300000000001 -8299.18 -8299.18 -8299.18 -33.7144 -9.897999 7.151300000000001 591.119 591.119 591.119 -33.7144 -9.897999 8.1513 -955.795 -955.795 -955.795 -33.7144 -8.897999 7.151300000000001 -661.712 -661.712 -661.712 -33.7144 -8.897999 8.1513 431.994 431.994 431.994 -34.7144 -9.897999 7.151300000000001 -1316.25 -1316.25 -1316.25 -34.7144 -8.897999 7.151300000000001 4723.33 4723.33 4723.33 -34.7144 -8.897999 8.1513 -8774.31 -8774.31 -8774.31 -35.7144 -11.897999 5.151300000000001 -53.2702 -53.2702 -53.2702 -35.7144 -11.897999 6.151300000000001 2086.29 2086.29 2086.29 -35.7144 -10.897999 5.151300000000001 -1610.46 -1610.46 -1610.46 -35.7144 -10.897999 6.151300000000001 -4539.45 -4539.45 -4539.45 -36.7144 -11.897999 6.151300000000001 -5268.21 -5268.21 -5268.21 -36.7144 -10.897999 6.151300000000001 5344.7 5344.7 5344.7 -35.7144 -11.897999 7.151300000000001 10520.3 10520.3 10520.3 -35.7144 -11.897999 8.1513 8170.7 8170.7 8170.7 -36.7144 -11.897999 7.151300000000001 -14357.5 -14357.5 -14357.5 -36.7144 -11.897999 8.1513 -14107.7 -14107.7 -14107.7 -36.7144 -10.897999 7.151300000000001 -417.632 -417.632 -417.632 -36.7144 -10.897999 8.1513 8123.82 8123.82 8123.82 -35.7144 -9.897999 6.151300000000001 -746.451 -746.451 -746.451 -35.7144 -8.897999 6.151300000000001 1504.06 1504.06 1504.06 -36.7144 -9.897999 6.151300000000001 -2040.21 -2040.21 -2040.21 -35.7144 -8.897999 7.151300000000001 835.755 835.755 835.755 -35.7144 -8.897999 8.1513 1965.38 1965.38 1965.38 -36.7144 -9.897999 7.151300000000001 -1996.3 -1996.3 -1996.3 -36.7144 -9.897999 8.1513 -8529.94 -8529.94 -8529.94 -36.7144 -8.897999 7.151300000000001 4331.55 4331.55 4331.55 -36.7144 -8.897999 8.1513 -12605.6 -12605.6 -12605.6 -33.7144 -11.897999 9.1513 2685.94 2685.94 2685.94 -33.7144 -11.897999 10.1513 -3102.39 -3102.39 -3102.39 -33.7144 -10.897999 10.1513 3424.11 3424.11 3424.11 -34.7144 -11.897999 9.1513 5566.76 5566.76 5566.76 -34.7144 -11.897999 10.1513 4479.25 4479.25 4479.25 -34.7144 -10.897999 9.1513 -1000.93 -1000.93 -1000.93 -34.7144 -10.897999 10.1513 -2898.96 -2898.96 -2898.96 -33.7144 -11.897999 11.1513 4.47791 4.47791 4.47791 -33.7144 -11.897999 12.1513 -27.4982 -27.4982 -27.4982 -33.7144 -10.897999 11.1513 -3493.37 -3493.37 -3493.37 -33.7144 -10.897999 12.1513 200.979 200.979 200.979 -34.7144 -11.897999 11.1513 3302.02 3302.02 3302.02 -34.7144 -10.897999 11.1513 -6718.09 -6718.09 -6718.09 -33.7144 -9.897999 10.1513 -282.684 -282.684 -282.684 -33.7144 -8.897999 9.1513 2146.84 2146.84 2146.84 -33.7144 -8.897999 10.1513 2167.11 2167.11 2167.11 -34.7144 -9.897999 10.1513 -15285.8 -15285.8 -15285.8 -34.7144 -8.897999 9.1513 4029.08 4029.08 4029.08 -34.7144 -8.897999 10.1513 -11321.2 -11321.2 -11321.2 -33.7144 -9.897999 11.1513 3618.97 3618.97 3618.97 -33.7144 -9.897999 12.1513 16458.1 16458.1 16458.1 -33.7144 -8.897999 11.1513 1823.05 1823.05 1823.05 -33.7144 -8.897999 12.1513 -13389.4 -13389.4 -13389.4 -34.7144 -8.897999 11.1513 -9075.1 -9075.1 -9075.1 -34.7144 -8.897999 12.1513 -25444.9 -25444.9 -25444.9 -35.7144 -11.897999 9.1513 2250.67 2250.67 2250.67 -35.7144 -10.897999 9.1513 -438.166 -438.166 -438.166 -35.7144 -10.897999 10.1513 -1683.63 -1683.63 -1683.63 -36.7144 -11.897999 9.1513 -2513.82 -2513.82 -2513.82 -36.7144 -11.897999 10.1513 -4159.99 -4159.99 -4159.99 -36.7144 -10.897999 9.1513 10467.8 10467.8 10467.8 -36.7144 -10.897999 10.1513 3668.79 3668.79 3668.79 -36.7144 -10.897999 11.1513 -7668.71 -7668.71 -7668.71 -35.7144 -9.897999 9.1513 27846.3 27846.3 27846.3 -35.7144 -9.897999 10.1513 5650.35 5650.35 5650.35 -35.7144 -8.897999 9.1513 16467.7 16467.7 16467.7 -35.7144 -8.897999 10.1513 11077.8 11077.8 11077.8 -36.7144 -9.897999 9.1513 -13148.4 -13148.4 -13148.4 -36.7144 -9.897999 10.1513 3279.31 3279.31 3279.31 -36.7144 -8.897999 9.1513 -31783.7 -31783.7 -31783.7 -36.7144 -8.897999 10.1513 8180.86 8180.86 8180.86 -35.7144 -9.897999 12.1513 -99707.2 -99707.2 -99707.2 -35.7144 -8.897999 11.1513 -79588.2 -79588.2 -79588.2 -35.7144 -8.897999 12.1513 143177.0 143177.0 143177.0 -36.7144 -9.897999 11.1513 112587.0 112587.0 112587.0 -36.7144 -9.897999 12.1513 89544.7 89544.7 89544.7 -36.7144 -8.897999 11.1513 185704.0 185704.0 185704.0 -36.7144 -8.897999 12.1513 109436.0 109436.0 109436.0 -29.714399999999998 -7.897999 3.151300000000001 2977.24 2977.24 2977.24 -29.714399999999998 -6.897999 3.151300000000001 -1046.27 -1046.27 -1046.27 -29.714399999999998 -6.897999 4.151300000000001 18430.0 18430.0 18430.0 -30.714399999999998 -7.897999 3.151300000000001 24574.5 24574.5 24574.5 -30.714399999999998 -7.897999 4.151300000000001 4905.13 4905.13 4905.13 -30.714399999999998 -6.897999 3.151300000000001 5111.23 5111.23 5111.23 -30.714399999999998 -6.897999 4.151300000000001 13394.2 13394.2 13394.2 -30.714399999999998 -4.897999 4.151300000000001 -1064.23 -1064.23 -1064.23 -31.714399999999998 -7.897999 4.151300000000001 30682.5 30682.5 30682.5 -31.714399999999998 -6.897999 4.151300000000001 1164.34 1164.34 1164.34 -31.714399999999998 -4.897999 2.151300000000001 1365.26 1365.26 1365.26 -32.7144 -4.897999 2.151300000000001 3335.13 3335.13 3335.13 -31.714399999999998 -5.897999 4.151300000000001 -23128.7 -23128.7 -23128.7 -31.714399999999998 -4.897999 3.151300000000001 -3728.96 -3728.96 -3728.96 -31.714399999999998 -4.897999 4.151300000000001 -4071.52 -4071.52 -4071.52 -32.7144 -5.897999 4.151300000000001 -1300.77 -1300.77 -1300.77 -32.7144 -4.897999 3.151300000000001 -5396.61 -5396.61 -5396.61 -32.7144 -4.897999 4.151300000000001 1629.76 1629.76 1629.76 -31.714399999999998 -0.897999 0.15130000000000088 -3883.55 -3883.55 -3883.55 -32.7144 -0.897999 -0.8486999999999991 4337.75 4337.75 4337.75 -32.7144 -0.897999 0.15130000000000088 -1641.74 -1641.74 -1641.74 -30.714399999999998 -3.897999 2.151300000000001 -836.718 -836.718 -836.718 -30.714399999999998 -2.897999 1.1513000000000009 710.123 710.123 710.123 -30.714399999999998 -2.897999 2.151300000000001 -2187.54 -2187.54 -2187.54 -29.714399999999998 -3.897999 3.151300000000001 873.154 873.154 873.154 -29.714399999999998 -3.897999 4.151300000000001 3179.23 3179.23 3179.23 -29.714399999999998 -2.897999 3.151300000000001 2658.04 2658.04 2658.04 -29.714399999999998 -2.897999 4.151300000000001 639.081 639.081 639.081 -30.714399999999998 -3.897999 3.151300000000001 -1937.2 -1937.2 -1937.2 -30.714399999999998 -3.897999 4.151300000000001 3125.4 3125.4 3125.4 -30.714399999999998 -2.897999 3.151300000000001 966.439 966.439 966.439 -30.714399999999998 -1.897999 2.151300000000001 15.4182 15.4182 15.4182 -29.714399999999998 -1.897999 3.151300000000001 1881.62 1881.62 1881.62 -29.714399999999998 -1.897999 4.151300000000001 -988.757 -988.757 -988.757 -30.714399999999998 -1.897999 3.151300000000001 -1600.71 -1600.71 -1600.71 -30.714399999999998 -1.897999 4.151300000000001 4074.5 4074.5 4074.5 -30.714399999999998 -0.897999 4.151300000000001 -1972.94 -1972.94 -1972.94 -31.714399999999998 -3.897999 1.1513000000000009 714.843 714.843 714.843 -31.714399999999998 -3.897999 2.151300000000001 -2506.41 -2506.41 -2506.41 -31.714399999999998 -2.897999 1.1513000000000009 704.207 704.207 704.207 -31.714399999999998 -2.897999 2.151300000000001 751.581 751.581 751.581 -32.7144 -3.897999 1.1513000000000009 359.381 359.381 359.381 -32.7144 -3.897999 2.151300000000001 757.584 757.584 757.584 -32.7144 -2.897999 1.1513000000000009 2186.06 2186.06 2186.06 -32.7144 -2.897999 2.151300000000001 206.079 206.079 206.079 -31.714399999999998 -3.897999 3.151300000000001 -1841.53 -1841.53 -1841.53 -31.714399999999998 -3.897999 4.151300000000001 -6841.94 -6841.94 -6841.94 -32.7144 -3.897999 3.151300000000001 -6054.51 -6054.51 -6054.51 -32.7144 -3.897999 4.151300000000001 9745.9 9745.9 9745.9 -32.7144 -2.897999 4.151300000000001 10591.6 10591.6 10591.6 -31.714399999999998 -1.897999 1.1513000000000009 -113.797 -113.797 -113.797 -31.714399999999998 -1.897999 2.151300000000001 -4729.84 -4729.84 -4729.84 -31.714399999999998 -0.897999 1.1513000000000009 13675.1 13675.1 13675.1 -31.714399999999998 -0.897999 2.151300000000001 9853.47 9853.47 9853.47 -32.7144 -1.897999 1.1513000000000009 7539.62 7539.62 7539.62 -32.7144 -1.897999 2.151300000000001 -5834.42 -5834.42 -5834.42 -32.7144 -0.897999 1.1513000000000009 -9825.42 -9825.42 -9825.42 -32.7144 -0.897999 2.151300000000001 -6531.97 -6531.97 -6531.97 -31.714399999999998 -1.897999 3.151300000000001 6054.53 6054.53 6054.53 -31.714399999999998 -0.897999 3.151300000000001 -7081.54 -7081.54 -7081.54 -31.714399999999998 -0.897999 4.151300000000001 -1661.93 -1661.93 -1661.93 -32.7144 -1.897999 3.151300000000001 120.947 120.947 120.947 -32.7144 -1.897999 4.151300000000001 -3253.68 -3253.68 -3253.68 -32.7144 -0.897999 3.151300000000001 1446.76 1446.76 1446.76 -32.7144 -0.897999 4.151300000000001 1503.14 1503.14 1503.14 -34.7144 -6.897999 3.151300000000001 -1399.74 -1399.74 -1399.74 -34.7144 -6.897999 4.151300000000001 -1593.28 -1593.28 -1593.28 -34.7144 -4.897999 2.151300000000001 1844.96 1844.96 1844.96 -33.7144 -5.897999 3.151300000000001 950.79 950.79 950.79 -33.7144 -5.897999 4.151300000000001 -277.184 -277.184 -277.184 -33.7144 -4.897999 3.151300000000001 -1977.36 -1977.36 -1977.36 -33.7144 -4.897999 4.151300000000001 1222.5 1222.5 1222.5 -34.7144 -5.897999 3.151300000000001 132.968 132.968 132.968 -34.7144 -5.897999 4.151300000000001 -7702.89 -7702.89 -7702.89 -34.7144 -4.897999 3.151300000000001 -504.872 -504.872 -504.872 -35.7144 -6.897999 3.151300000000001 1008.82 1008.82 1008.82 -35.7144 -6.897999 4.151300000000001 -71.2506 -71.2506 -71.2506 -36.7144 -6.897999 4.151300000000001 -2964.46 -2964.46 -2964.46 -35.7144 -5.897999 2.151300000000001 -165.764 -165.764 -165.764 -35.7144 -4.897999 2.151300000000001 1249.61 1249.61 1249.61 -35.7144 -5.897999 3.151300000000001 131.616 131.616 131.616 -35.7144 -4.897999 3.151300000000001 770.353 770.353 770.353 -36.7144 -5.897999 3.151300000000001 -425.517 -425.517 -425.517 -36.7144 -5.897999 4.151300000000001 3399.45 3399.45 3399.45 -36.7144 -4.897999 3.151300000000001 -2917.1 -2917.1 -2917.1 -36.7144 -4.897999 4.151300000000001 1690.46 1690.46 1690.46 -33.7144 -0.897999 -0.8486999999999991 258.495 258.495 258.495 -33.7144 -0.897999 0.15130000000000088 -1771.07 -1771.07 -1771.07 -34.7144 -1.897999 0.15130000000000088 161.653 161.653 161.653 -34.7144 -0.897999 -0.8486999999999991 2943.41 2943.41 2943.41 -34.7144 -0.897999 0.15130000000000088 -593.25 -593.25 -593.25 -35.7144 -2.897999 0.15130000000000088 -5491.06 -5491.06 -5491.06 -36.7144 -2.897999 0.15130000000000088 -17575.2 -17575.2 -17575.2 -35.7144 -1.897999 -0.8486999999999991 3835.05 3835.05 3835.05 -35.7144 -1.897999 0.15130000000000088 -1333.8 -1333.8 -1333.8 -35.7144 -0.897999 -0.8486999999999991 3802.87 3802.87 3802.87 -35.7144 -0.897999 0.15130000000000088 4394.46 4394.46 4394.46 -36.7144 -1.897999 -0.8486999999999991 -2603.11 -2603.11 -2603.11 -36.7144 -1.897999 0.15130000000000088 20572.1 20572.1 20572.1 -36.7144 -0.897999 -0.8486999999999991 -3694.64 -3694.64 -3694.64 -36.7144 -0.897999 0.15130000000000088 2487.65 2487.65 2487.65 -33.7144 -3.897999 2.151300000000001 -1626.06 -1626.06 -1626.06 -33.7144 -2.897999 2.151300000000001 2628.15 2628.15 2628.15 -34.7144 -2.897999 1.1513000000000009 -3564.11 -3564.11 -3564.11 -33.7144 -3.897999 3.151300000000001 -375.838 -375.838 -375.838 -33.7144 -3.897999 4.151300000000001 7360.65 7360.65 7360.65 -33.7144 -2.897999 3.151300000000001 -1484.15 -1484.15 -1484.15 -33.7144 -2.897999 4.151300000000001 -354.618 -354.618 -354.618 -34.7144 -3.897999 3.151300000000001 -1332.98 -1332.98 -1332.98 -34.7144 -2.897999 3.151300000000001 167.207 167.207 167.207 -34.7144 -2.897999 4.151300000000001 847.435 847.435 847.435 -33.7144 -1.897999 2.151300000000001 4532.33 4532.33 4532.33 -33.7144 -0.897999 1.1513000000000009 -405.781 -405.781 -405.781 -33.7144 -0.897999 2.151300000000001 -4762.27 -4762.27 -4762.27 -34.7144 -1.897999 1.1513000000000009 -880.841 -880.841 -880.841 -34.7144 -1.897999 2.151300000000001 546.121 546.121 546.121 -34.7144 -0.897999 1.1513000000000009 -5284.78 -5284.78 -5284.78 -34.7144 -0.897999 2.151300000000001 -576.127 -576.127 -576.127 -33.7144 -1.897999 3.151300000000001 -10708.2 -10708.2 -10708.2 -33.7144 -1.897999 4.151300000000001 -5999.17 -5999.17 -5999.17 -33.7144 -0.897999 4.151300000000001 -1865.61 -1865.61 -1865.61 -34.7144 -1.897999 3.151300000000001 5164.11 5164.11 5164.11 -34.7144 -1.897999 4.151300000000001 11294.3 11294.3 11294.3 -34.7144 -0.897999 3.151300000000001 -6977.11 -6977.11 -6977.11 -34.7144 -0.897999 4.151300000000001 4456.5 4456.5 4456.5 -35.7144 -2.897999 1.1513000000000009 387.426 387.426 387.426 -35.7144 -2.897999 2.151300000000001 997.716 997.716 997.716 -36.7144 -2.897999 1.1513000000000009 2339.93 2339.93 2339.93 -36.7144 -2.897999 2.151300000000001 -15064.2 -15064.2 -15064.2 -35.7144 -3.897999 3.151300000000001 1056.81 1056.81 1056.81 -35.7144 -2.897999 3.151300000000001 879.685 879.685 879.685 -35.7144 -2.897999 4.151300000000001 -7100.43 -7100.43 -7100.43 -36.7144 -3.897999 3.151300000000001 764.801 764.801 764.801 -36.7144 -3.897999 4.151300000000001 3442.62 3442.62 3442.62 -36.7144 -2.897999 3.151300000000001 -1146.7 -1146.7 -1146.7 -36.7144 -2.897999 4.151300000000001 -3109.29 -3109.29 -3109.29 -35.7144 -1.897999 2.151300000000001 -2099.99 -2099.99 -2099.99 -35.7144 -0.897999 1.1513000000000009 -2006.03 -2006.03 -2006.03 -35.7144 -0.897999 2.151300000000001 1023.71 1023.71 1023.71 -36.7144 -1.897999 2.151300000000001 -13805.8 -13805.8 -13805.8 -36.7144 -0.897999 2.151300000000001 5281.78 5281.78 5281.78 -35.7144 -1.897999 3.151300000000001 1977.92 1977.92 1977.92 -35.7144 -1.897999 4.151300000000001 -1764.08 -1764.08 -1764.08 -35.7144 -0.897999 3.151300000000001 -4127.6 -4127.6 -4127.6 -35.7144 -0.897999 4.151300000000001 2633.63 2633.63 2633.63 -36.7144 -1.897999 3.151300000000001 -5135.76 -5135.76 -5135.76 -29.714399999999998 -6.897999 5.151300000000001 4135.45 4135.45 4135.45 -30.714399999999998 -7.897999 5.151300000000001 804.274 804.274 804.274 -30.714399999999998 -7.897999 6.151300000000001 -11380.5 -11380.5 -11380.5 -30.714399999999998 -6.897999 5.151300000000001 -6321.0 -6321.0 -6321.0 -30.714399999999998 -6.897999 6.151300000000001 -10616.7 -10616.7 -10616.7 -29.714399999999998 -7.897999 8.1513 1381.8 1381.8 1381.8 -29.714399999999998 -6.897999 8.1513 -1155.97 -1155.97 -1155.97 -30.714399999999998 -7.897999 7.151300000000001 -7613.7 -7613.7 -7613.7 -30.714399999999998 -7.897999 8.1513 -59.8013 -59.8013 -59.8013 -29.714399999999998 -5.897999 5.151300000000001 1245.36 1245.36 1245.36 -29.714399999999998 -5.897999 6.151300000000001 988.473 988.473 988.473 -29.714399999999998 -4.897999 5.151300000000001 -585.109 -585.109 -585.109 -30.714399999999998 -5.897999 5.151300000000001 6692.68 6692.68 6692.68 -30.714399999999998 -5.897999 6.151300000000001 -2878.91 -2878.91 -2878.91 -30.714399999999998 -4.897999 5.151300000000001 1126.21 1126.21 1126.21 -30.714399999999998 -4.897999 6.151300000000001 601.222 601.222 601.222 -29.714399999999998 -5.897999 8.1513 -2480.13 -2480.13 -2480.13 -29.714399999999998 -4.897999 8.1513 -2650.11 -2650.11 -2650.11 -30.714399999999998 -5.897999 8.1513 -32.0999 -32.0999 -32.0999 -30.714399999999998 -4.897999 7.151300000000001 991.529 991.529 991.529 -30.714399999999998 -4.897999 8.1513 1730.7 1730.7 1730.7 -31.714399999999998 -7.897999 5.151300000000001 -3017.07 -3017.07 -3017.07 -31.714399999999998 -7.897999 6.151300000000001 -218.434 -218.434 -218.434 -31.714399999999998 -6.897999 5.151300000000001 -2449.17 -2449.17 -2449.17 -31.714399999999998 -6.897999 6.151300000000001 3718.17 3718.17 3718.17 -32.7144 -7.897999 6.151300000000001 5573.9 5573.9 5573.9 -32.7144 -6.897999 5.151300000000001 10602.5 10602.5 10602.5 -32.7144 -6.897999 6.151300000000001 3151.77 3151.77 3151.77 -31.714399999999998 -7.897999 7.151300000000001 321.936 321.936 321.936 -31.714399999999998 -7.897999 8.1513 -95.508 -95.508 -95.508 -32.7144 -7.897999 7.151300000000001 2293.9 2293.9 2293.9 -32.7144 -7.897999 8.1513 1789.81 1789.81 1789.81 -32.7144 -6.897999 7.151300000000001 5721.77 5721.77 5721.77 -32.7144 -6.897999 8.1513 -2821.04 -2821.04 -2821.04 -31.714399999999998 -5.897999 5.151300000000001 -12492.6 -12492.6 -12492.6 -31.714399999999998 -5.897999 6.151300000000001 5066.09 5066.09 5066.09 -31.714399999999998 -4.897999 6.151300000000001 -3914.76 -3914.76 -3914.76 -32.7144 -5.897999 5.151300000000001 -1309.99 -1309.99 -1309.99 -32.7144 -5.897999 6.151300000000001 491.3 491.3 491.3 -32.7144 -4.897999 5.151300000000001 1978.31 1978.31 1978.31 -32.7144 -4.897999 6.151300000000001 -5629.96 -5629.96 -5629.96 -31.714399999999998 -4.897999 7.151300000000001 2489.68 2489.68 2489.68 -32.7144 -4.897999 7.151300000000001 137.463 137.463 137.463 -29.714399999999998 -7.897999 9.1513 -100.353 -100.353 -100.353 -29.714399999999998 -7.897999 10.1513 -2441.76 -2441.76 -2441.76 -29.714399999999998 -6.897999 9.1513 587.536 587.536 587.536 -29.714399999999998 -6.897999 10.1513 929.276 929.276 929.276 -30.714399999999998 -7.897999 9.1513 111.658 111.658 111.658 -30.714399999999998 -6.897999 9.1513 869.863 869.863 869.863 -30.714399999999998 -6.897999 10.1513 1271.58 1271.58 1271.58 -29.714399999999998 -7.897999 11.1513 -964.28 -964.28 -964.28 -29.714399999999998 -7.897999 12.1513 -7472.94 -7472.94 -7472.94 -29.714399999999998 -6.897999 11.1513 -902.713 -902.713 -902.713 -29.714399999999998 -6.897999 12.1513 -905.441 -905.441 -905.441 -30.714399999999998 -7.897999 11.1513 -5089.99 -5089.99 -5089.99 -30.714399999999998 -7.897999 12.1513 9875.08 9875.08 9875.08 -30.714399999999998 -6.897999 11.1513 -6136.31 -6136.31 -6136.31 -30.714399999999998 -6.897999 12.1513 -60973.6 -60973.6 -60973.6 -29.714399999999998 -5.897999 9.1513 1202.53 1202.53 1202.53 -29.714399999999998 -5.897999 10.1513 319.538 319.538 319.538 -29.714399999999998 -4.897999 10.1513 4176.89 4176.89 4176.89 -30.714399999999998 -5.897999 9.1513 -1599.06 -1599.06 -1599.06 -30.714399999999998 -5.897999 10.1513 -48960.8 -48960.8 -48960.8 -30.714399999999998 -4.897999 9.1513 -2453.14 -2453.14 -2453.14 -30.714399999999998 -4.897999 10.1513 13155.9 13155.9 13155.9 -29.714399999999998 -5.897999 11.1513 -2695.35 -2695.35 -2695.35 -29.714399999999998 -5.897999 12.1513 -6950.27 -6950.27 -6950.27 -29.714399999999998 -4.897999 11.1513 1678.98 1678.98 1678.98 -30.714399999999998 -5.897999 11.1513 -63387.0 -63387.0 -63387.0 -30.714399999999998 -5.897999 12.1513 8737.91 8737.91 8737.91 -30.714399999999998 -4.897999 11.1513 -75715.2 -75715.2 -75715.2 -30.714399999999998 -4.897999 12.1513 32489.9 32489.9 32489.9 -31.714399999999998 -7.897999 9.1513 2135120.0 2135120.0 2135120.0 -31.714399999999998 -7.897999 10.1513 -628798.0 -628798.0 -628798.0 -31.714399999999998 -6.897999 9.1513 1334740.0 1334740.0 1334740.0 -31.714399999999998 -6.897999 10.1513 813374.0 813374.0 813374.0 -32.7144 -7.897999 9.1513 -760513.0 -760513.0 -760513.0 -32.7144 -7.897999 10.1513 802571.0 802571.0 802571.0 -32.7144 -6.897999 9.1513 -939368.0 -939368.0 -939368.0 -32.7144 -6.897999 10.1513 -133893.0 -133893.0 -133893.0 -31.714399999999998 -7.897999 11.1513 -2038400.0 -2038400.0 -2038400.0 -31.714399999999998 -6.897999 11.1513 -2079790.0 -2079790.0 -2079790.0 -31.714399999999998 -6.897999 12.1513 6458.26 6458.26 6458.26 -32.7144 -7.897999 11.1513 -432718.0 -432718.0 -432718.0 -32.7144 -6.897999 11.1513 -2848540.0 -2848540.0 -2848540.0 -32.7144 -6.897999 12.1513 43642.7 43642.7 43642.7 -31.714399999999998 -5.897999 10.1513 68969.4 68969.4 68969.4 -31.714399999999998 -4.897999 10.1513 26691.8 26691.8 26691.8 -32.7144 -5.897999 10.1513 -1219750.0 -1219750.0 -1219750.0 -31.714399999999998 -5.897999 11.1513 1231540.0 1231540.0 1231540.0 -31.714399999999998 -5.897999 12.1513 -17638.9 -17638.9 -17638.9 -31.714399999999998 -4.897999 11.1513 24879.9 24879.9 24879.9 -31.714399999999998 -4.897999 12.1513 -27947.3 -27947.3 -27947.3 -32.7144 -5.897999 11.1513 -1395790.0 -1395790.0 -1395790.0 -32.7144 -5.897999 12.1513 -10314.6 -10314.6 -10314.6 -32.7144 -4.897999 11.1513 -287299.0 -287299.0 -287299.0 -32.7144 -4.897999 12.1513 33716.8 33716.8 33716.8 -29.714399999999998 -3.897999 5.151300000000001 3203.62 3203.62 3203.62 -29.714399999999998 -3.897999 6.151300000000001 1661.27 1661.27 1661.27 -29.714399999999998 -2.897999 5.151300000000001 -882.214 -882.214 -882.214 -29.714399999999998 -2.897999 6.151300000000001 -3935.47 -3935.47 -3935.47 -30.714399999999998 -3.897999 5.151300000000001 2635.2 2635.2 2635.2 -30.714399999999998 -3.897999 6.151300000000001 5489.0 5489.0 5489.0 -30.714399999999998 -2.897999 6.151300000000001 -2090.94 -2090.94 -2090.94 -29.714399999999998 -3.897999 7.151300000000001 3925.59 3925.59 3925.59 -29.714399999999998 -3.897999 8.1513 1574.21 1574.21 1574.21 -29.714399999999998 -2.897999 7.151300000000001 -54.943 -54.943 -54.943 -29.714399999999998 -2.897999 8.1513 5128.95 5128.95 5128.95 -30.714399999999998 -3.897999 7.151300000000001 179.827 179.827 179.827 -30.714399999999998 -3.897999 8.1513 -1120.3 -1120.3 -1120.3 -30.714399999999998 -2.897999 7.151300000000001 -1813.98 -1813.98 -1813.98 -30.714399999999998 -2.897999 8.1513 -41.1287 -41.1287 -41.1287 -29.714399999999998 -1.897999 5.151300000000001 8225.27 8225.27 8225.27 -29.714399999999998 -0.897999 5.151300000000001 1413.74 1413.74 1413.74 -29.714399999999998 -0.897999 6.151300000000001 -8427.73 -8427.73 -8427.73 -30.714399999999998 -1.897999 5.151300000000001 10589.1 10589.1 10589.1 -30.714399999999998 -0.897999 5.151300000000001 1660.8 1660.8 1660.8 -30.714399999999998 -0.897999 6.151300000000001 5052.39 5052.39 5052.39 -29.714399999999998 -1.897999 8.1513 -1801.75 -1801.75 -1801.75 -29.714399999999998 -0.897999 7.151300000000001 -4440.5 -4440.5 -4440.5 -29.714399999999998 -0.897999 8.1513 -1176.52 -1176.52 -1176.52 -30.714399999999998 -1.897999 8.1513 -1197.89 -1197.89 -1197.89 -30.714399999999998 -0.897999 7.151300000000001 7538.66 7538.66 7538.66 -30.714399999999998 -0.897999 8.1513 246.933 246.933 246.933 -31.714399999999998 -3.897999 6.151300000000001 6024.67 6024.67 6024.67 -31.714399999999998 -2.897999 6.151300000000001 -3656.05 -3656.05 -3656.05 -32.7144 -3.897999 5.151300000000001 2676.29 2676.29 2676.29 -32.7144 -3.897999 6.151300000000001 -16084.9 -16084.9 -16084.9 -32.7144 -2.897999 5.151300000000001 17743.9 17743.9 17743.9 -32.7144 -2.897999 6.151300000000001 -17802.6 -17802.6 -17802.6 -31.714399999999998 -3.897999 7.151300000000001 -6292.69 -6292.69 -6292.69 -31.714399999999998 -3.897999 8.1513 -1160.81 -1160.81 -1160.81 -31.714399999999998 -2.897999 7.151300000000001 -9264.12 -9264.12 -9264.12 -31.714399999999998 -2.897999 8.1513 783.979 783.979 783.979 -32.7144 -3.897999 7.151300000000001 9719.16 9719.16 9719.16 -32.7144 -3.897999 8.1513 267.85 267.85 267.85 -32.7144 -2.897999 7.151300000000001 -2217.02 -2217.02 -2217.02 -32.7144 -2.897999 8.1513 -509.526 -509.526 -509.526 -32.7144 -0.897999 6.151300000000001 31.4245 31.4245 31.4245 -32.7144 -1.897999 7.151300000000001 -3913.27 -3913.27 -3913.27 -32.7144 -1.897999 8.1513 98.8614 98.8614 98.8614 -32.7144 -0.897999 7.151300000000001 -170.08 -170.08 -170.08 -32.7144 -0.897999 8.1513 1884.9 1884.9 1884.9 -29.714399999999998 -3.897999 9.1513 88.0215 88.0215 88.0215 -29.714399999999998 -3.897999 10.1513 218.621 218.621 218.621 -29.714399999999998 -2.897999 9.1513 1865.75 1865.75 1865.75 -29.714399999999998 -2.897999 10.1513 -298.67 -298.67 -298.67 -30.714399999999998 -3.897999 9.1513 1832.98 1832.98 1832.98 -30.714399999999998 -3.897999 10.1513 3396.54 3396.54 3396.54 -30.714399999999998 -2.897999 9.1513 884.295 884.295 884.295 -30.714399999999998 -2.897999 10.1513 -450.602 -450.602 -450.602 -29.714399999999998 -3.897999 11.1513 1857.78 1857.78 1857.78 -29.714399999999998 -3.897999 12.1513 -671.834 -671.834 -671.834 -29.714399999999998 -2.897999 11.1513 730.118 730.118 730.118 -29.714399999999998 -2.897999 12.1513 7147.32 7147.32 7147.32 -30.714399999999998 -3.897999 11.1513 -1824.0 -1824.0 -1824.0 -30.714399999999998 -3.897999 12.1513 -1819.08 -1819.08 -1819.08 -30.714399999999998 -2.897999 11.1513 1691.21 1691.21 1691.21 -30.714399999999998 -2.897999 12.1513 4955.02 4955.02 4955.02 -29.714399999999998 -1.897999 9.1513 -21546.1 -21546.1 -21546.1 -29.714399999999998 -1.897999 10.1513 -2520.69 -2520.69 -2520.69 -29.714399999999998 -0.897999 9.1513 24385.0 24385.0 24385.0 -29.714399999999998 -0.897999 10.1513 32884.7 32884.7 32884.7 -30.714399999999998 -1.897999 10.1513 13234.3 13234.3 13234.3 -30.714399999999998 -0.897999 10.1513 -13904.1 -13904.1 -13904.1 -29.714399999999998 -1.897999 12.1513 9758.93 9758.93 9758.93 -29.714399999999998 -0.897999 11.1513 -18526.4 -18526.4 -18526.4 -29.714399999999998 -0.897999 12.1513 143.439 143.439 143.439 -30.714399999999998 -1.897999 11.1513 -4523.76 -4523.76 -4523.76 -30.714399999999998 -0.897999 11.1513 -26349.2 -26349.2 -26349.2 -30.714399999999998 -0.897999 12.1513 -3310.71 -3310.71 -3310.71 -31.714399999999998 -3.897999 9.1513 -666.822 -666.822 -666.822 -31.714399999999998 -3.897999 10.1513 2066.95 2066.95 2066.95 -31.714399999999998 -2.897999 9.1513 781.421 781.421 781.421 -31.714399999999998 -2.897999 10.1513 -1569.57 -1569.57 -1569.57 -32.7144 -3.897999 9.1513 -362.876 -362.876 -362.876 -32.7144 -2.897999 9.1513 551.755 551.755 551.755 -32.7144 -2.897999 10.1513 -1353.48 -1353.48 -1353.48 -31.714399999999998 -3.897999 11.1513 -26.7979 -26.7979 -26.7979 -31.714399999999998 -3.897999 12.1513 998.198 998.198 998.198 -31.714399999999998 -2.897999 12.1513 -613.634 -613.634 -613.634 -32.7144 -3.897999 11.1513 235.831 235.831 235.831 -32.7144 -3.897999 12.1513 -390.824 -390.824 -390.824 -32.7144 -2.897999 11.1513 -1814.06 -1814.06 -1814.06 -32.7144 -2.897999 12.1513 -799.273 -799.273 -799.273 -31.714399999999998 -1.897999 10.1513 -798.952 -798.952 -798.952 -31.714399999999998 -0.897999 10.1513 68651.9 68651.9 68651.9 -32.7144 -1.897999 9.1513 1346.65 1346.65 1346.65 -32.7144 -1.897999 10.1513 911.996 911.996 911.996 -32.7144 -0.897999 9.1513 -727.288 -727.288 -727.288 -32.7144 -0.897999 10.1513 374.432 374.432 374.432 -31.714399999999998 -1.897999 11.1513 -30931.1 -30931.1 -30931.1 -31.714399999999998 -0.897999 11.1513 -13275.7 -13275.7 -13275.7 -31.714399999999998 -0.897999 12.1513 -15713.3 -15713.3 -15713.3 -32.7144 -1.897999 11.1513 13493.3 13493.3 13493.3 -32.7144 -1.897999 12.1513 357.374 357.374 357.374 -32.7144 -0.897999 11.1513 12075.2 12075.2 12075.2 -32.7144 -0.897999 12.1513 -13166.9 -13166.9 -13166.9 -33.7144 -7.897999 6.151300000000001 708.256 708.256 708.256 -33.7144 -6.897999 5.151300000000001 3195.97 3195.97 3195.97 -33.7144 -6.897999 6.151300000000001 296.43 296.43 296.43 -34.7144 -7.897999 5.151300000000001 -5694.09 -5694.09 -5694.09 -34.7144 -7.897999 6.151300000000001 3426.18 3426.18 3426.18 -34.7144 -6.897999 5.151300000000001 -3434.67 -3434.67 -3434.67 -34.7144 -6.897999 6.151300000000001 8622.51 8622.51 8622.51 -33.7144 -7.897999 7.151300000000001 1319.99 1319.99 1319.99 -33.7144 -7.897999 8.1513 -847.14 -847.14 -847.14 -34.7144 -7.897999 7.151300000000001 -3698.41 -3698.41 -3698.41 -34.7144 -7.897999 8.1513 4034.76 4034.76 4034.76 -34.7144 -6.897999 7.151300000000001 -7862.74 -7862.74 -7862.74 -33.7144 -5.897999 5.151300000000001 1189.47 1189.47 1189.47 -33.7144 -4.897999 5.151300000000001 -2359.65 -2359.65 -2359.65 -34.7144 -5.897999 8.1513 46660.2 46660.2 46660.2 -34.7144 -4.897999 8.1513 -26202.8 -26202.8 -26202.8 -35.7144 -7.897999 5.151300000000001 651.692 651.692 651.692 -35.7144 -7.897999 6.151300000000001 1525.33 1525.33 1525.33 -35.7144 -6.897999 5.151300000000001 -3511.23 -3511.23 -3511.23 -35.7144 -6.897999 6.151300000000001 12564.7 12564.7 12564.7 -36.7144 -6.897999 5.151300000000001 3506.57 3506.57 3506.57 -36.7144 -6.897999 6.151300000000001 5610.3 5610.3 5610.3 -35.7144 -7.897999 7.151300000000001 1840.73 1840.73 1840.73 -35.7144 -7.897999 8.1513 -7147.19 -7147.19 -7147.19 -35.7144 -6.897999 7.151300000000001 209.916 209.916 209.916 -35.7144 -6.897999 8.1513 3793.73 3793.73 3793.73 -36.7144 -7.897999 8.1513 5543.32 5543.32 5543.32 -36.7144 -6.897999 7.151300000000001 2354.3 2354.3 2354.3 -36.7144 -6.897999 8.1513 -193750.0 -193750.0 -193750.0 -36.7144 -5.897999 5.151300000000001 -4262.17 -4262.17 -4262.17 -36.7144 -4.897999 5.151300000000001 -14590.8 -14590.8 -14590.8 -35.7144 -5.897999 7.151300000000001 16163.9 16163.9 16163.9 -35.7144 -5.897999 8.1513 -8505.77 -8505.77 -8505.77 -35.7144 -4.897999 8.1513 -75931.1 -75931.1 -75931.1 -36.7144 -5.897999 7.151300000000001 -115352.0 -115352.0 -115352.0 -36.7144 -5.897999 8.1513 86574.7 86574.7 86574.7 -36.7144 -4.897999 8.1513 199153.0 199153.0 199153.0 -33.7144 -7.897999 9.1513 -839539.0 -839539.0 -839539.0 -33.7144 -6.897999 9.1513 -2116230.0 -2116230.0 -2116230.0 -33.7144 -6.897999 10.1513 273131.0 273131.0 273131.0 -34.7144 -7.897999 9.1513 -608.667 -608.667 -608.667 -34.7144 -7.897999 10.1513 1800.6 1800.6 1800.6 -34.7144 -6.897999 9.1513 100356.0 100356.0 100356.0 -34.7144 -6.897999 10.1513 240778.0 240778.0 240778.0 -33.7144 -7.897999 11.1513 1412850.0 1412850.0 1412850.0 -33.7144 -7.897999 12.1513 -29.7253 -29.7253 -29.7253 -33.7144 -6.897999 11.1513 980404.0 980404.0 980404.0 -33.7144 -6.897999 12.1513 1376.69 1376.69 1376.69 -34.7144 -7.897999 11.1513 -3363.74 -3363.74 -3363.74 -34.7144 -7.897999 12.1513 -10515.0 -10515.0 -10515.0 -34.7144 -6.897999 11.1513 -103558.0 -103558.0 -103558.0 -34.7144 -6.897999 12.1513 -10537.7 -10537.7 -10537.7 -33.7144 -5.897999 9.1513 848137.0 848137.0 848137.0 -33.7144 -5.897999 10.1513 2733280.0 2733280.0 2733280.0 -33.7144 -4.897999 10.1513 688933.0 688933.0 688933.0 -34.7144 -5.897999 9.1513 506604.0 506604.0 506604.0 -34.7144 -5.897999 10.1513 59979.7 59979.7 59979.7 -34.7144 -4.897999 9.1513 32185.9 32185.9 32185.9 -34.7144 -4.897999 10.1513 271797.0 271797.0 271797.0 -33.7144 -5.897999 11.1513 1637920.0 1637920.0 1637920.0 -33.7144 -5.897999 12.1513 -5819.23 -5819.23 -5819.23 -33.7144 -4.897999 11.1513 -364625.0 -364625.0 -364625.0 -33.7144 -4.897999 12.1513 -2167.3 -2167.3 -2167.3 -34.7144 -5.897999 11.1513 147019.0 147019.0 147019.0 -34.7144 -4.897999 11.1513 -45028.9 -45028.9 -45028.9 -34.7144 -4.897999 12.1513 -6893.33 -6893.33 -6893.33 -35.7144 -7.897999 9.1513 16051.9 16051.9 16051.9 -35.7144 -7.897999 10.1513 13521.8 13521.8 13521.8 -35.7144 -6.897999 9.1513 42003.7 42003.7 42003.7 -35.7144 -6.897999 10.1513 47377.3 47377.3 47377.3 -36.7144 -6.897999 9.1513 24556.4 24556.4 24556.4 -35.7144 -7.897999 11.1513 -5597.37 -5597.37 -5597.37 -36.7144 -7.897999 11.1513 199474.0 199474.0 199474.0 -36.7144 -6.897999 12.1513 15038.8 15038.8 15038.8 -35.7144 -5.897999 10.1513 47663.3 47663.3 47663.3 -35.7144 -4.897999 9.1513 73856.2 73856.2 73856.2 -35.7144 -4.897999 10.1513 4104.57 4104.57 4104.57 -35.7144 -5.897999 11.1513 1368.59 1368.59 1368.59 -35.7144 -4.897999 11.1513 7173.21 7173.21 7173.21 -35.7144 -4.897999 12.1513 10671.9 10671.9 10671.9 -36.7144 -5.897999 12.1513 25170.7 25170.7 25170.7 -36.7144 -4.897999 11.1513 -2051.51 -2051.51 -2051.51 -36.7144 -4.897999 12.1513 -8208.11 -8208.11 -8208.11 -33.7144 -3.897999 5.151300000000001 1676.99 1676.99 1676.99 -33.7144 -3.897999 6.151300000000001 -5701.17 -5701.17 -5701.17 -33.7144 -2.897999 5.151300000000001 2890.5 2890.5 2890.5 -33.7144 -2.897999 6.151300000000001 7725.86 7725.86 7725.86 -34.7144 -3.897999 5.151300000000001 -1997.62 -1997.62 -1997.62 -34.7144 -3.897999 6.151300000000001 4140.11 4140.11 4140.11 -34.7144 -2.897999 5.151300000000001 5015.01 5015.01 5015.01 -34.7144 -2.897999 6.151300000000001 2175.24 2175.24 2175.24 -33.7144 -3.897999 7.151300000000001 5499.37 5499.37 5499.37 -33.7144 -2.897999 7.151300000000001 15988.9 15988.9 15988.9 -33.7144 -2.897999 8.1513 -1800.49 -1800.49 -1800.49 -34.7144 -3.897999 7.151300000000001 105.886 105.886 105.886 -34.7144 -2.897999 7.151300000000001 2471.27 2471.27 2471.27 -34.7144 -2.897999 8.1513 -2137.76 -2137.76 -2137.76 -34.7144 -1.897999 5.151300000000001 5523.76 5523.76 5523.76 -34.7144 -1.897999 6.151300000000001 5653.09 5653.09 5653.09 -33.7144 -1.897999 7.151300000000001 -3054.33 -3054.33 -3054.33 -33.7144 -1.897999 8.1513 1369.28 1369.28 1369.28 -33.7144 -0.897999 7.151300000000001 -3379.86 -3379.86 -3379.86 -33.7144 -0.897999 8.1513 1089.44 1089.44 1089.44 -34.7144 -1.897999 7.151300000000001 -411.84 -411.84 -411.84 -34.7144 -1.897999 8.1513 -1035.48 -1035.48 -1035.48 -34.7144 -0.897999 7.151300000000001 2230.81 2230.81 2230.81 -34.7144 -0.897999 8.1513 425.151 425.151 425.151 -35.7144 -3.897999 6.151300000000001 -9362.04 -9362.04 -9362.04 -35.7144 -2.897999 5.151300000000001 -2499.58 -2499.58 -2499.58 -35.7144 -2.897999 6.151300000000001 5067.16 5067.16 5067.16 -36.7144 -3.897999 5.151300000000001 3510.44 3510.44 3510.44 -36.7144 -3.897999 6.151300000000001 -2745.43 -2745.43 -2745.43 -36.7144 -2.897999 5.151300000000001 1035.1 1035.1 1035.1 -36.7144 -2.897999 6.151300000000001 -1082.75 -1082.75 -1082.75 -35.7144 -3.897999 8.1513 -51702.5 -51702.5 -51702.5 -35.7144 -2.897999 7.151300000000001 -2028.54 -2028.54 -2028.54 -35.7144 -2.897999 8.1513 -7986.3 -7986.3 -7986.3 -36.7144 -2.897999 7.151300000000001 -1865.03 -1865.03 -1865.03 -36.7144 -2.897999 8.1513 -3827.83 -3827.83 -3827.83 -35.7144 -1.897999 5.151300000000001 3300.79 3300.79 3300.79 -35.7144 -1.897999 6.151300000000001 724.043 724.043 724.043 -36.7144 -1.897999 5.151300000000001 1937.67 1937.67 1937.67 -36.7144 -1.897999 6.151300000000001 1926.27 1926.27 1926.27 -36.7144 -0.897999 6.151300000000001 1690.91 1690.91 1690.91 -35.7144 -1.897999 7.151300000000001 226.85 226.85 226.85 -35.7144 -1.897999 8.1513 217.815 217.815 217.815 -35.7144 -0.897999 7.151300000000001 3252.35 3252.35 3252.35 -36.7144 -1.897999 7.151300000000001 -6022.76 -6022.76 -6022.76 -36.7144 -1.897999 8.1513 1426.86 1426.86 1426.86 -36.7144 -0.897999 7.151300000000001 -1831.4 -1831.4 -1831.4 -36.7144 -0.897999 8.1513 -1292.42 -1292.42 -1292.42 -33.7144 -2.897999 10.1513 -169.63 -169.63 -169.63 -34.7144 -3.897999 9.1513 -39338.6 -39338.6 -39338.6 -34.7144 -3.897999 10.1513 1337.64 1337.64 1337.64 -34.7144 -2.897999 9.1513 523.648 523.648 523.648 -34.7144 -2.897999 10.1513 7985.54 7985.54 7985.54 -33.7144 -3.897999 11.1513 2096.7 2096.7 2096.7 -33.7144 -3.897999 12.1513 -2820.19 -2820.19 -2820.19 -33.7144 -2.897999 11.1513 -1503.34 -1503.34 -1503.34 -33.7144 -2.897999 12.1513 -1445.34 -1445.34 -1445.34 -34.7144 -3.897999 11.1513 -4091.14 -4091.14 -4091.14 -34.7144 -3.897999 12.1513 -11582.0 -11582.0 -11582.0 -34.7144 -2.897999 11.1513 178.617 178.617 178.617 -34.7144 -2.897999 12.1513 524.594 524.594 524.594 -33.7144 -1.897999 9.1513 3538.19 3538.19 3538.19 -33.7144 -1.897999 10.1513 -778.349 -778.349 -778.349 -33.7144 -0.897999 9.1513 2291.08 2291.08 2291.08 -33.7144 -0.897999 10.1513 3021.67 3021.67 3021.67 -34.7144 -1.897999 9.1513 1997.62 1997.62 1997.62 -34.7144 -1.897999 10.1513 -2.03491 -2.03491 -2.03491 -34.7144 -0.897999 9.1513 -3186.23 -3186.23 -3186.23 -34.7144 -0.897999 10.1513 -6400.39 -6400.39 -6400.39 -33.7144 -1.897999 11.1513 -1454.13 -1454.13 -1454.13 -33.7144 -1.897999 12.1513 -4414.75 -4414.75 -4414.75 -33.7144 -0.897999 11.1513 316.379 316.379 316.379 -34.7144 -1.897999 12.1513 -2103.02 -2103.02 -2103.02 -35.7144 -3.897999 9.1513 -16341.2 -16341.2 -16341.2 -35.7144 -3.897999 10.1513 -4303.01 -4303.01 -4303.01 -35.7144 -2.897999 9.1513 -5640.41 -5640.41 -5640.41 -35.7144 -2.897999 10.1513 5736.82 5736.82 5736.82 -36.7144 -3.897999 10.1513 -6877.15 -6877.15 -6877.15 -36.7144 -2.897999 9.1513 -2884.25 -2884.25 -2884.25 -36.7144 -2.897999 10.1513 -338.996 -338.996 -338.996 -35.7144 -3.897999 11.1513 11760.1 11760.1 11760.1 -35.7144 -3.897999 12.1513 4609.85 4609.85 4609.85 -35.7144 -2.897999 11.1513 2264.65 2264.65 2264.65 -35.7144 -2.897999 12.1513 7386.8 7386.8 7386.8 -36.7144 -3.897999 11.1513 16990.1 16990.1 16990.1 -36.7144 -3.897999 12.1513 50337.7 50337.7 50337.7 -36.7144 -2.897999 11.1513 4340.58 4340.58 4340.58 -36.7144 -2.897999 12.1513 -21333.8 -21333.8 -21333.8 -35.7144 -1.897999 9.1513 -778.418 -778.418 -778.418 -35.7144 -1.897999 10.1513 1405.6 1405.6 1405.6 -35.7144 -0.897999 9.1513 -7179.01 -7179.01 -7179.01 -35.7144 -0.897999 10.1513 3572.66 3572.66 3572.66 -36.7144 -1.897999 9.1513 -4268.1 -4268.1 -4268.1 -36.7144 -1.897999 10.1513 4917.72 4917.72 4917.72 -36.7144 -0.897999 9.1513 -3240.16 -3240.16 -3240.16 -36.7144 -0.897999 10.1513 -3246.6 -3246.6 -3246.6 -35.7144 -0.897999 11.1513 -4017.91 -4017.91 -4017.91 -36.7144 -1.897999 11.1513 10797.7 10797.7 10797.7 -36.7144 -0.897999 11.1513 2905.61 2905.61 2905.61 -25.714399999999998 -8.897999 13.1513 -4139.76 -4139.76 -4139.76 -26.714399999999998 -9.897999 13.1513 -4653.37 -4653.37 -4653.37 -26.714399999999998 -8.897999 13.1513 10287.3 10287.3 10287.3 -28.714399999999998 -11.897999 13.1513 -1413.02 -1413.02 -1413.02 -28.714399999999998 -11.897999 14.1513 1261.07 1261.07 1261.07 -28.714399999999998 -10.897999 13.1513 9184.72 9184.72 9184.72 -28.714399999999998 -10.897999 14.1513 -23490.8 -23490.8 -23490.8 -28.714399999999998 -10.897999 15.1513 34621.0 34621.0 34621.0 -27.714399999999998 -9.897999 13.1513 -3685.59 -3685.59 -3685.59 -27.714399999999998 -8.897999 13.1513 -10539.0 -10539.0 -10539.0 -28.714399999999998 -9.897999 13.1513 9688.56 9688.56 9688.56 -28.714399999999998 -9.897999 14.1513 -54325.5 -54325.5 -54325.5 -28.714399999999998 -8.897999 13.1513 -4650.79 -4650.79 -4650.79 -28.714399999999998 -8.897999 14.1513 -9686.01 -9686.01 -9686.01 -28.714399999999998 -9.897999 15.1513 -16410.9 -16410.9 -16410.9 -28.714399999999998 -8.897999 15.1513 -58819.0 -58819.0 -58819.0 -26.714399999999998 -8.897999 18.1513 5008.84 5008.84 5008.84 -26.714399999999998 -8.897999 19.1513 -7518.83 -7518.83 -7518.83 -27.714399999999998 -8.897999 18.1513 1375.48 1375.48 1375.48 -28.714399999999998 -8.897999 18.1513 -25696.7 -25696.7 -25696.7 -27.714399999999998 -8.897999 19.1513 -250.21 -250.21 -250.21 -27.714399999999998 -8.897999 20.1513 289.281 289.281 289.281 -28.714399999999998 -8.897999 19.1513 44974.1 44974.1 44974.1 -28.714399999999998 -8.897999 20.1513 10872.2 10872.2 10872.2 -27.714399999999998 -8.897999 21.1513 645.946 645.946 645.946 -27.714399999999998 -8.897999 22.1513 -191.678 -191.678 -191.678 -28.714399999999998 -8.897999 21.1513 -8869.33 -8869.33 -8869.33 -28.714399999999998 -8.897999 22.1513 -615.844 -615.844 -615.844 -24.714399999999998 -5.897999 13.1513 -355.254 -355.254 -355.254 -24.714399999999998 -4.897999 13.1513 -4003.77 -4003.77 -4003.77 -24.714399999999998 -3.897999 13.1513 -1252.78 -1252.78 -1252.78 -24.714399999999998 -2.897999 13.1513 -1522.08 -1522.08 -1522.08 -24.714399999999998 -2.897999 14.1513 267.955 267.955 267.955 -23.714399999999998 -1.897999 13.1513 -174.255 -174.255 -174.255 -23.714399999999998 -1.897999 14.1513 114.703 114.703 114.703 -23.714399999999998 -0.897999 13.1513 -79.8611 -79.8611 -79.8611 -23.714399999999998 -0.897999 14.1513 130.298 130.298 130.298 -24.714399999999998 -1.897999 13.1513 152.319 152.319 152.319 -24.714399999999998 -1.897999 14.1513 800.005 800.005 800.005 -24.714399999999998 -0.897999 14.1513 367.828 367.828 367.828 -24.714399999999998 -1.897999 15.1513 -130.135 -130.135 -130.135 -24.714399999999998 -0.897999 15.1513 78.5252 78.5252 78.5252 -25.714399999999998 -7.897999 13.1513 7490.82 7490.82 7490.82 -25.714399999999998 -6.897999 13.1513 -3556.85 -3556.85 -3556.85 -26.714399999999998 -7.897999 13.1513 32414.1 32414.1 32414.1 -26.714399999999998 -6.897999 13.1513 -331507.0 -331507.0 -331507.0 -26.714399999999998 -7.897999 16.1513 -3895.94 -3895.94 -3895.94 -26.714399999999998 -6.897999 16.1513 -3043.59 -3043.59 -3043.59 -25.714399999999998 -5.897999 13.1513 -465.928 -465.928 -465.928 -25.714399999999998 -4.897999 13.1513 -3324.53 -3324.53 -3324.53 -26.714399999999998 -5.897999 13.1513 -134317.0 -134317.0 -134317.0 -26.714399999999998 -4.897999 13.1513 -2394.67 -2394.67 -2394.67 -26.714399999999998 -5.897999 16.1513 -924.989 -924.989 -924.989 -26.714399999999998 -4.897999 16.1513 -414.85 -414.85 -414.85 -27.714399999999998 -7.897999 13.1513 -366365.0 -366365.0 -366365.0 -27.714399999999998 -6.897999 13.1513 407921.0 407921.0 407921.0 -28.714399999999998 -6.897999 13.1513 -88417.4 -88417.4 -88417.4 -27.714399999999998 -7.897999 16.1513 5598.11 5598.11 5598.11 -27.714399999999998 -6.897999 16.1513 1433.2 1433.2 1433.2 -28.714399999999998 -6.897999 16.1513 -31858.0 -31858.0 -31858.0 -27.714399999999998 -5.897999 13.1513 87115.7 87115.7 87115.7 -27.714399999999998 -4.897999 13.1513 -140.471 -140.471 -140.471 -28.714399999999998 -5.897999 13.1513 97043.9 97043.9 97043.9 -28.714399999999998 -4.897999 13.1513 789.955 789.955 789.955 -27.714399999999998 -5.897999 16.1513 651.644 651.644 651.644 -27.714399999999998 -4.897999 16.1513 -320.098 -320.098 -320.098 -28.714399999999998 -5.897999 16.1513 -131294.0 -131294.0 -131294.0 -25.714399999999998 -7.897999 17.1513 6957.97 6957.97 6957.97 -25.714399999999998 -7.897999 18.1513 1538.37 1538.37 1538.37 -25.714399999999998 -6.897999 17.1513 -1383.41 -1383.41 -1383.41 -25.714399999999998 -6.897999 18.1513 -1061.77 -1061.77 -1061.77 -26.714399999999998 -7.897999 17.1513 3818.12 3818.12 3818.12 -26.714399999999998 -7.897999 18.1513 6355.72 6355.72 6355.72 -26.714399999999998 -6.897999 17.1513 -1759.15 -1759.15 -1759.15 -25.714399999999998 -7.897999 19.1513 219.786 219.786 219.786 -25.714399999999998 -7.897999 20.1513 -33.2145 -33.2145 -33.2145 -25.714399999999998 -6.897999 19.1513 2188.04 2188.04 2188.04 -25.714399999999998 -6.897999 20.1513 -248.573 -248.573 -248.573 -26.714399999999998 -7.897999 19.1513 -1725.94 -1725.94 -1725.94 -26.714399999999998 -7.897999 20.1513 1984.71 1984.71 1984.71 -26.714399999999998 -6.897999 20.1513 22.8931 22.8931 22.8931 -25.714399999999998 -5.897999 17.1513 671.427 671.427 671.427 -25.714399999999998 -5.897999 18.1513 1591.21 1591.21 1591.21 -25.714399999999998 -4.897999 17.1513 118.169 118.169 118.169 -25.714399999999998 -4.897999 18.1513 158.083 158.083 158.083 -26.714399999999998 -5.897999 17.1513 -5674.65 -5674.65 -5674.65 -26.714399999999998 -5.897999 18.1513 -4363.75 -4363.75 -4363.75 -26.714399999999998 -4.897999 17.1513 211.465 211.465 211.465 -26.714399999999998 -4.897999 18.1513 -158.424 -158.424 -158.424 -25.714399999999998 -5.897999 19.1513 -2605.05 -2605.05 -2605.05 -26.714399999999998 -5.897999 19.1513 -638.883 -638.883 -638.883 -26.714399999999998 -5.897999 20.1513 -234.152 -234.152 -234.152 -26.714399999999998 -4.897999 19.1513 11.2389 11.2389 11.2389 -26.714399999999998 -4.897999 20.1513 749.293 749.293 749.293 -27.714399999999998 -7.897999 17.1513 -4943.04 -4943.04 -4943.04 -27.714399999999998 -7.897999 18.1513 117.324 117.324 117.324 -27.714399999999998 -6.897999 17.1513 -2590.67 -2590.67 -2590.67 -28.714399999999998 -7.897999 17.1513 12512.6 12512.6 12512.6 -28.714399999999998 -7.897999 18.1513 -10284.1 -10284.1 -10284.1 -28.714399999999998 -6.897999 17.1513 -6108.65 -6108.65 -6108.65 -28.714399999999998 -6.897999 18.1513 10002.1 10002.1 10002.1 -27.714399999999998 -7.897999 19.1513 6082.14 6082.14 6082.14 -27.714399999999998 -7.897999 20.1513 323.685 323.685 323.685 -28.714399999999998 -7.897999 19.1513 -128.257 -128.257 -128.257 -28.714399999999998 -7.897999 20.1513 13876.8 13876.8 13876.8 -28.714399999999998 -6.897999 19.1513 9072.34 9072.34 9072.34 -27.714399999999998 -5.897999 17.1513 5037.02 5037.02 5037.02 -27.714399999999998 -4.897999 17.1513 -288.222 -288.222 -288.222 -27.714399999999998 -4.897999 18.1513 666.772 666.772 666.772 -28.714399999999998 -5.897999 17.1513 -12057.7 -12057.7 -12057.7 -28.714399999999998 -5.897999 18.1513 1174.48 1174.48 1174.48 -28.714399999999998 -4.897999 17.1513 13889.1 13889.1 13889.1 -28.714399999999998 -4.897999 18.1513 5334.44 5334.44 5334.44 -27.714399999999998 -4.897999 19.1513 1216.42 1216.42 1216.42 -27.714399999999998 -4.897999 20.1513 697.499 697.499 697.499 -25.714399999999998 -3.897999 13.1513 -1376.26 -1376.26 -1376.26 -25.714399999999998 -2.897999 13.1513 170.542 170.542 170.542 -25.714399999999998 -2.897999 14.1513 740.835 740.835 740.835 -26.714399999999998 -3.897999 13.1513 -1179.38 -1179.38 -1179.38 -26.714399999999998 -2.897999 13.1513 1681.14 1681.14 1681.14 -25.714399999999998 -1.897999 13.1513 -841.256 -841.256 -841.256 -25.714399999999998 -1.897999 14.1513 -229.675 -229.675 -229.675 -26.714399999999998 -1.897999 13.1513 1899.91 1899.91 1899.91 -26.714399999999998 -1.897999 14.1513 257.243 257.243 257.243 -25.714399999999998 -1.897999 15.1513 935.328 935.328 935.328 -25.714399999999998 -0.897999 15.1513 73.8361 73.8361 73.8361 -26.714399999999998 -1.897999 15.1513 525.683 525.683 525.683 -26.714399999999998 -0.897999 15.1513 1174.52 1174.52 1174.52 -26.714399999999998 -0.897999 16.1513 474.843 474.843 474.843 -27.714399999999998 -3.897999 13.1513 515.657 515.657 515.657 -28.714399999999998 -3.897999 13.1513 56.5827 56.5827 56.5827 -28.714399999999998 -2.897999 13.1513 1016.43 1016.43 1016.43 -27.714399999999998 -1.897999 13.1513 1741.12 1741.12 1741.12 -27.714399999999998 -1.897999 14.1513 -5801.17 -5801.17 -5801.17 -27.714399999999998 -0.897999 14.1513 6572.05 6572.05 6572.05 -28.714399999999998 -1.897999 13.1513 546.542 546.542 546.542 -28.714399999999998 -1.897999 14.1513 -6140.92 -6140.92 -6140.92 -28.714399999999998 -0.897999 13.1513 -2680.42 -2680.42 -2680.42 -28.714399999999998 -0.897999 14.1513 -3516.92 -3516.92 -3516.92 -27.714399999999998 -1.897999 15.1513 -2858.34 -2858.34 -2858.34 -27.714399999999998 -0.897999 15.1513 -743.226 -743.226 -743.226 -27.714399999999998 -0.897999 16.1513 1841.74 1841.74 1841.74 -28.714399999999998 -0.897999 15.1513 218.681 218.681 218.681 -28.714399999999998 -0.897999 16.1513 -2468.89 -2468.89 -2468.89 -27.714399999999998 -3.897999 18.1513 134.042 134.042 134.042 -28.714399999999998 -3.897999 18.1513 3644.7 3644.7 3644.7 -27.714399999999998 -3.897999 19.1513 2157.11 2157.11 2157.11 -27.714399999999998 -3.897999 20.1513 -1121.5 -1121.5 -1121.5 -27.714399999999998 -2.897999 20.1513 -9232.03 -9232.03 -9232.03 -28.714399999999998 -3.897999 19.1513 -6236.37 -6236.37 -6236.37 -28.714399999999998 -3.897999 20.1513 15108.8 15108.8 15108.8 -28.714399999999998 -2.897999 19.1513 -4632.41 -4632.41 -4632.41 -28.714399999999998 -2.897999 20.1513 -9603.56 -9603.56 -9603.56 -26.714399999999998 -7.897999 21.1513 -1700.79 -1700.79 -1700.79 -26.714399999999998 -6.897999 21.1513 1567.49 1567.49 1567.49 -26.714399999999998 -5.897999 21.1513 174.872 174.872 174.872 -26.714399999999998 -4.897999 21.1513 -1088.24 -1088.24 -1088.24 -27.714399999999998 -7.897999 21.1513 -215.11 -215.11 -215.11 -27.714399999999998 -7.897999 22.1513 353.635 353.635 353.635 -27.714399999999998 -6.897999 21.1513 356.563 356.563 356.563 -27.714399999999998 -6.897999 22.1513 288.313 288.313 288.313 -28.714399999999998 -7.897999 22.1513 -10.4432 -10.4432 -10.4432 -28.714399999999998 -6.897999 22.1513 -24.3261 -24.3261 -24.3261 -27.714399999999998 -5.897999 21.1513 368.207 368.207 368.207 -27.714399999999998 -5.897999 22.1513 -258.884 -258.884 -258.884 -27.714399999999998 -4.897999 21.1513 68.0502 68.0502 68.0502 -27.714399999999998 -4.897999 22.1513 -478.098 -478.098 -478.098 -28.714399999999998 -5.897999 21.1513 -6889.82 -6889.82 -6889.82 -28.714399999999998 -5.897999 22.1513 382.952 382.952 382.952 -28.714399999999998 -4.897999 21.1513 -2656.62 -2656.62 -2656.62 -28.714399999999998 -4.897999 22.1513 652.806 652.806 652.806 -27.714399999999998 -3.897999 21.1513 -1518.24 -1518.24 -1518.24 -27.714399999999998 -3.897999 22.1513 -648.131 -648.131 -648.131 -27.714399999999998 -2.897999 21.1513 2864.92 2864.92 2864.92 -27.714399999999998 -2.897999 22.1513 -836.167 -836.167 -836.167 -28.714399999999998 -3.897999 22.1513 14.3896 14.3896 14.3896 -28.714399999999998 -2.897999 21.1513 3513.25 3513.25 3513.25 -28.714399999999998 -2.897999 22.1513 -126.218 -126.218 -126.218 -30.714399999999998 -14.897999 16.1513 -11913.2 -11913.2 -11913.2 -29.714399999999998 -13.897999 14.1513 -20184.6 -20184.6 -20184.6 -29.714399999999998 -12.897999 14.1513 -17752.3 -17752.3 -17752.3 -30.714399999999998 -13.897999 14.1513 338.379 338.379 338.379 -30.714399999999998 -12.897999 13.1513 88695.5 88695.5 88695.5 -30.714399999999998 -12.897999 14.1513 63067.7 63067.7 63067.7 -29.714399999999998 -13.897999 15.1513 -29306.2 -29306.2 -29306.2 -29.714399999999998 -13.897999 16.1513 598.524 598.524 598.524 -29.714399999999998 -12.897999 15.1513 -15695.7 -15695.7 -15695.7 -29.714399999999998 -12.897999 16.1513 2809.56 2809.56 2809.56 -30.714399999999998 -13.897999 15.1513 -9952.6 -9952.6 -9952.6 -30.714399999999998 -13.897999 16.1513 8638.97 8638.97 8638.97 -30.714399999999998 -12.897999 16.1513 769.364 769.364 769.364 -31.714399999999998 -14.897999 15.1513 1633.01 1633.01 1633.01 -31.714399999999998 -14.897999 16.1513 -11659.9 -11659.9 -11659.9 -32.7144 -14.897999 16.1513 -14654.6 -14654.6 -14654.6 -31.714399999999998 -13.897999 14.1513 4806.38 4806.38 4806.38 -31.714399999999998 -12.897999 13.1513 55238.9 55238.9 55238.9 -31.714399999999998 -12.897999 14.1513 -582.281 -582.281 -582.281 -32.7144 -13.897999 13.1513 46721.0 46721.0 46721.0 -32.7144 -13.897999 14.1513 -7316.15 -7316.15 -7316.15 -32.7144 -12.897999 13.1513 17140.6 17140.6 17140.6 -31.714399999999998 -13.897999 15.1513 5901.39 5901.39 5901.39 -31.714399999999998 -13.897999 16.1513 7016.17 7016.17 7016.17 -32.7144 -13.897999 15.1513 -4839.03 -4839.03 -4839.03 -32.7144 -13.897999 16.1513 3653.78 3653.78 3653.78 -30.714399999999998 -13.897999 17.1513 6.36279 6.36279 6.36279 -30.714399999999998 -12.897999 17.1513 -319.647 -319.647 -319.647 -31.714399999999998 -13.897999 17.1513 1645.54 1645.54 1645.54 -31.714399999999998 -12.897999 17.1513 534.941 534.941 534.941 -32.7144 -13.897999 17.1513 -5506.21 -5506.21 -5506.21 -32.7144 -12.897999 17.1513 -2130.55 -2130.55 -2130.55 -29.714399999999998 -11.897999 13.1513 -13587.6 -13587.6 -13587.6 -29.714399999999998 -11.897999 14.1513 -25048.1 -25048.1 -25048.1 -30.714399999999998 -11.897999 13.1513 15032.3 15032.3 15032.3 -30.714399999999998 -11.897999 14.1513 25093.1 25093.1 25093.1 -30.714399999999998 -10.897999 13.1513 -1571.17 -1571.17 -1571.17 -29.714399999999998 -11.897999 15.1513 -42910.1 -42910.1 -42910.1 -29.714399999999998 -11.897999 16.1513 1305.77 1305.77 1305.77 -29.714399999999998 -10.897999 15.1513 1998.91 1998.91 1998.91 -29.714399999999998 -10.897999 16.1513 -39313.2 -39313.2 -39313.2 -30.714399999999998 -11.897999 16.1513 -1231.74 -1231.74 -1231.74 -30.714399999999998 -10.897999 15.1513 33413.8 33413.8 33413.8 -30.714399999999998 -10.897999 16.1513 14267.6 14267.6 14267.6 -29.714399999999998 -8.897999 13.1513 14292.7 14292.7 14292.7 -29.714399999999998 -8.897999 14.1513 -22876.6 -22876.6 -22876.6 -30.714399999999998 -9.897999 14.1513 19893.4 19893.4 19893.4 -29.714399999999998 -9.897999 15.1513 20693.0 20693.0 20693.0 -29.714399999999998 -8.897999 15.1513 6141.83 6141.83 6141.83 -30.714399999999998 -9.897999 15.1513 61514.6 61514.6 61514.6 -30.714399999999998 -8.897999 15.1513 -36748.3 -36748.3 -36748.3 -30.714399999999998 -8.897999 16.1513 -121765.0 -121765.0 -121765.0 -31.714399999999998 -11.897999 13.1513 40988.0 40988.0 40988.0 -31.714399999999998 -11.897999 14.1513 18.3345 18.3345 18.3345 -31.714399999999998 -10.897999 13.1513 -3617.74 -3617.74 -3617.74 -31.714399999999998 -10.897999 14.1513 -20525.4 -20525.4 -20525.4 -32.7144 -11.897999 14.1513 16560.5 16560.5 16560.5 -32.7144 -10.897999 13.1513 5917.72 5917.72 5917.72 -32.7144 -10.897999 14.1513 13459.1 13459.1 13459.1 -31.714399999999998 -11.897999 15.1513 286.777 286.777 286.777 -31.714399999999998 -10.897999 15.1513 -47520.3 -47520.3 -47520.3 -31.714399999999998 -10.897999 16.1513 -83846.6 -83846.6 -83846.6 -31.714399999999998 -9.897999 13.1513 -24758.5 -24758.5 -24758.5 -31.714399999999998 -9.897999 14.1513 30567.2 30567.2 30567.2 -31.714399999999998 -8.897999 14.1513 27355.2 27355.2 27355.2 -32.7144 -9.897999 13.1513 17740.6 17740.6 17740.6 -32.7144 -9.897999 14.1513 56030.5 56030.5 56030.5 -32.7144 -8.897999 13.1513 39168.8 39168.8 39168.8 -32.7144 -8.897999 14.1513 87765.4 87765.4 87765.4 -31.714399999999998 -9.897999 15.1513 351504.0 351504.0 351504.0 -31.714399999999998 -9.897999 16.1513 423121.0 423121.0 423121.0 -31.714399999999998 -8.897999 15.1513 -370300.0 -370300.0 -370300.0 -31.714399999999998 -8.897999 16.1513 -27874.2 -27874.2 -27874.2 -32.7144 -9.897999 15.1513 -245412.0 -245412.0 -245412.0 -32.7144 -9.897999 16.1513 -233362.0 -233362.0 -233362.0 -32.7144 -8.897999 15.1513 -627122.0 -627122.0 -627122.0 -32.7144 -8.897999 16.1513 432406.0 432406.0 432406.0 -30.714399999999998 -11.897999 17.1513 662.682 662.682 662.682 -29.714399999999998 -8.897999 19.1513 4486.94 4486.94 4486.94 -29.714399999999998 -8.897999 20.1513 -45941.9 -45941.9 -45941.9 -30.714399999999998 -8.897999 20.1513 -1081690.0 -1081690.0 -1081690.0 -31.714399999999998 -11.897999 17.1513 1002.38 1002.38 1002.38 -31.714399999999998 -10.897999 17.1513 8153.51 8153.51 8153.51 -32.7144 -11.897999 17.1513 5228.63 5228.63 5228.63 -32.7144 -10.897999 17.1513 237891.0 237891.0 237891.0 -31.714399999999998 -9.897999 17.1513 360937.0 360937.0 360937.0 -31.714399999999998 -8.897999 17.1513 376602.0 376602.0 376602.0 -31.714399999999998 -8.897999 18.1513 -183338.0 -183338.0 -183338.0 -32.7144 -9.897999 17.1513 142705.0 142705.0 142705.0 -32.7144 -8.897999 17.1513 506050.0 506050.0 506050.0 -32.7144 -8.897999 18.1513 -36294.6 -36294.6 -36294.6 -32.7144 -8.897999 19.1513 -816448.0 -816448.0 -816448.0 -32.7144 -8.897999 20.1513 659999.0 659999.0 659999.0 -33.7144 -13.897999 13.1513 -422.292 -422.292 -422.292 -33.7144 -13.897999 14.1513 680.476 680.476 680.476 -33.7144 -12.897999 13.1513 4065.43 4065.43 4065.43 -34.7144 -13.897999 13.1513 16498.6 16498.6 16498.6 -34.7144 -13.897999 14.1513 9002.61 9002.61 9002.61 -34.7144 -12.897999 13.1513 14817.5 14817.5 14817.5 -34.7144 -12.897999 14.1513 -14161.0 -14161.0 -14161.0 -33.7144 -13.897999 15.1513 -15085.4 -15085.4 -15085.4 -33.7144 -13.897999 16.1513 -6681.95 -6681.95 -6681.95 -33.7144 -12.897999 16.1513 975.082 975.082 975.082 -34.7144 -13.897999 15.1513 -11931.3 -11931.3 -11931.3 -34.7144 -13.897999 16.1513 3427.71 3427.71 3427.71 -34.7144 -12.897999 15.1513 -18180.4 -18180.4 -18180.4 -34.7144 -12.897999 16.1513 9737.54 9737.54 9737.54 -33.7144 -13.897999 17.1513 -4750.89 -4750.89 -4750.89 -33.7144 -12.897999 17.1513 -5762.78 -5762.78 -5762.78 -34.7144 -12.897999 17.1513 6879.34 6879.34 6879.34 -33.7144 -11.897999 13.1513 -9701.39 -9701.39 -9701.39 -33.7144 -10.897999 13.1513 -4662.94 -4662.94 -4662.94 -33.7144 -10.897999 14.1513 4441.77 4441.77 4441.77 -34.7144 -11.897999 13.1513 8659.82 8659.82 8659.82 -34.7144 -11.897999 14.1513 -7688.33 -7688.33 -7688.33 -34.7144 -10.897999 13.1513 -5561.0 -5561.0 -5561.0 -34.7144 -10.897999 14.1513 -26299.0 -26299.0 -26299.0 -34.7144 -11.897999 15.1513 -4970.34 -4970.34 -4970.34 -34.7144 -11.897999 16.1513 3091.59 3091.59 3091.59 -33.7144 -9.897999 14.1513 52903.1 52903.1 52903.1 -33.7144 -8.897999 13.1513 129.552 129.552 129.552 -33.7144 -8.897999 14.1513 26891.9 26891.9 26891.9 -34.7144 -9.897999 14.1513 10371.7 10371.7 10371.7 -34.7144 -8.897999 13.1513 -8691.66 -8691.66 -8691.66 -34.7144 -8.897999 14.1513 -8216.72 -8216.72 -8216.72 -33.7144 -9.897999 15.1513 -280433.0 -280433.0 -280433.0 -33.7144 -8.897999 15.1513 -501520.0 -501520.0 -501520.0 -33.7144 -8.897999 16.1513 -529382.0 -529382.0 -529382.0 -35.7144 -11.897999 14.1513 15921.7 15921.7 15921.7 -35.7144 -10.897999 14.1513 5401.39 5401.39 5401.39 -35.7144 -11.897999 15.1513 -774.88 -774.88 -774.88 -35.7144 -11.897999 16.1513 5606.29 5606.29 5606.29 -35.7144 -10.897999 15.1513 -5380.36 -5380.36 -5380.36 -35.7144 -10.897999 16.1513 11756.8 11756.8 11756.8 -36.7144 -10.897999 15.1513 -10961.9 -10961.9 -10961.9 -36.7144 -10.897999 16.1513 2330.64 2330.64 2330.64 -35.7144 -9.897999 13.1513 -121893.0 -121893.0 -121893.0 -35.7144 -9.897999 14.1513 -10654.5 -10654.5 -10654.5 -35.7144 -8.897999 13.1513 -151213.0 -151213.0 -151213.0 -35.7144 -8.897999 14.1513 1450.03 1450.03 1450.03 -36.7144 -9.897999 13.1513 -167684.0 -167684.0 -167684.0 -36.7144 -8.897999 13.1513 -193611.0 -193611.0 -193611.0 -36.7144 -8.897999 14.1513 -519.247 -519.247 -519.247 -35.7144 -9.897999 15.1513 -2431.99 -2431.99 -2431.99 -35.7144 -9.897999 16.1513 26262.2 26262.2 26262.2 -35.7144 -8.897999 15.1513 12192.0 12192.0 12192.0 -36.7144 -9.897999 15.1513 -716.419 -716.419 -716.419 -36.7144 -9.897999 16.1513 -3099.13 -3099.13 -3099.13 -36.7144 -8.897999 15.1513 -6027.65 -6027.65 -6027.65 -36.7144 -8.897999 16.1513 403.532 403.532 403.532 -33.7144 -11.897999 17.1513 4079.8 4079.8 4079.8 -33.7144 -10.897999 17.1513 15059.8 15059.8 15059.8 -34.7144 -11.897999 17.1513 2576.81 2576.81 2576.81 -34.7144 -10.897999 17.1513 3626.66 3626.66 3626.66 -34.7144 -10.897999 18.1513 1776.24 1776.24 1776.24 -33.7144 -9.897999 17.1513 38367.3 38367.3 38367.3 -33.7144 -9.897999 18.1513 22331.5 22331.5 22331.5 -33.7144 -8.897999 17.1513 247854.0 247854.0 247854.0 -33.7144 -8.897999 18.1513 16716.5 16716.5 16716.5 -34.7144 -9.897999 17.1513 4809.78 4809.78 4809.78 -34.7144 -9.897999 18.1513 -10436.9 -10436.9 -10436.9 -33.7144 -9.897999 19.1513 513150.0 513150.0 513150.0 -33.7144 -9.897999 20.1513 36660.6 36660.6 36660.6 -33.7144 -8.897999 19.1513 1119690.0 1119690.0 1119690.0 -33.7144 -8.897999 20.1513 130792.0 130792.0 130792.0 -34.7144 -9.897999 19.1513 509280.0 509280.0 509280.0 -34.7144 -9.897999 20.1513 291779.0 291779.0 291779.0 -34.7144 -8.897999 19.1513 279172.0 279172.0 279172.0 -35.7144 -10.897999 17.1513 20213.6 20213.6 20213.6 -35.7144 -10.897999 18.1513 -2639.35 -2639.35 -2639.35 -35.7144 -9.897999 17.1513 12321.0 12321.0 12321.0 -35.7144 -9.897999 18.1513 -5722.4 -5722.4 -5722.4 -35.7144 -8.897999 17.1513 31604.9 31604.9 31604.9 -35.7144 -8.897999 18.1513 14134.4 14134.4 14134.4 -36.7144 -9.897999 17.1513 3153.1 3153.1 3153.1 -36.7144 -9.897999 18.1513 523.982 523.982 523.982 -36.7144 -8.897999 17.1513 1195.76 1195.76 1195.76 -36.7144 -8.897999 18.1513 1868.71 1868.71 1868.71 -35.7144 -9.897999 19.1513 10943.8 10943.8 10943.8 -35.7144 -9.897999 20.1513 6482.69 6482.69 6482.69 -35.7144 -8.897999 19.1513 18247.8 18247.8 18247.8 -35.7144 -8.897999 20.1513 11650.7 11650.7 11650.7 -36.7144 -9.897999 19.1513 87.3962 87.3962 87.3962 -36.7144 -8.897999 19.1513 -1121.4 -1121.4 -1121.4 -29.714399999999998 -8.897999 21.1513 -26307.2 -26307.2 -26307.2 -29.714399999999998 -8.897999 22.1513 -62.0458 -62.0458 -62.0458 -30.714399999999998 -8.897999 21.1513 1852240.0 1852240.0 1852240.0 -32.7144 -8.897999 21.1513 1909690.0 1909690.0 1909690.0 -33.7144 -8.897999 21.1513 198508.0 198508.0 198508.0 -34.7144 -9.897999 21.1513 -179126.0 -179126.0 -179126.0 -34.7144 -8.897999 21.1513 654086.0 654086.0 654086.0 -35.7144 -9.897999 21.1513 1723.75 1723.75 1723.75 -35.7144 -8.897999 21.1513 -874.318 -874.318 -874.318 -29.714399999999998 -7.897999 13.1513 -79.8742 -79.8742 -79.8742 -29.714399999999998 -7.897999 14.1513 -6174.2 -6174.2 -6174.2 -29.714399999999998 -6.897999 13.1513 -3702.61 -3702.61 -3702.61 -29.714399999999998 -6.897999 14.1513 29774.5 29774.5 29774.5 -30.714399999999998 -7.897999 13.1513 -12828.8 -12828.8 -12828.8 -30.714399999999998 -6.897999 13.1513 8812.29 8812.29 8812.29 -30.714399999999998 -6.897999 14.1513 58025.3 58025.3 58025.3 -29.714399999999998 -7.897999 15.1513 -5993.24 -5993.24 -5993.24 -29.714399999999998 -7.897999 16.1513 80462.6 80462.6 80462.6 -29.714399999999998 -6.897999 15.1513 -218426.0 -218426.0 -218426.0 -29.714399999999998 -6.897999 16.1513 284770.0 284770.0 284770.0 -30.714399999999998 -7.897999 16.1513 34188.0 34188.0 34188.0 -30.714399999999998 -6.897999 15.1513 -264161.0 -264161.0 -264161.0 -30.714399999999998 -6.897999 16.1513 198213.0 198213.0 198213.0 -29.714399999999998 -5.897999 13.1513 791.585 791.585 791.585 -29.714399999999998 -4.897999 13.1513 1490.67 1490.67 1490.67 -30.714399999999998 -5.897999 13.1513 12999.9 12999.9 12999.9 -30.714399999999998 -5.897999 14.1513 19379.1 19379.1 19379.1 -30.714399999999998 -4.897999 13.1513 -1576.4 -1576.4 -1576.4 -30.714399999999998 -4.897999 14.1513 80016.7 80016.7 80016.7 -30.714399999999998 -5.897999 15.1513 -148312.0 -148312.0 -148312.0 -31.714399999999998 -6.897999 13.1513 -5410.31 -5410.31 -5410.31 -31.714399999999998 -6.897999 14.1513 -17994.6 -17994.6 -17994.6 -32.7144 -7.897999 13.1513 32631.5 32631.5 32631.5 -32.7144 -7.897999 14.1513 -3082.4 -3082.4 -3082.4 -32.7144 -6.897999 13.1513 -4089.16 -4089.16 -4089.16 -32.7144 -6.897999 14.1513 -569.287 -569.287 -569.287 -31.714399999999998 -7.897999 15.1513 -613071.0 -613071.0 -613071.0 -31.714399999999998 -7.897999 16.1513 1710.45 1710.45 1710.45 -31.714399999999998 -6.897999 15.1513 -15329.1 -15329.1 -15329.1 -31.714399999999998 -6.897999 16.1513 -34035.6 -34035.6 -34035.6 -32.7144 -7.897999 15.1513 443397.0 443397.0 443397.0 -32.7144 -7.897999 16.1513 -37555.5 -37555.5 -37555.5 -32.7144 -6.897999 15.1513 -4740.3 -4740.3 -4740.3 -32.7144 -6.897999 16.1513 -42294.0 -42294.0 -42294.0 -31.714399999999998 -5.897999 13.1513 -15557.1 -15557.1 -15557.1 -31.714399999999998 -5.897999 14.1513 18573.4 18573.4 18573.4 -31.714399999999998 -4.897999 13.1513 -803.304 -803.304 -803.304 -31.714399999999998 -4.897999 14.1513 -193077.0 -193077.0 -193077.0 -32.7144 -5.897999 13.1513 3470.43 3470.43 3470.43 -32.7144 -5.897999 14.1513 -127431.0 -127431.0 -127431.0 -32.7144 -4.897999 13.1513 3426.59 3426.59 3426.59 -32.7144 -4.897999 14.1513 -83470.6 -83470.6 -83470.6 -31.714399999999998 -5.897999 15.1513 -356043.0 -356043.0 -356043.0 -31.714399999999998 -5.897999 16.1513 -42347.0 -42347.0 -42347.0 -31.714399999999998 -4.897999 15.1513 -240408.0 -240408.0 -240408.0 -32.7144 -5.897999 15.1513 -71811.1 -71811.1 -71811.1 -32.7144 -5.897999 16.1513 -72212.1 -72212.1 -72212.1 -32.7144 -4.897999 15.1513 412404.0 412404.0 412404.0 -32.7144 -4.897999 16.1513 650877.0 650877.0 650877.0 -29.714399999999998 -6.897999 18.1513 -43441.2 -43441.2 -43441.2 -30.714399999999998 -6.897999 18.1513 -29902.1 -29902.1 -29902.1 -29.714399999999998 -7.897999 19.1513 10197.0 10197.0 10197.0 -29.714399999999998 -7.897999 20.1513 117.244 117.244 117.244 -29.714399999999998 -6.897999 19.1513 -12970.5 -12970.5 -12970.5 -29.714399999999998 -6.897999 20.1513 5349.91 5349.91 5349.91 -30.714399999999998 -7.897999 19.1513 -701563.0 -701563.0 -701563.0 -30.714399999999998 -7.897999 20.1513 -1007770.0 -1007770.0 -1007770.0 -30.714399999999998 -6.897999 19.1513 29321.7 29321.7 29321.7 -30.714399999999998 -6.897999 20.1513 11023.4 11023.4 11023.4 -29.714399999999998 -5.897999 17.1513 -3251.34 -3251.34 -3251.34 -29.714399999999998 -5.897999 18.1513 -30803.4 -30803.4 -30803.4 -29.714399999999998 -4.897999 17.1513 -19.7947 -19.7947 -19.7947 -29.714399999999998 -4.897999 18.1513 6944.41 6944.41 6944.41 -30.714399999999998 -5.897999 17.1513 -37313.9 -37313.9 -37313.9 -30.714399999999998 -5.897999 18.1513 -68419.6 -68419.6 -68419.6 -30.714399999999998 -4.897999 17.1513 -27783.0 -27783.0 -27783.0 -30.714399999999998 -4.897999 18.1513 -15003.4 -15003.4 -15003.4 -29.714399999999998 -5.897999 20.1513 -39160.5 -39160.5 -39160.5 -30.714399999999998 -5.897999 19.1513 6326.98 6326.98 6326.98 -30.714399999999998 -5.897999 20.1513 -60770.9 -60770.9 -60770.9 -30.714399999999998 -4.897999 20.1513 -57038.6 -57038.6 -57038.6 -31.714399999999998 -7.897999 17.1513 242302.0 242302.0 242302.0 -31.714399999999998 -7.897999 18.1513 64185.4 64185.4 64185.4 -31.714399999999998 -6.897999 17.1513 -47697.2 -47697.2 -47697.2 -31.714399999999998 -6.897999 18.1513 -895953.0 -895953.0 -895953.0 -32.7144 -7.897999 17.1513 6211.4 6211.4 6211.4 -32.7144 -7.897999 18.1513 7697.6 7697.6 7697.6 -31.714399999999998 -7.897999 19.1513 -1548560.0 -1548560.0 -1548560.0 -31.714399999999998 -6.897999 19.1513 -863093.0 -863093.0 -863093.0 -31.714399999999998 -6.897999 20.1513 1030710.0 1030710.0 1030710.0 -32.7144 -7.897999 19.1513 -438018.0 -438018.0 -438018.0 -32.7144 -7.897999 20.1513 -952795.0 -952795.0 -952795.0 -32.7144 -6.897999 19.1513 254350.0 254350.0 254350.0 -32.7144 -6.897999 20.1513 -965199.0 -965199.0 -965199.0 -31.714399999999998 -5.897999 17.1513 -171086.0 -171086.0 -171086.0 -31.714399999999998 -5.897999 18.1513 216276.0 216276.0 216276.0 -31.714399999999998 -4.897999 18.1513 -53641.2 -53641.2 -53641.2 -32.7144 -5.897999 17.1513 -29776.4 -29776.4 -29776.4 -32.7144 -5.897999 18.1513 36865.6 36865.6 36865.6 -32.7144 -4.897999 18.1513 1159730.0 1159730.0 1159730.0 -31.714399999999998 -5.897999 19.1513 1116000.0 1116000.0 1116000.0 -31.714399999999998 -5.897999 20.1513 924288.0 924288.0 924288.0 -31.714399999999998 -4.897999 20.1513 -201511.0 -201511.0 -201511.0 -32.7144 -5.897999 19.1513 361522.0 361522.0 361522.0 -32.7144 -5.897999 20.1513 -17767.9 -17767.9 -17767.9 -32.7144 -4.897999 20.1513 -369567.0 -369567.0 -369567.0 -29.714399999999998 -3.897999 13.1513 2407.6 2407.6 2407.6 -29.714399999999998 -2.897999 13.1513 775.383 775.383 775.383 -30.714399999999998 -3.897999 13.1513 -4567.48 -4567.48 -4567.48 -30.714399999999998 -3.897999 14.1513 8946.81 8946.81 8946.81 -30.714399999999998 -2.897999 13.1513 -5336.88 -5336.88 -5336.88 -30.714399999999998 -2.897999 14.1513 -6802.82 -6802.82 -6802.82 -29.714399999999998 -1.897999 13.1513 453.091 453.091 453.091 -29.714399999999998 -0.897999 13.1513 -1820.76 -1820.76 -1820.76 -29.714399999999998 -0.897999 14.1513 3200.66 3200.66 3200.66 -31.714399999999998 -3.897999 13.1513 2779.16 2779.16 2779.16 -31.714399999999998 -3.897999 14.1513 -19964.6 -19964.6 -19964.6 -31.714399999999998 -2.897999 13.1513 -4430.59 -4430.59 -4430.59 -31.714399999999998 -2.897999 14.1513 -4177.37 -4177.37 -4177.37 -32.7144 -2.897999 13.1513 2514.59 2514.59 2514.59 -32.7144 -2.897999 14.1513 3201.26 3201.26 3201.26 -31.714399999999998 -3.897999 15.1513 -200262.0 -200262.0 -200262.0 -31.714399999999998 -2.897999 15.1513 -2233.48 -2233.48 -2233.48 -32.7144 -3.897999 15.1513 -24907.2 -24907.2 -24907.2 -32.7144 -2.897999 15.1513 337.389 337.389 337.389 -31.714399999999998 -1.897999 13.1513 193.517 193.517 193.517 -31.714399999999998 -1.897999 14.1513 4532.76 4532.76 4532.76 -32.7144 -1.897999 13.1513 562.715 562.715 562.715 -32.7144 -1.897999 14.1513 1097.54 1097.54 1097.54 -32.7144 -0.897999 13.1513 -6892.91 -6892.91 -6892.91 -31.714399999999998 -0.897999 16.1513 -2976.81 -2976.81 -2976.81 -32.7144 -0.897999 16.1513 -239.609 -239.609 -239.609 -29.714399999999998 -3.897999 17.1513 -29347.5 -29347.5 -29347.5 -29.714399999999998 -3.897999 18.1513 7807.83 7807.83 7807.83 -30.714399999999998 -3.897999 17.1513 -14869.2 -14869.2 -14869.2 -30.714399999999998 -3.897999 18.1513 -6354.19 -6354.19 -6354.19 -29.714399999999998 -3.897999 19.1513 8864.66 8864.66 8864.66 -29.714399999999998 -3.897999 20.1513 -15338.8 -15338.8 -15338.8 -29.714399999999998 -2.897999 19.1513 242.154 242.154 242.154 -29.714399999999998 -2.897999 20.1513 -406.626 -406.626 -406.626 -30.714399999999998 -3.897999 19.1513 8080.08 8080.08 8080.08 -30.714399999999998 -3.897999 20.1513 -12592.1 -12592.1 -12592.1 -30.714399999999998 -2.897999 20.1513 814.866 814.866 814.866 -30.714399999999998 -0.897999 18.1513 -859.19 -859.19 -859.19 -31.714399999999998 -3.897999 18.1513 -11019.7 -11019.7 -11019.7 -32.7144 -3.897999 18.1513 10412.0 10412.0 10412.0 -31.714399999999998 -3.897999 19.1513 2634.54 2634.54 2634.54 -31.714399999999998 -3.897999 20.1513 -8299.03 -8299.03 -8299.03 -31.714399999999998 -2.897999 19.1513 183.142 183.142 183.142 -31.714399999999998 -2.897999 20.1513 578.923 578.923 578.923 -32.7144 -3.897999 19.1513 -1171.12 -1171.12 -1171.12 -32.7144 -3.897999 20.1513 3034.04 3034.04 3034.04 -32.7144 -2.897999 19.1513 -158.705 -158.705 -158.705 -31.714399999999998 -1.897999 17.1513 -119.789 -119.789 -119.789 -31.714399999999998 -1.897999 18.1513 -4332.63 -4332.63 -4332.63 -31.714399999999998 -0.897999 17.1513 550.739 550.739 550.739 -31.714399999999998 -0.897999 18.1513 -5231.28 -5231.28 -5231.28 -32.7144 -1.897999 17.1513 70.3067 70.3067 70.3067 -32.7144 -1.897999 18.1513 2967.32 2967.32 2967.32 -32.7144 -0.897999 17.1513 354.697 354.697 354.697 -31.714399999999998 -1.897999 19.1513 5524.15 5524.15 5524.15 -31.714399999999998 -1.897999 20.1513 -7945.49 -7945.49 -7945.49 -31.714399999999998 -0.897999 19.1513 6627.49 6627.49 6627.49 -31.714399999999998 -0.897999 20.1513 2101.62 2101.62 2101.62 -32.7144 -1.897999 19.1513 3113.9 3113.9 3113.9 -32.7144 -1.897999 20.1513 -654.27 -654.27 -654.27 -32.7144 -0.897999 19.1513 12696.3 12696.3 12696.3 -32.7144 -0.897999 20.1513 -4753.96 -4753.96 -4753.96 -33.7144 -7.897999 13.1513 2770.42 2770.42 2770.42 -33.7144 -7.897999 14.1513 -11679.3 -11679.3 -11679.3 -33.7144 -6.897999 13.1513 226.629 226.629 226.629 -33.7144 -6.897999 14.1513 1507.85 1507.85 1507.85 -34.7144 -7.897999 13.1513 -3086.6 -3086.6 -3086.6 -34.7144 -7.897999 14.1513 -20971.4 -20971.4 -20971.4 -34.7144 -6.897999 13.1513 3846.36 3846.36 3846.36 -34.7144 -6.897999 14.1513 -23611.3 -23611.3 -23611.3 -33.7144 -7.897999 15.1513 140155.0 140155.0 140155.0 -33.7144 -7.897999 16.1513 -74262.8 -74262.8 -74262.8 -33.7144 -6.897999 15.1513 22238.6 22238.6 22238.6 -33.7144 -6.897999 16.1513 -7881.97 -7881.97 -7881.97 -34.7144 -7.897999 15.1513 -6087.67 -6087.67 -6087.67 -34.7144 -6.897999 15.1513 -5060.77 -5060.77 -5060.77 -34.7144 -6.897999 16.1513 -29979.0 -29979.0 -29979.0 -33.7144 -5.897999 13.1513 9905.68 9905.68 9905.68 -33.7144 -5.897999 14.1513 -23388.4 -23388.4 -23388.4 -33.7144 -4.897999 13.1513 -603.911 -603.911 -603.911 -33.7144 -4.897999 14.1513 -43747.4 -43747.4 -43747.4 -34.7144 -5.897999 13.1513 -7849.92 -7849.92 -7849.92 -34.7144 -5.897999 14.1513 10212.7 10212.7 10212.7 -34.7144 -4.897999 13.1513 -12899.8 -12899.8 -12899.8 -34.7144 -4.897999 14.1513 6166.05 6166.05 6166.05 -33.7144 -5.897999 15.1513 211102.0 211102.0 211102.0 -33.7144 -5.897999 16.1513 -134358.0 -134358.0 -134358.0 -33.7144 -4.897999 15.1513 429114.0 429114.0 429114.0 -33.7144 -4.897999 16.1513 65321.9 65321.9 65321.9 -34.7144 -5.897999 16.1513 8807.56 8807.56 8807.56 -34.7144 -4.897999 15.1513 22611.6 22611.6 22611.6 -34.7144 -4.897999 16.1513 14032.6 14032.6 14032.6 -35.7144 -7.897999 14.1513 -1975.72 -1975.72 -1975.72 -35.7144 -6.897999 13.1513 -4805.01 -4805.01 -4805.01 -35.7144 -6.897999 14.1513 -10790.4 -10790.4 -10790.4 -36.7144 -7.897999 14.1513 -3361.6 -3361.6 -3361.6 -36.7144 -6.897999 13.1513 -7595.58 -7595.58 -7595.58 -36.7144 -6.897999 14.1513 -4503.1 -4503.1 -4503.1 -35.7144 -7.897999 15.1513 -6977.25 -6977.25 -6977.25 -35.7144 -7.897999 16.1513 27096.0 27096.0 27096.0 -35.7144 -6.897999 15.1513 6594.58 6594.58 6594.58 -35.7144 -6.897999 16.1513 3067.74 3067.74 3067.74 -36.7144 -7.897999 15.1513 -2637.59 -2637.59 -2637.59 -36.7144 -7.897999 16.1513 87.3805 87.3805 87.3805 -35.7144 -5.897999 13.1513 4550.5 4550.5 4550.5 -35.7144 -5.897999 14.1513 -5027.34 -5027.34 -5027.34 -35.7144 -4.897999 13.1513 11881.9 11881.9 11881.9 -35.7144 -4.897999 14.1513 7390.69 7390.69 7390.69 -36.7144 -5.897999 13.1513 -1593.22 -1593.22 -1593.22 -36.7144 -4.897999 13.1513 -21323.7 -21323.7 -21323.7 -35.7144 -5.897999 15.1513 -1626.18 -1626.18 -1626.18 -35.7144 -5.897999 16.1513 -4933.56 -4933.56 -4933.56 -35.7144 -4.897999 15.1513 7986.83 7986.83 7986.83 -35.7144 -4.897999 16.1513 10234.7 10234.7 10234.7 -33.7144 -6.897999 17.1513 -173607.0 -173607.0 -173607.0 -34.7144 -6.897999 17.1513 52728.7 52728.7 52728.7 -34.7144 -6.897999 18.1513 723788.0 723788.0 723788.0 -33.7144 -6.897999 19.1513 -488946.0 -488946.0 -488946.0 -33.7144 -6.897999 20.1513 1284410.0 1284410.0 1284410.0 -34.7144 -6.897999 19.1513 -58529.1 -58529.1 -58529.1 -34.7144 -6.897999 20.1513 531759.0 531759.0 531759.0 -33.7144 -5.897999 17.1513 -302232.0 -302232.0 -302232.0 -33.7144 -5.897999 18.1513 -1166090.0 -1166090.0 -1166090.0 -33.7144 -4.897999 18.1513 4246.7 4246.7 4246.7 -34.7144 -5.897999 17.1513 -44032.6 -44032.6 -44032.6 -34.7144 -5.897999 18.1513 -360740.0 -360740.0 -360740.0 -33.7144 -5.897999 19.1513 -196660.0 -196660.0 -196660.0 -33.7144 -5.897999 20.1513 -250163.0 -250163.0 -250163.0 -33.7144 -4.897999 19.1513 300289.0 300289.0 300289.0 -33.7144 -4.897999 20.1513 -1380890.0 -1380890.0 -1380890.0 -34.7144 -5.897999 19.1513 -405472.0 -405472.0 -405472.0 -34.7144 -5.897999 20.1513 -330191.0 -330191.0 -330191.0 -35.7144 -7.897999 17.1513 -64241.2 -64241.2 -64241.2 -35.7144 -7.897999 18.1513 30224.8 30224.8 30224.8 -35.7144 -6.897999 17.1513 73717.3 73717.3 73717.3 -35.7144 -6.897999 18.1513 179850.0 179850.0 179850.0 -36.7144 -7.897999 17.1513 442.744 442.744 442.744 -36.7144 -7.897999 18.1513 -12346.9 -12346.9 -12346.9 -35.7144 -7.897999 19.1513 -27037.6 -27037.6 -27037.6 -35.7144 -7.897999 20.1513 -64319.4 -64319.4 -64319.4 -35.7144 -6.897999 19.1513 33837.2 33837.2 33837.2 -35.7144 -6.897999 20.1513 -215871.0 -215871.0 -215871.0 -33.7144 -3.897999 13.1513 -1588.12 -1588.12 -1588.12 -33.7144 -3.897999 14.1513 43688.1 43688.1 43688.1 -33.7144 -2.897999 13.1513 4094.42 4094.42 4094.42 -33.7144 -2.897999 14.1513 2105.0 2105.0 2105.0 -34.7144 -3.897999 13.1513 -10402.4 -10402.4 -10402.4 -34.7144 -3.897999 14.1513 1620.71 1620.71 1620.71 -34.7144 -2.897999 13.1513 617.733 617.733 617.733 -34.7144 -2.897999 14.1513 2451.61 2451.61 2451.61 -33.7144 -3.897999 15.1513 430219.0 430219.0 430219.0 -33.7144 -3.897999 16.1513 1226.66 1226.66 1226.66 -33.7144 -2.897999 15.1513 -2853.99 -2853.99 -2853.99 -34.7144 -3.897999 15.1513 4034.52 4034.52 4034.52 -34.7144 -3.897999 16.1513 16752.6 16752.6 16752.6 -34.7144 -2.897999 15.1513 -1849.85 -1849.85 -1849.85 -34.7144 -2.897999 16.1513 1448.59 1448.59 1448.59 -33.7144 -1.897999 13.1513 -2425.32 -2425.32 -2425.32 -33.7144 -1.897999 14.1513 -6238.25 -6238.25 -6238.25 -33.7144 -0.897999 13.1513 -11841.1 -11841.1 -11841.1 -33.7144 -0.897999 14.1513 -14775.9 -14775.9 -14775.9 -34.7144 -1.897999 13.1513 1258.51 1258.51 1258.51 -34.7144 -1.897999 14.1513 -1346.09 -1346.09 -1346.09 -34.7144 -0.897999 13.1513 7045.33 7045.33 7045.33 -34.7144 -0.897999 14.1513 -1159.39 -1159.39 -1159.39 -33.7144 -1.897999 15.1513 -815.726 -815.726 -815.726 -33.7144 -1.897999 16.1513 -606.316 -606.316 -606.316 -33.7144 -0.897999 15.1513 2146.35 2146.35 2146.35 -33.7144 -0.897999 16.1513 -875.865 -875.865 -875.865 -34.7144 -1.897999 15.1513 3112.66 3112.66 3112.66 -34.7144 -1.897999 16.1513 448.331 448.331 448.331 -34.7144 -0.897999 15.1513 9408.18 9408.18 9408.18 -34.7144 -0.897999 16.1513 12838.1 12838.1 12838.1 -35.7144 -3.897999 13.1513 6022.58 6022.58 6022.58 -35.7144 -3.897999 14.1513 -5875.54 -5875.54 -5875.54 -35.7144 -2.897999 13.1513 3969.86 3969.86 3969.86 -35.7144 -2.897999 14.1513 -653.195 -653.195 -653.195 -36.7144 -3.897999 13.1513 44970.7 44970.7 44970.7 -36.7144 -3.897999 14.1513 29363.8 29363.8 29363.8 -36.7144 -2.897999 13.1513 -33319.6 -33319.6 -33319.6 -36.7144 -2.897999 14.1513 25946.6 25946.6 25946.6 -35.7144 -3.897999 15.1513 3420.1 3420.1 3420.1 -35.7144 -3.897999 16.1513 2890.47 2890.47 2890.47 -35.7144 -2.897999 15.1513 281.104 281.104 281.104 -35.7144 -2.897999 16.1513 2473.63 2473.63 2473.63 -36.7144 -2.897999 15.1513 -1248.12 -1248.12 -1248.12 -36.7144 -2.897999 16.1513 1266.47 1266.47 1266.47 -35.7144 -1.897999 13.1513 -1670.48 -1670.48 -1670.48 -35.7144 -1.897999 14.1513 -6159.04 -6159.04 -6159.04 -36.7144 -1.897999 13.1513 -24263.0 -24263.0 -24263.0 -36.7144 -1.897999 14.1513 -74786.3 -74786.3 -74786.3 -35.7144 -1.897999 16.1513 354.007 354.007 354.007 -35.7144 -0.897999 16.1513 9736.01 9736.01 9736.01 -36.7144 -1.897999 15.1513 1397.16 1397.16 1397.16 -36.7144 -1.897999 16.1513 4668.28 4668.28 4668.28 -36.7144 -0.897999 16.1513 -11209.0 -11209.0 -11209.0 -33.7144 -3.897999 18.1513 -29709.1 -29709.1 -29709.1 -34.7144 -3.897999 17.1513 -3751.76 -3751.76 -3751.76 -34.7144 -3.897999 18.1513 -20510.6 -20510.6 -20510.6 -34.7144 -2.897999 17.1513 3753.17 3753.17 3753.17 -34.7144 -2.897999 18.1513 -1436.17 -1436.17 -1436.17 -33.7144 -3.897999 19.1513 -6056.88 -6056.88 -6056.88 -33.7144 -3.897999 20.1513 1865.59 1865.59 1865.59 -33.7144 -2.897999 19.1513 -911.856 -911.856 -911.856 -34.7144 -3.897999 19.1513 3104.16 3104.16 3104.16 -34.7144 -3.897999 20.1513 -1601.06 -1601.06 -1601.06 -34.7144 -2.897999 19.1513 997.943 997.943 997.943 -33.7144 -1.897999 17.1513 662.589 662.589 662.589 -33.7144 -1.897999 18.1513 -218.747 -218.747 -218.747 -33.7144 -0.897999 17.1513 872.181 872.181 872.181 -33.7144 -0.897999 18.1513 -2577.17 -2577.17 -2577.17 -34.7144 -1.897999 17.1513 1834.22 1834.22 1834.22 -34.7144 -1.897999 18.1513 -1182.84 -1182.84 -1182.84 -34.7144 -0.897999 17.1513 -4685.52 -4685.52 -4685.52 -34.7144 -0.897999 18.1513 -769.454 -769.454 -769.454 -33.7144 -1.897999 19.1513 -5268.15 -5268.15 -5268.15 -33.7144 -0.897999 19.1513 -2151.53 -2151.53 -2151.53 -33.7144 -0.897999 20.1513 -5695.93 -5695.93 -5695.93 -34.7144 -1.897999 19.1513 -381.025 -381.025 -381.025 -34.7144 -0.897999 19.1513 152.887 152.887 152.887 -35.7144 -3.897999 17.1513 -3842.34 -3842.34 -3842.34 -35.7144 -3.897999 18.1513 -14458.2 -14458.2 -14458.2 -35.7144 -2.897999 18.1513 -5293.86 -5293.86 -5293.86 -36.7144 -3.897999 17.1513 3415.29 3415.29 3415.29 -36.7144 -3.897999 18.1513 1040.78 1040.78 1040.78 -36.7144 -2.897999 17.1513 1111.5 1111.5 1111.5 -36.7144 -2.897999 18.1513 3050.78 3050.78 3050.78 -35.7144 -3.897999 19.1513 -398.131 -398.131 -398.131 -35.7144 -3.897999 20.1513 8667.74 8667.74 8667.74 -35.7144 -2.897999 19.1513 -845.753 -845.753 -845.753 -35.7144 -2.897999 20.1513 -727.099 -727.099 -727.099 -36.7144 -2.897999 19.1513 3120.25 3120.25 3120.25 -36.7144 -2.897999 20.1513 2909.17 2909.17 2909.17 -35.7144 -0.897999 17.1513 -10085.4 -10085.4 -10085.4 -35.7144 -0.897999 18.1513 694.779 694.779 694.779 -36.7144 -1.897999 17.1513 4685.32 4685.32 4685.32 -36.7144 -1.897999 18.1513 84.7034 84.7034 84.7034 -36.7144 -0.897999 17.1513 -12817.3 -12817.3 -12817.3 -36.7144 -0.897999 18.1513 -1229.73 -1229.73 -1229.73 -35.7144 -1.897999 19.1513 -1279.96 -1279.96 -1279.96 -35.7144 -1.897999 20.1513 -2168.42 -2168.42 -2168.42 -35.7144 -0.897999 19.1513 -1195.1 -1195.1 -1195.1 -36.7144 -1.897999 19.1513 -3929.13 -3929.13 -3929.13 -36.7144 -1.897999 20.1513 1083.11 1083.11 1083.11 -29.714399999999998 -7.897999 21.1513 2840.32 2840.32 2840.32 -29.714399999999998 -7.897999 22.1513 198.981 198.981 198.981 -29.714399999999998 -6.897999 21.1513 -34075.7 -34075.7 -34075.7 -29.714399999999998 -6.897999 22.1513 267.546 267.546 267.546 -30.714399999999998 -7.897999 21.1513 -87097.1 -87097.1 -87097.1 -30.714399999999998 -6.897999 21.1513 24000.8 24000.8 24000.8 -29.714399999999998 -5.897999 21.1513 -35541.0 -35541.0 -35541.0 -29.714399999999998 -5.897999 22.1513 1488.48 1488.48 1488.48 -29.714399999999998 -4.897999 22.1513 921.948 921.948 921.948 -30.714399999999998 -5.897999 21.1513 15645.1 15645.1 15645.1 -30.714399999999998 -4.897999 21.1513 20110.9 20110.9 20110.9 -30.714399999999998 -4.897999 22.1513 703.884 703.884 703.884 -32.7144 -7.897999 21.1513 -1252740.0 -1252740.0 -1252740.0 -32.7144 -6.897999 21.1513 5807.06 5807.06 5807.06 -31.714399999999998 -5.897999 21.1513 31862.9 31862.9 31862.9 -31.714399999999998 -4.897999 21.1513 37871.5 37871.5 37871.5 -32.7144 -5.897999 21.1513 -551.647 -551.647 -551.647 -32.7144 -4.897999 21.1513 6589.69 6589.69 6589.69 -29.714399999999998 -3.897999 22.1513 -466.848 -466.848 -466.848 -29.714399999999998 -2.897999 21.1513 31.2785 31.2785 31.2785 -29.714399999999998 -2.897999 22.1513 -161.376 -161.376 -161.376 -30.714399999999998 -3.897999 21.1513 12781.7 12781.7 12781.7 -30.714399999999998 -3.897999 22.1513 317.528 317.528 317.528 -30.714399999999998 -2.897999 21.1513 -883.986 -883.986 -883.986 -30.714399999999998 -2.897999 22.1513 -408.936 -408.936 -408.936 -31.714399999999998 -3.897999 21.1513 68.0966 68.0966 68.0966 -31.714399999999998 -2.897999 21.1513 -459.313 -459.313 -459.313 -32.7144 -3.897999 21.1513 6425.89 6425.89 6425.89 -32.7144 -2.897999 21.1513 498.411 498.411 498.411 -32.7144 -2.897999 22.1513 -1088.33 -1088.33 -1088.33 -31.714399999999998 -1.897999 21.1513 -631.691 -631.691 -631.691 -31.714399999999998 -0.897999 21.1513 -383.0 -383.0 -383.0 -32.7144 -1.897999 21.1513 1603.83 1603.83 1603.83 -32.7144 -1.897999 22.1513 730.322 730.322 730.322 -32.7144 -0.897999 21.1513 1404.63 1404.63 1404.63 -33.7144 -7.897999 21.1513 170018.0 170018.0 170018.0 -33.7144 -6.897999 21.1513 32493.0 32493.0 32493.0 -34.7144 -7.897999 21.1513 17012.2 17012.2 17012.2 -34.7144 -6.897999 21.1513 220029.0 220029.0 220029.0 -33.7144 -5.897999 21.1513 2563.03 2563.03 2563.03 -33.7144 -4.897999 21.1513 26055.7 26055.7 26055.7 -33.7144 -4.897999 22.1513 5329.77 5329.77 5329.77 -34.7144 -4.897999 21.1513 20961.9 20961.9 20961.9 -34.7144 -4.897999 22.1513 5553.5 5553.5 5553.5 -33.7144 -4.897999 23.1513 5237.06 5237.06 5237.06 -34.7144 -4.897999 23.1513 -4425.64 -4425.64 -4425.64 -35.7144 -7.897999 21.1513 -355721.0 -355721.0 -355721.0 -35.7144 -4.897999 21.1513 -37531.1 -37531.1 -37531.1 -35.7144 -4.897999 22.1513 -6216.38 -6216.38 -6216.38 -35.7144 -4.897999 23.1513 5334.34 5334.34 5334.34 -33.7144 -3.897999 21.1513 5318.64 5318.64 5318.64 -33.7144 -3.897999 22.1513 3478.01 3478.01 3478.01 -33.7144 -2.897999 21.1513 1391.02 1391.02 1391.02 -33.7144 -2.897999 22.1513 -864.551 -864.551 -864.551 -34.7144 -3.897999 21.1513 13471.6 13471.6 13471.6 -33.7144 -3.897999 23.1513 4171.23 4171.23 4171.23 -33.7144 -2.897999 23.1513 -286.178 -286.178 -286.178 -34.7144 -3.897999 23.1513 3932.58 3932.58 3932.58 -34.7144 -2.897999 23.1513 3750.29 3750.29 3750.29 -33.7144 -1.897999 22.1513 -952.574 -952.574 -952.574 -33.7144 -0.897999 21.1513 1201.67 1201.67 1201.67 -33.7144 -0.897999 22.1513 -109.705 -109.705 -109.705 -34.7144 -1.897999 22.1513 -141.563 -141.563 -141.563 -34.7144 -0.897999 22.1513 -2290.55 -2290.55 -2290.55 -33.7144 -1.897999 23.1513 -230.788 -230.788 -230.788 -34.7144 -1.897999 23.1513 -411.367 -411.367 -411.367 -35.7144 -3.897999 21.1513 -16789.7 -16789.7 -16789.7 -35.7144 -3.897999 22.1513 -6535.6 -6535.6 -6535.6 -35.7144 -2.897999 21.1513 -614.162 -614.162 -614.162 -36.7144 -3.897999 21.1513 7396.89 7396.89 7396.89 -36.7144 -3.897999 22.1513 -17476.6 -17476.6 -17476.6 -36.7144 -2.897999 21.1513 5474.8 5474.8 5474.8 -36.7144 -2.897999 22.1513 -8652.0 -8652.0 -8652.0 -35.7144 -3.897999 23.1513 -11305.8 -11305.8 -11305.8 -35.7144 -2.897999 23.1513 -1409.97 -1409.97 -1409.97 -36.7144 -3.897999 23.1513 -6810.86 -6810.86 -6810.86 -36.7144 -2.897999 23.1513 -10711.0 -10711.0 -10711.0 -35.7144 -1.897999 22.1513 -237.219 -237.219 -237.219 -35.7144 -0.897999 22.1513 -495.198 -495.198 -495.198 -36.7144 -1.897999 21.1513 -684.713 -684.713 -684.713 -36.7144 -1.897999 22.1513 1602.56 1602.56 1602.56 -35.7144 -1.897999 23.1513 -2498.76 -2498.76 -2498.76 -35.7144 -0.897999 23.1513 1712.38 1712.38 1712.38 -36.7144 -1.897999 23.1513 2525.49 2525.49 2525.49 -36.7144 -0.897999 23.1513 -820.74 -820.74 -820.74 -26.714399999999998 1.102001 2.151300000000001 2163.21 2163.21 2163.21 -26.714399999999998 1.102001 3.151300000000001 7414.14 7414.14 7414.14 -26.714399999999998 2.102001 2.151300000000001 5938.19 5938.19 5938.19 -26.714399999999998 2.102001 3.151300000000001 -11414.5 -11414.5 -11414.5 -27.714399999999998 0.10200100000000001 2.151300000000001 -14157.3 -14157.3 -14157.3 -27.714399999999998 1.102001 1.1513000000000009 -2732.59 -2732.59 -2732.59 -27.714399999999998 1.102001 2.151300000000001 394.418 394.418 394.418 -28.714399999999998 0.10200100000000001 1.1513000000000009 2094.7 2094.7 2094.7 -28.714399999999998 0.10200100000000001 2.151300000000001 14569.6 14569.6 14569.6 -28.714399999999998 1.102001 1.1513000000000009 -159.368 -159.368 -159.368 -28.714399999999998 1.102001 2.151300000000001 16854.9 16854.9 16854.9 -27.714399999999998 0.10200100000000001 3.151300000000001 -24017.5 -24017.5 -24017.5 -27.714399999999998 1.102001 3.151300000000001 -19571.4 -19571.4 -19571.4 -27.714399999999998 1.102001 4.151300000000001 -16576.7 -16576.7 -16576.7 -28.714399999999998 0.10200100000000001 3.151300000000001 -6587.61 -6587.61 -6587.61 -28.714399999999998 0.10200100000000001 4.151300000000001 -23698.9 -23698.9 -23698.9 -28.714399999999998 1.102001 3.151300000000001 11502.5 11502.5 11502.5 -28.714399999999998 1.102001 4.151300000000001 -4481.07 -4481.07 -4481.07 -27.714399999999998 2.102001 1.1513000000000009 -303.144 -303.144 -303.144 -27.714399999999998 2.102001 2.151300000000001 26316.1 26316.1 26316.1 -27.714399999999998 3.102001 1.1513000000000009 -562.405 -562.405 -562.405 -27.714399999999998 3.102001 2.151300000000001 7083.21 7083.21 7083.21 -28.714399999999998 2.102001 1.1513000000000009 -796.325 -796.325 -796.325 -28.714399999999998 3.102001 1.1513000000000009 -679.025 -679.025 -679.025 -28.714399999999998 3.102001 2.151300000000001 1062.92 1062.92 1062.92 -27.714399999999998 2.102001 3.151300000000001 14637.9 14637.9 14637.9 -27.714399999999998 2.102001 4.151300000000001 3998.44 3998.44 3998.44 -27.714399999999998 3.102001 3.151300000000001 -734.641 -734.641 -734.641 -27.714399999999998 3.102001 4.151300000000001 -4532.43 -4532.43 -4532.43 -28.714399999999998 2.102001 4.151300000000001 17255.6 17255.6 17255.6 -28.714399999999998 3.102001 3.151300000000001 1298.72 1298.72 1298.72 -28.714399999999998 3.102001 4.151300000000001 573.091 573.091 573.091 -28.714399999999998 4.102001 2.151300000000001 114.236 114.236 114.236 -28.714399999999998 4.102001 3.151300000000001 1017.34 1017.34 1017.34 -28.714399999999998 4.102001 4.151300000000001 1894.96 1894.96 1894.96 -22.714399999999998 0.10200100000000001 7.151300000000001 107.636 107.636 107.636 -22.714399999999998 0.10200100000000001 8.1513 -467.003 -467.003 -467.003 -23.714399999999998 0.10200100000000001 7.151300000000001 -12.7972 -12.7972 -12.7972 -23.714399999999998 0.10200100000000001 8.1513 380.975 380.975 380.975 -23.714399999999998 1.102001 8.1513 -223.989 -223.989 -223.989 -24.714399999999998 0.10200100000000001 7.151300000000001 5199.77 5199.77 5199.77 -24.714399999999998 0.10200100000000001 8.1513 7142.71 7142.71 7142.71 -24.714399999999998 1.102001 8.1513 25807.3 25807.3 25807.3 -22.714399999999998 0.10200100000000001 9.1513 166.346 166.346 166.346 -22.714399999999998 0.10200100000000001 10.1513 -42.2375 -42.2375 -42.2375 -22.714399999999998 1.102001 9.1513 -436.096 -436.096 -436.096 -22.714399999999998 1.102001 10.1513 255.731 255.731 255.731 -22.714399999999998 0.10200100000000001 11.1513 -396.851 -396.851 -396.851 -22.714399999999998 1.102001 11.1513 -485.445 -485.445 -485.445 -23.714399999999998 1.102001 9.1513 484.031 484.031 484.031 -23.714399999999998 1.102001 10.1513 -411.702 -411.702 -411.702 -24.714399999999998 1.102001 9.1513 10968.6 10968.6 10968.6 -24.714399999999998 1.102001 10.1513 -6102.56 -6102.56 -6102.56 -23.714399999999998 0.10200100000000001 11.1513 -46.2442 -46.2442 -46.2442 -23.714399999999998 0.10200100000000001 12.1513 418.186 418.186 418.186 -23.714399999999998 1.102001 11.1513 -877.227 -877.227 -877.227 -24.714399999999998 0.10200100000000001 11.1513 126.608 126.608 126.608 -24.714399999999998 0.10200100000000001 12.1513 1314.01 1314.01 1314.01 -24.714399999999998 1.102001 11.1513 1498.09 1498.09 1498.09 -24.714399999999998 1.102001 12.1513 2177.65 2177.65 2177.65 -24.714399999999998 3.102001 9.1513 5899.85 5899.85 5899.85 -24.714399999999998 3.102001 10.1513 101.06 101.06 101.06 -23.714399999999998 2.102001 11.1513 -804.221 -804.221 -804.221 -23.714399999999998 2.102001 12.1513 733.937 733.937 733.937 -23.714399999999998 3.102001 11.1513 -413.126 -413.126 -413.126 -23.714399999999998 3.102001 12.1513 -1019.85 -1019.85 -1019.85 -24.714399999999998 2.102001 11.1513 -68.4921 -68.4921 -68.4921 -24.714399999999998 2.102001 12.1513 3240.34 3240.34 3240.34 -24.714399999999998 3.102001 11.1513 -1360.59 -1360.59 -1360.59 -23.714399999999998 5.102001 8.1513 3382.6 3382.6 3382.6 -24.714399999999998 5.102001 8.1513 -1355.13 -1355.13 -1355.13 -23.714399999999998 6.102001 8.1513 5003.08 5003.08 5003.08 -24.714399999999998 6.102001 8.1513 -4729.39 -4729.39 -4729.39 -22.714399999999998 5.102001 10.1513 943.213 943.213 943.213 -22.714399999999998 5.102001 11.1513 56.9781 56.9781 56.9781 -22.714399999999998 6.102001 10.1513 38.5761 38.5761 38.5761 -22.714399999999998 6.102001 11.1513 -201.0 -201.0 -201.0 -23.714399999999998 4.102001 9.1513 209.841 209.841 209.841 -23.714399999999998 4.102001 10.1513 260.817 260.817 260.817 -23.714399999999998 5.102001 9.1513 -3953.66 -3953.66 -3953.66 -23.714399999999998 5.102001 10.1513 -82.7903 -82.7903 -82.7903 -24.714399999999998 4.102001 9.1513 -121.608 -121.608 -121.608 -24.714399999999998 4.102001 10.1513 1300.19 1300.19 1300.19 -24.714399999999998 5.102001 9.1513 -14043.8 -14043.8 -14043.8 -23.714399999999998 4.102001 11.1513 1068.11 1068.11 1068.11 -23.714399999999998 4.102001 12.1513 378.39 378.39 378.39 -23.714399999999998 5.102001 11.1513 1818.77 1818.77 1818.77 -23.714399999999998 5.102001 12.1513 836.338 836.338 836.338 -24.714399999999998 4.102001 11.1513 312.664 312.664 312.664 -24.714399999999998 5.102001 12.1513 -1006.42 -1006.42 -1006.42 -23.714399999999998 6.102001 9.1513 6460.02 6460.02 6460.02 -23.714399999999998 6.102001 10.1513 -720.962 -720.962 -720.962 -23.714399999999998 7.102001 9.1513 9174.92 9174.92 9174.92 -23.714399999999998 7.102001 10.1513 -450.902 -450.902 -450.902 -24.714399999999998 6.102001 9.1513 -4687.11 -4687.11 -4687.11 -24.714399999999998 7.102001 9.1513 -659.694 -659.694 -659.694 -24.714399999999998 7.102001 10.1513 995.141 995.141 995.141 -23.714399999999998 6.102001 11.1513 -182.03 -182.03 -182.03 -23.714399999999998 6.102001 12.1513 2538.53 2538.53 2538.53 -23.714399999999998 7.102001 11.1513 -595.576 -595.576 -595.576 -23.714399999999998 7.102001 12.1513 -756.78 -756.78 -756.78 -24.714399999999998 6.102001 12.1513 2156.15 2156.15 2156.15 -24.714399999999998 7.102001 11.1513 950.781 950.781 950.781 -24.714399999999998 7.102001 12.1513 -3342.5 -3342.5 -3342.5 -25.714399999999998 0.10200100000000001 7.151300000000001 -16546.7 -16546.7 -16546.7 -25.714399999999998 0.10200100000000001 8.1513 2461.3 2461.3 2461.3 -25.714399999999998 1.102001 8.1513 -31849.9 -31849.9 -31849.9 -26.714399999999998 0.10200100000000001 8.1513 22276.1 22276.1 22276.1 -26.714399999999998 3.102001 7.151300000000001 -510.99 -510.99 -510.99 -26.714399999999998 3.102001 8.1513 37.7555 37.7555 37.7555 -28.714399999999998 0.10200100000000001 6.151300000000001 -2229.77 -2229.77 -2229.77 -28.714399999999998 1.102001 5.151300000000001 416.689 416.689 416.689 -28.714399999999998 0.10200100000000001 7.151300000000001 3616.6 3616.6 3616.6 -27.714399999999998 3.102001 6.151300000000001 -2470.87 -2470.87 -2470.87 -28.714399999999998 2.102001 5.151300000000001 -291.159 -291.159 -291.159 -28.714399999999998 3.102001 5.151300000000001 -840.359 -840.359 -840.359 -28.714399999999998 3.102001 6.151300000000001 -1047.61 -1047.61 -1047.61 -27.714399999999998 3.102001 7.151300000000001 -76.8964 -76.8964 -76.8964 -27.714399999999998 3.102001 8.1513 1415.25 1415.25 1415.25 -28.714399999999998 3.102001 7.151300000000001 846.995 846.995 846.995 -28.714399999999998 3.102001 8.1513 -984.455 -984.455 -984.455 -25.714399999999998 0.10200100000000001 9.1513 -10558.3 -10558.3 -10558.3 -25.714399999999998 0.10200100000000001 10.1513 5140.61 5140.61 5140.61 -25.714399999999998 1.102001 9.1513 -5836.11 -5836.11 -5836.11 -25.714399999999998 1.102001 10.1513 -6414.96 -6414.96 -6414.96 -26.714399999999998 0.10200100000000001 9.1513 1727.97 1727.97 1727.97 -26.714399999999998 0.10200100000000001 10.1513 4316.9 4316.9 4316.9 -26.714399999999998 1.102001 9.1513 -2101.16 -2101.16 -2101.16 -26.714399999999998 1.102001 10.1513 -429.243 -429.243 -429.243 -25.714399999999998 0.10200100000000001 11.1513 -1149.72 -1149.72 -1149.72 -25.714399999999998 0.10200100000000001 12.1513 608.878 608.878 608.878 -25.714399999999998 1.102001 11.1513 -1263.43 -1263.43 -1263.43 -25.714399999999998 1.102001 12.1513 -1101.07 -1101.07 -1101.07 -26.714399999999998 0.10200100000000001 11.1513 -2304.21 -2304.21 -2304.21 -26.714399999999998 0.10200100000000001 12.1513 703.929 703.929 703.929 -26.714399999999998 1.102001 11.1513 927.714 927.714 927.714 -26.714399999999998 1.102001 12.1513 -662.756 -662.756 -662.756 -25.714399999999998 2.102001 9.1513 8770.05 8770.05 8770.05 -25.714399999999998 2.102001 10.1513 1496.27 1496.27 1496.27 -25.714399999999998 3.102001 9.1513 -506.272 -506.272 -506.272 -25.714399999999998 3.102001 10.1513 -200.697 -200.697 -200.697 -26.714399999999998 2.102001 9.1513 3090.63 3090.63 3090.63 -26.714399999999998 3.102001 9.1513 -3049.2 -3049.2 -3049.2 -25.714399999999998 2.102001 11.1513 -1430.07 -1430.07 -1430.07 -25.714399999999998 2.102001 12.1513 366.877 366.877 366.877 -25.714399999999998 3.102001 11.1513 -463.843 -463.843 -463.843 -26.714399999999998 2.102001 12.1513 932.805 932.805 932.805 -26.714399999999998 3.102001 12.1513 2959.25 2959.25 2959.25 -27.714399999999998 0.10200100000000001 10.1513 3450.6 3450.6 3450.6 -27.714399999999998 1.102001 9.1513 -1050.33 -1050.33 -1050.33 -27.714399999999998 1.102001 10.1513 466.985 466.985 466.985 -28.714399999999998 0.10200100000000001 10.1513 5432.6 5432.6 5432.6 -28.714399999999998 1.102001 9.1513 4905.42 4905.42 4905.42 -28.714399999999998 1.102001 10.1513 2388.12 2388.12 2388.12 -27.714399999999998 0.10200100000000001 11.1513 -3979.26 -3979.26 -3979.26 -27.714399999999998 1.102001 11.1513 879.779 879.779 879.779 -27.714399999999998 1.102001 12.1513 -969.957 -969.957 -969.957 -28.714399999999998 0.10200100000000001 11.1513 -5661.96 -5661.96 -5661.96 -28.714399999999998 0.10200100000000001 12.1513 777.521 777.521 777.521 -28.714399999999998 1.102001 11.1513 311.176 311.176 311.176 -28.714399999999998 1.102001 12.1513 -1232.16 -1232.16 -1232.16 -27.714399999999998 2.102001 9.1513 1766.9 1766.9 1766.9 -27.714399999999998 3.102001 9.1513 1872.04 1872.04 1872.04 -28.714399999999998 2.102001 9.1513 2391.12 2391.12 2391.12 -28.714399999999998 2.102001 10.1513 319.34 319.34 319.34 -28.714399999999998 3.102001 9.1513 465.479 465.479 465.479 -28.714399999999998 3.102001 10.1513 -163.929 -163.929 -163.929 -27.714399999999998 2.102001 12.1513 -2465.2 -2465.2 -2465.2 -27.714399999999998 3.102001 11.1513 359.267 359.267 359.267 -27.714399999999998 3.102001 12.1513 -427.783 -427.783 -427.783 -28.714399999999998 2.102001 11.1513 1255.07 1255.07 1255.07 -28.714399999999998 2.102001 12.1513 -2168.4 -2168.4 -2168.4 -28.714399999999998 3.102001 11.1513 940.696 940.696 940.696 -28.714399999999998 3.102001 12.1513 49.2231 49.2231 49.2231 -26.714399999999998 4.102001 6.151300000000001 4637.36 4637.36 4637.36 -26.714399999999998 5.102001 6.151300000000001 1949.1 1949.1 1949.1 -25.714399999999998 4.102001 7.151300000000001 780.019 780.019 780.019 -25.714399999999998 4.102001 8.1513 149.897 149.897 149.897 -25.714399999999998 5.102001 7.151300000000001 2688.36 2688.36 2688.36 -25.714399999999998 5.102001 8.1513 -145.466 -145.466 -145.466 -26.714399999999998 4.102001 7.151300000000001 -442.841 -442.841 -442.841 -26.714399999999998 4.102001 8.1513 9.5795 9.5795 9.5795 -26.714399999999998 5.102001 7.151300000000001 1386.47 1386.47 1386.47 -26.714399999999998 5.102001 8.1513 -958.176 -958.176 -958.176 -25.714399999999998 6.102001 8.1513 -1765.71 -1765.71 -1765.71 -26.714399999999998 6.102001 7.151300000000001 398.941 398.941 398.941 -26.714399999999998 6.102001 8.1513 2549.78 2549.78 2549.78 -27.714399999999998 4.102001 6.151300000000001 -1629.86 -1629.86 -1629.86 -27.714399999999998 5.102001 6.151300000000001 -217.733 -217.733 -217.733 -28.714399999999998 4.102001 6.151300000000001 -1447.35 -1447.35 -1447.35 -28.714399999999998 5.102001 6.151300000000001 1293.23 1293.23 1293.23 -27.714399999999998 4.102001 8.1513 -928.347 -928.347 -928.347 -27.714399999999998 5.102001 7.151300000000001 -3413.46 -3413.46 -3413.46 -27.714399999999998 5.102001 8.1513 462.686 462.686 462.686 -28.714399999999998 4.102001 7.151300000000001 -979.759 -979.759 -979.759 -28.714399999999998 4.102001 8.1513 -1754.24 -1754.24 -1754.24 -27.714399999999998 6.102001 6.151300000000001 333.762 333.762 333.762 -27.714399999999998 7.102001 6.151300000000001 -197.864 -197.864 -197.864 -28.714399999999998 6.102001 6.151300000000001 386.321 386.321 386.321 -28.714399999999998 7.102001 5.151300000000001 -573.68 -573.68 -573.68 -28.714399999999998 7.102001 6.151300000000001 869.58 869.58 869.58 -27.714399999999998 6.102001 7.151300000000001 85.155 85.155 85.155 -27.714399999999998 6.102001 8.1513 -462.961 -462.961 -462.961 -27.714399999999998 7.102001 7.151300000000001 -1041.26 -1041.26 -1041.26 -27.714399999999998 7.102001 8.1513 690.496 690.496 690.496 -28.714399999999998 7.102001 7.151300000000001 1645.82 1645.82 1645.82 -28.714399999999998 7.102001 8.1513 3030.18 3030.18 3030.18 -25.714399999999998 4.102001 9.1513 127.044 127.044 127.044 -25.714399999999998 4.102001 10.1513 -778.624 -778.624 -778.624 -25.714399999999998 5.102001 9.1513 -44.5747 -44.5747 -44.5747 -25.714399999999998 5.102001 10.1513 390.865 390.865 390.865 -26.714399999999998 4.102001 9.1513 -422.336 -422.336 -422.336 -26.714399999999998 5.102001 9.1513 -77.2818 -77.2818 -77.2818 -26.714399999999998 5.102001 10.1513 903.287 903.287 903.287 -26.714399999999998 5.102001 12.1513 125.138 125.138 125.138 -25.714399999999998 6.102001 9.1513 -127.474 -127.474 -127.474 -25.714399999999998 6.102001 10.1513 -149.055 -149.055 -149.055 -25.714399999999998 7.102001 9.1513 511.568 511.568 511.568 -25.714399999999998 7.102001 10.1513 170.304 170.304 170.304 -26.714399999999998 6.102001 9.1513 -100.028 -100.028 -100.028 -26.714399999999998 6.102001 10.1513 -400.216 -400.216 -400.216 -26.714399999999998 7.102001 9.1513 -161.413 -161.413 -161.413 -26.714399999999998 7.102001 10.1513 734.285 734.285 734.285 -25.714399999999998 7.102001 11.1513 227.58 227.58 227.58 -25.714399999999998 7.102001 12.1513 -584.274 -584.274 -584.274 -26.714399999999998 7.102001 12.1513 -217.195 -217.195 -217.195 -27.714399999999998 4.102001 9.1513 -344.098 -344.098 -344.098 -27.714399999999998 4.102001 10.1513 -342.068 -342.068 -342.068 -27.714399999999998 5.102001 9.1513 -327.591 -327.591 -327.591 -27.714399999999998 5.102001 10.1513 49.4605 49.4605 49.4605 -28.714399999999998 4.102001 9.1513 733.815 733.815 733.815 -28.714399999999998 4.102001 10.1513 480.855 480.855 480.855 -28.714399999999998 5.102001 9.1513 816.751 816.751 816.751 -28.714399999999998 5.102001 10.1513 344.053 344.053 344.053 -27.714399999999998 4.102001 11.1513 191.173 191.173 191.173 -27.714399999999998 4.102001 12.1513 -581.635 -581.635 -581.635 -27.714399999999998 5.102001 11.1513 -119.676 -119.676 -119.676 -27.714399999999998 5.102001 12.1513 -1005.69 -1005.69 -1005.69 -28.714399999999998 4.102001 11.1513 -393.873 -393.873 -393.873 -28.714399999999998 5.102001 11.1513 17.7306 17.7306 17.7306 -28.714399999999998 5.102001 12.1513 144.839 144.839 144.839 -27.714399999999998 6.102001 9.1513 119.986 119.986 119.986 -27.714399999999998 6.102001 10.1513 -21.3537 -21.3537 -21.3537 -27.714399999999998 7.102001 9.1513 -338.779 -338.779 -338.779 -27.714399999999998 7.102001 10.1513 646.955 646.955 646.955 -28.714399999999998 6.102001 9.1513 -96.9155 -96.9155 -96.9155 -28.714399999999998 6.102001 10.1513 -586.663 -586.663 -586.663 -28.714399999999998 7.102001 9.1513 -3008.76 -3008.76 -3008.76 -28.714399999999998 7.102001 10.1513 29.47 29.47 29.47 -27.714399999999998 7.102001 11.1513 -756.759 -756.759 -756.759 -28.714399999999998 6.102001 11.1513 -203.462 -203.462 -203.462 -28.714399999999998 6.102001 12.1513 -218.999 -218.999 -218.999 -28.714399999999998 7.102001 11.1513 -888.346 -888.346 -888.346 -28.714399999999998 7.102001 12.1513 -1573.64 -1573.64 -1573.64 -28.714399999999998 8.102001 5.151300000000001 -425.185 -425.185 -425.185 -28.714399999999998 8.102001 6.151300000000001 -2016.85 -2016.85 -2016.85 -28.714399999999998 9.102001 6.151300000000001 586.109 586.109 586.109 -28.714399999999998 8.102001 7.151300000000001 1689.64 1689.64 1689.64 -28.714399999999998 9.102001 7.151300000000001 -2721.2 -2721.2 -2721.2 -25.714399999999998 8.102001 10.1513 -335.415 -335.415 -335.415 -26.714399999999998 8.102001 10.1513 212.029 212.029 212.029 -25.714399999999998 8.102001 11.1513 743.007 743.007 743.007 -25.714399999999998 8.102001 12.1513 -153.717 -153.717 -153.717 -26.714399999999998 8.102001 11.1513 -2.24167 -2.24167 -2.24167 -26.714399999999998 8.102001 12.1513 83.1764 83.1764 83.1764 -27.714399999999998 8.102001 10.1513 -58.1847 -58.1847 -58.1847 -27.714399999999998 8.102001 11.1513 -30.071 -30.071 -30.071 -27.714399999999998 8.102001 12.1513 301.762 301.762 301.762 -28.714399999999998 8.102001 11.1513 -33.8068 -33.8068 -33.8068 -28.714399999999998 8.102001 12.1513 144.105 144.105 144.105 -30.714399999999998 0.10200100000000001 0.15130000000000088 -1308.27 -1308.27 -1308.27 -30.714399999999998 1.102001 0.15130000000000088 -3688.26 -3688.26 -3688.26 -30.714399999999998 2.102001 -0.8486999999999991 619.616 619.616 619.616 -30.714399999999998 2.102001 0.15130000000000088 -7992.8 -7992.8 -7992.8 -30.714399999999998 3.102001 -0.8486999999999991 5336.54 5336.54 5336.54 -30.714399999999998 3.102001 0.15130000000000088 1384.55 1384.55 1384.55 -31.714399999999998 0.10200100000000001 0.15130000000000088 -4069.37 -4069.37 -4069.37 -31.714399999999998 1.102001 -0.8486999999999991 5844.18 5844.18 5844.18 -31.714399999999998 1.102001 0.15130000000000088 -1494.61 -1494.61 -1494.61 -32.7144 0.10200100000000001 -0.8486999999999991 11085.5 11085.5 11085.5 -32.7144 0.10200100000000001 0.15130000000000088 6438.32 6438.32 6438.32 -32.7144 1.102001 -0.8486999999999991 7986.17 7986.17 7986.17 -32.7144 1.102001 0.15130000000000088 5137.4 5137.4 5137.4 -31.714399999999998 2.102001 -1.8486999999999991 5517.49 5517.49 5517.49 -31.714399999999998 3.102001 -1.8486999999999991 -641.181 -641.181 -641.181 -32.7144 2.102001 -1.8486999999999991 1891.09 1891.09 1891.09 -32.7144 3.102001 -1.8486999999999991 -4159.68 -4159.68 -4159.68 -31.714399999999998 2.102001 -0.8486999999999991 3762.83 3762.83 3762.83 -31.714399999999998 3.102001 -0.8486999999999991 2137.32 2137.32 2137.32 -32.7144 2.102001 -0.8486999999999991 -445.693 -445.693 -445.693 -32.7144 3.102001 -0.8486999999999991 -180.31 -180.31 -180.31 -29.714399999999998 0.10200100000000001 1.1513000000000009 -2064.96 -2064.96 -2064.96 -29.714399999999998 0.10200100000000001 2.151300000000001 988.188 988.188 988.188 -29.714399999999998 1.102001 1.1513000000000009 -1018.77 -1018.77 -1018.77 -29.714399999999998 1.102001 2.151300000000001 106.148 106.148 106.148 -30.714399999999998 0.10200100000000001 1.1513000000000009 -3261.27 -3261.27 -3261.27 -30.714399999999998 0.10200100000000001 2.151300000000001 3188.21 3188.21 3188.21 -30.714399999999998 1.102001 1.1513000000000009 1206.25 1206.25 1206.25 -29.714399999999998 0.10200100000000001 3.151300000000001 868.484 868.484 868.484 -29.714399999999998 0.10200100000000001 4.151300000000001 -26.7126 -26.7126 -26.7126 -29.714399999999998 1.102001 3.151300000000001 173.401 173.401 173.401 -29.714399999999998 1.102001 4.151300000000001 876.493 876.493 876.493 -30.714399999999998 0.10200100000000001 3.151300000000001 -343.97 -343.97 -343.97 -30.714399999999998 0.10200100000000001 4.151300000000001 -3964.03 -3964.03 -3964.03 -30.714399999999998 1.102001 3.151300000000001 1227.29 1227.29 1227.29 -30.714399999999998 1.102001 4.151300000000001 -349.305 -349.305 -349.305 -29.714399999999998 2.102001 1.1513000000000009 -6211.17 -6211.17 -6211.17 -29.714399999999998 2.102001 2.151300000000001 -1803.66 -1803.66 -1803.66 -29.714399999999998 3.102001 1.1513000000000009 1604.88 1604.88 1604.88 -29.714399999999998 3.102001 2.151300000000001 1343.35 1343.35 1343.35 -30.714399999999998 2.102001 1.1513000000000009 -6030.98 -6030.98 -6030.98 -30.714399999999998 3.102001 1.1513000000000009 853.863 853.863 853.863 -30.714399999999998 3.102001 2.151300000000001 3644.85 3644.85 3644.85 -29.714399999999998 3.102001 4.151300000000001 -498.296 -498.296 -498.296 -30.714399999999998 2.102001 4.151300000000001 -35.721 -35.721 -35.721 -30.714399999999998 3.102001 4.151300000000001 -382.221 -382.221 -382.221 -31.714399999999998 0.10200100000000001 1.1513000000000009 -7110.77 -7110.77 -7110.77 -31.714399999999998 0.10200100000000001 2.151300000000001 7807.4 7807.4 7807.4 -32.7144 0.10200100000000001 1.1513000000000009 -10198.1 -10198.1 -10198.1 -32.7144 0.10200100000000001 2.151300000000001 -3314.43 -3314.43 -3314.43 -32.7144 1.102001 2.151300000000001 -847.944 -847.944 -847.944 -31.714399999999998 0.10200100000000001 3.151300000000001 -9007.67 -9007.67 -9007.67 -31.714399999999998 0.10200100000000001 4.151300000000001 834.541 834.541 834.541 -31.714399999999998 1.102001 3.151300000000001 4310.97 4310.97 4310.97 -31.714399999999998 1.102001 4.151300000000001 -1686.0 -1686.0 -1686.0 -32.7144 0.10200100000000001 3.151300000000001 9885.09 9885.09 9885.09 -32.7144 0.10200100000000001 4.151300000000001 -1777.0 -1777.0 -1777.0 -32.7144 1.102001 3.151300000000001 -2904.49 -2904.49 -2904.49 -32.7144 1.102001 4.151300000000001 -4377.74 -4377.74 -4377.74 -31.714399999999998 3.102001 1.1513000000000009 3039.55 3039.55 3039.55 -31.714399999999998 3.102001 2.151300000000001 3038.12 3038.12 3038.12 -32.7144 3.102001 1.1513000000000009 1916.73 1916.73 1916.73 -32.7144 3.102001 2.151300000000001 166.696 166.696 166.696 -32.7144 2.102001 3.151300000000001 -5150.86 -5150.86 -5150.86 -32.7144 2.102001 4.151300000000001 -3880.16 -3880.16 -3880.16 -32.7144 3.102001 3.151300000000001 -74.9775 -74.9775 -74.9775 -30.714399999999998 4.102001 -0.8486999999999991 -1134.09 -1134.09 -1134.09 -30.714399999999998 4.102001 0.15130000000000088 5257.54 5257.54 5257.54 -31.714399999999998 4.102001 -0.8486999999999991 1417.84 1417.84 1417.84 -31.714399999999998 4.102001 0.15130000000000088 704.53 704.53 704.53 -32.7144 4.102001 -0.8486999999999991 -1109.06 -1109.06 -1109.06 -32.7144 4.102001 0.15130000000000088 -6489.41 -6489.41 -6489.41 -29.714399999999998 4.102001 2.151300000000001 6974.99 6974.99 6974.99 -30.714399999999998 4.102001 1.1513000000000009 -1404.33 -1404.33 -1404.33 -30.714399999999998 4.102001 2.151300000000001 -6228.08 -6228.08 -6228.08 -30.714399999999998 5.102001 2.151300000000001 -10074.2 -10074.2 -10074.2 -29.714399999999998 4.102001 3.151300000000001 4377.41 4377.41 4377.41 -29.714399999999998 4.102001 4.151300000000001 24274.2 24274.2 24274.2 -29.714399999999998 5.102001 4.151300000000001 -2136.34 -2136.34 -2136.34 -30.714399999999998 4.102001 3.151300000000001 -12614.0 -12614.0 -12614.0 -30.714399999999998 4.102001 4.151300000000001 18283.4 18283.4 18283.4 -30.714399999999998 5.102001 3.151300000000001 -10295.9 -10295.9 -10295.9 -30.714399999999998 5.102001 4.151300000000001 2254.18 2254.18 2254.18 -30.714399999999998 6.102001 3.151300000000001 -3433.57 -3433.57 -3433.57 -30.714399999999998 6.102001 4.151300000000001 -6192.32 -6192.32 -6192.32 -31.714399999999998 4.102001 1.1513000000000009 -1343.19 -1343.19 -1343.19 -31.714399999999998 4.102001 2.151300000000001 1324.18 1324.18 1324.18 -31.714399999999998 5.102001 2.151300000000001 -10990.3 -10990.3 -10990.3 -32.7144 4.102001 1.1513000000000009 -3190.19 -3190.19 -3190.19 -32.7144 4.102001 2.151300000000001 394.688 394.688 394.688 -32.7144 5.102001 2.151300000000001 370.367 370.367 370.367 -31.714399999999998 4.102001 3.151300000000001 2652.13 2652.13 2652.13 -32.7144 4.102001 3.151300000000001 -293.404 -293.404 -293.404 -32.7144 5.102001 3.151300000000001 66.4436 66.4436 66.4436 -32.7144 5.102001 4.151300000000001 -336.91 -336.91 -336.91 -31.714399999999998 6.102001 2.151300000000001 -2785.11 -2785.11 -2785.11 -31.714399999999998 6.102001 3.151300000000001 -33.229 -33.229 -33.229 -31.714399999999998 6.102001 4.151300000000001 -4028.42 -4028.42 -4028.42 -32.7144 6.102001 3.151300000000001 -144900.0 -144900.0 -144900.0 -32.7144 6.102001 4.151300000000001 -465.397 -465.397 -465.397 -33.7144 0.10200100000000001 -0.8486999999999991 6743.39 6743.39 6743.39 -33.7144 1.102001 -0.8486999999999991 7767.25 7767.25 7767.25 -34.7144 0.10200100000000001 -0.8486999999999991 1396.0 1396.0 1396.0 -34.7144 0.10200100000000001 0.15130000000000088 -2719.24 -2719.24 -2719.24 -34.7144 1.102001 -0.8486999999999991 1399.27 1399.27 1399.27 -34.7144 1.102001 0.15130000000000088 3236.77 3236.77 3236.77 -34.7144 3.102001 -1.8486999999999991 14357.8 14357.8 14357.8 -33.7144 2.102001 -0.8486999999999991 -2395.58 -2395.58 -2395.58 -33.7144 2.102001 0.15130000000000088 -1364.41 -1364.41 -1364.41 -33.7144 3.102001 -0.8486999999999991 -4245.39 -4245.39 -4245.39 -33.7144 3.102001 0.15130000000000088 -747.298 -747.298 -747.298 -34.7144 2.102001 0.15130000000000088 -3553.84 -3553.84 -3553.84 -34.7144 3.102001 -0.8486999999999991 2867.7 2867.7 2867.7 -34.7144 3.102001 0.15130000000000088 8385.46 8385.46 8385.46 -35.7144 0.10200100000000001 0.15130000000000088 1932.09 1932.09 1932.09 -36.7144 0.10200100000000001 0.15130000000000088 3097.2 3097.2 3097.2 -35.7144 3.102001 -1.8486999999999991 -5628.84 -5628.84 -5628.84 -36.7144 3.102001 -1.8486999999999991 10930.1 10930.1 10930.1 -35.7144 2.102001 -0.8486999999999991 -1700.48 -1700.48 -1700.48 -35.7144 2.102001 0.15130000000000088 -565.004 -565.004 -565.004 -35.7144 3.102001 -0.8486999999999991 -5337.84 -5337.84 -5337.84 -35.7144 3.102001 0.15130000000000088 14676.3 14676.3 14676.3 -36.7144 2.102001 -0.8486999999999991 3396.84 3396.84 3396.84 -36.7144 2.102001 0.15130000000000088 4649.67 4649.67 4649.67 -36.7144 3.102001 -0.8486999999999991 -668.928 -668.928 -668.928 -36.7144 3.102001 0.15130000000000088 10819.6 10819.6 10819.6 -33.7144 0.10200100000000001 2.151300000000001 -6688.75 -6688.75 -6688.75 -33.7144 1.102001 2.151300000000001 7337.99 7337.99 7337.99 -34.7144 0.10200100000000001 1.1513000000000009 -3928.43 -3928.43 -3928.43 -34.7144 0.10200100000000001 2.151300000000001 1906.93 1906.93 1906.93 -34.7144 1.102001 1.1513000000000009 3960.03 3960.03 3960.03 -34.7144 1.102001 2.151300000000001 -435.75 -435.75 -435.75 -33.7144 0.10200100000000001 4.151300000000001 1761.38 1761.38 1761.38 -33.7144 1.102001 3.151300000000001 -4973.22 -4973.22 -4973.22 -33.7144 1.102001 4.151300000000001 -6294.24 -6294.24 -6294.24 -34.7144 0.10200100000000001 3.151300000000001 1590.16 1590.16 1590.16 -34.7144 0.10200100000000001 4.151300000000001 -1048.88 -1048.88 -1048.88 -34.7144 1.102001 3.151300000000001 739.356 739.356 739.356 -34.7144 1.102001 4.151300000000001 -1823.24 -1823.24 -1823.24 -33.7144 2.102001 1.1513000000000009 1918.1 1918.1 1918.1 -33.7144 2.102001 2.151300000000001 7488.11 7488.11 7488.11 -33.7144 3.102001 1.1513000000000009 -420.738 -420.738 -420.738 -33.7144 3.102001 2.151300000000001 -225.62 -225.62 -225.62 -34.7144 2.102001 1.1513000000000009 -2442.08 -2442.08 -2442.08 -34.7144 2.102001 2.151300000000001 -1673.41 -1673.41 -1673.41 -34.7144 3.102001 1.1513000000000009 -224.076 -224.076 -224.076 -34.7144 3.102001 2.151300000000001 229.567 229.567 229.567 -33.7144 2.102001 3.151300000000001 1878.62 1878.62 1878.62 -33.7144 2.102001 4.151300000000001 -908.369 -908.369 -908.369 -33.7144 3.102001 3.151300000000001 1485.73 1485.73 1485.73 -33.7144 3.102001 4.151300000000001 3523.57 3523.57 3523.57 -34.7144 2.102001 3.151300000000001 1569.49 1569.49 1569.49 -34.7144 2.102001 4.151300000000001 1726.63 1726.63 1726.63 -34.7144 3.102001 3.151300000000001 489.31 489.31 489.31 -35.7144 0.10200100000000001 1.1513000000000009 -3420.49 -3420.49 -3420.49 -35.7144 0.10200100000000001 2.151300000000001 8693.32 8693.32 8693.32 -36.7144 0.10200100000000001 1.1513000000000009 8061.62 8061.62 8061.62 -36.7144 0.10200100000000001 2.151300000000001 934.69 934.69 934.69 -36.7144 1.102001 2.151300000000001 -5422.28 -5422.28 -5422.28 -35.7144 0.10200100000000001 3.151300000000001 1776.6 1776.6 1776.6 -35.7144 1.102001 3.151300000000001 6979.64 6979.64 6979.64 -36.7144 0.10200100000000001 3.151300000000001 -3914.59 -3914.59 -3914.59 -36.7144 1.102001 3.151300000000001 21498.9 21498.9 21498.9 -36.7144 1.102001 4.151300000000001 -6958.08 -6958.08 -6958.08 -35.7144 2.102001 1.1513000000000009 2568.99 2568.99 2568.99 -35.7144 2.102001 2.151300000000001 -1642.36 -1642.36 -1642.36 -35.7144 3.102001 1.1513000000000009 3650.25 3650.25 3650.25 -35.7144 3.102001 2.151300000000001 -4590.57 -4590.57 -4590.57 -36.7144 2.102001 1.1513000000000009 -23133.6 -23133.6 -23133.6 -36.7144 3.102001 1.1513000000000009 -24181.7 -24181.7 -24181.7 -36.7144 3.102001 2.151300000000001 39891.8 39891.8 39891.8 -35.7144 2.102001 3.151300000000001 1893.54 1893.54 1893.54 -35.7144 3.102001 3.151300000000001 63.917 63.917 63.917 -36.7144 2.102001 3.151300000000001 -93412.1 -93412.1 -93412.1 -36.7144 2.102001 4.151300000000001 -53839.2 -53839.2 -53839.2 -36.7144 3.102001 3.151300000000001 26981.7 26981.7 26981.7 -36.7144 3.102001 4.151300000000001 -102154.0 -102154.0 -102154.0 -34.7144 4.102001 -1.8486999999999991 3214.52 3214.52 3214.52 -33.7144 4.102001 -0.8486999999999991 -5849.15 -5849.15 -5849.15 -33.7144 4.102001 0.15130000000000088 -2763.45 -2763.45 -2763.45 -33.7144 5.102001 0.15130000000000088 -12332.4 -12332.4 -12332.4 -34.7144 4.102001 -0.8486999999999991 479.161 479.161 479.161 -34.7144 4.102001 0.15130000000000088 16923.8 16923.8 16923.8 -34.7144 5.102001 -0.8486999999999991 9808.29 9808.29 9808.29 -34.7144 5.102001 0.15130000000000088 -3353.05 -3353.05 -3353.05 -33.7144 6.102001 0.15130000000000088 -245.148 -245.148 -245.148 -33.7144 7.102001 0.15130000000000088 440.18 440.18 440.18 -34.7144 6.102001 -0.8486999999999991 -16620.5 -16620.5 -16620.5 -34.7144 6.102001 0.15130000000000088 -18365.2 -18365.2 -18365.2 -34.7144 7.102001 -0.8486999999999991 -25628.9 -25628.9 -25628.9 -34.7144 7.102001 0.15130000000000088 815.18 815.18 815.18 -35.7144 4.102001 -1.8486999999999991 -19063.3 -19063.3 -19063.3 -35.7144 5.102001 -1.8486999999999991 -13713.0 -13713.0 -13713.0 -36.7144 4.102001 -1.8486999999999991 -4067.28 -4067.28 -4067.28 -36.7144 5.102001 -1.8486999999999991 4728.87 4728.87 4728.87 -35.7144 4.102001 -0.8486999999999991 -10692.2 -10692.2 -10692.2 -35.7144 5.102001 -0.8486999999999991 1904.53 1904.53 1904.53 -36.7144 5.102001 -0.8486999999999991 -5199.49 -5199.49 -5199.49 -36.7144 5.102001 0.15130000000000088 -3153.59 -3153.59 -3153.59 -35.7144 6.102001 -0.8486999999999991 2567.85 2567.85 2567.85 -35.7144 6.102001 0.15130000000000088 -18687.1 -18687.1 -18687.1 -35.7144 7.102001 -0.8486999999999991 -1989.02 -1989.02 -1989.02 -35.7144 7.102001 0.15130000000000088 39735.5 39735.5 39735.5 -36.7144 6.102001 -0.8486999999999991 -5666.97 -5666.97 -5666.97 -36.7144 6.102001 0.15130000000000088 -3606.61 -3606.61 -3606.61 -36.7144 7.102001 0.15130000000000088 45962.1 45962.1 45962.1 -33.7144 4.102001 1.1513000000000009 5397.6 5397.6 5397.6 -33.7144 4.102001 2.151300000000001 -725.368 -725.368 -725.368 -33.7144 5.102001 1.1513000000000009 3687.92 3687.92 3687.92 -33.7144 5.102001 2.151300000000001 1200.83 1200.83 1200.83 -34.7144 4.102001 1.1513000000000009 4699.02 4699.02 4699.02 -34.7144 4.102001 2.151300000000001 1015.68 1015.68 1015.68 -34.7144 5.102001 2.151300000000001 -773.657 -773.657 -773.657 -33.7144 4.102001 3.151300000000001 193.05 193.05 193.05 -33.7144 4.102001 4.151300000000001 1082.24 1082.24 1082.24 -33.7144 5.102001 3.151300000000001 199.94 199.94 199.94 -33.7144 5.102001 4.151300000000001 69.1369 69.1369 69.1369 -34.7144 4.102001 3.151300000000001 1954.82 1954.82 1954.82 -34.7144 5.102001 3.151300000000001 -987.094 -987.094 -987.094 -34.7144 5.102001 4.151300000000001 213.041 213.041 213.041 -33.7144 6.102001 1.1513000000000009 -54035.6 -54035.6 -54035.6 -33.7144 6.102001 2.151300000000001 -4599.93 -4599.93 -4599.93 -33.7144 7.102001 1.1513000000000009 -4741.25 -4741.25 -4741.25 -33.7144 7.102001 2.151300000000001 47520.2 47520.2 47520.2 -34.7144 6.102001 2.151300000000001 52991.5 52991.5 52991.5 -34.7144 7.102001 1.1513000000000009 26059.4 26059.4 26059.4 -34.7144 7.102001 2.151300000000001 1945.11 1945.11 1945.11 -33.7144 6.102001 4.151300000000001 1401.37 1401.37 1401.37 -34.7144 6.102001 3.151300000000001 -99702.1 -99702.1 -99702.1 -34.7144 6.102001 4.151300000000001 4932.27 4932.27 4932.27 -34.7144 7.102001 4.151300000000001 1786.3 1786.3 1786.3 -36.7144 5.102001 1.1513000000000009 8632.33 8632.33 8632.33 -35.7144 5.102001 3.151300000000001 -1474.09 -1474.09 -1474.09 -35.7144 6.102001 2.151300000000001 3258.9 3258.9 3258.9 -35.7144 7.102001 1.1513000000000009 -54655.7 -54655.7 -54655.7 -35.7144 7.102001 2.151300000000001 -822.521 -822.521 -822.521 -36.7144 6.102001 1.1513000000000009 -2619.35 -2619.35 -2619.35 -36.7144 6.102001 2.151300000000001 -2519.02 -2519.02 -2519.02 -36.7144 7.102001 1.1513000000000009 -30527.8 -30527.8 -30527.8 -36.7144 7.102001 2.151300000000001 -588.996 -588.996 -588.996 -35.7144 6.102001 3.151300000000001 -483.458 -483.458 -483.458 -35.7144 6.102001 4.151300000000001 1372.74 1372.74 1372.74 -36.7144 6.102001 3.151300000000001 -1289.41 -1289.41 -1289.41 -36.7144 6.102001 4.151300000000001 -2910.7 -2910.7 -2910.7 -36.7144 7.102001 4.151300000000001 1537.18 1537.18 1537.18 -29.714399999999998 0.10200100000000001 6.151300000000001 -2458.95 -2458.95 -2458.95 -29.714399999999998 1.102001 5.151300000000001 602.498 602.498 602.498 -29.714399999999998 1.102001 6.151300000000001 -4505.2 -4505.2 -4505.2 -30.714399999999998 0.10200100000000001 5.151300000000001 1334.83 1334.83 1334.83 -30.714399999999998 0.10200100000000001 6.151300000000001 1534.55 1534.55 1534.55 -30.714399999999998 1.102001 5.151300000000001 -2593.03 -2593.03 -2593.03 -30.714399999999998 1.102001 6.151300000000001 -4633.25 -4633.25 -4633.25 -29.714399999999998 0.10200100000000001 7.151300000000001 -2552.27 -2552.27 -2552.27 -29.714399999999998 0.10200100000000001 8.1513 5829.7 5829.7 5829.7 -29.714399999999998 1.102001 7.151300000000001 -5619.02 -5619.02 -5619.02 -29.714399999999998 1.102001 8.1513 -1726.6 -1726.6 -1726.6 -30.714399999999998 0.10200100000000001 7.151300000000001 465.47 465.47 465.47 -30.714399999999998 0.10200100000000001 8.1513 5372.48 5372.48 5372.48 -30.714399999999998 1.102001 7.151300000000001 -768.131 -768.131 -768.131 -30.714399999999998 1.102001 8.1513 271.398 271.398 271.398 -29.714399999999998 2.102001 5.151300000000001 314.452 314.452 314.452 -29.714399999999998 2.102001 6.151300000000001 -3847.03 -3847.03 -3847.03 -29.714399999999998 3.102001 5.151300000000001 -2190.1 -2190.1 -2190.1 -29.714399999999998 3.102001 6.151300000000001 -313.296 -313.296 -313.296 -30.714399999999998 2.102001 5.151300000000001 -81.039 -81.039 -81.039 -30.714399999999998 2.102001 6.151300000000001 -2001.69 -2001.69 -2001.69 -30.714399999999998 3.102001 5.151300000000001 -570.042 -570.042 -570.042 -30.714399999999998 3.102001 6.151300000000001 -361.562 -361.562 -361.562 -29.714399999999998 2.102001 7.151300000000001 -1515.14 -1515.14 -1515.14 -29.714399999999998 2.102001 8.1513 -1851.71 -1851.71 -1851.71 -29.714399999999998 3.102001 7.151300000000001 113.851 113.851 113.851 -29.714399999999998 3.102001 8.1513 -429.219 -429.219 -429.219 -30.714399999999998 2.102001 7.151300000000001 1757.53 1757.53 1757.53 -30.714399999999998 2.102001 8.1513 -482.845 -482.845 -482.845 -31.714399999999998 0.10200100000000001 5.151300000000001 9340.59 9340.59 9340.59 -31.714399999999998 0.10200100000000001 6.151300000000001 8257.41 8257.41 8257.41 -31.714399999999998 1.102001 5.151300000000001 24603.7 24603.7 24603.7 -31.714399999999998 1.102001 6.151300000000001 27785.5 27785.5 27785.5 -32.7144 0.10200100000000001 5.151300000000001 26757.0 26757.0 26757.0 -32.7144 0.10200100000000001 6.151300000000001 -44900.0 -44900.0 -44900.0 -32.7144 1.102001 6.151300000000001 -61914.6 -61914.6 -61914.6 -31.714399999999998 0.10200100000000001 7.151300000000001 21171.1 21171.1 21171.1 -31.714399999999998 1.102001 7.151300000000001 -4787.04 -4787.04 -4787.04 -32.7144 0.10200100000000001 7.151300000000001 32024.1 32024.1 32024.1 -32.7144 0.10200100000000001 8.1513 647.534 647.534 647.534 -32.7144 1.102001 7.151300000000001 -30471.2 -30471.2 -30471.2 -32.7144 1.102001 8.1513 -67.3625 -67.3625 -67.3625 -31.714399999999998 2.102001 5.151300000000001 -4618.39 -4618.39 -4618.39 -31.714399999999998 2.102001 6.151300000000001 29375.9 29375.9 29375.9 -31.714399999999998 3.102001 5.151300000000001 -434.31 -434.31 -434.31 -31.714399999999998 3.102001 6.151300000000001 -995.626 -995.626 -995.626 -32.7144 2.102001 5.151300000000001 30520.9 30520.9 30520.9 -32.7144 2.102001 6.151300000000001 -20176.6 -20176.6 -20176.6 -32.7144 3.102001 5.151300000000001 -653.641 -653.641 -653.641 -32.7144 3.102001 6.151300000000001 189.558 189.558 189.558 -31.714399999999998 2.102001 7.151300000000001 4023.81 4023.81 4023.81 -31.714399999999998 2.102001 8.1513 -241.53 -241.53 -241.53 -32.7144 2.102001 7.151300000000001 -13690.7 -13690.7 -13690.7 -32.7144 2.102001 8.1513 -497.946 -497.946 -497.946 -32.7144 3.102001 7.151300000000001 -851.839 -851.839 -851.839 -32.7144 3.102001 8.1513 -405.914 -405.914 -405.914 -29.714399999999998 0.10200100000000001 9.1513 17767.3 17767.3 17767.3 -29.714399999999998 0.10200100000000001 10.1513 -2631.74 -2631.74 -2631.74 -29.714399999999998 1.102001 9.1513 2356.15 2356.15 2356.15 -29.714399999999998 1.102001 10.1513 -1993.59 -1993.59 -1993.59 -30.714399999999998 1.102001 10.1513 -1622.23 -1622.23 -1622.23 -29.714399999999998 0.10200100000000001 11.1513 -14411.2 -14411.2 -14411.2 -29.714399999999998 0.10200100000000001 12.1513 -75.0788 -75.0788 -75.0788 -29.714399999999998 1.102001 11.1513 115.157 115.157 115.157 -29.714399999999998 1.102001 12.1513 -1889.57 -1889.57 -1889.57 -30.714399999999998 0.10200100000000001 12.1513 -1647.87 -1647.87 -1647.87 -30.714399999999998 1.102001 11.1513 781.249 781.249 781.249 -30.714399999999998 1.102001 12.1513 -1600.53 -1600.53 -1600.53 -29.714399999999998 2.102001 9.1513 -336.068 -336.068 -336.068 -29.714399999999998 2.102001 10.1513 1443.07 1443.07 1443.07 -29.714399999999998 3.102001 9.1513 -5070.34 -5070.34 -5070.34 -29.714399999999998 3.102001 10.1513 -5667.07 -5667.07 -5667.07 -30.714399999999998 2.102001 10.1513 503.666 503.666 503.666 -30.714399999999998 3.102001 10.1513 3501.16 3501.16 3501.16 -29.714399999999998 2.102001 11.1513 1793.56 1793.56 1793.56 -29.714399999999998 2.102001 12.1513 -701.699 -701.699 -701.699 -29.714399999999998 3.102001 11.1513 446.342 446.342 446.342 -29.714399999999998 3.102001 12.1513 -644.262 -644.262 -644.262 -30.714399999999998 2.102001 11.1513 122.232 122.232 122.232 -30.714399999999998 3.102001 11.1513 -2135.26 -2135.26 -2135.26 -30.714399999999998 3.102001 12.1513 -1963.85 -1963.85 -1963.85 -31.714399999999998 1.102001 10.1513 17.1409 17.1409 17.1409 -32.7144 0.10200100000000001 9.1513 -870.204 -870.204 -870.204 -32.7144 0.10200100000000001 10.1513 -5157.86 -5157.86 -5157.86 -32.7144 1.102001 9.1513 -166.892 -166.892 -166.892 -32.7144 1.102001 10.1513 987.481 987.481 987.481 -31.714399999999998 0.10200100000000001 12.1513 6170.39 6170.39 6170.39 -31.714399999999998 1.102001 11.1513 4647.14 4647.14 4647.14 -31.714399999999998 1.102001 12.1513 12262.2 12262.2 12262.2 -32.7144 0.10200100000000001 11.1513 -1153.73 -1153.73 -1153.73 -32.7144 0.10200100000000001 12.1513 22714.2 22714.2 22714.2 -32.7144 1.102001 11.1513 -1434.56 -1434.56 -1434.56 -32.7144 1.102001 12.1513 4421.6 4421.6 4421.6 -31.714399999999998 2.102001 10.1513 -2755.56 -2755.56 -2755.56 -31.714399999999998 3.102001 10.1513 -3568.53 -3568.53 -3568.53 -31.714399999999998 2.102001 11.1513 -3394.45 -3394.45 -3394.45 -31.714399999999998 2.102001 12.1513 98.2757 98.2757 98.2757 -31.714399999999998 3.102001 11.1513 -1917.78 -1917.78 -1917.78 -31.714399999999998 3.102001 12.1513 344.525 344.525 344.525 -32.7144 2.102001 11.1513 -2587.58 -2587.58 -2587.58 -32.7144 2.102001 12.1513 -1817.13 -1817.13 -1817.13 -32.7144 3.102001 11.1513 585.722 585.722 585.722 -32.7144 3.102001 12.1513 1493.75 1493.75 1493.75 -29.714399999999998 4.102001 6.151300000000001 -1574.66 -1574.66 -1574.66 -29.714399999999998 5.102001 5.151300000000001 7111.9 7111.9 7111.9 -29.714399999999998 5.102001 6.151300000000001 429.26 429.26 429.26 -30.714399999999998 4.102001 5.151300000000001 490.654 490.654 490.654 -30.714399999999998 4.102001 6.151300000000001 -661.628 -661.628 -661.628 -30.714399999999998 5.102001 5.151300000000001 499.071 499.071 499.071 -30.714399999999998 5.102001 6.151300000000001 1683.41 1683.41 1683.41 -29.714399999999998 4.102001 7.151300000000001 -768.702 -768.702 -768.702 -29.714399999999998 4.102001 8.1513 -6668.04 -6668.04 -6668.04 -29.714399999999998 6.102001 5.151300000000001 3516.19 3516.19 3516.19 -29.714399999999998 6.102001 6.151300000000001 172.427 172.427 172.427 -29.714399999999998 7.102001 5.151300000000001 -110.05 -110.05 -110.05 -29.714399999999998 7.102001 6.151300000000001 -767.333 -767.333 -767.333 -30.714399999999998 6.102001 5.151300000000001 -452.456 -452.456 -452.456 -30.714399999999998 6.102001 6.151300000000001 1054.12 1054.12 1054.12 -30.714399999999998 7.102001 5.151300000000001 186.27 186.27 186.27 -29.714399999999998 6.102001 8.1513 1301.93 1301.93 1301.93 -29.714399999999998 7.102001 7.151300000000001 -1530.9 -1530.9 -1530.9 -29.714399999999998 7.102001 8.1513 -757.179 -757.179 -757.179 -30.714399999999998 6.102001 8.1513 -144.845 -144.845 -144.845 -30.714399999999998 7.102001 8.1513 -77.0078 -77.0078 -77.0078 -31.714399999999998 4.102001 6.151300000000001 -926.931 -926.931 -926.931 -31.714399999999998 5.102001 5.151300000000001 1334.98 1334.98 1334.98 -31.714399999999998 5.102001 6.151300000000001 1127.09 1127.09 1127.09 -32.7144 5.102001 5.151300000000001 432.961 432.961 432.961 -32.7144 5.102001 6.151300000000001 21.9125 21.9125 21.9125 -31.714399999999998 4.102001 7.151300000000001 -86.7141 -86.7141 -86.7141 -31.714399999999998 5.102001 7.151300000000001 -364.797 -364.797 -364.797 -31.714399999999998 5.102001 8.1513 9639.89 9639.89 9639.89 -32.7144 4.102001 7.151300000000001 108.265 108.265 108.265 -32.7144 4.102001 8.1513 637.482 637.482 637.482 -32.7144 5.102001 7.151300000000001 -137.217 -137.217 -137.217 -32.7144 5.102001 8.1513 171.625 171.625 171.625 -31.714399999999998 6.102001 5.151300000000001 36.9966 36.9966 36.9966 -31.714399999999998 6.102001 6.151300000000001 231.531 231.531 231.531 -31.714399999999998 7.102001 5.151300000000001 -360.781 -360.781 -360.781 -31.714399999999998 7.102001 6.151300000000001 67.1894 67.1894 67.1894 -32.7144 6.102001 5.151300000000001 -136.882 -136.882 -136.882 -32.7144 6.102001 6.151300000000001 -363.561 -363.561 -363.561 -32.7144 7.102001 5.151300000000001 9.4073 9.4073 9.4073 -32.7144 7.102001 6.151300000000001 -205.888 -205.888 -205.888 -31.714399999999998 6.102001 7.151300000000001 -869.432 -869.432 -869.432 -32.7144 6.102001 7.151300000000001 -92.5267 -92.5267 -92.5267 -32.7144 6.102001 8.1513 2107.69 2107.69 2107.69 -29.714399999999998 4.102001 9.1513 -4794.38 -4794.38 -4794.38 -29.714399999999998 4.102001 10.1513 -862.903 -862.903 -862.903 -29.714399999999998 5.102001 9.1513 -2911.41 -2911.41 -2911.41 -29.714399999999998 5.102001 10.1513 -10485.0 -10485.0 -10485.0 -30.714399999999998 4.102001 9.1513 13432.4 13432.4 13432.4 -30.714399999999998 4.102001 10.1513 1019.66 1019.66 1019.66 -30.714399999999998 5.102001 10.1513 -6905.23 -6905.23 -6905.23 -29.714399999999998 4.102001 12.1513 579.579 579.579 579.579 -29.714399999999998 5.102001 11.1513 658.425 658.425 658.425 -29.714399999999998 5.102001 12.1513 317.604 317.604 317.604 -30.714399999999998 4.102001 11.1513 877.705 877.705 877.705 -30.714399999999998 4.102001 12.1513 -1907.45 -1907.45 -1907.45 -30.714399999999998 5.102001 11.1513 -1083.17 -1083.17 -1083.17 -30.714399999999998 5.102001 12.1513 -791.332 -791.332 -791.332 -29.714399999999998 6.102001 9.1513 778.189 778.189 778.189 -29.714399999999998 6.102001 10.1513 -337.601 -337.601 -337.601 -29.714399999999998 7.102001 9.1513 1400.68 1400.68 1400.68 -29.714399999999998 7.102001 10.1513 169.2 169.2 169.2 -30.714399999999998 6.102001 9.1513 2600.0 2600.0 2600.0 -30.714399999999998 7.102001 9.1513 -605.825 -605.825 -605.825 -30.714399999999998 7.102001 10.1513 -296.454 -296.454 -296.454 -29.714399999999998 6.102001 11.1513 -12.8279 -12.8279 -12.8279 -29.714399999999998 6.102001 12.1513 1368.01 1368.01 1368.01 -29.714399999999998 7.102001 11.1513 1085.74 1085.74 1085.74 -29.714399999999998 7.102001 12.1513 474.668 474.668 474.668 -30.714399999999998 6.102001 12.1513 -70.0543 -70.0543 -70.0543 -30.714399999999998 7.102001 11.1513 -353.407 -353.407 -353.407 -30.714399999999998 7.102001 12.1513 432.303 432.303 432.303 -31.714399999999998 4.102001 9.1513 6016.25 6016.25 6016.25 -31.714399999999998 4.102001 10.1513 1327.88 1327.88 1327.88 -31.714399999999998 5.102001 9.1513 2010.85 2010.85 2010.85 -31.714399999999998 5.102001 10.1513 3821.79 3821.79 3821.79 -32.7144 4.102001 9.1513 1451.55 1451.55 1451.55 -32.7144 4.102001 10.1513 -510.165 -510.165 -510.165 -32.7144 5.102001 9.1513 408.577 408.577 408.577 -32.7144 5.102001 10.1513 1952.26 1952.26 1952.26 -31.714399999999998 4.102001 11.1513 -225.76 -225.76 -225.76 -31.714399999999998 5.102001 11.1513 -361.248 -361.248 -361.248 -32.7144 4.102001 11.1513 -3602.41 -3602.41 -3602.41 -32.7144 4.102001 12.1513 533.28 533.28 533.28 -32.7144 5.102001 11.1513 1703.19 1703.19 1703.19 -32.7144 5.102001 12.1513 1938.72 1938.72 1938.72 -31.714399999999998 6.102001 9.1513 -545.372 -545.372 -545.372 -31.714399999999998 6.102001 10.1513 1000.77 1000.77 1000.77 -31.714399999999998 7.102001 9.1513 136.283 136.283 136.283 -31.714399999999998 7.102001 10.1513 1662.68 1662.68 1662.68 -32.7144 6.102001 9.1513 1499.7 1499.7 1499.7 -32.7144 6.102001 10.1513 -1901.46 -1901.46 -1901.46 -32.7144 7.102001 9.1513 732.333 732.333 732.333 -32.7144 7.102001 10.1513 -3320.37 -3320.37 -3320.37 -31.714399999999998 6.102001 11.1513 -302.081 -302.081 -302.081 -31.714399999999998 6.102001 12.1513 -185.986 -185.986 -185.986 -31.714399999999998 7.102001 11.1513 -6708.94 -6708.94 -6708.94 -31.714399999999998 7.102001 12.1513 -9106.38 -9106.38 -9106.38 -32.7144 6.102001 12.1513 -955.486 -955.486 -955.486 -33.7144 1.102001 6.151300000000001 -12043.7 -12043.7 -12043.7 -34.7144 1.102001 5.151300000000001 2495.22 2495.22 2495.22 -34.7144 1.102001 6.151300000000001 -4816.99 -4816.99 -4816.99 -33.7144 0.10200100000000001 7.151300000000001 6521.01 6521.01 6521.01 -33.7144 1.102001 7.151300000000001 -6543.33 -6543.33 -6543.33 -33.7144 1.102001 8.1513 507.528 507.528 507.528 -34.7144 1.102001 7.151300000000001 2639.99 2639.99 2639.99 -34.7144 1.102001 8.1513 -3055.88 -3055.88 -3055.88 -33.7144 2.102001 5.151300000000001 -14601.6 -14601.6 -14601.6 -33.7144 2.102001 6.151300000000001 -8264.7 -8264.7 -8264.7 -33.7144 3.102001 6.151300000000001 -93.8621 -93.8621 -93.8621 -34.7144 2.102001 5.151300000000001 6014.48 6014.48 6014.48 -34.7144 2.102001 6.151300000000001 638.353 638.353 638.353 -34.7144 3.102001 5.151300000000001 6251.78 6251.78 6251.78 -34.7144 3.102001 6.151300000000001 -6827.55 -6827.55 -6827.55 -33.7144 2.102001 7.151300000000001 10420.1 10420.1 10420.1 -33.7144 3.102001 7.151300000000001 -337.938 -337.938 -337.938 -34.7144 2.102001 7.151300000000001 -620.07 -620.07 -620.07 -34.7144 2.102001 8.1513 -1527.32 -1527.32 -1527.32 -34.7144 3.102001 7.151300000000001 -4879.95 -4879.95 -4879.95 -34.7144 3.102001 8.1513 -586.658 -586.658 -586.658 -35.7144 1.102001 5.151300000000001 3217.59 3217.59 3217.59 -35.7144 1.102001 6.151300000000001 -5748.29 -5748.29 -5748.29 -36.7144 0.10200100000000001 5.151300000000001 1050.62 1050.62 1050.62 -36.7144 0.10200100000000001 6.151300000000001 1148.96 1148.96 1148.96 -36.7144 1.102001 5.151300000000001 -1954.3 -1954.3 -1954.3 -36.7144 1.102001 6.151300000000001 740.062 740.062 740.062 -35.7144 1.102001 8.1513 -864.904 -864.904 -864.904 -36.7144 0.10200100000000001 7.151300000000001 597.522 597.522 597.522 -36.7144 0.10200100000000001 8.1513 2875.8 2875.8 2875.8 -36.7144 1.102001 7.151300000000001 3818.5 3818.5 3818.5 -36.7144 1.102001 8.1513 2323.24 2323.24 2323.24 -35.7144 2.102001 5.151300000000001 -2571.84 -2571.84 -2571.84 -35.7144 2.102001 6.151300000000001 2220.93 2220.93 2220.93 -35.7144 3.102001 5.151300000000001 4031.19 4031.19 4031.19 -35.7144 3.102001 6.151300000000001 4548.1 4548.1 4548.1 -36.7144 2.102001 5.151300000000001 -2412.8 -2412.8 -2412.8 -36.7144 2.102001 6.151300000000001 -170.996 -170.996 -170.996 -36.7144 3.102001 5.151300000000001 -5760.66 -5760.66 -5760.66 -36.7144 3.102001 6.151300000000001 6558.2 6558.2 6558.2 -35.7144 2.102001 7.151300000000001 -739.336 -739.336 -739.336 -35.7144 2.102001 8.1513 488.425 488.425 488.425 -35.7144 3.102001 7.151300000000001 -3056.22 -3056.22 -3056.22 -35.7144 3.102001 8.1513 1880.18 1880.18 1880.18 -36.7144 2.102001 7.151300000000001 -332.509 -332.509 -332.509 -36.7144 2.102001 8.1513 5073.09 5073.09 5073.09 -36.7144 3.102001 7.151300000000001 -1339.69 -1339.69 -1339.69 -36.7144 3.102001 8.1513 1732.75 1732.75 1732.75 -33.7144 0.10200100000000001 9.1513 -723.363 -723.363 -723.363 -33.7144 0.10200100000000001 10.1513 3393.12 3393.12 3393.12 -33.7144 1.102001 9.1513 1241.89 1241.89 1241.89 -33.7144 1.102001 10.1513 -354.446 -354.446 -354.446 -34.7144 0.10200100000000001 10.1513 -3664.64 -3664.64 -3664.64 -34.7144 1.102001 9.1513 -4445.9 -4445.9 -4445.9 -34.7144 1.102001 10.1513 2453.47 2453.47 2453.47 -33.7144 0.10200100000000001 12.1513 20787.6 20787.6 20787.6 -33.7144 1.102001 11.1513 2175.26 2175.26 2175.26 -33.7144 1.102001 12.1513 -23.2549 -23.2549 -23.2549 -34.7144 1.102001 11.1513 2692.4 2692.4 2692.4 -34.7144 1.102001 12.1513 696.063 696.063 696.063 -33.7144 2.102001 10.1513 611.803 611.803 611.803 -33.7144 3.102001 10.1513 -1659.98 -1659.98 -1659.98 -34.7144 2.102001 9.1513 627.866 627.866 627.866 -34.7144 2.102001 10.1513 -2293.83 -2293.83 -2293.83 -34.7144 3.102001 9.1513 655.751 655.751 655.751 -34.7144 3.102001 10.1513 -1106.78 -1106.78 -1106.78 -33.7144 2.102001 11.1513 2185.31 2185.31 2185.31 -33.7144 3.102001 11.1513 1793.78 1793.78 1793.78 -33.7144 3.102001 12.1513 1898.29 1898.29 1898.29 -34.7144 2.102001 11.1513 -284.071 -284.071 -284.071 -34.7144 2.102001 12.1513 -453.672 -453.672 -453.672 -34.7144 3.102001 12.1513 -134.3 -134.3 -134.3 -35.7144 0.10200100000000001 10.1513 2610.03 2610.03 2610.03 -35.7144 1.102001 9.1513 533.683 533.683 533.683 -35.7144 1.102001 10.1513 -701.106 -701.106 -701.106 -36.7144 0.10200100000000001 9.1513 -2392.98 -2392.98 -2392.98 -36.7144 0.10200100000000001 10.1513 8907.92 8907.92 8907.92 -36.7144 1.102001 9.1513 -3301.39 -3301.39 -3301.39 -36.7144 1.102001 10.1513 4490.91 4490.91 4490.91 -35.7144 0.10200100000000001 11.1513 282.548 282.548 282.548 -35.7144 1.102001 11.1513 5559.17 5559.17 5559.17 -36.7144 0.10200100000000001 11.1513 2351.08 2351.08 2351.08 -36.7144 1.102001 11.1513 -3550.12 -3550.12 -3550.12 -36.7144 1.102001 12.1513 -1171.86 -1171.86 -1171.86 -35.7144 2.102001 9.1513 -1777.37 -1777.37 -1777.37 -35.7144 2.102001 10.1513 3140.7 3140.7 3140.7 -35.7144 3.102001 9.1513 243.676 243.676 243.676 -35.7144 3.102001 10.1513 -1055.36 -1055.36 -1055.36 -36.7144 2.102001 9.1513 -3070.1 -3070.1 -3070.1 -36.7144 2.102001 10.1513 -913.12 -913.12 -913.12 -36.7144 3.102001 10.1513 -381.161 -381.161 -381.161 -35.7144 2.102001 11.1513 2143.21 2143.21 2143.21 -35.7144 2.102001 12.1513 -202.862 -202.862 -202.862 -35.7144 3.102001 11.1513 -1466.93 -1466.93 -1466.93 -35.7144 3.102001 12.1513 361.109 361.109 361.109 -36.7144 2.102001 11.1513 2223.32 2223.32 2223.32 -36.7144 2.102001 12.1513 -1747.14 -1747.14 -1747.14 -36.7144 3.102001 11.1513 -758.282 -758.282 -758.282 -36.7144 3.102001 12.1513 -532.509 -532.509 -532.509 -33.7144 5.102001 5.151300000000001 -1613.78 -1613.78 -1613.78 -33.7144 5.102001 6.151300000000001 -970.102 -970.102 -970.102 -34.7144 4.102001 6.151300000000001 2380.86 2380.86 2380.86 -34.7144 5.102001 6.151300000000001 1211.66 1211.66 1211.66 -33.7144 4.102001 7.151300000000001 -453.575 -453.575 -453.575 -33.7144 4.102001 8.1513 -1570.86 -1570.86 -1570.86 -33.7144 5.102001 7.151300000000001 -1337.21 -1337.21 -1337.21 -33.7144 5.102001 8.1513 268.311 268.311 268.311 -34.7144 4.102001 7.151300000000001 -478.195 -478.195 -478.195 -34.7144 4.102001 8.1513 -765.801 -765.801 -765.801 -34.7144 5.102001 7.151300000000001 -644.044 -644.044 -644.044 -34.7144 5.102001 8.1513 -899.139 -899.139 -899.139 -33.7144 6.102001 5.151300000000001 457.291 457.291 457.291 -33.7144 6.102001 6.151300000000001 -695.912 -695.912 -695.912 -33.7144 7.102001 5.151300000000001 226.228 226.228 226.228 -33.7144 7.102001 6.151300000000001 -266.334 -266.334 -266.334 -34.7144 6.102001 5.151300000000001 -595.404 -595.404 -595.404 -34.7144 7.102001 5.151300000000001 2060.79 2060.79 2060.79 -33.7144 6.102001 7.151300000000001 -643.794 -643.794 -643.794 -33.7144 6.102001 8.1513 271.775 271.775 271.775 -33.7144 7.102001 8.1513 -39.2234 -39.2234 -39.2234 -34.7144 6.102001 7.151300000000001 -776.14 -776.14 -776.14 -34.7144 6.102001 8.1513 -49.3243 -49.3243 -49.3243 -34.7144 7.102001 8.1513 1747.91 1747.91 1747.91 -35.7144 4.102001 5.151300000000001 1632.35 1632.35 1632.35 -35.7144 4.102001 6.151300000000001 -2178.0 -2178.0 -2178.0 -35.7144 5.102001 5.151300000000001 252.53 252.53 252.53 -35.7144 5.102001 6.151300000000001 208.047 208.047 208.047 -36.7144 4.102001 5.151300000000001 -5544.09 -5544.09 -5544.09 -36.7144 4.102001 6.151300000000001 -2356.86 -2356.86 -2356.86 -36.7144 5.102001 5.151300000000001 1489.61 1489.61 1489.61 -36.7144 5.102001 6.151300000000001 32.1763 32.1763 32.1763 -35.7144 4.102001 7.151300000000001 -2043.25 -2043.25 -2043.25 -35.7144 4.102001 8.1513 17.7358 17.7358 17.7358 -35.7144 5.102001 7.151300000000001 -1058.67 -1058.67 -1058.67 -35.7144 5.102001 8.1513 24.0132 24.0132 24.0132 -36.7144 4.102001 7.151300000000001 700.357 700.357 700.357 -36.7144 4.102001 8.1513 981.005 981.005 981.005 -36.7144 5.102001 7.151300000000001 -87.1452 -87.1452 -87.1452 -36.7144 5.102001 8.1513 891.039 891.039 891.039 -35.7144 6.102001 5.151300000000001 -1034.74 -1034.74 -1034.74 -35.7144 6.102001 6.151300000000001 -1892.41 -1892.41 -1892.41 -35.7144 7.102001 5.151300000000001 193.153 193.153 193.153 -35.7144 7.102001 6.151300000000001 1035.74 1035.74 1035.74 -36.7144 6.102001 5.151300000000001 -1733.34 -1733.34 -1733.34 -36.7144 6.102001 6.151300000000001 -577.413 -577.413 -577.413 -36.7144 7.102001 5.151300000000001 4602.79 4602.79 4602.79 -36.7144 7.102001 6.151300000000001 -3425.97 -3425.97 -3425.97 -35.7144 6.102001 7.151300000000001 -23.8946 -23.8946 -23.8946 -35.7144 6.102001 8.1513 664.667 664.667 664.667 -35.7144 7.102001 7.151300000000001 -2158.64 -2158.64 -2158.64 -35.7144 7.102001 8.1513 -5210.16 -5210.16 -5210.16 -36.7144 6.102001 7.151300000000001 1666.55 1666.55 1666.55 -36.7144 6.102001 8.1513 1608.01 1608.01 1608.01 -36.7144 7.102001 7.151300000000001 758.919 758.919 758.919 -36.7144 7.102001 8.1513 5790.22 5790.22 5790.22 -33.7144 4.102001 9.1513 -1922.86 -1922.86 -1922.86 -33.7144 4.102001 10.1513 -761.394 -761.394 -761.394 -33.7144 5.102001 9.1513 -559.087 -559.087 -559.087 -33.7144 5.102001 10.1513 1003.0 1003.0 1003.0 -34.7144 4.102001 9.1513 -397.549 -397.549 -397.549 -34.7144 4.102001 10.1513 1892.14 1892.14 1892.14 -34.7144 5.102001 10.1513 1.3004 1.3004 1.3004 -33.7144 4.102001 11.1513 -1498.02 -1498.02 -1498.02 -33.7144 4.102001 12.1513 888.888 888.888 888.888 -33.7144 5.102001 11.1513 801.317 801.317 801.317 -33.7144 5.102001 12.1513 1575.66 1575.66 1575.66 -34.7144 4.102001 11.1513 3001.74 3001.74 3001.74 -34.7144 4.102001 12.1513 -413.21 -413.21 -413.21 -34.7144 5.102001 11.1513 3383.64 3383.64 3383.64 -34.7144 5.102001 12.1513 1603.87 1603.87 1603.87 -33.7144 6.102001 9.1513 -1814.99 -1814.99 -1814.99 -33.7144 6.102001 10.1513 1839.68 1839.68 1839.68 -33.7144 7.102001 9.1513 -945.033 -945.033 -945.033 -33.7144 7.102001 10.1513 -9760.09 -9760.09 -9760.09 -34.7144 6.102001 9.1513 661.662 661.662 661.662 -34.7144 6.102001 10.1513 2142.25 2142.25 2142.25 -34.7144 7.102001 9.1513 750.215 750.215 750.215 -34.7144 7.102001 10.1513 148.997 148.997 148.997 -34.7144 6.102001 11.1513 2884.91 2884.91 2884.91 -34.7144 6.102001 12.1513 919.405 919.405 919.405 -35.7144 4.102001 9.1513 -150.287 -150.287 -150.287 -35.7144 4.102001 10.1513 -322.698 -322.698 -322.698 -35.7144 5.102001 9.1513 -855.907 -855.907 -855.907 -35.7144 5.102001 10.1513 692.995 692.995 692.995 -36.7144 4.102001 9.1513 258.542 258.542 258.542 -36.7144 4.102001 10.1513 -877.817 -877.817 -877.817 -36.7144 5.102001 9.1513 363.129 363.129 363.129 -36.7144 5.102001 10.1513 -1119.32 -1119.32 -1119.32 -35.7144 4.102001 11.1513 -457.334 -457.334 -457.334 -35.7144 4.102001 12.1513 447.671 447.671 447.671 -35.7144 5.102001 11.1513 -368.221 -368.221 -368.221 -36.7144 4.102001 11.1513 132.557 132.557 132.557 -36.7144 4.102001 12.1513 678.996 678.996 678.996 -36.7144 5.102001 11.1513 1410.76 1410.76 1410.76 -36.7144 5.102001 12.1513 335.926 335.926 335.926 -35.7144 6.102001 9.1513 -551.461 -551.461 -551.461 -35.7144 6.102001 10.1513 -513.59 -513.59 -513.59 -36.7144 6.102001 9.1513 -208.078 -208.078 -208.078 -36.7144 6.102001 10.1513 -904.275 -904.275 -904.275 -36.7144 7.102001 9.1513 -239.087 -239.087 -239.087 -35.7144 6.102001 11.1513 -1552.2 -1552.2 -1552.2 -35.7144 6.102001 12.1513 71.5656 71.5656 71.5656 -35.7144 7.102001 11.1513 63.763 63.763 63.763 -35.7144 7.102001 12.1513 288.58 288.58 288.58 -36.7144 6.102001 11.1513 229.999 229.999 229.999 -36.7144 6.102001 12.1513 -650.367 -650.367 -650.367 -36.7144 7.102001 11.1513 -723.671 -723.671 -723.671 -36.7144 7.102001 12.1513 -112.844 -112.844 -112.844 -34.7144 8.102001 0.15130000000000088 -21719.2 -21719.2 -21719.2 -35.7144 8.102001 0.15130000000000088 -108120.0 -108120.0 -108120.0 -34.7144 8.102001 1.1513000000000009 231979.0 231979.0 231979.0 -35.7144 8.102001 1.1513000000000009 110291.0 110291.0 110291.0 -29.714399999999998 8.102001 5.151300000000001 632.025 632.025 632.025 -29.714399999999998 8.102001 6.151300000000001 608.239 608.239 608.239 -29.714399999999998 9.102001 5.151300000000001 285.254 285.254 285.254 -29.714399999999998 9.102001 6.151300000000001 -118.129 -118.129 -118.129 -30.714399999999998 8.102001 5.151300000000001 882.366 882.366 882.366 -30.714399999999998 9.102001 5.151300000000001 11.6363 11.6363 11.6363 -30.714399999999998 9.102001 6.151300000000001 607.875 607.875 607.875 -29.714399999999998 8.102001 7.151300000000001 -2133.12 -2133.12 -2133.12 -29.714399999999998 8.102001 8.1513 -1122.99 -1122.99 -1122.99 -29.714399999999998 9.102001 7.151300000000001 2633.12 2633.12 2633.12 -30.714399999999998 8.102001 7.151300000000001 56.3974 56.3974 56.3974 -30.714399999999998 8.102001 8.1513 -1724.83 -1724.83 -1724.83 -30.714399999999998 9.102001 7.151300000000001 1197.38 1197.38 1197.38 -30.714399999999998 9.102001 8.1513 -1245.31 -1245.31 -1245.31 -30.714399999999998 10.102001 8.1513 3648.11 3648.11 3648.11 -30.714399999999998 11.102001 8.1513 -6812.13 -6812.13 -6812.13 -31.714399999999998 8.102001 5.151300000000001 -400.816 -400.816 -400.816 -31.714399999999998 8.102001 6.151300000000001 397.148 397.148 397.148 -31.714399999999998 9.102001 5.151300000000001 82.4102 82.4102 82.4102 -31.714399999999998 9.102001 6.151300000000001 879.202 879.202 879.202 -32.7144 8.102001 5.151300000000001 261.786 261.786 261.786 -32.7144 8.102001 6.151300000000001 641.294 641.294 641.294 -32.7144 9.102001 5.151300000000001 276.278 276.278 276.278 -32.7144 9.102001 6.151300000000001 -581.478 -581.478 -581.478 -31.714399999999998 8.102001 8.1513 -34.329 -34.329 -34.329 -31.714399999999998 9.102001 7.151300000000001 3107.38 3107.38 3107.38 -31.714399999999998 9.102001 8.1513 71.6673 71.6673 71.6673 -32.7144 9.102001 7.151300000000001 62.1785 62.1785 62.1785 -32.7144 10.102001 6.151300000000001 -433.713 -433.713 -433.713 -31.714399999999998 10.102001 7.151300000000001 -991.506 -991.506 -991.506 -31.714399999999998 10.102001 8.1513 2160.74 2160.74 2160.74 -31.714399999999998 11.102001 8.1513 1197.05 1197.05 1197.05 -32.7144 10.102001 7.151300000000001 -922.666 -922.666 -922.666 -32.7144 10.102001 8.1513 1444.84 1444.84 1444.84 -32.7144 11.102001 8.1513 -919.31 -919.31 -919.31 -29.714399999999998 8.102001 9.1513 909.048 909.048 909.048 -29.714399999999998 8.102001 10.1513 -257.642 -257.642 -257.642 -29.714399999999998 9.102001 9.1513 -2208.73 -2208.73 -2208.73 -29.714399999999998 9.102001 10.1513 -97.6867 -97.6867 -97.6867 -30.714399999999998 8.102001 9.1513 762.072 762.072 762.072 -30.714399999999998 8.102001 10.1513 -456.574 -456.574 -456.574 -30.714399999999998 9.102001 9.1513 -1328.95 -1328.95 -1328.95 -29.714399999999998 8.102001 11.1513 8.346 8.346 8.346 -29.714399999999998 9.102001 11.1513 18.0733 18.0733 18.0733 -30.714399999999998 8.102001 11.1513 645.754 645.754 645.754 -30.714399999999998 8.102001 12.1513 -0.894283 -0.894283 -0.894283 -30.714399999999998 9.102001 11.1513 -144.756 -144.756 -144.756 -30.714399999999998 9.102001 12.1513 -22.4515 -22.4515 -22.4515 -29.714399999999998 10.102001 10.1513 -112.813 -112.813 -112.813 -30.714399999999998 10.102001 9.1513 1599.57 1599.57 1599.57 -30.714399999999998 10.102001 10.1513 152.92 152.92 152.92 -30.714399999999998 11.102001 9.1513 2155.85 2155.85 2155.85 -30.714399999999998 11.102001 10.1513 -40.8174 -40.8174 -40.8174 -29.714399999999998 10.102001 11.1513 62.949 62.949 62.949 -30.714399999999998 10.102001 11.1513 19.9615 19.9615 19.9615 -30.714399999999998 11.102001 11.1513 -166.507 -166.507 -166.507 -31.714399999999998 8.102001 9.1513 -1379.51 -1379.51 -1379.51 -31.714399999999998 8.102001 10.1513 -5485.69 -5485.69 -5485.69 -32.7144 8.102001 10.1513 4449.36 4449.36 4449.36 -31.714399999999998 8.102001 11.1513 -2903.96 -2903.96 -2903.96 -31.714399999999998 8.102001 12.1513 485.119 485.119 485.119 -31.714399999999998 9.102001 11.1513 -10879.0 -10879.0 -10879.0 -31.714399999999998 9.102001 12.1513 -9399.36 -9399.36 -9399.36 -32.7144 8.102001 11.1513 14976.3 14976.3 14976.3 -32.7144 9.102001 11.1513 9911.84 9911.84 9911.84 -32.7144 9.102001 12.1513 -2559.68 -2559.68 -2559.68 -32.7144 11.102001 10.1513 1788.78 1788.78 1788.78 -31.714399999999998 10.102001 11.1513 125.08 125.08 125.08 -31.714399999999998 11.102001 11.1513 -1083.38 -1083.38 -1083.38 -32.7144 10.102001 11.1513 705.972 705.972 705.972 -32.7144 10.102001 12.1513 -404.251 -404.251 -404.251 -32.7144 11.102001 11.1513 112.316 112.316 112.316 -31.714399999999998 12.102001 8.1513 658.143 658.143 658.143 -32.7144 12.102001 8.1513 -119.235 -119.235 -119.235 -30.714399999999998 12.102001 9.1513 -3313.53 -3313.53 -3313.53 -30.714399999999998 12.102001 10.1513 5211.37 5211.37 5211.37 -30.714399999999998 12.102001 11.1513 -442.496 -442.496 -442.496 -31.714399999999998 12.102001 9.1513 -1590.14 -1590.14 -1590.14 -31.714399999999998 12.102001 10.1513 -31.4723 -31.4723 -31.4723 -32.7144 12.102001 9.1513 -1858.89 -1858.89 -1858.89 -32.7144 12.102001 10.1513 -309.275 -309.275 -309.275 -31.714399999999998 12.102001 11.1513 2338.1 2338.1 2338.1 -32.7144 12.102001 11.1513 3055.1 3055.1 3055.1 -33.7144 8.102001 5.151300000000001 969.473 969.473 969.473 -33.7144 9.102001 5.151300000000001 445.533 445.533 445.533 -33.7144 9.102001 6.151300000000001 102.037 102.037 102.037 -34.7144 8.102001 5.151300000000001 -3833.62 -3833.62 -3833.62 -34.7144 9.102001 5.151300000000001 -1034.57 -1034.57 -1034.57 -34.7144 9.102001 6.151300000000001 4620.08 4620.08 4620.08 -33.7144 9.102001 7.151300000000001 1791.1 1791.1 1791.1 -33.7144 9.102001 8.1513 2519.38 2519.38 2519.38 -34.7144 8.102001 8.1513 3032.28 3032.28 3032.28 -34.7144 9.102001 7.151300000000001 2471.99 2471.99 2471.99 -34.7144 9.102001 8.1513 3501.56 3501.56 3501.56 -33.7144 10.102001 6.151300000000001 -1415.91 -1415.91 -1415.91 -34.7144 10.102001 6.151300000000001 -1152.99 -1152.99 -1152.99 -33.7144 10.102001 7.151300000000001 101.581 101.581 101.581 -33.7144 10.102001 8.1513 -46.2239 -46.2239 -46.2239 -33.7144 11.102001 8.1513 -7421.25 -7421.25 -7421.25 -34.7144 10.102001 7.151300000000001 -1505.96 -1505.96 -1505.96 -34.7144 10.102001 8.1513 -3548.83 -3548.83 -3548.83 -35.7144 8.102001 5.151300000000001 28.2913 28.2913 28.2913 -35.7144 8.102001 6.151300000000001 -2608.47 -2608.47 -2608.47 -35.7144 9.102001 6.151300000000001 -372.12 -372.12 -372.12 -36.7144 8.102001 5.151300000000001 1209.58 1209.58 1209.58 -36.7144 8.102001 6.151300000000001 3890.96 3890.96 3890.96 -35.7144 8.102001 7.151300000000001 -8856.17 -8856.17 -8856.17 -35.7144 8.102001 8.1513 -146.486 -146.486 -146.486 -35.7144 9.102001 7.151300000000001 -5524.19 -5524.19 -5524.19 -33.7144 8.102001 10.1513 6935.42 6935.42 6935.42 -33.7144 9.102001 10.1513 6700.26 6700.26 6700.26 -34.7144 8.102001 9.1513 -2901.01 -2901.01 -2901.01 -34.7144 8.102001 10.1513 162.012 162.012 162.012 -34.7144 9.102001 9.1513 -3380.2 -3380.2 -3380.2 -34.7144 9.102001 10.1513 1489.94 1489.94 1489.94 -33.7144 8.102001 11.1513 11290.2 11290.2 11290.2 -33.7144 8.102001 12.1513 284.062 284.062 284.062 -33.7144 9.102001 11.1513 8425.61 8425.61 8425.61 -33.7144 9.102001 12.1513 -4983.1 -4983.1 -4983.1 -34.7144 8.102001 11.1513 1686.17 1686.17 1686.17 -34.7144 8.102001 12.1513 169.617 169.617 169.617 -34.7144 9.102001 11.1513 1280.31 1280.31 1280.31 -34.7144 9.102001 12.1513 694.015 694.015 694.015 -33.7144 10.102001 9.1513 -1494.85 -1494.85 -1494.85 -33.7144 10.102001 10.1513 -1708.53 -1708.53 -1708.53 -33.7144 11.102001 9.1513 771.682 771.682 771.682 -33.7144 11.102001 10.1513 2603.4 2603.4 2603.4 -34.7144 10.102001 9.1513 -1938.39 -1938.39 -1938.39 -34.7144 10.102001 10.1513 -264.751 -264.751 -264.751 -34.7144 11.102001 9.1513 381.864 381.864 381.864 -34.7144 11.102001 10.1513 370.47 370.47 370.47 -33.7144 10.102001 11.1513 -2258.92 -2258.92 -2258.92 -33.7144 10.102001 12.1513 -842.525 -842.525 -842.525 -33.7144 11.102001 11.1513 701.537 701.537 701.537 -34.7144 10.102001 11.1513 -1929.2 -1929.2 -1929.2 -34.7144 10.102001 12.1513 374.493 374.493 374.493 -34.7144 11.102001 11.1513 681.093 681.093 681.093 -34.7144 11.102001 12.1513 -75.8289 -75.8289 -75.8289 -35.7144 8.102001 10.1513 -233.619 -233.619 -233.619 -35.7144 9.102001 10.1513 -942.67 -942.67 -942.67 -36.7144 8.102001 10.1513 240.921 240.921 240.921 -36.7144 9.102001 10.1513 -1857.15 -1857.15 -1857.15 -35.7144 8.102001 11.1513 554.11 554.11 554.11 -35.7144 8.102001 12.1513 -415.996 -415.996 -415.996 -36.7144 8.102001 11.1513 2267.48 2267.48 2267.48 -35.7144 10.102001 10.1513 -320.065 -320.065 -320.065 -35.7144 11.102001 10.1513 22.9936 22.9936 22.9936 -36.7144 10.102001 10.1513 -675.08 -675.08 -675.08 -36.7144 11.102001 10.1513 -750.566 -750.566 -750.566 -35.7144 11.102001 11.1513 -249.724 -249.724 -249.724 -35.7144 11.102001 12.1513 280.347 280.347 280.347 -36.7144 11.102001 11.1513 823.461 823.461 823.461 -33.7144 12.102001 8.1513 3555.88 3555.88 3555.88 -33.7144 12.102001 9.1513 2152.12 2152.12 2152.12 -33.7144 12.102001 10.1513 1935.99 1935.99 1935.99 -34.7144 12.102001 11.1513 -287.663 -287.663 -287.663 -34.7144 12.102001 12.1513 -86.3462 -86.3462 -86.3462 -35.7144 12.102001 11.1513 156.824 156.824 156.824 -35.7144 12.102001 12.1513 -667.444 -667.444 -667.444 -35.7144 13.102001 12.1513 942.637 942.637 942.637 -36.7144 12.102001 11.1513 -783.411 -783.411 -783.411 -36.7144 12.102001 12.1513 -44.1675 -44.1675 -44.1675 -36.7144 13.102001 11.1513 731.39 731.39 731.39 -36.7144 13.102001 12.1513 1583.0 1583.0 1583.0 -23.714399999999998 0.10200100000000001 13.1513 164.297 164.297 164.297 -24.714399999999998 0.10200100000000001 13.1513 -63.3833 -63.3833 -63.3833 -24.714399999999998 0.10200100000000001 14.1513 -230.351 -230.351 -230.351 -24.714399999999998 1.102001 13.1513 -806.543 -806.543 -806.543 -24.714399999999998 1.102001 14.1513 123.541 123.541 123.541 -24.714399999999998 0.10200100000000001 15.1513 -109.879 -109.879 -109.879 -24.714399999999998 1.102001 15.1513 356.042 356.042 356.042 -23.714399999999998 2.102001 13.1513 1209.57 1209.57 1209.57 -23.714399999999998 3.102001 13.1513 -1660.5 -1660.5 -1660.5 -23.714399999999998 3.102001 14.1513 -487.259 -487.259 -487.259 -24.714399999999998 2.102001 13.1513 2074.9 2074.9 2074.9 -24.714399999999998 2.102001 14.1513 -1409.94 -1409.94 -1409.94 -24.714399999999998 3.102001 13.1513 -2297.96 -2297.96 -2297.96 -24.714399999999998 3.102001 14.1513 -294.575 -294.575 -294.575 -23.714399999999998 4.102001 13.1513 1228.63 1228.63 1228.63 -23.714399999999998 4.102001 14.1513 -194.754 -194.754 -194.754 -23.714399999999998 5.102001 13.1513 -639.174 -639.174 -639.174 -24.714399999999998 4.102001 13.1513 -3713.64 -3713.64 -3713.64 -24.714399999999998 4.102001 14.1513 120.725 120.725 120.725 -24.714399999999998 5.102001 13.1513 1548.39 1548.39 1548.39 -24.714399999999998 6.102001 13.1513 1963.01 1963.01 1963.01 -24.714399999999998 7.102001 13.1513 -4256.34 -4256.34 -4256.34 -25.714399999999998 1.102001 13.1513 -302.763 -302.763 -302.763 -25.714399999999998 1.102001 14.1513 4.61314 4.61314 4.61314 -26.714399999999998 1.102001 13.1513 -2355.18 -2355.18 -2355.18 -26.714399999999998 1.102001 14.1513 342.785 342.785 342.785 -25.714399999999998 0.10200100000000001 15.1513 -154.911 -154.911 -154.911 -25.714399999999998 1.102001 15.1513 -44.4688 -44.4688 -44.4688 -26.714399999999998 0.10200100000000001 15.1513 552.478 552.478 552.478 -26.714399999999998 0.10200100000000001 16.1513 -79.6347 -79.6347 -79.6347 -26.714399999999998 1.102001 15.1513 166.841 166.841 166.841 -26.714399999999998 1.102001 16.1513 369.984 369.984 369.984 -25.714399999999998 2.102001 13.1513 1379.7 1379.7 1379.7 -25.714399999999998 2.102001 14.1513 1147.72 1147.72 1147.72 -25.714399999999998 3.102001 13.1513 -2398.27 -2398.27 -2398.27 -25.714399999999998 3.102001 14.1513 3482.22 3482.22 3482.22 -26.714399999999998 2.102001 13.1513 -397.995 -397.995 -397.995 -26.714399999999998 2.102001 14.1513 643.834 643.834 643.834 -26.714399999999998 3.102001 13.1513 162.094 162.094 162.094 -25.714399999999998 2.102001 15.1513 -424.734 -424.734 -424.734 -26.714399999999998 2.102001 15.1513 -275.101 -275.101 -275.101 -26.714399999999998 2.102001 16.1513 681.594 681.594 681.594 -27.714399999999998 1.102001 13.1513 2905.76 2905.76 2905.76 -27.714399999999998 1.102001 14.1513 -595.327 -595.327 -595.327 -28.714399999999998 0.10200100000000001 13.1513 458.666 458.666 458.666 -28.714399999999998 0.10200100000000001 14.1513 496.998 496.998 496.998 -28.714399999999998 1.102001 13.1513 810.172 810.172 810.172 -28.714399999999998 1.102001 14.1513 -607.616 -607.616 -607.616 -27.714399999999998 0.10200100000000001 16.1513 407.535 407.535 407.535 -27.714399999999998 1.102001 16.1513 -454.389 -454.389 -454.389 -28.714399999999998 0.10200100000000001 15.1513 535.407 535.407 535.407 -28.714399999999998 0.10200100000000001 16.1513 -243.683 -243.683 -243.683 -28.714399999999998 1.102001 15.1513 3133.31 3133.31 3133.31 -28.714399999999998 1.102001 16.1513 -58.9263 -58.9263 -58.9263 -27.714399999999998 2.102001 14.1513 96.5918 96.5918 96.5918 -27.714399999999998 3.102001 13.1513 2064.9 2064.9 2064.9 -28.714399999999998 2.102001 14.1513 -3945.43 -3945.43 -3945.43 -27.714399999999998 2.102001 15.1513 -581.853 -581.853 -581.853 -27.714399999999998 2.102001 16.1513 214.31 214.31 214.31 -28.714399999999998 2.102001 15.1513 -1029.01 -1029.01 -1029.01 -28.714399999999998 2.102001 16.1513 -310.255 -310.255 -310.255 -25.714399999999998 4.102001 13.1513 -561.87 -561.87 -561.87 -25.714399999999998 4.102001 14.1513 -439.676 -439.676 -439.676 -25.714399999999998 5.102001 13.1513 -654.888 -654.888 -654.888 -26.714399999999998 4.102001 13.1513 849.918 849.918 849.918 -26.714399999999998 5.102001 13.1513 822.258 822.258 822.258 -25.714399999999998 6.102001 13.1513 291.772 291.772 291.772 -25.714399999999998 7.102001 13.1513 -288.852 -288.852 -288.852 -26.714399999999998 6.102001 13.1513 -402.002 -402.002 -402.002 -26.714399999999998 7.102001 13.1513 900.955 900.955 900.955 -27.714399999999998 4.102001 13.1513 255.222 255.222 255.222 -27.714399999999998 5.102001 13.1513 -117.947 -117.947 -117.947 -28.714399999999998 5.102001 13.1513 464.81 464.81 464.81 -27.714399999999998 6.102001 13.1513 -427.253 -427.253 -427.253 -27.714399999999998 7.102001 13.1513 1109.25 1109.25 1109.25 -28.714399999999998 6.102001 13.1513 856.687 856.687 856.687 -28.714399999999998 7.102001 13.1513 -2223.66 -2223.66 -2223.66 -27.714399999999998 8.102001 13.1513 -541.887 -541.887 -541.887 -28.714399999999998 8.102001 13.1513 -369.485 -369.485 -369.485 -29.714399999999998 0.10200100000000001 13.1513 -3.60947 -3.60947 -3.60947 -29.714399999999998 0.10200100000000001 14.1513 483.321 483.321 483.321 -29.714399999999998 1.102001 13.1513 -176.508 -176.508 -176.508 -29.714399999999998 1.102001 14.1513 -2109.49 -2109.49 -2109.49 -30.714399999999998 1.102001 13.1513 -1425.19 -1425.19 -1425.19 -30.714399999999998 1.102001 14.1513 1666.85 1666.85 1666.85 -29.714399999999998 0.10200100000000001 15.1513 893.011 893.011 893.011 -29.714399999999998 1.102001 15.1513 -1411.77 -1411.77 -1411.77 -29.714399999999998 2.102001 13.1513 -811.094 -811.094 -811.094 -29.714399999999998 2.102001 14.1513 -2680.2 -2680.2 -2680.2 -29.714399999999998 3.102001 13.1513 -2503.7 -2503.7 -2503.7 -29.714399999999998 3.102001 14.1513 24.4805 24.4805 24.4805 -30.714399999999998 2.102001 14.1513 204.95 204.95 204.95 -30.714399999999998 3.102001 13.1513 1581.0 1581.0 1581.0 -30.714399999999998 3.102001 14.1513 3311.92 3311.92 3311.92 -31.714399999999998 1.102001 13.1513 -3304.54 -3304.54 -3304.54 -31.714399999999998 1.102001 14.1513 -15339.2 -15339.2 -15339.2 -32.7144 0.10200100000000001 13.1513 21602.9 21602.9 21602.9 -32.7144 1.102001 13.1513 188.473 188.473 188.473 -31.714399999999998 0.10200100000000001 16.1513 4410.4 4410.4 4410.4 -32.7144 0.10200100000000001 16.1513 4650.35 4650.35 4650.35 -31.714399999999998 2.102001 13.1513 1033.44 1033.44 1033.44 -31.714399999999998 2.102001 14.1513 1236.89 1236.89 1236.89 -31.714399999999998 3.102001 13.1513 2604.97 2604.97 2604.97 -31.714399999999998 3.102001 14.1513 2764.94 2764.94 2764.94 -32.7144 2.102001 13.1513 -256.34 -256.34 -256.34 -32.7144 2.102001 14.1513 675.026 675.026 675.026 -32.7144 3.102001 13.1513 -1648.46 -1648.46 -1648.46 -32.7144 3.102001 14.1513 2601.25 2601.25 2601.25 -32.7144 2.102001 15.1513 -8874.92 -8874.92 -8874.92 -32.7144 2.102001 16.1513 -7717.44 -7717.44 -7717.44 -32.7144 3.102001 15.1513 -587.515 -587.515 -587.515 -32.7144 3.102001 16.1513 -1934.14 -1934.14 -1934.14 -30.714399999999998 0.10200100000000001 18.1513 -797.963 -797.963 -797.963 -31.714399999999998 0.10200100000000001 17.1513 9083.05 9083.05 9083.05 -31.714399999999998 0.10200100000000001 18.1513 -2862.24 -2862.24 -2862.24 -31.714399999999998 1.102001 17.1513 2508.02 2508.02 2508.02 -31.714399999999998 1.102001 18.1513 -1874.7 -1874.7 -1874.7 -32.7144 0.10200100000000001 17.1513 -1695.56 -1695.56 -1695.56 -32.7144 1.102001 17.1513 2067.01 2067.01 2067.01 -32.7144 1.102001 18.1513 715.756 715.756 715.756 -31.714399999999998 0.10200100000000001 19.1513 -1415.37 -1415.37 -1415.37 -31.714399999999998 1.102001 19.1513 31.9516 31.9516 31.9516 -32.7144 0.10200100000000001 19.1513 5861.42 5861.42 5861.42 -32.7144 0.10200100000000001 20.1513 -165.986 -165.986 -165.986 -32.7144 1.102001 19.1513 1015.38 1015.38 1015.38 -31.714399999999998 3.102001 17.1513 1456.69 1456.69 1456.69 -31.714399999999998 3.102001 18.1513 -4501.44 -4501.44 -4501.44 -32.7144 2.102001 18.1513 -12446.5 -12446.5 -12446.5 -32.7144 3.102001 17.1513 3103.21 3103.21 3103.21 -32.7144 3.102001 18.1513 -6860.83 -6860.83 -6860.83 -31.714399999999998 3.102001 19.1513 -3189.27 -3189.27 -3189.27 -32.7144 2.102001 19.1513 7546.34 7546.34 7546.34 -32.7144 3.102001 19.1513 -9439.8 -9439.8 -9439.8 -29.714399999999998 4.102001 13.1513 466.375 466.375 466.375 -29.714399999999998 4.102001 14.1513 62.6029 62.6029 62.6029 -29.714399999999998 5.102001 13.1513 1002.12 1002.12 1002.12 -29.714399999999998 5.102001 14.1513 -1116.69 -1116.69 -1116.69 -30.714399999999998 4.102001 13.1513 -714.148 -714.148 -714.148 -30.714399999999998 4.102001 14.1513 1026.93 1026.93 1026.93 -30.714399999999998 5.102001 13.1513 -509.995 -509.995 -509.995 -30.714399999999998 5.102001 14.1513 -827.129 -827.129 -827.129 -29.714399999999998 4.102001 15.1513 -31.8749 -31.8749 -31.8749 -29.714399999999998 4.102001 16.1513 318.438 318.438 318.438 -29.714399999999998 5.102001 15.1513 -1495.76 -1495.76 -1495.76 -29.714399999999998 5.102001 16.1513 -457.88 -457.88 -457.88 -30.714399999999998 4.102001 15.1513 475.715 475.715 475.715 -30.714399999999998 4.102001 16.1513 43.8786 43.8786 43.8786 -29.714399999999998 6.102001 13.1513 1103.73 1103.73 1103.73 -29.714399999999998 6.102001 14.1513 -102.808 -102.808 -102.808 -29.714399999999998 7.102001 13.1513 -631.602 -631.602 -631.602 -30.714399999999998 6.102001 13.1513 -519.949 -519.949 -519.949 -30.714399999999998 6.102001 14.1513 -1955.78 -1955.78 -1955.78 -29.714399999999998 6.102001 15.1513 324.489 324.489 324.489 -29.714399999999998 6.102001 16.1513 605.266 605.266 605.266 -29.714399999999998 7.102001 15.1513 90.3691 90.3691 90.3691 -29.714399999999998 7.102001 16.1513 53.884 53.884 53.884 -30.714399999999998 6.102001 15.1513 -1803.1 -1803.1 -1803.1 -30.714399999999998 6.102001 16.1513 1654.14 1654.14 1654.14 -30.714399999999998 7.102001 15.1513 -868.459 -868.459 -868.459 -30.714399999999998 7.102001 16.1513 -53.6828 -53.6828 -53.6828 -31.714399999999998 4.102001 14.1513 -1159.89 -1159.89 -1159.89 -31.714399999999998 5.102001 14.1513 1322.23 1322.23 1322.23 -32.7144 4.102001 13.1513 14.9453 14.9453 14.9453 -32.7144 4.102001 14.1513 -1200.72 -1200.72 -1200.72 -32.7144 5.102001 13.1513 -23.6292 -23.6292 -23.6292 -32.7144 5.102001 14.1513 944.449 944.449 944.449 -31.714399999999998 4.102001 15.1513 942.306 942.306 942.306 -31.714399999999998 4.102001 16.1513 283.87 283.87 283.87 -31.714399999999998 5.102001 15.1513 1679.23 1679.23 1679.23 -31.714399999999998 5.102001 16.1513 4064.64 4064.64 4064.64 -32.7144 4.102001 15.1513 78.4586 78.4586 78.4586 -32.7144 4.102001 16.1513 169.943 169.943 169.943 -32.7144 5.102001 15.1513 494.32 494.32 494.32 -32.7144 5.102001 16.1513 -1120.74 -1120.74 -1120.74 -31.714399999999998 6.102001 13.1513 96.7661 96.7661 96.7661 -31.714399999999998 6.102001 14.1513 611.165 611.165 611.165 -32.7144 6.102001 13.1513 586.205 586.205 586.205 -32.7144 6.102001 14.1513 99.2772 99.2772 99.2772 -32.7144 7.102001 13.1513 203.622 203.622 203.622 -32.7144 7.102001 14.1513 -90.4829 -90.4829 -90.4829 -31.714399999999998 6.102001 15.1513 1966.91 1966.91 1966.91 -31.714399999999998 6.102001 16.1513 6919.62 6919.62 6919.62 -31.714399999999998 7.102001 15.1513 932.849 932.849 932.849 -31.714399999999998 7.102001 16.1513 3971.56 3971.56 3971.56 -32.7144 6.102001 15.1513 -1752.29 -1752.29 -1752.29 -32.7144 6.102001 16.1513 -1095.11 -1095.11 -1095.11 -32.7144 7.102001 15.1513 -2188.15 -2188.15 -2188.15 -32.7144 7.102001 16.1513 2188.25 2188.25 2188.25 -29.714399999999998 4.102001 17.1513 -87.5187 -87.5187 -87.5187 -29.714399999999998 5.102001 17.1513 -569.721 -569.721 -569.721 -30.714399999999998 4.102001 17.1513 526.513 526.513 526.513 -30.714399999999998 5.102001 17.1513 -1416.44 -1416.44 -1416.44 -29.714399999999998 6.102001 17.1513 -51.9658 -51.9658 -51.9658 -30.714399999999998 6.102001 17.1513 1896.26 1896.26 1896.26 -31.714399999999998 4.102001 17.1513 4289.38 4289.38 4289.38 -31.714399999999998 4.102001 18.1513 -7741.57 -7741.57 -7741.57 -31.714399999999998 5.102001 17.1513 4828.75 4828.75 4828.75 -31.714399999999998 5.102001 18.1513 -1248.52 -1248.52 -1248.52 -32.7144 4.102001 17.1513 12012.4 12012.4 12012.4 -32.7144 5.102001 17.1513 -4314.12 -4314.12 -4314.12 -32.7144 5.102001 18.1513 -1184.15 -1184.15 -1184.15 -31.714399999999998 4.102001 19.1513 2547.17 2547.17 2547.17 -31.714399999999998 5.102001 19.1513 -2710.54 -2710.54 -2710.54 -31.714399999999998 5.102001 20.1513 -1269.51 -1269.51 -1269.51 -32.7144 4.102001 19.1513 2846.21 2846.21 2846.21 -32.7144 4.102001 20.1513 -1098.94 -1098.94 -1098.94 -32.7144 5.102001 19.1513 1176.27 1176.27 1176.27 -32.7144 5.102001 20.1513 -244.303 -244.303 -244.303 -31.714399999999998 6.102001 17.1513 -2065.01 -2065.01 -2065.01 -31.714399999999998 6.102001 18.1513 769.706 769.706 769.706 -31.714399999999998 7.102001 17.1513 -237.87 -237.87 -237.87 -31.714399999999998 7.102001 18.1513 1475.43 1475.43 1475.43 -32.7144 6.102001 17.1513 -2518.76 -2518.76 -2518.76 -32.7144 6.102001 18.1513 -1184.57 -1184.57 -1184.57 -32.7144 7.102001 17.1513 -1258.15 -1258.15 -1258.15 -31.714399999999998 6.102001 19.1513 625.479 625.479 625.479 -31.714399999999998 6.102001 20.1513 54.1982 54.1982 54.1982 -31.714399999999998 7.102001 19.1513 -251.442 -251.442 -251.442 -31.714399999999998 7.102001 20.1513 -195.743 -195.743 -195.743 -32.7144 6.102001 19.1513 823.725 823.725 823.725 -33.7144 0.10200100000000001 13.1513 4017.0 4017.0 4017.0 -33.7144 0.10200100000000001 14.1513 -14147.1 -14147.1 -14147.1 -33.7144 1.102001 13.1513 5583.71 5583.71 5583.71 -33.7144 1.102001 14.1513 -12398.9 -12398.9 -12398.9 -34.7144 0.10200100000000001 13.1513 4901.95 4901.95 4901.95 -34.7144 0.10200100000000001 14.1513 -759.951 -759.951 -759.951 -34.7144 1.102001 13.1513 -4746.95 -4746.95 -4746.95 -34.7144 1.102001 14.1513 -2763.68 -2763.68 -2763.68 -33.7144 0.10200100000000001 15.1513 -5233.73 -5233.73 -5233.73 -33.7144 0.10200100000000001 16.1513 1458.23 1458.23 1458.23 -33.7144 1.102001 15.1513 -5985.3 -5985.3 -5985.3 -33.7144 1.102001 16.1513 1547.59 1547.59 1547.59 -34.7144 0.10200100000000001 15.1513 19752.1 19752.1 19752.1 -34.7144 0.10200100000000001 16.1513 -761.832 -761.832 -761.832 -34.7144 1.102001 15.1513 9481.44 9481.44 9481.44 -34.7144 1.102001 16.1513 -3780.56 -3780.56 -3780.56 -33.7144 2.102001 13.1513 -243.492 -243.492 -243.492 -33.7144 2.102001 14.1513 -4864.29 -4864.29 -4864.29 -33.7144 3.102001 13.1513 -61.2457 -61.2457 -61.2457 -33.7144 3.102001 14.1513 907.298 907.298 907.298 -34.7144 2.102001 13.1513 -1134.79 -1134.79 -1134.79 -34.7144 2.102001 14.1513 -2530.78 -2530.78 -2530.78 -34.7144 3.102001 13.1513 -827.975 -827.975 -827.975 -33.7144 2.102001 15.1513 4003.77 4003.77 4003.77 -33.7144 2.102001 16.1513 217.74 217.74 217.74 -33.7144 3.102001 16.1513 -787.637 -787.637 -787.637 -35.7144 0.10200100000000001 14.1513 2402.37 2402.37 2402.37 -35.7144 1.102001 14.1513 1415.24 1415.24 1415.24 -36.7144 1.102001 13.1513 2184.85 2184.85 2184.85 -36.7144 1.102001 14.1513 2441.03 2441.03 2441.03 -35.7144 0.10200100000000001 15.1513 -6835.76 -6835.76 -6835.76 -35.7144 0.10200100000000001 16.1513 -1178.03 -1178.03 -1178.03 -35.7144 1.102001 15.1513 2770.15 2770.15 2770.15 -35.7144 1.102001 16.1513 -3565.99 -3565.99 -3565.99 -36.7144 0.10200100000000001 15.1513 6583.4 6583.4 6583.4 -36.7144 0.10200100000000001 16.1513 -16597.2 -16597.2 -16597.2 -36.7144 1.102001 15.1513 -11565.0 -11565.0 -11565.0 -36.7144 1.102001 16.1513 -21759.4 -21759.4 -21759.4 -35.7144 2.102001 13.1513 -311.046 -311.046 -311.046 -35.7144 2.102001 14.1513 2702.6 2702.6 2702.6 -35.7144 3.102001 13.1513 -1907.57 -1907.57 -1907.57 -36.7144 2.102001 13.1513 -1097.81 -1097.81 -1097.81 -36.7144 2.102001 14.1513 -172.731 -172.731 -172.731 -36.7144 3.102001 13.1513 -353.016 -353.016 -353.016 -33.7144 0.10200100000000001 17.1513 3293.31 3293.31 3293.31 -33.7144 0.10200100000000001 18.1513 2151.82 2151.82 2151.82 -33.7144 1.102001 17.1513 2781.61 2781.61 2781.61 -33.7144 1.102001 18.1513 229.404 229.404 229.404 -34.7144 0.10200100000000001 17.1513 2721.02 2721.02 2721.02 -34.7144 0.10200100000000001 18.1513 -477.225 -477.225 -477.225 -34.7144 1.102001 17.1513 18357.4 18357.4 18357.4 -34.7144 1.102001 18.1513 -518.368 -518.368 -518.368 -33.7144 0.10200100000000001 19.1513 2841.39 2841.39 2841.39 -33.7144 0.10200100000000001 20.1513 -1846.14 -1846.14 -1846.14 -33.7144 1.102001 19.1513 166.247 166.247 166.247 -33.7144 1.102001 20.1513 -24.9374 -24.9374 -24.9374 -33.7144 2.102001 17.1513 10072.4 10072.4 10072.4 -33.7144 2.102001 18.1513 2868.37 2868.37 2868.37 -33.7144 3.102001 17.1513 9895.21 9895.21 9895.21 -33.7144 3.102001 18.1513 2158.82 2158.82 2158.82 -34.7144 3.102001 17.1513 -387.014 -387.014 -387.014 -33.7144 2.102001 19.1513 -7768.47 -7768.47 -7768.47 -33.7144 2.102001 20.1513 1353.78 1353.78 1353.78 -33.7144 3.102001 19.1513 -4108.95 -4108.95 -4108.95 -33.7144 3.102001 20.1513 142.583 142.583 142.583 -34.7144 2.102001 20.1513 -713.836 -713.836 -713.836 -34.7144 3.102001 20.1513 693.852 693.852 693.852 -35.7144 0.10200100000000001 17.1513 9681.98 9681.98 9681.98 -35.7144 0.10200100000000001 18.1513 678.547 678.547 678.547 -36.7144 0.10200100000000001 17.1513 8045.68 8045.68 8045.68 -36.7144 0.10200100000000001 18.1513 -629.028 -629.028 -629.028 -36.7144 1.102001 17.1513 12234.5 12234.5 12234.5 -36.7144 1.102001 18.1513 2479.78 2479.78 2479.78 -35.7144 0.10200100000000001 19.1513 -3628.64 -3628.64 -3628.64 -36.7144 0.10200100000000001 19.1513 26.6252 26.6252 26.6252 -36.7144 0.10200100000000001 20.1513 -846.114 -846.114 -846.114 -36.7144 1.102001 19.1513 -3623.46 -3623.46 -3623.46 -36.7144 1.102001 20.1513 1490.29 1490.29 1490.29 -35.7144 3.102001 17.1513 682.94 682.94 682.94 -36.7144 2.102001 17.1513 366.225 366.225 366.225 -36.7144 2.102001 18.1513 -1169.93 -1169.93 -1169.93 -36.7144 3.102001 17.1513 1350.54 1350.54 1350.54 -36.7144 3.102001 18.1513 -65.2796 -65.2796 -65.2796 -35.7144 3.102001 20.1513 -515.247 -515.247 -515.247 -36.7144 2.102001 19.1513 -5749.29 -5749.29 -5749.29 -36.7144 2.102001 20.1513 -1584.06 -1584.06 -1584.06 -36.7144 3.102001 19.1513 -108.867 -108.867 -108.867 -36.7144 3.102001 20.1513 -3649.43 -3649.43 -3649.43 -33.7144 4.102001 13.1513 -2025.93 -2025.93 -2025.93 -33.7144 4.102001 14.1513 2935.36 2935.36 2935.36 -33.7144 5.102001 13.1513 -1518.55 -1518.55 -1518.55 -33.7144 5.102001 14.1513 -1071.78 -1071.78 -1071.78 -34.7144 4.102001 13.1513 -1663.51 -1663.51 -1663.51 -34.7144 5.102001 13.1513 770.254 770.254 770.254 -34.7144 5.102001 14.1513 -941.852 -941.852 -941.852 -33.7144 4.102001 15.1513 1736.09 1736.09 1736.09 -33.7144 4.102001 16.1513 2266.77 2266.77 2266.77 -33.7144 5.102001 15.1513 -2625.78 -2625.78 -2625.78 -33.7144 5.102001 16.1513 614.786 614.786 614.786 -34.7144 4.102001 15.1513 3737.97 3737.97 3737.97 -34.7144 4.102001 16.1513 -6331.08 -6331.08 -6331.08 -34.7144 5.102001 15.1513 3093.16 3093.16 3093.16 -34.7144 5.102001 16.1513 1066.89 1066.89 1066.89 -33.7144 6.102001 13.1513 -2255.31 -2255.31 -2255.31 -33.7144 7.102001 13.1513 -12.6151 -12.6151 -12.6151 -34.7144 6.102001 13.1513 -2229.89 -2229.89 -2229.89 -34.7144 6.102001 14.1513 -718.911 -718.911 -718.911 -34.7144 7.102001 13.1513 377.683 377.683 377.683 -33.7144 6.102001 15.1513 -282.454 -282.454 -282.454 -33.7144 6.102001 16.1513 -191.092 -191.092 -191.092 -33.7144 7.102001 16.1513 -759.065 -759.065 -759.065 -34.7144 6.102001 15.1513 1354.99 1354.99 1354.99 -34.7144 6.102001 16.1513 788.33 788.33 788.33 -35.7144 5.102001 13.1513 -8799.55 -8799.55 -8799.55 -35.7144 5.102001 14.1513 -6313.75 -6313.75 -6313.75 -36.7144 5.102001 13.1513 -7804.44 -7804.44 -7804.44 -36.7144 5.102001 14.1513 7732.09 7732.09 7732.09 -35.7144 4.102001 15.1513 6934.03 6934.03 6934.03 -35.7144 4.102001 16.1513 -1382.32 -1382.32 -1382.32 -35.7144 5.102001 15.1513 -6687.82 -6687.82 -6687.82 -36.7144 4.102001 15.1513 3209.65 3209.65 3209.65 -36.7144 4.102001 16.1513 -2536.89 -2536.89 -2536.89 -36.7144 5.102001 15.1513 6539.2 6539.2 6539.2 -36.7144 5.102001 16.1513 2074.03 2074.03 2074.03 -35.7144 6.102001 13.1513 -5507.27 -5507.27 -5507.27 -35.7144 6.102001 14.1513 6450.66 6450.66 6450.66 -35.7144 7.102001 13.1513 -339.865 -339.865 -339.865 -35.7144 7.102001 14.1513 -275.734 -275.734 -275.734 -36.7144 6.102001 13.1513 -4022.39 -4022.39 -4022.39 -36.7144 6.102001 14.1513 -1283.57 -1283.57 -1283.57 -36.7144 7.102001 13.1513 -60.9288 -60.9288 -60.9288 -36.7144 7.102001 14.1513 -151.909 -151.909 -151.909 -35.7144 6.102001 15.1513 -4311.96 -4311.96 -4311.96 -35.7144 6.102001 16.1513 -281.929 -281.929 -281.929 -35.7144 7.102001 15.1513 -589.24 -589.24 -589.24 -35.7144 7.102001 16.1513 -550.29 -550.29 -550.29 -36.7144 6.102001 16.1513 320.692 320.692 320.692 -36.7144 7.102001 15.1513 289.732 289.732 289.732 -36.7144 7.102001 16.1513 190.069 190.069 190.069 -33.7144 4.102001 17.1513 -991.219 -991.219 -991.219 -33.7144 5.102001 17.1513 448.295 448.295 448.295 -34.7144 4.102001 17.1513 397.7 397.7 397.7 -34.7144 5.102001 17.1513 585.144 585.144 585.144 -33.7144 4.102001 20.1513 -17.7539 -17.7539 -17.7539 -33.7144 5.102001 19.1513 164.89 164.89 164.89 -33.7144 5.102001 20.1513 -456.536 -456.536 -456.536 -34.7144 4.102001 20.1513 403.66 403.66 403.66 -34.7144 5.102001 20.1513 -172.861 -172.861 -172.861 -33.7144 6.102001 17.1513 1003.5 1003.5 1003.5 -33.7144 6.102001 18.1513 -289.972 -289.972 -289.972 -33.7144 7.102001 17.1513 -91.853 -91.853 -91.853 -34.7144 6.102001 17.1513 -411.191 -411.191 -411.191 -34.7144 7.102001 19.1513 988.525 988.525 988.525 -34.7144 7.102001 20.1513 1176.2 1176.2 1176.2 -35.7144 4.102001 17.1513 -75.3036 -75.3036 -75.3036 -35.7144 4.102001 18.1513 -771.202 -771.202 -771.202 -35.7144 5.102001 17.1513 -422.142 -422.142 -422.142 -35.7144 5.102001 18.1513 -334.723 -334.723 -334.723 -36.7144 4.102001 17.1513 251.225 251.225 251.225 -36.7144 4.102001 18.1513 35.6469 35.6469 35.6469 -36.7144 5.102001 18.1513 14.7933 14.7933 14.7933 -35.7144 4.102001 19.1513 -314.151 -314.151 -314.151 -35.7144 4.102001 20.1513 -720.658 -720.658 -720.658 -35.7144 5.102001 19.1513 190.186 190.186 190.186 -35.7144 5.102001 20.1513 -180.06 -180.06 -180.06 -36.7144 4.102001 19.1513 247.701 247.701 247.701 -36.7144 4.102001 20.1513 -232.297 -232.297 -232.297 -36.7144 5.102001 19.1513 -683.065 -683.065 -683.065 -36.7144 5.102001 20.1513 863.498 863.498 863.498 -35.7144 6.102001 17.1513 249.022 249.022 249.022 -35.7144 6.102001 18.1513 369.366 369.366 369.366 -35.7144 7.102001 18.1513 188.191 188.191 188.191 -36.7144 6.102001 17.1513 138.661 138.661 138.661 -36.7144 6.102001 18.1513 -84.1629 -84.1629 -84.1629 -36.7144 7.102001 18.1513 456.791 456.791 456.791 -35.7144 6.102001 20.1513 -137.89 -137.89 -137.89 -35.7144 7.102001 19.1513 -786.618 -786.618 -786.618 -35.7144 7.102001 20.1513 -77.0916 -77.0916 -77.0916 -36.7144 6.102001 19.1513 -584.944 -584.944 -584.944 -36.7144 6.102001 20.1513 301.152 301.152 301.152 -36.7144 7.102001 19.1513 2092.24 2092.24 2092.24 -36.7144 7.102001 20.1513 246.223 246.223 246.223 -31.714399999999998 5.102001 21.1513 -500.607 -500.607 -500.607 -32.7144 5.102001 21.1513 135.129 135.129 135.129 -31.714399999999998 6.102001 21.1513 88.6383 88.6383 88.6383 -31.714399999999998 6.102001 22.1513 176.678 176.678 176.678 -31.714399999999998 7.102001 21.1513 -778.831 -778.831 -778.831 -31.714399999999998 7.102001 22.1513 150.05 150.05 150.05 -32.7144 6.102001 21.1513 -672.715 -672.715 -672.715 -32.7144 6.102001 22.1513 296.534 296.534 296.534 -32.7144 7.102001 21.1513 -469.06 -469.06 -469.06 -32.7144 7.102001 22.1513 -125.238 -125.238 -125.238 -33.7144 0.10200100000000001 21.1513 1302.16 1302.16 1302.16 -33.7144 0.10200100000000001 22.1513 -325.76 -325.76 -325.76 -33.7144 1.102001 21.1513 -689.955 -689.955 -689.955 -34.7144 0.10200100000000001 21.1513 -117.307 -117.307 -117.307 -34.7144 0.10200100000000001 22.1513 -1230.42 -1230.42 -1230.42 -34.7144 1.102001 21.1513 584.85 584.85 584.85 -34.7144 1.102001 22.1513 -1022.59 -1022.59 -1022.59 -33.7144 2.102001 21.1513 -434.537 -434.537 -434.537 -34.7144 2.102001 21.1513 -425.252 -425.252 -425.252 -34.7144 2.102001 22.1513 823.598 823.598 823.598 -34.7144 3.102001 21.1513 671.69 671.69 671.69 -34.7144 3.102001 22.1513 345.024 345.024 345.024 -35.7144 0.10200100000000001 21.1513 186.071 186.071 186.071 -35.7144 0.10200100000000001 22.1513 1663.18 1663.18 1663.18 -35.7144 1.102001 21.1513 -412.317 -412.317 -412.317 -35.7144 1.102001 22.1513 1436.4 1436.4 1436.4 -36.7144 0.10200100000000001 21.1513 4405.25 4405.25 4405.25 -36.7144 0.10200100000000001 22.1513 -532.213 -532.213 -532.213 -36.7144 1.102001 21.1513 -658.878 -658.878 -658.878 -36.7144 1.102001 22.1513 -642.751 -642.751 -642.751 -35.7144 0.10200100000000001 23.1513 -2439.64 -2439.64 -2439.64 -36.7144 0.10200100000000001 23.1513 -1738.6 -1738.6 -1738.6 -36.7144 1.102001 23.1513 -28.5989 -28.5989 -28.5989 -35.7144 2.102001 22.1513 -35.7568 -35.7568 -35.7568 -35.7144 3.102001 21.1513 -2355.66 -2355.66 -2355.66 -35.7144 3.102001 22.1513 -463.869 -463.869 -463.869 -36.7144 2.102001 21.1513 5303.66 5303.66 5303.66 -36.7144 2.102001 22.1513 264.397 264.397 264.397 -36.7144 3.102001 21.1513 -5108.76 -5108.76 -5108.76 -36.7144 3.102001 22.1513 758.319 758.319 758.319 -33.7144 4.102001 21.1513 956.552 956.552 956.552 -33.7144 5.102001 21.1513 -22.6733 -22.6733 -22.6733 -33.7144 5.102001 22.1513 348.727 348.727 348.727 -34.7144 4.102001 21.1513 -668.886 -668.886 -668.886 -34.7144 5.102001 21.1513 -311.085 -311.085 -311.085 -34.7144 5.102001 22.1513 -308.92 -308.92 -308.92 -33.7144 6.102001 21.1513 -1643.18 -1643.18 -1643.18 -33.7144 6.102001 22.1513 -184.632 -184.632 -184.632 -33.7144 7.102001 21.1513 12.9285 12.9285 12.9285 -33.7144 7.102001 22.1513 132.923 132.923 132.923 -34.7144 6.102001 22.1513 69.6387 69.6387 69.6387 -34.7144 7.102001 21.1513 551.673 551.673 551.673 -34.7144 7.102001 22.1513 682.927 682.927 682.927 -35.7144 5.102001 21.1513 -155.278 -155.278 -155.278 -35.7144 5.102001 22.1513 -54.6201 -54.6201 -54.6201 -35.7144 6.102001 21.1513 -255.59 -255.59 -255.59 -35.7144 6.102001 22.1513 -70.4388 -70.4388 -70.4388 -35.7144 7.102001 21.1513 1895.49 1895.49 1895.49 -35.7144 7.102001 22.1513 632.392 632.392 632.392 -36.7144 6.102001 21.1513 410.216 410.216 410.216 -36.7144 7.102001 21.1513 461.401 461.401 461.401 -31.714399999999998 8.102001 14.1513 -123.922 -123.922 -123.922 -31.714399999999998 9.102001 13.1513 -35.1931 -35.1931 -35.1931 -31.714399999999998 9.102001 14.1513 -1448.35 -1448.35 -1448.35 -32.7144 8.102001 13.1513 332.378 332.378 332.378 -32.7144 8.102001 14.1513 -278.093 -278.093 -278.093 -32.7144 9.102001 13.1513 -192.333 -192.333 -192.333 -31.714399999999998 9.102001 15.1513 -1683.96 -1683.96 -1683.96 -32.7144 8.102001 15.1513 1103.48 1103.48 1103.48 -32.7144 8.102001 16.1513 -262.749 -262.749 -262.749 -32.7144 9.102001 15.1513 -695.199 -695.199 -695.199 -32.7144 9.102001 16.1513 -1887.98 -1887.98 -1887.98 -31.714399999999998 10.102001 14.1513 3816.63 3816.63 3816.63 -32.7144 10.102001 13.1513 -789.786 -789.786 -789.786 -32.7144 10.102001 14.1513 2582.57 2582.57 2582.57 -32.7144 11.102001 13.1513 738.547 738.547 738.547 -32.7144 11.102001 14.1513 1670.59 1670.59 1670.59 -32.7144 10.102001 15.1513 1324.36 1324.36 1324.36 -32.7144 10.102001 16.1513 1538.75 1538.75 1538.75 -32.7144 11.102001 15.1513 -2020.65 -2020.65 -2020.65 -31.714399999999998 8.102001 17.1513 -2186.09 -2186.09 -2186.09 -31.714399999999998 8.102001 18.1513 291.512 291.512 291.512 -31.714399999999998 9.102001 18.1513 -73.8657 -73.8657 -73.8657 -32.7144 8.102001 17.1513 -2040.74 -2040.74 -2040.74 -32.7144 8.102001 18.1513 463.196 463.196 463.196 -32.7144 9.102001 17.1513 -1688.61 -1688.61 -1688.61 -32.7144 9.102001 18.1513 -621.6 -621.6 -621.6 -31.714399999999998 8.102001 19.1513 -1812.2 -1812.2 -1812.2 -31.714399999999998 8.102001 20.1513 -695.681 -695.681 -695.681 -31.714399999999998 9.102001 19.1513 -1215.86 -1215.86 -1215.86 -32.7144 8.102001 20.1513 -990.704 -990.704 -990.704 -32.7144 9.102001 19.1513 -1811.41 -1811.41 -1811.41 -32.7144 9.102001 20.1513 -727.234 -727.234 -727.234 -32.7144 10.102001 17.1513 -4181.39 -4181.39 -4181.39 -33.7144 8.102001 13.1513 -152.301 -152.301 -152.301 -34.7144 8.102001 13.1513 -61.2256 -61.2256 -61.2256 -34.7144 9.102001 13.1513 119.777 119.777 119.777 -33.7144 10.102001 13.1513 -119.372 -119.372 -119.372 -33.7144 11.102001 13.1513 -335.242 -335.242 -335.242 -33.7144 11.102001 14.1513 -438.944 -438.944 -438.944 -34.7144 10.102001 13.1513 -28.3024 -28.3024 -28.3024 -34.7144 10.102001 14.1513 1221.94 1221.94 1221.94 -34.7144 11.102001 13.1513 271.182 271.182 271.182 -34.7144 11.102001 14.1513 -1047.8 -1047.8 -1047.8 -33.7144 10.102001 15.1513 -52.5267 -52.5267 -52.5267 -33.7144 10.102001 16.1513 321.655 321.655 321.655 -33.7144 11.102001 15.1513 384.236 384.236 384.236 -33.7144 11.102001 16.1513 -2332.1 -2332.1 -2332.1 -34.7144 10.102001 15.1513 615.573 615.573 615.573 -34.7144 11.102001 15.1513 -338.879 -338.879 -338.879 -34.7144 11.102001 16.1513 813.672 813.672 813.672 -35.7144 8.102001 13.1513 104.298 104.298 104.298 -35.7144 8.102001 14.1513 273.872 273.872 273.872 -35.7144 9.102001 13.1513 1041.79 1041.79 1041.79 -35.7144 9.102001 14.1513 816.79 816.79 816.79 -36.7144 8.102001 13.1513 3905.87 3905.87 3905.87 -36.7144 8.102001 14.1513 -142.03 -142.03 -142.03 -36.7144 9.102001 13.1513 1116.93 1116.93 1116.93 -36.7144 9.102001 14.1513 -862.174 -862.174 -862.174 -35.7144 8.102001 15.1513 -278.033 -278.033 -278.033 -35.7144 8.102001 16.1513 -3908.03 -3908.03 -3908.03 -35.7144 9.102001 15.1513 698.171 698.171 698.171 -35.7144 9.102001 16.1513 2880.46 2880.46 2880.46 -36.7144 8.102001 15.1513 -553.353 -553.353 -553.353 -36.7144 8.102001 16.1513 1650.68 1650.68 1650.68 -36.7144 9.102001 15.1513 -675.849 -675.849 -675.849 -36.7144 9.102001 16.1513 2674.21 2674.21 2674.21 -35.7144 10.102001 13.1513 1671.89 1671.89 1671.89 -35.7144 10.102001 14.1513 199.046 199.046 199.046 -35.7144 11.102001 13.1513 -659.723 -659.723 -659.723 -35.7144 11.102001 14.1513 -1019.99 -1019.99 -1019.99 -36.7144 10.102001 13.1513 1446.79 1446.79 1446.79 -36.7144 10.102001 14.1513 780.779 780.779 780.779 -36.7144 11.102001 14.1513 2.03247 2.03247 2.03247 -35.7144 10.102001 15.1513 980.55 980.55 980.55 -35.7144 10.102001 16.1513 2625.09 2625.09 2625.09 -35.7144 11.102001 15.1513 648.687 648.687 648.687 -35.7144 11.102001 16.1513 1123.65 1123.65 1123.65 -36.7144 10.102001 15.1513 -22.8849 -22.8849 -22.8849 -36.7144 10.102001 16.1513 3332.26 3332.26 3332.26 -36.7144 11.102001 15.1513 485.731 485.731 485.731 -36.7144 11.102001 16.1513 -311.107 -311.107 -311.107 -33.7144 8.102001 18.1513 426.818 426.818 426.818 -33.7144 9.102001 17.1513 -1901.17 -1901.17 -1901.17 -33.7144 9.102001 18.1513 1255.58 1255.58 1255.58 -34.7144 8.102001 18.1513 -5198.29 -5198.29 -5198.29 -34.7144 9.102001 18.1513 2418.32 2418.32 2418.32 -33.7144 8.102001 19.1513 2064.41 2064.41 2064.41 -33.7144 8.102001 20.1513 -305.049 -305.049 -305.049 -33.7144 9.102001 19.1513 1146.25 1146.25 1146.25 -33.7144 9.102001 20.1513 211.393 211.393 211.393 -34.7144 8.102001 19.1513 -234.938 -234.938 -234.938 -34.7144 8.102001 20.1513 674.12 674.12 674.12 -34.7144 9.102001 19.1513 1275.27 1275.27 1275.27 -33.7144 10.102001 17.1513 1263.69 1263.69 1263.69 -33.7144 10.102001 18.1513 1237.14 1237.14 1237.14 -33.7144 11.102001 17.1513 -2643.26 -2643.26 -2643.26 -33.7144 11.102001 18.1513 -98.9371 -98.9371 -98.9371 -34.7144 10.102001 18.1513 3087.9 3087.9 3087.9 -34.7144 11.102001 17.1513 1382.7 1382.7 1382.7 -34.7144 11.102001 18.1513 1661.34 1661.34 1661.34 -35.7144 8.102001 18.1513 -5671.08 -5671.08 -5671.08 -35.7144 9.102001 17.1513 1930.71 1930.71 1930.71 -35.7144 9.102001 18.1513 -2484.06 -2484.06 -2484.06 -36.7144 8.102001 17.1513 -1028.41 -1028.41 -1028.41 -36.7144 8.102001 18.1513 -1909.51 -1909.51 -1909.51 -36.7144 9.102001 17.1513 2671.54 2671.54 2671.54 -36.7144 9.102001 18.1513 356.123 356.123 356.123 -35.7144 8.102001 19.1513 -369.323 -369.323 -369.323 -35.7144 8.102001 20.1513 -92.4248 -92.4248 -92.4248 -35.7144 10.102001 18.1513 -335.618 -335.618 -335.618 -35.7144 11.102001 17.1513 -66.4904 -66.4904 -66.4904 -35.7144 11.102001 18.1513 505.799 505.799 505.799 -36.7144 10.102001 17.1513 -1107.92 -1107.92 -1107.92 -36.7144 10.102001 18.1513 -1512.44 -1512.44 -1512.44 -36.7144 11.102001 17.1513 -263.237 -263.237 -263.237 -36.7144 11.102001 18.1513 -402.413 -402.413 -402.413 -35.7144 12.102001 13.1513 -2964.91 -2964.91 -2964.91 -35.7144 12.102001 14.1513 -2259.04 -2259.04 -2259.04 -35.7144 13.102001 13.1513 -1264.23 -1264.23 -1264.23 -36.7144 12.102001 13.1513 -1428.86 -1428.86 -1428.86 -36.7144 12.102001 14.1513 -366.459 -366.459 -366.459 -36.7144 13.102001 13.1513 455.052 455.052 455.052 -36.7144 12.102001 16.1513 272.813 272.813 272.813 -36.7144 12.102001 17.1513 -316.835 -316.835 -316.835 -31.714399999999998 8.102001 21.1513 1426.0 1426.0 1426.0 -32.7144 8.102001 21.1513 799.439 799.439 799.439 -32.7144 8.102001 22.1513 348.87 348.87 348.87 -33.7144 8.102001 21.1513 -267.51 -267.51 -267.51 -33.7144 8.102001 22.1513 -157.87 -157.87 -157.87 -34.7144 8.102001 21.1513 -826.598 -826.598 -826.598 -35.7144 8.102001 21.1513 -1090.26 -1090.26 -1090.26 -37.7144 -12.897999 9.1513 -2170.7 -2170.7 -2170.7 -37.7144 -12.897999 10.1513 -4283.7 -4283.7 -4283.7 -38.7144 -12.897999 9.1513 12451.9 12451.9 12451.9 -38.7144 -12.897999 10.1513 7633.39 7633.39 7633.39 -37.7144 -12.897999 11.1513 2816.99 2816.99 2816.99 -38.7144 -12.897999 11.1513 5087.6 5087.6 5087.6 -39.7144 -12.897999 9.1513 16285.1 16285.1 16285.1 -39.7144 -12.897999 10.1513 -4220.75 -4220.75 -4220.75 -40.7144 -12.897999 10.1513 -39279.3 -39279.3 -39279.3 -39.7144 -12.897999 11.1513 -1848.88 -1848.88 -1848.88 -40.7144 -12.897999 11.1513 7901.29 7901.29 7901.29 -37.7144 -11.897999 8.1513 1518.44 1518.44 1518.44 -37.7144 -10.897999 8.1513 1603.7 1603.7 1603.7 -38.7144 -11.897999 8.1513 -3562.88 -3562.88 -3562.88 -38.7144 -10.897999 8.1513 -1870.96 -1870.96 -1870.96 -37.7144 -9.897999 8.1513 -4656.25 -4656.25 -4656.25 -37.7144 -8.897999 8.1513 -11713.8 -11713.8 -11713.8 -38.7144 -8.897999 8.1513 -205258.0 -205258.0 -205258.0 -39.7144 -11.897999 8.1513 3212.59 3212.59 3212.59 -39.7144 -10.897999 8.1513 5421.39 5421.39 5421.39 -37.7144 -11.897999 9.1513 -498.526 -498.526 -498.526 -37.7144 -11.897999 10.1513 -2374.52 -2374.52 -2374.52 -37.7144 -10.897999 9.1513 -2804.61 -2804.61 -2804.61 -37.7144 -10.897999 10.1513 -1988.4 -1988.4 -1988.4 -38.7144 -11.897999 9.1513 -5965.89 -5965.89 -5965.89 -38.7144 -10.897999 9.1513 -963.325 -963.325 -963.325 -37.7144 -11.897999 11.1513 -2618.81 -2618.81 -2618.81 -37.7144 -11.897999 12.1513 3297.84 3297.84 3297.84 -37.7144 -10.897999 11.1513 1185.62 1185.62 1185.62 -37.7144 -10.897999 12.1513 -504.51 -504.51 -504.51 -38.7144 -11.897999 11.1513 -870.825 -870.825 -870.825 -38.7144 -11.897999 12.1513 847.135 847.135 847.135 -38.7144 -10.897999 12.1513 132.012 132.012 132.012 -37.7144 -9.897999 9.1513 5799.93 5799.93 5799.93 -37.7144 -9.897999 10.1513 13408.5 13408.5 13408.5 -37.7144 -8.897999 9.1513 1646.83 1646.83 1646.83 -37.7144 -8.897999 10.1513 8360.54 8360.54 8360.54 -38.7144 -9.897999 9.1513 -30513.7 -30513.7 -30513.7 -38.7144 -8.897999 9.1513 -217335.0 -217335.0 -217335.0 -37.7144 -9.897999 11.1513 33250.1 33250.1 33250.1 -37.7144 -9.897999 12.1513 66071.0 66071.0 66071.0 -37.7144 -8.897999 11.1513 213578.0 213578.0 213578.0 -37.7144 -8.897999 12.1513 -2963.53 -2963.53 -2963.53 -38.7144 -9.897999 12.1513 1958.55 1958.55 1958.55 -38.7144 -8.897999 12.1513 8024.28 8024.28 8024.28 -39.7144 -11.897999 9.1513 8107.64 8107.64 8107.64 -39.7144 -11.897999 10.1513 3473.66 3473.66 3473.66 -39.7144 -10.897999 9.1513 -1598.11 -1598.11 -1598.11 -39.7144 -10.897999 10.1513 5844.46 5844.46 5844.46 -40.7144 -11.897999 9.1513 897.429 897.429 897.429 -40.7144 -11.897999 10.1513 -11311.1 -11311.1 -11311.1 -40.7144 -10.897999 9.1513 -502.657 -502.657 -502.657 -40.7144 -10.897999 10.1513 20791.4 20791.4 20791.4 -39.7144 -11.897999 11.1513 6825.46 6825.46 6825.46 -39.7144 -11.897999 12.1513 -1474.87 -1474.87 -1474.87 -39.7144 -10.897999 11.1513 8337.71 8337.71 8337.71 -39.7144 -10.897999 12.1513 -5624.44 -5624.44 -5624.44 -40.7144 -11.897999 11.1513 4114.26 4114.26 4114.26 -40.7144 -11.897999 12.1513 -417.419 -417.419 -417.419 -40.7144 -10.897999 12.1513 485.581 485.581 485.581 -39.7144 -9.897999 9.1513 -344910.0 -344910.0 -344910.0 -39.7144 -8.897999 9.1513 -519502.0 -519502.0 -519502.0 -40.7144 -9.897999 9.1513 -298538.0 -298538.0 -298538.0 -40.7144 -9.897999 10.1513 -1099120.0 -1099120.0 -1099120.0 -40.7144 -8.897999 9.1513 553492.0 553492.0 553492.0 -39.7144 -9.897999 12.1513 4129.24 4129.24 4129.24 -39.7144 -8.897999 12.1513 -7413.68 -7413.68 -7413.68 -40.7144 -9.897999 12.1513 7100.6 7100.6 7100.6 -40.7144 -8.897999 12.1513 4663.42 4663.42 4663.42 -41.7144 -12.897999 10.1513 8954.7 8954.7 8954.7 -41.7144 -12.897999 11.1513 -11666.0 -11666.0 -11666.0 -44.7144 -8.897999 8.1513 1692830.0 1692830.0 1692830.0 -41.7144 -11.897999 9.1513 6361.69 6361.69 6361.69 -41.7144 -11.897999 10.1513 -998.126 -998.126 -998.126 -41.7144 -10.897999 9.1513 -1203.42 -1203.42 -1203.42 -42.7144 -11.897999 9.1513 -4623.57 -4623.57 -4623.57 -42.7144 -11.897999 10.1513 7844.73 7844.73 7844.73 -42.7144 -10.897999 9.1513 -74800.7 -74800.7 -74800.7 -42.7144 -10.897999 10.1513 3944.62 3944.62 3944.62 -41.7144 -11.897999 11.1513 4407.41 4407.41 4407.41 -41.7144 -11.897999 12.1513 -773.225 -773.225 -773.225 -41.7144 -10.897999 12.1513 -3299.23 -3299.23 -3299.23 -42.7144 -11.897999 11.1513 404.297 404.297 404.297 -42.7144 -11.897999 12.1513 2262.27 2262.27 2262.27 -42.7144 -10.897999 11.1513 1320.45 1320.45 1320.45 -42.7144 -10.897999 12.1513 2505.08 2505.08 2505.08 -41.7144 -9.897999 9.1513 -3076.21 -3076.21 -3076.21 -41.7144 -9.897999 10.1513 1114.4 1114.4 1114.4 -41.7144 -8.897999 9.1513 824.587 824.587 824.587 -42.7144 -9.897999 9.1513 186364.0 186364.0 186364.0 -42.7144 -9.897999 10.1513 1317.34 1317.34 1317.34 -42.7144 -8.897999 9.1513 188847.0 188847.0 188847.0 -42.7144 -8.897999 10.1513 6760.56 6760.56 6760.56 -41.7144 -9.897999 12.1513 -3816.73 -3816.73 -3816.73 -41.7144 -8.897999 12.1513 -14411.9 -14411.9 -14411.9 -42.7144 -9.897999 11.1513 7797.28 7797.28 7797.28 -42.7144 -9.897999 12.1513 4637.77 4637.77 4637.77 -42.7144 -8.897999 11.1513 1799.09 1799.09 1799.09 -42.7144 -8.897999 12.1513 -3856.2 -3856.2 -3856.2 -43.7144 -10.897999 11.1513 -458.368 -458.368 -458.368 -43.7144 -8.897999 10.1513 89819.9 89819.9 89819.9 -44.7144 -8.897999 9.1513 -336472.0 -336472.0 -336472.0 -43.7144 -8.897999 11.1513 35801.7 35801.7 35801.7 -37.7144 -2.897999 0.15130000000000088 7521.35 7521.35 7521.35 -38.7144 -2.897999 0.15130000000000088 -12579.7 -12579.7 -12579.7 -37.7144 -1.897999 -0.8486999999999991 681.352 681.352 681.352 -37.7144 -1.897999 0.15130000000000088 1208.63 1208.63 1208.63 -37.7144 -0.897999 -0.8486999999999991 1106.65 1106.65 1106.65 -37.7144 -0.897999 0.15130000000000088 2063.88 2063.88 2063.88 -38.7144 -1.897999 -0.8486999999999991 -2359.87 -2359.87 -2359.87 -38.7144 -1.897999 0.15130000000000088 4017.5 4017.5 4017.5 -38.7144 -0.897999 -0.8486999999999991 -3253.1 -3253.1 -3253.1 -39.7144 -1.897999 -0.8486999999999991 -2451.49 -2451.49 -2451.49 -39.7144 -1.897999 0.15130000000000088 1295.66 1295.66 1295.66 -39.7144 -0.897999 -0.8486999999999991 -5611.53 -5611.53 -5611.53 -39.7144 -0.897999 0.15130000000000088 -821.282 -821.282 -821.282 -40.7144 -0.897999 0.15130000000000088 1.52588 1.52588 1.52588 -37.7144 -2.897999 1.1513000000000009 -12304.1 -12304.1 -12304.1 -37.7144 -2.897999 2.151300000000001 -12203.9 -12203.9 -12203.9 -38.7144 -2.897999 1.1513000000000009 3169.42 3169.42 3169.42 -38.7144 -2.897999 2.151300000000001 23615.7 23615.7 23615.7 -37.7144 -3.897999 4.151300000000001 6051.63 6051.63 6051.63 -37.7144 -2.897999 3.151300000000001 235.183 235.183 235.183 -37.7144 -2.897999 4.151300000000001 5032.42 5032.42 5032.42 -38.7144 -2.897999 3.151300000000001 4055.88 4055.88 4055.88 -38.7144 -2.897999 4.151300000000001 -2704.62 -2704.62 -2704.62 -37.7144 -1.897999 2.151300000000001 12501.8 12501.8 12501.8 -38.7144 -1.897999 1.1513000000000009 12478.0 12478.0 12478.0 -38.7144 -1.897999 2.151300000000001 -24785.9 -24785.9 -24785.9 -37.7144 -1.897999 3.151300000000001 -826.672 -826.672 -826.672 -38.7144 -1.897999 3.151300000000001 -79987.3 -79987.3 -79987.3 -38.7144 -1.897999 4.151300000000001 -89051.9 -89051.9 -89051.9 -38.7144 -0.897999 4.151300000000001 -14921.9 -14921.9 -14921.9 -39.7144 -1.897999 1.1513000000000009 -542.237 -542.237 -542.237 -39.7144 -1.897999 2.151300000000001 18641.3 18641.3 18641.3 -39.7144 -0.897999 1.1513000000000009 -635.702 -635.702 -635.702 -39.7144 -0.897999 2.151300000000001 50543.0 50543.0 50543.0 -40.7144 -1.897999 2.151300000000001 -20941.1 -20941.1 -20941.1 -40.7144 -0.897999 1.1513000000000009 -2117.58 -2117.58 -2117.58 -40.7144 -0.897999 2.151300000000001 39300.4 39300.4 39300.4 -39.7144 -1.897999 3.151300000000001 8238.36 8238.36 8238.36 -39.7144 -1.897999 4.151300000000001 -11368.2 -11368.2 -11368.2 -39.7144 -0.897999 4.151300000000001 20991.5 20991.5 20991.5 -40.7144 -1.897999 3.151300000000001 22818.9 22818.9 22818.9 -40.7144 -1.897999 4.151300000000001 -5900.34 -5900.34 -5900.34 -40.7144 -0.897999 3.151300000000001 62188.4 62188.4 62188.4 -40.7144 -0.897999 4.151300000000001 35134.5 35134.5 35134.5 -41.7144 -5.897999 4.151300000000001 1023.27 1023.27 1023.27 -41.7144 -4.897999 4.151300000000001 -2403.17 -2403.17 -2403.17 -42.7144 -5.897999 4.151300000000001 2267.31 2267.31 2267.31 -42.7144 -4.897999 3.151300000000001 -3268.67 -3268.67 -3268.67 -42.7144 -4.897999 4.151300000000001 1882.69 1882.69 1882.69 -43.7144 -5.897999 4.151300000000001 -16587.4 -16587.4 -16587.4 -43.7144 -4.897999 3.151300000000001 1301.51 1301.51 1301.51 -43.7144 -4.897999 4.151300000000001 -65730.6 -65730.6 -65730.6 -44.7144 -5.897999 4.151300000000001 61255.7 61255.7 61255.7 -44.7144 -4.897999 3.151300000000001 -110395.0 -110395.0 -110395.0 -44.7144 -4.897999 4.151300000000001 -193232.0 -193232.0 -193232.0 -41.7144 -3.897999 4.151300000000001 941.849 941.849 941.849 -41.7144 -2.897999 4.151300000000001 -1964.03 -1964.03 -1964.03 -42.7144 -3.897999 3.151300000000001 -5153.2 -5153.2 -5153.2 -42.7144 -3.897999 4.151300000000001 7355.69 7355.69 7355.69 -42.7144 -2.897999 4.151300000000001 3467.01 3467.01 3467.01 -41.7144 -0.897999 3.151300000000001 -2096.63 -2096.63 -2096.63 -41.7144 -0.897999 4.151300000000001 -3932.65 -3932.65 -3932.65 -43.7144 -3.897999 3.151300000000001 6380.28 6380.28 6380.28 -43.7144 -3.897999 4.151300000000001 89347.5 89347.5 89347.5 -43.7144 -2.897999 4.151300000000001 -15547.8 -15547.8 -15547.8 -44.7144 -3.897999 3.151300000000001 139219.0 139219.0 139219.0 -44.7144 -3.897999 4.151300000000001 -1728.36 -1728.36 -1728.36 -44.7144 -2.897999 3.151300000000001 14631.3 14631.3 14631.3 -44.7144 -2.897999 4.151300000000001 12090.8 12090.8 12090.8 -37.7144 -6.897999 5.151300000000001 -13609.3 -13609.3 -13609.3 -37.7144 -6.897999 6.151300000000001 -6105.61 -6105.61 -6105.61 -38.7144 -7.897999 6.151300000000001 23539.7 23539.7 23539.7 -38.7144 -6.897999 5.151300000000001 -10053.4 -10053.4 -10053.4 -38.7144 -6.897999 6.151300000000001 14655.0 14655.0 14655.0 -37.7144 -7.897999 8.1513 -3263.0 -3263.0 -3263.0 -37.7144 -6.897999 7.151300000000001 24823.9 24823.9 24823.9 -37.7144 -6.897999 8.1513 17679.1 17679.1 17679.1 -38.7144 -7.897999 7.151300000000001 -14281.0 -14281.0 -14281.0 -38.7144 -7.897999 8.1513 106925.0 106925.0 106925.0 -38.7144 -6.897999 7.151300000000001 23476.9 23476.9 23476.9 -38.7144 -6.897999 8.1513 -19574.2 -19574.2 -19574.2 -37.7144 -5.897999 5.151300000000001 -4986.5 -4986.5 -4986.5 -37.7144 -4.897999 5.151300000000001 4553.27 4553.27 4553.27 -38.7144 -5.897999 5.151300000000001 -32552.7 -32552.7 -32552.7 -38.7144 -5.897999 6.151300000000001 -44098.3 -44098.3 -44098.3 -38.7144 -4.897999 5.151300000000001 792.944 792.944 792.944 -38.7144 -4.897999 6.151300000000001 -10247.4 -10247.4 -10247.4 -37.7144 -5.897999 7.151300000000001 -1219.19 -1219.19 -1219.19 -37.7144 -5.897999 8.1513 14770.3 14770.3 14770.3 -37.7144 -4.897999 7.151300000000001 -5301.47 -5301.47 -5301.47 -37.7144 -4.897999 8.1513 -64365.4 -64365.4 -64365.4 -38.7144 -5.897999 7.151300000000001 530.323 530.323 530.323 -38.7144 -5.897999 8.1513 9308.33 9308.33 9308.33 -38.7144 -4.897999 7.151300000000001 16938.7 16938.7 16938.7 -38.7144 -4.897999 8.1513 -10080.6 -10080.6 -10080.6 -39.7144 -7.897999 6.151300000000001 -1555.78 -1555.78 -1555.78 -39.7144 -6.897999 6.151300000000001 21188.9 21188.9 21188.9 -40.7144 -7.897999 6.151300000000001 5026.42 5026.42 5026.42 -40.7144 -6.897999 6.151300000000001 98.7704 98.7704 98.7704 -39.7144 -7.897999 7.151300000000001 29403.8 29403.8 29403.8 -39.7144 -7.897999 8.1513 212554.0 212554.0 212554.0 -40.7144 -7.897999 7.151300000000001 -7697.2 -7697.2 -7697.2 -40.7144 -7.897999 8.1513 789465.0 789465.0 789465.0 -40.7144 -6.897999 7.151300000000001 -3510.6 -3510.6 -3510.6 -40.7144 -6.897999 8.1513 6557.06 6557.06 6557.06 -39.7144 -5.897999 6.151300000000001 -4703.87 -4703.87 -4703.87 -39.7144 -4.897999 6.151300000000001 4724.55 4724.55 4724.55 -40.7144 -5.897999 6.151300000000001 605.988 605.988 605.988 -40.7144 -4.897999 6.151300000000001 5646.95 5646.95 5646.95 -39.7144 -5.897999 7.151300000000001 -9067.4 -9067.4 -9067.4 -39.7144 -5.897999 8.1513 -1945.94 -1945.94 -1945.94 -39.7144 -4.897999 7.151300000000001 3831.17 3831.17 3831.17 -39.7144 -4.897999 8.1513 -19415.6 -19415.6 -19415.6 -40.7144 -5.897999 7.151300000000001 3764.08 3764.08 3764.08 -40.7144 -5.897999 8.1513 3368.6 3368.6 3368.6 -40.7144 -4.897999 7.151300000000001 -847.298 -847.298 -847.298 -40.7144 -4.897999 8.1513 9345.53 9345.53 9345.53 -37.7144 -6.897999 9.1513 -14499.4 -14499.4 -14499.4 -38.7144 -7.897999 9.1513 231067.0 231067.0 231067.0 -38.7144 -6.897999 9.1513 -16100.6 -16100.6 -16100.6 -38.7144 -6.897999 10.1513 153949.0 153949.0 153949.0 -37.7144 -7.897999 12.1513 -33729.9 -33729.9 -33729.9 -37.7144 -6.897999 12.1513 -4614.23 -4614.23 -4614.23 -38.7144 -7.897999 12.1513 9892.78 9892.78 9892.78 -38.7144 -6.897999 11.1513 -8641.29 -8641.29 -8641.29 -38.7144 -6.897999 12.1513 10726.4 10726.4 10726.4 -37.7144 -5.897999 9.1513 -34627.7 -34627.7 -34627.7 -38.7144 -5.897999 9.1513 -9791.28 -9791.28 -9791.28 -38.7144 -5.897999 10.1513 -11107.0 -11107.0 -11107.0 -38.7144 -4.897999 9.1513 5715.26 5715.26 5715.26 -38.7144 -4.897999 10.1513 10304.2 10304.2 10304.2 -37.7144 -5.897999 12.1513 -908.272 -908.272 -908.272 -37.7144 -4.897999 11.1513 -930.648 -930.648 -930.648 -37.7144 -4.897999 12.1513 7816.04 7816.04 7816.04 -38.7144 -5.897999 11.1513 -8325.41 -8325.41 -8325.41 -38.7144 -5.897999 12.1513 15670.8 15670.8 15670.8 -38.7144 -4.897999 11.1513 4137.7 4137.7 4137.7 -38.7144 -4.897999 12.1513 -1717.6 -1717.6 -1717.6 -39.7144 -7.897999 9.1513 29224.2 29224.2 29224.2 -39.7144 -7.897999 10.1513 289592.0 289592.0 289592.0 -39.7144 -6.897999 9.1513 12307.1 12307.1 12307.1 -39.7144 -6.897999 10.1513 -23007.9 -23007.9 -23007.9 -40.7144 -7.897999 9.1513 94618.1 94618.1 94618.1 -40.7144 -7.897999 10.1513 182709.0 182709.0 182709.0 -40.7144 -6.897999 9.1513 32673.9 32673.9 32673.9 -40.7144 -6.897999 10.1513 95488.1 95488.1 95488.1 -39.7144 -7.897999 12.1513 -880.573 -880.573 -880.573 -39.7144 -6.897999 11.1513 -4006.58 -4006.58 -4006.58 -39.7144 -6.897999 12.1513 13391.5 13391.5 13391.5 -40.7144 -7.897999 11.1513 -6689.17 -6689.17 -6689.17 -40.7144 -7.897999 12.1513 -15476.8 -15476.8 -15476.8 -40.7144 -6.897999 11.1513 -1446.08 -1446.08 -1446.08 -40.7144 -6.897999 12.1513 7811.95 7811.95 7811.95 -39.7144 -5.897999 9.1513 9372.84 9372.84 9372.84 -39.7144 -4.897999 9.1513 -4507.58 -4507.58 -4507.58 -39.7144 -4.897999 10.1513 7777.73 7777.73 7777.73 -40.7144 -5.897999 9.1513 -780.477 -780.477 -780.477 -39.7144 -5.897999 11.1513 -39399.7 -39399.7 -39399.7 -39.7144 -5.897999 12.1513 5624.32 5624.32 5624.32 -39.7144 -4.897999 11.1513 -4906.48 -4906.48 -4906.48 -39.7144 -4.897999 12.1513 5115.62 5115.62 5115.62 -40.7144 -5.897999 12.1513 5332.5 5332.5 5332.5 -40.7144 -4.897999 12.1513 3370.58 3370.58 3370.58 -37.7144 -3.897999 5.151300000000001 5645.89 5645.89 5645.89 -37.7144 -3.897999 6.151300000000001 -10653.5 -10653.5 -10653.5 -37.7144 -2.897999 5.151300000000001 -431.552 -431.552 -431.552 -37.7144 -2.897999 6.151300000000001 -972.16 -972.16 -972.16 -38.7144 -3.897999 5.151300000000001 3704.08 3704.08 3704.08 -38.7144 -3.897999 6.151300000000001 -5043.37 -5043.37 -5043.37 -38.7144 -2.897999 5.151300000000001 1889.84 1889.84 1889.84 -38.7144 -2.897999 6.151300000000001 -3330.33 -3330.33 -3330.33 -37.7144 -3.897999 7.151300000000001 -3985.46 -3985.46 -3985.46 -37.7144 -2.897999 7.151300000000001 5137.89 5137.89 5137.89 -38.7144 -3.897999 7.151300000000001 8177.7 8177.7 8177.7 -38.7144 -3.897999 8.1513 1029.2 1029.2 1029.2 -38.7144 -2.897999 7.151300000000001 -5357.0 -5357.0 -5357.0 -38.7144 -2.897999 8.1513 6815.22 6815.22 6815.22 -37.7144 -1.897999 6.151300000000001 -1139.13 -1139.13 -1139.13 -37.7144 -0.897999 5.151300000000001 -102.935 -102.935 -102.935 -37.7144 -0.897999 6.151300000000001 1501.64 1501.64 1501.64 -38.7144 -1.897999 5.151300000000001 350.663 350.663 350.663 -38.7144 -1.897999 6.151300000000001 359.219 359.219 359.219 -38.7144 -0.897999 5.151300000000001 -1212.99 -1212.99 -1212.99 -38.7144 -0.897999 6.151300000000001 3709.94 3709.94 3709.94 -37.7144 -1.897999 7.151300000000001 -238.641 -238.641 -238.641 -37.7144 -1.897999 8.1513 -33032.9 -33032.9 -33032.9 -37.7144 -0.897999 7.151300000000001 2272.01 2272.01 2272.01 -37.7144 -0.897999 8.1513 -21428.3 -21428.3 -21428.3 -38.7144 -1.897999 8.1513 15361.9 15361.9 15361.9 -38.7144 -0.897999 7.151300000000001 -2511.6 -2511.6 -2511.6 -38.7144 -0.897999 8.1513 54162.0 54162.0 54162.0 -39.7144 -2.897999 6.151300000000001 8392.77 8392.77 8392.77 -40.7144 -2.897999 5.151300000000001 20845.6 20845.6 20845.6 -40.7144 -2.897999 6.151300000000001 14959.8 14959.8 14959.8 -39.7144 -2.897999 7.151300000000001 -10073.8 -10073.8 -10073.8 -40.7144 -2.897999 7.151300000000001 -7933.32 -7933.32 -7933.32 -40.7144 -2.897999 8.1513 -7336.41 -7336.41 -7336.41 -39.7144 -1.897999 5.151300000000001 5262.72 5262.72 5262.72 -39.7144 -1.897999 6.151300000000001 9382.83 9382.83 9382.83 -39.7144 -0.897999 5.151300000000001 2734.52 2734.52 2734.52 -39.7144 -0.897999 6.151300000000001 -4460.83 -4460.83 -4460.83 -40.7144 -1.897999 5.151300000000001 11690.1 11690.1 11690.1 -40.7144 -0.897999 5.151300000000001 -2396.09 -2396.09 -2396.09 -39.7144 -1.897999 7.151300000000001 -10895.6 -10895.6 -10895.6 -39.7144 -1.897999 8.1513 1262.58 1262.58 1262.58 -39.7144 -0.897999 7.151300000000001 5573.25 5573.25 5573.25 -39.7144 -0.897999 8.1513 81947.4 81947.4 81947.4 -40.7144 -1.897999 7.151300000000001 -7353.24 -7353.24 -7353.24 -40.7144 -1.897999 8.1513 -7661.03 -7661.03 -7661.03 -40.7144 -0.897999 8.1513 4436.41 4436.41 4436.41 -37.7144 -2.897999 9.1513 11382.6 11382.6 11382.6 -37.7144 -2.897999 10.1513 1182.35 1182.35 1182.35 -38.7144 -3.897999 9.1513 21583.0 21583.0 21583.0 -38.7144 -2.897999 9.1513 1579.98 1579.98 1579.98 -38.7144 -2.897999 10.1513 27764.2 27764.2 27764.2 -37.7144 -3.897999 11.1513 -8611.61 -8611.61 -8611.61 -37.7144 -3.897999 12.1513 64420.3 64420.3 64420.3 -37.7144 -2.897999 11.1513 5274.08 5274.08 5274.08 -37.7144 -2.897999 12.1513 -57613.0 -57613.0 -57613.0 -38.7144 -3.897999 11.1513 4404.16 4404.16 4404.16 -38.7144 -3.897999 12.1513 -26780.8 -26780.8 -26780.8 -38.7144 -2.897999 11.1513 16876.0 16876.0 16876.0 -38.7144 -2.897999 12.1513 -12937.4 -12937.4 -12937.4 -37.7144 -1.897999 9.1513 -38764.7 -38764.7 -38764.7 -37.7144 -1.897999 10.1513 -20942.1 -20942.1 -20942.1 -37.7144 -0.897999 9.1513 18411.7 18411.7 18411.7 -37.7144 -0.897999 10.1513 -1434.45 -1434.45 -1434.45 -38.7144 -1.897999 9.1513 37449.5 37449.5 37449.5 -38.7144 -1.897999 10.1513 -71168.6 -71168.6 -71168.6 -38.7144 -0.897999 9.1513 29053.1 29053.1 29053.1 -38.7144 -0.897999 10.1513 -18993.6 -18993.6 -18993.6 -37.7144 -1.897999 11.1513 -11007.3 -11007.3 -11007.3 -37.7144 -1.897999 12.1513 -68036.7 -68036.7 -68036.7 -37.7144 -0.897999 11.1513 -7072.16 -7072.16 -7072.16 -38.7144 -1.897999 11.1513 6.9646 6.9646 6.9646 -38.7144 -1.897999 12.1513 21789.4 21789.4 21789.4 -38.7144 -0.897999 11.1513 -3737.9 -3737.9 -3737.9 -38.7144 -0.897999 12.1513 -7325.8 -7325.8 -7325.8 -39.7144 -3.897999 9.1513 -41635.6 -41635.6 -41635.6 -39.7144 -3.897999 10.1513 -17441.7 -17441.7 -17441.7 -39.7144 -2.897999 9.1513 -12014.2 -12014.2 -12014.2 -39.7144 -2.897999 10.1513 -11178.1 -11178.1 -11178.1 -39.7144 -3.897999 11.1513 -5637.99 -5637.99 -5637.99 -39.7144 -3.897999 12.1513 11115.1 11115.1 11115.1 -39.7144 -2.897999 11.1513 907.053 907.053 907.053 -39.7144 -2.897999 12.1513 -5299.3 -5299.3 -5299.3 -39.7144 -1.897999 9.1513 24717.3 24717.3 24717.3 -39.7144 -0.897999 9.1513 3788.74 3788.74 3788.74 -39.7144 -0.897999 10.1513 -82004.2 -82004.2 -82004.2 -40.7144 -1.897999 9.1513 5731.45 5731.45 5731.45 -40.7144 -0.897999 9.1513 5492.21 5492.21 5492.21 -40.7144 -0.897999 10.1513 161.108 161.108 161.108 -39.7144 -1.897999 11.1513 -10999.8 -10999.8 -10999.8 -39.7144 -1.897999 12.1513 4640.66 4640.66 4640.66 -39.7144 -0.897999 11.1513 772.376 772.376 772.376 -39.7144 -0.897999 12.1513 -3670.48 -3670.48 -3670.48 -40.7144 -0.897999 11.1513 -2673.04 -2673.04 -2673.04 -40.7144 -0.897999 12.1513 -6782.68 -6782.68 -6782.68 -42.7144 -6.897999 6.151300000000001 364169.0 364169.0 364169.0 -41.7144 -7.897999 7.151300000000001 717.324 717.324 717.324 -41.7144 -7.897999 8.1513 1143.84 1143.84 1143.84 -41.7144 -6.897999 7.151300000000001 4924.09 4924.09 4924.09 -41.7144 -6.897999 8.1513 2172.09 2172.09 2172.09 -42.7144 -6.897999 7.151300000000001 38288.1 38288.1 38288.1 -42.7144 -6.897999 8.1513 -34234.4 -34234.4 -34234.4 -41.7144 -5.897999 5.151300000000001 -695.469 -695.469 -695.469 -41.7144 -5.897999 6.151300000000001 -3379.9 -3379.9 -3379.9 -41.7144 -4.897999 5.151300000000001 299.632 299.632 299.632 -41.7144 -4.897999 6.151300000000001 390.27 390.27 390.27 -42.7144 -5.897999 5.151300000000001 -200.595 -200.595 -200.595 -42.7144 -5.897999 6.151300000000001 6270.49 6270.49 6270.49 -41.7144 -5.897999 7.151300000000001 -3524.0 -3524.0 -3524.0 -41.7144 -5.897999 8.1513 2808.56 2808.56 2808.56 -41.7144 -4.897999 7.151300000000001 -4102.64 -4102.64 -4102.64 -41.7144 -4.897999 8.1513 -5243.91 -5243.91 -5243.91 -42.7144 -5.897999 7.151300000000001 -3176.23 -3176.23 -3176.23 -42.7144 -5.897999 8.1513 2639.68 2639.68 2639.68 -42.7144 -4.897999 8.1513 -21475.8 -21475.8 -21475.8 -43.7144 -6.897999 6.151300000000001 -545367.0 -545367.0 -545367.0 -44.7144 -6.897999 6.151300000000001 183675.0 183675.0 183675.0 -43.7144 -7.897999 8.1513 188433.0 188433.0 188433.0 -43.7144 -6.897999 7.151300000000001 -128165.0 -128165.0 -128165.0 -43.7144 -6.897999 8.1513 -23111.2 -23111.2 -23111.2 -44.7144 -7.897999 7.151300000000001 388891.0 388891.0 388891.0 -44.7144 -7.897999 8.1513 -139338.0 -139338.0 -139338.0 -44.7144 -6.897999 7.151300000000001 -226957.0 -226957.0 -226957.0 -44.7144 -6.897999 8.1513 -136750.0 -136750.0 -136750.0 -43.7144 -5.897999 5.151300000000001 11107.5 11107.5 11107.5 -43.7144 -5.897999 6.151300000000001 -63049.5 -63049.5 -63049.5 -44.7144 -5.897999 5.151300000000001 160378.0 160378.0 160378.0 -44.7144 -5.897999 6.151300000000001 -56967.4 -56967.4 -56967.4 -44.7144 -4.897999 6.151300000000001 -22560.2 -22560.2 -22560.2 -43.7144 -5.897999 8.1513 -6140.7 -6140.7 -6140.7 -44.7144 -5.897999 7.151300000000001 -296134.0 -296134.0 -296134.0 -41.7144 -7.897999 9.1513 597.778 597.778 597.778 -41.7144 -7.897999 10.1513 -2157.04 -2157.04 -2157.04 -41.7144 -6.897999 9.1513 -885.092 -885.092 -885.092 -41.7144 -6.897999 10.1513 2035.0 2035.0 2035.0 -42.7144 -7.897999 9.1513 33991.0 33991.0 33991.0 -42.7144 -7.897999 10.1513 4698.89 4698.89 4698.89 -42.7144 -6.897999 9.1513 5777.45 5777.45 5777.45 -42.7144 -6.897999 10.1513 5133.05 5133.05 5133.05 -41.7144 -7.897999 12.1513 448.768 448.768 448.768 -41.7144 -6.897999 11.1513 8172.97 8172.97 8172.97 -41.7144 -6.897999 12.1513 7343.29 7343.29 7343.29 -42.7144 -7.897999 11.1513 1722.06 1722.06 1722.06 -42.7144 -7.897999 12.1513 5356.51 5356.51 5356.51 -42.7144 -6.897999 11.1513 -2581.38 -2581.38 -2581.38 -42.7144 -6.897999 12.1513 -10222.7 -10222.7 -10222.7 -42.7144 -5.897999 9.1513 -924.085 -924.085 -924.085 -42.7144 -4.897999 9.1513 -3306.2 -3306.2 -3306.2 -43.7144 -7.897999 9.1513 167563.0 167563.0 167563.0 -43.7144 -7.897999 10.1513 28543.6 28543.6 28543.6 -43.7144 -6.897999 9.1513 -12201.5 -12201.5 -12201.5 -43.7144 -6.897999 10.1513 31603.7 31603.7 31603.7 -44.7144 -7.897999 9.1513 187066.0 187066.0 187066.0 -44.7144 -7.897999 10.1513 -54359.2 -54359.2 -54359.2 -44.7144 -6.897999 10.1513 -753.423 -753.423 -753.423 -43.7144 -7.897999 11.1513 104739.0 104739.0 104739.0 -43.7144 -5.897999 9.1513 -295.744 -295.744 -295.744 -43.7144 -5.897999 10.1513 -1598.7 -1598.7 -1598.7 -43.7144 -4.897999 9.1513 4709.02 4709.02 4709.02 -43.7144 -4.897999 10.1513 -5675.06 -5675.06 -5675.06 -44.7144 -5.897999 9.1513 -24334.4 -24334.4 -24334.4 -44.7144 -5.897999 10.1513 -7163.16 -7163.16 -7163.16 -44.7144 -4.897999 10.1513 -1271.71 -1271.71 -1271.71 -44.7144 -5.897999 11.1513 18749.2 18749.2 18749.2 -44.7144 -4.897999 11.1513 11099.4 11099.4 11099.4 -41.7144 -3.897999 5.151300000000001 496.887 496.887 496.887 -41.7144 -3.897999 6.151300000000001 -5165.99 -5165.99 -5165.99 -41.7144 -2.897999 5.151300000000001 17892.9 17892.9 17892.9 -41.7144 -2.897999 6.151300000000001 -543.309 -543.309 -543.309 -42.7144 -2.897999 5.151300000000001 -2876.72 -2876.72 -2876.72 -42.7144 -2.897999 6.151300000000001 -1978.14 -1978.14 -1978.14 -41.7144 -3.897999 7.151300000000001 -15787.3 -15787.3 -15787.3 -41.7144 -3.897999 8.1513 1018.1 1018.1 1018.1 -41.7144 -2.897999 7.151300000000001 -9549.55 -9549.55 -9549.55 -41.7144 -2.897999 8.1513 241.461 241.461 241.461 -42.7144 -3.897999 8.1513 1987.0 1987.0 1987.0 -42.7144 -2.897999 7.151300000000001 4061.29 4061.29 4061.29 -42.7144 -2.897999 8.1513 2669.54 2669.54 2669.54 -41.7144 -1.897999 5.151300000000001 5183.05 5183.05 5183.05 -41.7144 -0.897999 5.151300000000001 -1563.95 -1563.95 -1563.95 -42.7144 -1.897999 5.151300000000001 -6469.72 -6469.72 -6469.72 -42.7144 -1.897999 6.151300000000001 -9788.48 -9788.48 -9788.48 -42.7144 -0.897999 5.151300000000001 5101.62 5101.62 5101.62 -42.7144 -0.897999 6.151300000000001 -91.0931 -91.0931 -91.0931 -41.7144 -1.897999 7.151300000000001 -11795.3 -11795.3 -11795.3 -41.7144 -1.897999 8.1513 -2322.14 -2322.14 -2322.14 -41.7144 -0.897999 7.151300000000001 1663.14 1663.14 1663.14 -41.7144 -0.897999 8.1513 812.655 812.655 812.655 -42.7144 -1.897999 7.151300000000001 -9936.64 -9936.64 -9936.64 -42.7144 -1.897999 8.1513 1480.87 1480.87 1480.87 -42.7144 -0.897999 7.151300000000001 -4794.42 -4794.42 -4794.42 -42.7144 -0.897999 8.1513 15.7538 15.7538 15.7538 -43.7144 -2.897999 5.151300000000001 -921.605 -921.605 -921.605 -43.7144 -2.897999 6.151300000000001 -12841.9 -12841.9 -12841.9 -44.7144 -3.897999 6.151300000000001 7901.44 7901.44 7901.44 -44.7144 -2.897999 5.151300000000001 16432.7 16432.7 16432.7 -44.7144 -2.897999 6.151300000000001 -5728.67 -5728.67 -5728.67 -43.7144 -3.897999 8.1513 -2501.98 -2501.98 -2501.98 -43.7144 -2.897999 7.151300000000001 5982.51 5982.51 5982.51 -43.7144 -2.897999 8.1513 8723.72 8723.72 8723.72 -44.7144 -3.897999 7.151300000000001 29680.1 29680.1 29680.1 -44.7144 -2.897999 7.151300000000001 37340.8 37340.8 37340.8 -43.7144 -0.897999 5.151300000000001 2864.23 2864.23 2864.23 -43.7144 -0.897999 6.151300000000001 20.6938 20.6938 20.6938 -44.7144 -1.897999 5.151300000000001 -19774.6 -19774.6 -19774.6 -44.7144 -1.897999 6.151300000000001 35062.5 35062.5 35062.5 -44.7144 -0.897999 5.151300000000001 -7858.2 -7858.2 -7858.2 -44.7144 -0.897999 6.151300000000001 -19042.3 -19042.3 -19042.3 -43.7144 -1.897999 7.151300000000001 5979.65 5979.65 5979.65 -43.7144 -1.897999 8.1513 3775.69 3775.69 3775.69 -43.7144 -0.897999 7.151300000000001 215.073 215.073 215.073 -43.7144 -0.897999 8.1513 -3524.86 -3524.86 -3524.86 -44.7144 -1.897999 7.151300000000001 33789.0 33789.0 33789.0 -41.7144 -0.897999 9.1513 1285.21 1285.21 1285.21 -42.7144 -0.897999 9.1513 -2976.72 -2976.72 -2976.72 -42.7144 -0.897999 10.1513 -441.519 -441.519 -441.519 -41.7144 -0.897999 11.1513 -1469.93 -1469.93 -1469.93 -41.7144 -0.897999 12.1513 -99503.4 -99503.4 -99503.4 -42.7144 -0.897999 11.1513 -4278.93 -4278.93 -4278.93 -43.7144 -3.897999 9.1513 -3178.35 -3178.35 -3178.35 -43.7144 -3.897999 10.1513 3076.64 3076.64 3076.64 -43.7144 -2.897999 9.1513 -4499.86 -4499.86 -4499.86 -43.7144 -2.897999 10.1513 -3899.64 -3899.64 -3899.64 -44.7144 -3.897999 10.1513 -12846.8 -12846.8 -12846.8 -44.7144 -2.897999 9.1513 -8517.34 -8517.34 -8517.34 -44.7144 -2.897999 10.1513 -7207.53 -7207.53 -7207.53 -43.7144 -3.897999 11.1513 7623.52 7623.52 7623.52 -43.7144 -3.897999 12.1513 2653.18 2653.18 2653.18 -43.7144 -2.897999 11.1513 1552.51 1552.51 1552.51 -43.7144 -2.897999 12.1513 -33747.5 -33747.5 -33747.5 -44.7144 -3.897999 11.1513 11287.2 11287.2 11287.2 -44.7144 -3.897999 12.1513 4167.12 4167.12 4167.12 -44.7144 -2.897999 11.1513 -1821.43 -1821.43 -1821.43 -43.7144 -1.897999 9.1513 2664.13 2664.13 2664.13 -43.7144 -0.897999 9.1513 6506.37 6506.37 6506.37 -43.7144 -0.897999 10.1513 -491.374 -491.374 -491.374 -44.7144 -1.897999 9.1513 2327.82 2327.82 2327.82 -44.7144 -1.897999 10.1513 -8499.73 -8499.73 -8499.73 -44.7144 -0.897999 9.1513 -3492.38 -3492.38 -3492.38 -44.7144 -0.897999 10.1513 -7610.81 -7610.81 -7610.81 -43.7144 -1.897999 11.1513 550.501 550.501 550.501 -43.7144 -1.897999 12.1513 12759.8 12759.8 12759.8 -43.7144 -0.897999 11.1513 -1547.16 -1547.16 -1547.16 -43.7144 -0.897999 12.1513 26783.1 26783.1 26783.1 -44.7144 -1.897999 11.1513 -1957.32 -1957.32 -1957.32 -44.7144 -0.897999 11.1513 1567.79 1567.79 1567.79 -44.7144 -0.897999 12.1513 -2458.31 -2458.31 -2458.31 -45.7144 -8.897999 8.1513 -1224540.0 -1224540.0 -1224540.0 -45.7144 -8.897999 9.1513 -740316.0 -740316.0 -740316.0 -45.7144 -5.897999 4.151300000000001 20366.2 20366.2 20366.2 -45.7144 -4.897999 3.151300000000001 27655.9 27655.9 27655.9 -45.7144 -4.897999 4.151300000000001 -122485.0 -122485.0 -122485.0 -45.7144 -3.897999 3.151300000000001 90434.3 90434.3 90434.3 -45.7144 -3.897999 4.151300000000001 104622.0 104622.0 104622.0 -45.7144 -2.897999 4.151300000000001 126091.0 126091.0 126091.0 -45.7144 -7.897999 7.151300000000001 -103637.0 -103637.0 -103637.0 -45.7144 -7.897999 8.1513 -98648.8 -98648.8 -98648.8 -45.7144 -6.897999 7.151300000000001 74463.7 74463.7 74463.7 -46.7144 -7.897999 7.151300000000001 -109168.0 -109168.0 -109168.0 -46.7144 -7.897999 8.1513 -84052.0 -84052.0 -84052.0 -46.7144 -6.897999 7.151300000000001 37238.4 37238.4 37238.4 -46.7144 -6.897999 8.1513 -83729.5 -83729.5 -83729.5 -45.7144 -5.897999 5.151300000000001 57898.9 57898.9 57898.9 -45.7144 -5.897999 6.151300000000001 255768.0 255768.0 255768.0 -45.7144 -4.897999 5.151300000000001 -29999.3 -29999.3 -29999.3 -45.7144 -4.897999 6.151300000000001 -48429.7 -48429.7 -48429.7 -45.7144 -5.897999 7.151300000000001 184009.0 184009.0 184009.0 -45.7144 -4.897999 7.151300000000001 187184.0 187184.0 187184.0 -46.7144 -5.897999 7.151300000000001 28626.4 28626.4 28626.4 -46.7144 -5.897999 8.1513 -30257.0 -30257.0 -30257.0 -46.7144 -4.897999 7.151300000000001 -37632.6 -37632.6 -37632.6 -46.7144 -4.897999 8.1513 81412.7 81412.7 81412.7 -47.7144 -6.897999 8.1513 306186.0 306186.0 306186.0 -48.7144 -6.897999 8.1513 187322.0 187322.0 187322.0 -47.7144 -5.897999 7.151300000000001 -477511.0 -477511.0 -477511.0 -47.7144 -5.897999 8.1513 -171619.0 -171619.0 -171619.0 -47.7144 -4.897999 7.151300000000001 -89927.6 -89927.6 -89927.6 -47.7144 -4.897999 8.1513 121113.0 121113.0 121113.0 -48.7144 -5.897999 8.1513 -49426.7 -49426.7 -49426.7 -48.7144 -4.897999 8.1513 -251483.0 -251483.0 -251483.0 -45.7144 -7.897999 9.1513 -122823.0 -122823.0 -122823.0 -45.7144 -7.897999 10.1513 41617.6 41617.6 41617.6 -45.7144 -6.897999 10.1513 -46142.4 -46142.4 -46142.4 -46.7144 -7.897999 9.1513 5910.49 5910.49 5910.49 -46.7144 -7.897999 10.1513 60174.1 60174.1 60174.1 -46.7144 -6.897999 9.1513 22624.0 22624.0 22624.0 -46.7144 -6.897999 10.1513 -16429.7 -16429.7 -16429.7 -46.7144 -6.897999 11.1513 54571.5 54571.5 54571.5 -45.7144 -5.897999 10.1513 -18484.0 -18484.0 -18484.0 -45.7144 -4.897999 10.1513 -21914.1 -21914.1 -21914.1 -46.7144 -5.897999 10.1513 -40766.8 -40766.8 -40766.8 -46.7144 -4.897999 10.1513 10305.3 10305.3 10305.3 -45.7144 -5.897999 11.1513 -26514.2 -26514.2 -26514.2 -45.7144 -4.897999 11.1513 907.373 907.373 907.373 -46.7144 -5.897999 11.1513 -30649.0 -30649.0 -30649.0 -46.7144 -4.897999 11.1513 -16393.7 -16393.7 -16393.7 -47.7144 -7.897999 9.1513 -87476.1 -87476.1 -87476.1 -47.7144 -7.897999 10.1513 16366.5 16366.5 16366.5 -47.7144 -6.897999 9.1513 70822.2 70822.2 70822.2 -47.7144 -6.897999 10.1513 -49883.1 -49883.1 -49883.1 -48.7144 -7.897999 9.1513 -6298.01 -6298.01 -6298.01 -48.7144 -7.897999 10.1513 10287.1 10287.1 10287.1 -48.7144 -6.897999 9.1513 -168411.0 -168411.0 -168411.0 -48.7144 -6.897999 10.1513 1260.04 1260.04 1260.04 -47.7144 -7.897999 11.1513 53826.5 53826.5 53826.5 -47.7144 -6.897999 11.1513 -15632.5 -15632.5 -15632.5 -47.7144 -6.897999 12.1513 27295.7 27295.7 27295.7 -48.7144 -7.897999 11.1513 -24136.4 -24136.4 -24136.4 -48.7144 -6.897999 11.1513 -11450.8 -11450.8 -11450.8 -48.7144 -6.897999 12.1513 21334.5 21334.5 21334.5 -48.7144 -5.897999 9.1513 330904.0 330904.0 330904.0 -48.7144 -4.897999 9.1513 -19083.3 -19083.3 -19083.3 -47.7144 -5.897999 11.1513 -16692.3 -16692.3 -16692.3 -47.7144 -5.897999 12.1513 15033.5 15033.5 15033.5 -47.7144 -4.897999 11.1513 5700.41 5700.41 5700.41 -47.7144 -4.897999 12.1513 -12239.2 -12239.2 -12239.2 -48.7144 -5.897999 11.1513 3500.0 3500.0 3500.0 -48.7144 -5.897999 12.1513 19997.0 19997.0 19997.0 -48.7144 -4.897999 11.1513 913.415 913.415 913.415 -48.7144 -4.897999 12.1513 -5245.98 -5245.98 -5245.98 -45.7144 -3.897999 5.151300000000001 -36161.0 -36161.0 -36161.0 -45.7144 -3.897999 6.151300000000001 -23932.8 -23932.8 -23932.8 -45.7144 -2.897999 5.151300000000001 -28047.9 -28047.9 -28047.9 -45.7144 -2.897999 6.151300000000001 1796.37 1796.37 1796.37 -45.7144 -3.897999 7.151300000000001 -7695.67 -7695.67 -7695.67 -45.7144 -2.897999 7.151300000000001 -106106.0 -106106.0 -106106.0 -45.7144 -2.897999 8.1513 -4163.99 -4163.99 -4163.99 -46.7144 -3.897999 7.151300000000001 7915.44 7915.44 7915.44 -46.7144 -3.897999 8.1513 11136.2 11136.2 11136.2 -46.7144 -2.897999 7.151300000000001 10344.5 10344.5 10344.5 -46.7144 -2.897999 8.1513 -43191.4 -43191.4 -43191.4 -45.7144 -1.897999 5.151300000000001 1112.39 1112.39 1112.39 -45.7144 -1.897999 6.151300000000001 18480.5 18480.5 18480.5 -45.7144 -0.897999 5.151300000000001 87.9565 87.9565 87.9565 -45.7144 -0.897999 6.151300000000001 -8376.72 -8376.72 -8376.72 -46.7144 -1.897999 6.151300000000001 37288.8 37288.8 37288.8 -46.7144 -0.897999 5.151300000000001 4547.52 4547.52 4547.52 -46.7144 -0.897999 6.151300000000001 18839.6 18839.6 18839.6 -45.7144 -1.897999 7.151300000000001 -24408.4 -24408.4 -24408.4 -45.7144 -1.897999 8.1513 -21494.4 -21494.4 -21494.4 -45.7144 -0.897999 7.151300000000001 -5766.62 -5766.62 -5766.62 -45.7144 -0.897999 8.1513 -35521.7 -35521.7 -35521.7 -46.7144 -1.897999 7.151300000000001 -35616.6 -35616.6 -35616.6 -46.7144 -0.897999 7.151300000000001 10662.9 10662.9 10662.9 -46.7144 -0.897999 8.1513 18207.9 18207.9 18207.9 -47.7144 -3.897999 7.151300000000001 10099.9 10099.9 10099.9 -47.7144 -3.897999 8.1513 22130.5 22130.5 22130.5 -48.7144 -3.897999 8.1513 -135108.0 -135108.0 -135108.0 -45.7144 -3.897999 9.1513 10489.0 10489.0 10489.0 -45.7144 -3.897999 10.1513 -12337.6 -12337.6 -12337.6 -45.7144 -2.897999 9.1513 -7123.54 -7123.54 -7123.54 -45.7144 -2.897999 10.1513 690.779 690.779 690.779 -46.7144 -3.897999 9.1513 14076.1 14076.1 14076.1 -46.7144 -3.897999 10.1513 16127.5 16127.5 16127.5 -46.7144 -2.897999 9.1513 11226.4 11226.4 11226.4 -45.7144 -3.897999 11.1513 1151.1 1151.1 1151.1 -45.7144 -3.897999 12.1513 -2945.42 -2945.42 -2945.42 -45.7144 -2.897999 11.1513 -5921.72 -5921.72 -5921.72 -46.7144 -3.897999 11.1513 -2740.2 -2740.2 -2740.2 -46.7144 -3.897999 12.1513 1071.91 1071.91 1071.91 -46.7144 -2.897999 11.1513 -3835.51 -3835.51 -3835.51 -46.7144 -2.897999 12.1513 -1281.43 -1281.43 -1281.43 -45.7144 -1.897999 9.1513 -21762.2 -21762.2 -21762.2 -45.7144 -1.897999 10.1513 4889.29 4889.29 4889.29 -45.7144 -0.897999 9.1513 -9222.46 -9222.46 -9222.46 -46.7144 -0.897999 9.1513 -2611.37 -2611.37 -2611.37 -46.7144 -0.897999 10.1513 263.657 263.657 263.657 -45.7144 -1.897999 11.1513 -2147.46 -2147.46 -2147.46 -45.7144 -0.897999 11.1513 1265.55 1265.55 1265.55 -46.7144 -1.897999 11.1513 1485.2 1485.2 1485.2 -46.7144 -0.897999 11.1513 3354.9 3354.9 3354.9 -47.7144 -3.897999 9.1513 -10667.1 -10667.1 -10667.1 -47.7144 -3.897999 10.1513 1150.4 1150.4 1150.4 -47.7144 -2.897999 9.1513 10818.8 10818.8 10818.8 -48.7144 -3.897999 9.1513 -16195.3 -16195.3 -16195.3 -48.7144 -3.897999 10.1513 -21691.2 -21691.2 -21691.2 -47.7144 -3.897999 11.1513 -1134.6 -1134.6 -1134.6 -47.7144 -3.897999 12.1513 2472.49 2472.49 2472.49 -47.7144 -2.897999 11.1513 5124.73 5124.73 5124.73 -48.7144 -3.897999 11.1513 17585.9 17585.9 17585.9 -48.7144 -3.897999 12.1513 -511.088 -511.088 -511.088 -48.7144 -2.897999 11.1513 8333.3 8333.3 8333.3 -48.7144 -2.897999 12.1513 1162.44 1162.44 1162.44 -47.7144 -0.897999 10.1513 2001.85 2001.85 2001.85 -48.7144 -0.897999 10.1513 -2096.52 -2096.52 -2096.52 -47.7144 -1.897999 11.1513 -2032.04 -2032.04 -2032.04 -47.7144 -0.897999 11.1513 -2777.16 -2777.16 -2777.16 -48.7144 -1.897999 11.1513 12167.2 12167.2 12167.2 -48.7144 -1.897999 12.1513 176.642 176.642 176.642 -48.7144 -0.897999 11.1513 840.108 840.108 840.108 -48.7144 -0.897999 12.1513 -1989.24 -1989.24 -1989.24 -49.7144 -5.897999 8.1513 -79867.1 -79867.1 -79867.1 -49.7144 -4.897999 8.1513 -144921.0 -144921.0 -144921.0 -50.7144 -5.897999 8.1513 -43152.4 -43152.4 -43152.4 -50.7144 -4.897999 8.1513 167592.0 167592.0 167592.0 -51.7144 -5.897999 8.1513 -29438.2 -29438.2 -29438.2 -51.7144 -4.897999 8.1513 -43335.0 -43335.0 -43335.0 -49.7144 -6.897999 9.1513 149084.0 149084.0 149084.0 -49.7144 -6.897999 10.1513 -6684.72 -6684.72 -6684.72 -50.7144 -6.897999 9.1513 -30009.4 -30009.4 -30009.4 -50.7144 -6.897999 10.1513 -15607.5 -15607.5 -15607.5 -49.7144 -6.897999 11.1513 -6604.25 -6604.25 -6604.25 -49.7144 -6.897999 12.1513 -1346.92 -1346.92 -1346.92 -50.7144 -6.897999 11.1513 234.194 234.194 234.194 -50.7144 -6.897999 12.1513 3401.69 3401.69 3401.69 -49.7144 -5.897999 9.1513 185522.0 185522.0 185522.0 -50.7144 -5.897999 9.1513 22783.9 22783.9 22783.9 -50.7144 -5.897999 10.1513 -4860.16 -4860.16 -4860.16 -50.7144 -4.897999 10.1513 -3015.61 -3015.61 -3015.61 -49.7144 -5.897999 12.1513 -3389.17 -3389.17 -3389.17 -50.7144 -5.897999 11.1513 -1319.85 -1319.85 -1319.85 -50.7144 -5.897999 12.1513 -1038.23 -1038.23 -1038.23 -50.7144 -4.897999 11.1513 16806.1 16806.1 16806.1 -50.7144 -4.897999 12.1513 -7134.78 -7134.78 -7134.78 -51.7144 -5.897999 9.1513 18733.3 18733.3 18733.3 -51.7144 -5.897999 10.1513 6806.19 6806.19 6806.19 -51.7144 -4.897999 9.1513 2103.42 2103.42 2103.42 -51.7144 -4.897999 10.1513 9519.9 9519.9 9519.9 -51.7144 -5.897999 11.1513 -5236.11 -5236.11 -5236.11 -51.7144 -5.897999 12.1513 11930.4 11930.4 11930.4 -51.7144 -4.897999 11.1513 7544.14 7544.14 7544.14 -51.7144 -4.897999 12.1513 2629.07 2629.07 2629.07 -49.7144 -3.897999 8.1513 24842.6 24842.6 24842.6 -50.7144 -3.897999 8.1513 88556.8 88556.8 88556.8 -51.7144 -3.897999 8.1513 -65857.0 -65857.0 -65857.0 -49.7144 -3.897999 9.1513 -45499.1 -45499.1 -45499.1 -49.7144 -3.897999 10.1513 -14078.4 -14078.4 -14078.4 -49.7144 -2.897999 9.1513 -14931.5 -14931.5 -14931.5 -49.7144 -2.897999 10.1513 -34330.2 -34330.2 -34330.2 -50.7144 -3.897999 9.1513 6034.4 6034.4 6034.4 -50.7144 -3.897999 10.1513 -50195.7 -50195.7 -50195.7 -50.7144 -2.897999 9.1513 25126.5 25126.5 25126.5 -50.7144 -2.897999 10.1513 7448.43 7448.43 7448.43 -49.7144 -3.897999 11.1513 -4209.65 -4209.65 -4209.65 -49.7144 -3.897999 12.1513 -4748.2 -4748.2 -4748.2 -49.7144 -2.897999 11.1513 -3082.57 -3082.57 -3082.57 -49.7144 -2.897999 12.1513 -24245.4 -24245.4 -24245.4 -50.7144 -3.897999 11.1513 6808.3 6808.3 6808.3 -50.7144 -3.897999 12.1513 -7666.2 -7666.2 -7666.2 -50.7144 -2.897999 11.1513 -2843.8 -2843.8 -2843.8 -50.7144 -2.897999 12.1513 -11554.5 -11554.5 -11554.5 -49.7144 -0.897999 10.1513 1560.28 1560.28 1560.28 -50.7144 -0.897999 10.1513 -1822.68 -1822.68 -1822.68 -49.7144 -1.897999 11.1513 285.044 285.044 285.044 -49.7144 -1.897999 12.1513 1904.43 1904.43 1904.43 -49.7144 -0.897999 11.1513 1926.13 1926.13 1926.13 -49.7144 -0.897999 12.1513 1771.77 1771.77 1771.77 -50.7144 -0.897999 11.1513 -872.506 -872.506 -872.506 -50.7144 -0.897999 12.1513 -1833.65 -1833.65 -1833.65 -51.7144 -3.897999 9.1513 73253.9 73253.9 73253.9 -51.7144 -3.897999 10.1513 7794.9 7794.9 7794.9 -51.7144 -3.897999 11.1513 4983.93 4983.93 4983.93 -51.7144 -3.897999 12.1513 4609.81 4609.81 4609.81 -38.7144 -10.897999 14.1513 2659.49 2659.49 2659.49 -38.7144 -10.897999 15.1513 -9311.27 -9311.27 -9311.27 -37.7144 -9.897999 13.1513 -253497.0 -253497.0 -253497.0 -37.7144 -9.897999 14.1513 -141.832 -141.832 -141.832 -37.7144 -8.897999 13.1513 -79763.2 -79763.2 -79763.2 -37.7144 -8.897999 14.1513 -5659.6 -5659.6 -5659.6 -38.7144 -9.897999 13.1513 -1513.72 -1513.72 -1513.72 -38.7144 -9.897999 14.1513 209.515 209.515 209.515 -38.7144 -8.897999 13.1513 2981.72 2981.72 2981.72 -37.7144 -9.897999 15.1513 11108.9 11108.9 11108.9 -37.7144 -9.897999 16.1513 -2722.94 -2722.94 -2722.94 -37.7144 -8.897999 15.1513 -1058.07 -1058.07 -1058.07 -37.7144 -8.897999 16.1513 4117.19 4117.19 4117.19 -38.7144 -9.897999 15.1513 5223.14 5223.14 5223.14 -38.7144 -9.897999 16.1513 -3107.6 -3107.6 -3107.6 -38.7144 -8.897999 15.1513 -5136.93 -5136.93 -5136.93 -38.7144 -8.897999 16.1513 -2670.01 -2670.01 -2670.01 -39.7144 -10.897999 14.1513 -5637.84 -5637.84 -5637.84 -39.7144 -10.897999 15.1513 -3095.94 -3095.94 -3095.94 -39.7144 -9.897999 13.1513 8110.03 8110.03 8110.03 -39.7144 -9.897999 14.1513 -4621.29 -4621.29 -4621.29 -39.7144 -8.897999 13.1513 19365.9 19365.9 19365.9 -39.7144 -8.897999 14.1513 639.737 639.737 639.737 -40.7144 -9.897999 13.1513 200385.0 200385.0 200385.0 -40.7144 -9.897999 14.1513 47703.0 47703.0 47703.0 -40.7144 -8.897999 13.1513 7118.31 7118.31 7118.31 -40.7144 -8.897999 14.1513 13236.1 13236.1 13236.1 -39.7144 -9.897999 15.1513 4972.56 4972.56 4972.56 -39.7144 -9.897999 16.1513 -1419.97 -1419.97 -1419.97 -39.7144 -8.897999 15.1513 -111.369 -111.369 -111.369 -39.7144 -8.897999 16.1513 1614.0 1614.0 1614.0 -40.7144 -9.897999 15.1513 17561.0 17561.0 17561.0 -40.7144 -8.897999 15.1513 1188.12 1188.12 1188.12 -41.7144 -10.897999 13.1513 -178591.0 -178591.0 -178591.0 -41.7144 -9.897999 13.1513 -60321.8 -60321.8 -60321.8 -41.7144 -8.897999 13.1513 12374.9 12374.9 12374.9 -37.7144 -7.897999 13.1513 23435.0 23435.0 23435.0 -37.7144 -7.897999 14.1513 9595.6 9595.6 9595.6 -37.7144 -6.897999 13.1513 9049.56 9049.56 9049.56 -37.7144 -6.897999 14.1513 13616.0 13616.0 13616.0 -38.7144 -7.897999 13.1513 6648.4 6648.4 6648.4 -38.7144 -7.897999 14.1513 16025.8 16025.8 16025.8 -38.7144 -6.897999 13.1513 -4305.18 -4305.18 -4305.18 -38.7144 -6.897999 14.1513 27247.7 27247.7 27247.7 -37.7144 -7.897999 15.1513 -12679.0 -12679.0 -12679.0 -38.7144 -7.897999 15.1513 6822.02 6822.02 6822.02 -38.7144 -7.897999 16.1513 59.6202 59.6202 59.6202 -38.7144 -6.897999 15.1513 -13631.9 -13631.9 -13631.9 -37.7144 -5.897999 13.1513 -7879.15 -7879.15 -7879.15 -37.7144 -5.897999 14.1513 -1092.59 -1092.59 -1092.59 -37.7144 -4.897999 13.1513 -492.142 -492.142 -492.142 -37.7144 -4.897999 14.1513 11958.5 11958.5 11958.5 -38.7144 -5.897999 13.1513 380.565 380.565 380.565 -38.7144 -5.897999 14.1513 11989.7 11989.7 11989.7 -38.7144 -4.897999 13.1513 3480.13 3480.13 3480.13 -38.7144 -4.897999 14.1513 2901.47 2901.47 2901.47 -37.7144 -4.897999 15.1513 2597.38 2597.38 2597.38 -38.7144 -5.897999 15.1513 -3571.54 -3571.54 -3571.54 -38.7144 -4.897999 15.1513 3713.87 3713.87 3713.87 -39.7144 -7.897999 13.1513 -2621.41 -2621.41 -2621.41 -39.7144 -7.897999 14.1513 -6339.14 -6339.14 -6339.14 -39.7144 -6.897999 14.1513 49095.8 49095.8 49095.8 -40.7144 -7.897999 13.1513 -7414.56 -7414.56 -7414.56 -40.7144 -7.897999 14.1513 3559.12 3559.12 3559.12 -40.7144 -6.897999 13.1513 -8627.87 -8627.87 -8627.87 -40.7144 -6.897999 14.1513 -36047.7 -36047.7 -36047.7 -39.7144 -7.897999 15.1513 -12394.4 -12394.4 -12394.4 -39.7144 -7.897999 16.1513 -558.464 -558.464 -558.464 -39.7144 -6.897999 15.1513 21497.1 21497.1 21497.1 -40.7144 -7.897999 15.1513 -2052.08 -2052.08 -2052.08 -40.7144 -6.897999 15.1513 -13717.0 -13717.0 -13717.0 -39.7144 -5.897999 14.1513 6945.12 6945.12 6945.12 -39.7144 -4.897999 13.1513 27186.9 27186.9 27186.9 -39.7144 -4.897999 14.1513 110667.0 110667.0 110667.0 -40.7144 -5.897999 13.1513 -78072.4 -78072.4 -78072.4 -40.7144 -5.897999 14.1513 -107888.0 -107888.0 -107888.0 -40.7144 -4.897999 13.1513 12202.4 12202.4 12202.4 -40.7144 -4.897999 14.1513 22282.9 22282.9 22282.9 -39.7144 -5.897999 15.1513 -28378.9 -28378.9 -28378.9 -39.7144 -4.897999 15.1513 72513.3 72513.3 72513.3 -39.7144 -4.897999 16.1513 421.146 421.146 421.146 -40.7144 -5.897999 15.1513 21498.7 21498.7 21498.7 -40.7144 -5.897999 16.1513 -52569.0 -52569.0 -52569.0 -40.7144 -4.897999 16.1513 12361.0 12361.0 12361.0 -39.7144 -4.897999 17.1513 20005.2 20005.2 20005.2 -39.7144 -4.897999 18.1513 -20113.2 -20113.2 -20113.2 -40.7144 -5.897999 17.1513 -59616.5 -59616.5 -59616.5 -40.7144 -5.897999 18.1513 51348.1 51348.1 51348.1 -40.7144 -4.897999 17.1513 -39070.3 -39070.3 -39070.3 -40.7144 -4.897999 18.1513 -55237.2 -55237.2 -55237.2 -39.7144 -4.897999 19.1513 -4733.05 -4733.05 -4733.05 -39.7144 -4.897999 20.1513 9082.57 9082.57 9082.57 -40.7144 -5.897999 19.1513 3775.53 3775.53 3775.53 -40.7144 -5.897999 20.1513 19810.1 19810.1 19810.1 -40.7144 -4.897999 19.1513 -24031.5 -24031.5 -24031.5 -40.7144 -4.897999 20.1513 10567.6 10567.6 10567.6 -37.7144 -3.897999 13.1513 42870.6 42870.6 42870.6 -37.7144 -3.897999 14.1513 73259.3 73259.3 73259.3 -37.7144 -2.897999 13.1513 -67481.9 -67481.9 -67481.9 -37.7144 -2.897999 14.1513 46406.1 46406.1 46406.1 -38.7144 -2.897999 13.1513 26167.6 26167.6 26167.6 -38.7144 -2.897999 14.1513 16065.1 16065.1 16065.1 -37.7144 -3.897999 15.1513 14252.4 14252.4 14252.4 -37.7144 -2.897999 15.1513 13120.7 13120.7 13120.7 -38.7144 -3.897999 15.1513 1023.04 1023.04 1023.04 -38.7144 -2.897999 15.1513 1884.53 1884.53 1884.53 -37.7144 -1.897999 13.1513 -49067.1 -49067.1 -49067.1 -37.7144 -1.897999 14.1513 -52081.5 -52081.5 -52081.5 -38.7144 -1.897999 13.1513 -2106.42 -2106.42 -2106.42 -38.7144 -1.897999 14.1513 -14743.1 -14743.1 -14743.1 -37.7144 -1.897999 15.1513 -7010.42 -7010.42 -7010.42 -37.7144 -1.897999 16.1513 1838.62 1838.62 1838.62 -37.7144 -0.897999 16.1513 2684.03 2684.03 2684.03 -38.7144 -1.897999 15.1513 5890.13 5890.13 5890.13 -38.7144 -1.897999 16.1513 345.052 345.052 345.052 -38.7144 -0.897999 15.1513 -4297.37 -4297.37 -4297.37 -38.7144 -0.897999 16.1513 -404.983 -404.983 -404.983 -39.7144 -3.897999 13.1513 -1600.87 -1600.87 -1600.87 -39.7144 -3.897999 14.1513 1893.09 1893.09 1893.09 -39.7144 -2.897999 13.1513 5767.0 5767.0 5767.0 -39.7144 -2.897999 14.1513 1912.97 1912.97 1912.97 -40.7144 -3.897999 13.1513 -1604.6 -1604.6 -1604.6 -40.7144 -3.897999 14.1513 1445.04 1445.04 1445.04 -40.7144 -2.897999 14.1513 -1845.93 -1845.93 -1845.93 -39.7144 -3.897999 15.1513 -3199.32 -3199.32 -3199.32 -39.7144 -3.897999 16.1513 1662.95 1662.95 1662.95 -39.7144 -2.897999 15.1513 4926.47 4926.47 4926.47 -39.7144 -2.897999 16.1513 4370.43 4370.43 4370.43 -40.7144 -3.897999 16.1513 78605.8 78605.8 78605.8 -40.7144 -2.897999 16.1513 -2950.03 -2950.03 -2950.03 -39.7144 -1.897999 13.1513 -5967.77 -5967.77 -5967.77 -39.7144 -1.897999 14.1513 8058.25 8058.25 8058.25 -39.7144 -0.897999 13.1513 -2852.15 -2852.15 -2852.15 -39.7144 -0.897999 14.1513 -300.586 -300.586 -300.586 -40.7144 -0.897999 13.1513 4605.38 4605.38 4605.38 -40.7144 -0.897999 14.1513 6119.87 6119.87 6119.87 -39.7144 -1.897999 15.1513 5011.71 5011.71 5011.71 -39.7144 -1.897999 16.1513 -875.396 -875.396 -875.396 -39.7144 -0.897999 15.1513 2072.6 2072.6 2072.6 -39.7144 -0.897999 16.1513 -525.986 -525.986 -525.986 -40.7144 -1.897999 16.1513 -6645.62 -6645.62 -6645.62 -40.7144 -0.897999 15.1513 7787.45 7787.45 7787.45 -40.7144 -0.897999 16.1513 1063.97 1063.97 1063.97 -37.7144 -3.897999 18.1513 -6343.93 -6343.93 -6343.93 -37.7144 -2.897999 17.1513 3690.48 3690.48 3690.48 -37.7144 -2.897999 18.1513 -1651.11 -1651.11 -1651.11 -38.7144 -3.897999 17.1513 -839.454 -839.454 -839.454 -38.7144 -3.897999 18.1513 -5246.4 -5246.4 -5246.4 -38.7144 -2.897999 17.1513 6806.92 6806.92 6806.92 -38.7144 -2.897999 18.1513 -5557.67 -5557.67 -5557.67 -37.7144 -3.897999 19.1513 72.1817 72.1817 72.1817 -37.7144 -2.897999 19.1513 -3582.24 -3582.24 -3582.24 -37.7144 -2.897999 20.1513 829.933 829.933 829.933 -38.7144 -3.897999 19.1513 587.255 587.255 587.255 -38.7144 -3.897999 20.1513 9973.61 9973.61 9973.61 -38.7144 -2.897999 20.1513 5223.2 5223.2 5223.2 -37.7144 -1.897999 17.1513 -1056.78 -1056.78 -1056.78 -37.7144 -1.897999 18.1513 5766.77 5766.77 5766.77 -37.7144 -0.897999 17.1513 -1485.34 -1485.34 -1485.34 -37.7144 -0.897999 18.1513 -3984.0 -3984.0 -3984.0 -38.7144 -1.897999 17.1513 5297.07 5297.07 5297.07 -38.7144 -1.897999 18.1513 997.98 997.98 997.98 -38.7144 -0.897999 17.1513 206.652 206.652 206.652 -38.7144 -0.897999 18.1513 -1312.18 -1312.18 -1312.18 -37.7144 -1.897999 19.1513 12104.3 12104.3 12104.3 -37.7144 -1.897999 20.1513 3.55222 3.55222 3.55222 -38.7144 -1.897999 20.1513 1989.67 1989.67 1989.67 -39.7144 -3.897999 17.1513 11779.4 11779.4 11779.4 -39.7144 -3.897999 18.1513 42532.8 42532.8 42532.8 -39.7144 -2.897999 17.1513 2290.77 2290.77 2290.77 -40.7144 -3.897999 17.1513 52915.2 52915.2 52915.2 -40.7144 -2.897999 17.1513 2724.98 2724.98 2724.98 -39.7144 -3.897999 19.1513 4754.86 4754.86 4754.86 -39.7144 -3.897999 20.1513 2728.18 2728.18 2728.18 -39.7144 -2.897999 20.1513 -9387.84 -9387.84 -9387.84 -40.7144 -3.897999 20.1513 5274.69 5274.69 5274.69 -40.7144 -2.897999 20.1513 -4451.7 -4451.7 -4451.7 -39.7144 -1.897999 17.1513 -4981.68 -4981.68 -4981.68 -39.7144 -0.897999 17.1513 -3221.29 -3221.29 -3221.29 -40.7144 -1.897999 17.1513 -5849.7 -5849.7 -5849.7 -40.7144 -0.897999 17.1513 1967.53 1967.53 1967.53 -40.7144 -0.897999 18.1513 3229.76 3229.76 3229.76 -39.7144 -1.897999 20.1513 912.886 912.886 912.886 -39.7144 -0.897999 20.1513 14758.9 14758.9 14758.9 -40.7144 -1.897999 19.1513 9390.34 9390.34 9390.34 -40.7144 -1.897999 20.1513 -4038.66 -4038.66 -4038.66 -40.7144 -0.897999 19.1513 7437.57 7437.57 7437.57 -40.7144 -0.897999 20.1513 1445.77 1445.77 1445.77 -41.7144 -6.897999 13.1513 -51576.5 -51576.5 -51576.5 -41.7144 -6.897999 14.1513 862.84 862.84 862.84 -41.7144 -5.897999 13.1513 -57914.3 -57914.3 -57914.3 -41.7144 -5.897999 14.1513 -30832.9 -30832.9 -30832.9 -41.7144 -5.897999 16.1513 18088.2 18088.2 18088.2 -41.7144 -4.897999 16.1513 54972.2 54972.2 54972.2 -42.7144 -5.897999 16.1513 18622.2 18622.2 18622.2 -42.7144 -4.897999 16.1513 27481.5 27481.5 27481.5 -41.7144 -5.897999 17.1513 -37893.8 -37893.8 -37893.8 -41.7144 -5.897999 18.1513 -31060.8 -31060.8 -31060.8 -41.7144 -4.897999 18.1513 -40406.9 -40406.9 -40406.9 -42.7144 -5.897999 17.1513 -17954.5 -17954.5 -17954.5 -42.7144 -5.897999 18.1513 -1320.74 -1320.74 -1320.74 -42.7144 -4.897999 17.1513 -6219.8 -6219.8 -6219.8 -42.7144 -4.897999 18.1513 -418.655 -418.655 -418.655 -41.7144 -5.897999 19.1513 -10127.3 -10127.3 -10127.3 -41.7144 -5.897999 20.1513 1198.69 1198.69 1198.69 -41.7144 -4.897999 20.1513 10603.3 10603.3 10603.3 -42.7144 -5.897999 19.1513 1845.73 1845.73 1845.73 -42.7144 -5.897999 20.1513 -9630.58 -9630.58 -9630.58 -42.7144 -4.897999 19.1513 -6053.05 -6053.05 -6053.05 -42.7144 -4.897999 20.1513 -6372.15 -6372.15 -6372.15 -43.7144 -4.897999 19.1513 3113.0 3113.0 3113.0 -43.7144 -4.897999 20.1513 -1294.1 -1294.1 -1294.1 -41.7144 -3.897999 15.1513 -14405.5 -14405.5 -14405.5 -41.7144 -3.897999 16.1513 -43571.7 -43571.7 -43571.7 -41.7144 -2.897999 16.1513 14645.1 14645.1 14645.1 -42.7144 -3.897999 16.1513 11312.7 11312.7 11312.7 -42.7144 -2.897999 16.1513 12935.2 12935.2 12935.2 -41.7144 -0.897999 13.1513 -24229.2 -24229.2 -24229.2 -41.7144 -0.897999 14.1513 -36574.8 -36574.8 -36574.8 -42.7144 -1.897999 14.1513 71001.4 71001.4 71001.4 -42.7144 -0.897999 14.1513 12680.0 12680.0 12680.0 -41.7144 -1.897999 16.1513 -14546.2 -14546.2 -14546.2 -41.7144 -0.897999 15.1513 -4779.18 -4779.18 -4779.18 -41.7144 -0.897999 16.1513 2113.83 2113.83 2113.83 -42.7144 -1.897999 15.1513 -5710.03 -5710.03 -5710.03 -42.7144 -1.897999 16.1513 -14157.2 -14157.2 -14157.2 -42.7144 -0.897999 15.1513 1058.66 1058.66 1058.66 -42.7144 -0.897999 16.1513 -1811.0 -1811.0 -1811.0 -43.7144 -3.897999 13.1513 -7705.81 -7705.81 -7705.81 -43.7144 -2.897999 13.1513 -40135.3 -40135.3 -40135.3 -43.7144 -2.897999 14.1513 105288.0 105288.0 105288.0 -44.7144 -3.897999 13.1513 -3127.82 -3127.82 -3127.82 -44.7144 -2.897999 13.1513 -8524.73 -8524.73 -8524.73 -44.7144 -2.897999 14.1513 -5160.22 -5160.22 -5160.22 -43.7144 -2.897999 15.1513 9295.48 9295.48 9295.48 -43.7144 -2.897999 16.1513 -10345.8 -10345.8 -10345.8 -44.7144 -3.897999 15.1513 1395.17 1395.17 1395.17 -44.7144 -3.897999 16.1513 -455.061 -455.061 -455.061 -44.7144 -2.897999 15.1513 4800.66 4800.66 4800.66 -44.7144 -2.897999 16.1513 -2280.82 -2280.82 -2280.82 -43.7144 -1.897999 13.1513 25133.7 25133.7 25133.7 -43.7144 -1.897999 14.1513 64346.8 64346.8 64346.8 -43.7144 -0.897999 13.1513 -42254.7 -42254.7 -42254.7 -43.7144 -0.897999 14.1513 -4553.46 -4553.46 -4553.46 -44.7144 -1.897999 13.1513 -7414.6 -7414.6 -7414.6 -44.7144 -1.897999 14.1513 -4692.3 -4692.3 -4692.3 -44.7144 -0.897999 13.1513 -6410.3 -6410.3 -6410.3 -44.7144 -0.897999 14.1513 5236.51 5236.51 5236.51 -43.7144 -1.897999 15.1513 3462.0 3462.0 3462.0 -43.7144 -1.897999 16.1513 538.795 538.795 538.795 -43.7144 -0.897999 16.1513 8128.49 8128.49 8128.49 -44.7144 -1.897999 15.1513 935.518 935.518 935.518 -44.7144 -0.897999 15.1513 -266.833 -266.833 -266.833 -44.7144 -0.897999 16.1513 -5390.48 -5390.48 -5390.48 -41.7144 -2.897999 17.1513 6423.07 6423.07 6423.07 -42.7144 -3.897999 17.1513 7694.76 7694.76 7694.76 -42.7144 -3.897999 18.1513 3044.06 3044.06 3044.06 -42.7144 -2.897999 17.1513 7066.9 7066.9 7066.9 -42.7144 -2.897999 18.1513 -874.014 -874.014 -874.014 -41.7144 -2.897999 19.1513 -4116.4 -4116.4 -4116.4 -41.7144 -2.897999 20.1513 -3277.77 -3277.77 -3277.77 -42.7144 -3.897999 19.1513 -13468.2 -13468.2 -13468.2 -42.7144 -3.897999 20.1513 -7151.66 -7151.66 -7151.66 -42.7144 -2.897999 19.1513 4384.27 4384.27 4384.27 -42.7144 -2.897999 20.1513 8609.44 8609.44 8609.44 -41.7144 -1.897999 17.1513 -11553.5 -11553.5 -11553.5 -41.7144 -1.897999 18.1513 7488.75 7488.75 7488.75 -41.7144 -0.897999 17.1513 337.476 337.476 337.476 -41.7144 -0.897999 18.1513 5647.29 5647.29 5647.29 -42.7144 -1.897999 17.1513 12063.9 12063.9 12063.9 -42.7144 -1.897999 18.1513 8616.74 8616.74 8616.74 -42.7144 -0.897999 17.1513 -9784.05 -9784.05 -9784.05 -41.7144 -1.897999 19.1513 8383.84 8383.84 8383.84 -41.7144 -1.897999 20.1513 -6313.85 -6313.85 -6313.85 -41.7144 -0.897999 19.1513 -4716.9 -4716.9 -4716.9 -42.7144 -1.897999 19.1513 10209.4 10209.4 10209.4 -43.7144 -2.897999 17.1513 -4477.77 -4477.77 -4477.77 -44.7144 -3.897999 17.1513 1082.95 1082.95 1082.95 -44.7144 -2.897999 17.1513 2511.47 2511.47 2511.47 -43.7144 -3.897999 19.1513 8951.3 8951.3 8951.3 -43.7144 -1.897999 17.1513 -1165.01 -1165.01 -1165.01 -43.7144 -0.897999 17.1513 2255.99 2255.99 2255.99 -44.7144 -1.897999 17.1513 -5836.35 -5836.35 -5836.35 -44.7144 -0.897999 17.1513 1080.6 1080.6 1080.6 -40.7144 -4.897999 21.1513 7962.75 7962.75 7962.75 -37.7144 -2.897999 21.1513 3411.88 3411.88 3411.88 -37.7144 -1.897999 21.1513 -1407.01 -1407.01 -1407.01 -37.7144 -1.897999 22.1513 543.3 543.3 543.3 -38.7144 -1.897999 21.1513 -7665.66 -7665.66 -7665.66 -38.7144 -1.897999 22.1513 -6476.19 -6476.19 -6476.19 -38.7144 -0.897999 21.1513 -5744.62 -5744.62 -5744.62 -38.7144 -0.897999 22.1513 -3656.39 -3656.39 -3656.39 -37.7144 -1.897999 23.1513 -228.129 -228.129 -228.129 -37.7144 -0.897999 23.1513 -789.66 -789.66 -789.66 -38.7144 -1.897999 23.1513 -4862.05 -4862.05 -4862.05 -38.7144 -0.897999 23.1513 -68.6564 -68.6564 -68.6564 -40.7144 -3.897999 21.1513 9919.08 9919.08 9919.08 -40.7144 -2.897999 21.1513 2986.62 2986.62 2986.62 -39.7144 -1.897999 21.1513 5055.96 5055.96 5055.96 -39.7144 -0.897999 21.1513 -5558.13 -5558.13 -5558.13 -40.7144 -1.897999 21.1513 2203.59 2203.59 2203.59 -41.7144 -4.897999 21.1513 -12331.0 -12331.0 -12331.0 -42.7144 -4.897999 21.1513 3309.47 3309.47 3309.47 -41.7144 -3.897999 21.1513 1133.64 1133.64 1133.64 -41.7144 -2.897999 21.1513 4951.32 4951.32 4951.32 -42.7144 -3.897999 21.1513 -5184.89 -5184.89 -5184.89 -42.7144 -2.897999 21.1513 -2602.01 -2602.01 -2602.01 -41.7144 -1.897999 21.1513 1616.24 1616.24 1616.24 -48.7144 -6.897999 13.1513 -1585.25 -1585.25 -1585.25 -47.7144 -5.897999 13.1513 3218.59 3218.59 3218.59 -47.7144 -4.897999 13.1513 2211.27 2211.27 2211.27 -48.7144 -5.897999 13.1513 -4055.5 -4055.5 -4055.5 -48.7144 -4.897999 13.1513 46.7205 46.7205 46.7205 -45.7144 -3.897999 13.1513 -2947.57 -2947.57 -2947.57 -45.7144 -2.897999 13.1513 169.452 169.452 169.452 -45.7144 -2.897999 14.1513 4258.2 4258.2 4258.2 -46.7144 -3.897999 13.1513 -2099.72 -2099.72 -2099.72 -46.7144 -2.897999 13.1513 -1021.82 -1021.82 -1021.82 -46.7144 -2.897999 14.1513 -3269.07 -3269.07 -3269.07 -45.7144 -3.897999 15.1513 -1688.2 -1688.2 -1688.2 -45.7144 -3.897999 16.1513 916.393 916.393 916.393 -45.7144 -2.897999 15.1513 5861.65 5861.65 5861.65 -45.7144 -2.897999 16.1513 -11873.0 -11873.0 -11873.0 -46.7144 -2.897999 15.1513 1204.98 1204.98 1204.98 -46.7144 -2.897999 16.1513 -734.662 -734.662 -734.662 -45.7144 -1.897999 14.1513 8181.38 8181.38 8181.38 -45.7144 -0.897999 14.1513 8093.88 8093.88 8093.88 -46.7144 -1.897999 14.1513 1239.18 1239.18 1239.18 -46.7144 -0.897999 14.1513 2560.1 2560.1 2560.1 -45.7144 -1.897999 15.1513 -5610.5 -5610.5 -5610.5 -45.7144 -0.897999 15.1513 -1122.62 -1122.62 -1122.62 -45.7144 -0.897999 16.1513 -5312.55 -5312.55 -5312.55 -46.7144 -1.897999 15.1513 -3603.16 -3603.16 -3603.16 -46.7144 -1.897999 16.1513 -2762.82 -2762.82 -2762.82 -46.7144 -0.897999 15.1513 84.1244 84.1244 84.1244 -46.7144 -0.897999 16.1513 -1733.69 -1733.69 -1733.69 -47.7144 -3.897999 13.1513 -2199.82 -2199.82 -2199.82 -47.7144 -3.897999 14.1513 565.412 565.412 565.412 -47.7144 -2.897999 14.1513 1315.82 1315.82 1315.82 -48.7144 -3.897999 13.1513 -2475.7 -2475.7 -2475.7 -48.7144 -3.897999 14.1513 -636.113 -636.113 -636.113 -48.7144 -2.897999 13.1513 -1871.93 -1871.93 -1871.93 -48.7144 -2.897999 14.1513 -443.675 -443.675 -443.675 -47.7144 -1.897999 14.1513 919.745 919.745 919.745 -47.7144 -0.897999 14.1513 1024.45 1024.45 1024.45 -48.7144 -1.897999 13.1513 -1089.45 -1089.45 -1089.45 -48.7144 -1.897999 14.1513 127.367 127.367 127.367 -48.7144 -0.897999 13.1513 9461.96 9461.96 9461.96 -48.7144 -0.897999 14.1513 8242.62 8242.62 8242.62 -47.7144 -0.897999 15.1513 -595.526 -595.526 -595.526 -47.7144 -0.897999 16.1513 1316.67 1316.67 1316.67 -48.7144 -0.897999 16.1513 -244.684 -244.684 -244.684 -45.7144 -3.897999 17.1513 -1685.61 -1685.61 -1685.61 -45.7144 -2.897999 17.1513 4646.71 4646.71 4646.71 -46.7144 -2.897999 17.1513 166.981 166.981 166.981 -45.7144 -1.897999 17.1513 -1638.21 -1638.21 -1638.21 -45.7144 -0.897999 17.1513 -3746.5 -3746.5 -3746.5 -45.7144 -0.897999 18.1513 -1586.03 -1586.03 -1586.03 -46.7144 -1.897999 17.1513 -2435.67 -2435.67 -2435.67 -46.7144 -0.897999 17.1513 923.876 923.876 923.876 -46.7144 -0.897999 18.1513 -27.5063 -27.5063 -27.5063 -47.7144 -0.897999 17.1513 1969.24 1969.24 1969.24 -47.7144 -0.897999 18.1513 -116.626 -116.626 -116.626 -48.7144 -0.897999 17.1513 -1492.6 -1492.6 -1492.6 -49.7144 -6.897999 13.1513 2779.53 2779.53 2779.53 -49.7144 -5.897999 13.1513 -3648.08 -3648.08 -3648.08 -49.7144 -4.897999 13.1513 -7865.44 -7865.44 -7865.44 -50.7144 -5.897999 13.1513 -5946.62 -5946.62 -5946.62 -50.7144 -4.897999 13.1513 221.186 221.186 221.186 -51.7144 -4.897999 13.1513 16132.7 16132.7 16132.7 -49.7144 -3.897999 13.1513 1702.65 1702.65 1702.65 -49.7144 -2.897999 13.1513 1136.66 1136.66 1136.66 -49.7144 -2.897999 14.1513 180.446 180.446 180.446 -50.7144 -3.897999 13.1513 -3194.91 -3194.91 -3194.91 -49.7144 -1.897999 13.1513 -36.0718 -36.0718 -36.0718 -49.7144 -1.897999 14.1513 -104.74 -104.74 -104.74 -49.7144 -0.897999 13.1513 -1513.66 -1513.66 -1513.66 -49.7144 -0.897999 14.1513 11844.3 11844.3 11844.3 -50.7144 -0.897999 13.1513 -3183.8 -3183.8 -3183.8 -50.7144 -0.897999 14.1513 -6906.53 -6906.53 -6906.53 -51.7144 -3.897999 13.1513 112.909 112.909 112.909 -37.7144 0.10200100000000001 -0.8486999999999991 3270.18 3270.18 3270.18 -37.7144 0.10200100000000001 0.15130000000000088 4041.21 4041.21 4041.21 -37.7144 1.102001 -0.8486999999999991 4552.31 4552.31 4552.31 -37.7144 1.102001 0.15130000000000088 -4795.0 -4795.0 -4795.0 -38.7144 0.10200100000000001 -0.8486999999999991 -259.25 -259.25 -259.25 -38.7144 1.102001 -0.8486999999999991 -9027.63 -9027.63 -9027.63 -38.7144 1.102001 0.15130000000000088 -12296.4 -12296.4 -12296.4 -37.7144 3.102001 -1.8486999999999991 12177.8 12177.8 12177.8 -37.7144 2.102001 0.15130000000000088 6258.57 6258.57 6258.57 -37.7144 3.102001 -0.8486999999999991 -9897.96 -9897.96 -9897.96 -37.7144 3.102001 0.15130000000000088 1541.7 1541.7 1541.7 -39.7144 0.10200100000000001 -0.8486999999999991 6466.2 6466.2 6466.2 -39.7144 0.10200100000000001 0.15130000000000088 -2881.06 -2881.06 -2881.06 -39.7144 1.102001 -0.8486999999999991 -414.922 -414.922 -414.922 -39.7144 1.102001 0.15130000000000088 -2205.34 -2205.34 -2205.34 -40.7144 0.10200100000000001 0.15130000000000088 -562.817 -562.817 -562.817 -37.7144 0.10200100000000001 1.1513000000000009 4788.33 4788.33 4788.33 -37.7144 1.102001 1.1513000000000009 1786.67 1786.67 1786.67 -37.7144 1.102001 2.151300000000001 9460.37 9460.37 9460.37 -38.7144 0.10200100000000001 2.151300000000001 -40880.4 -40880.4 -40880.4 -38.7144 1.102001 1.1513000000000009 6682.05 6682.05 6682.05 -38.7144 1.102001 2.151300000000001 16064.3 16064.3 16064.3 -37.7144 0.10200100000000001 4.151300000000001 -15019.4 -15019.4 -15019.4 -37.7144 1.102001 3.151300000000001 6379.42 6379.42 6379.42 -37.7144 1.102001 4.151300000000001 -550.129 -550.129 -550.129 -38.7144 0.10200100000000001 4.151300000000001 -61289.9 -61289.9 -61289.9 -38.7144 1.102001 3.151300000000001 5179.16 5179.16 5179.16 -37.7144 3.102001 1.1513000000000009 -14537.4 -14537.4 -14537.4 -37.7144 3.102001 2.151300000000001 62792.6 62792.6 62792.6 -38.7144 2.102001 2.151300000000001 -18250.9 -18250.9 -18250.9 -38.7144 3.102001 1.1513000000000009 -13642.2 -13642.2 -13642.2 -38.7144 3.102001 2.151300000000001 189598.0 189598.0 189598.0 -37.7144 2.102001 3.151300000000001 -70700.0 -70700.0 -70700.0 -37.7144 2.102001 4.151300000000001 -15512.0 -15512.0 -15512.0 -37.7144 3.102001 3.151300000000001 36169.3 36169.3 36169.3 -37.7144 3.102001 4.151300000000001 -24895.9 -24895.9 -24895.9 -38.7144 2.102001 3.151300000000001 -24173.4 -24173.4 -24173.4 -38.7144 3.102001 3.151300000000001 -1210.58 -1210.58 -1210.58 -38.7144 3.102001 4.151300000000001 -94318.8 -94318.8 -94318.8 -39.7144 0.10200100000000001 1.1513000000000009 -6868.27 -6868.27 -6868.27 -39.7144 0.10200100000000001 2.151300000000001 -72228.2 -72228.2 -72228.2 -39.7144 1.102001 1.1513000000000009 23154.7 23154.7 23154.7 -39.7144 1.102001 2.151300000000001 22590.1 22590.1 22590.1 -40.7144 0.10200100000000001 1.1513000000000009 -18776.4 -18776.4 -18776.4 -40.7144 0.10200100000000001 2.151300000000001 49507.5 49507.5 49507.5 -40.7144 1.102001 2.151300000000001 2080.16 2080.16 2080.16 -40.7144 0.10200100000000001 3.151300000000001 -8561.37 -8561.37 -8561.37 -40.7144 0.10200100000000001 4.151300000000001 87731.8 87731.8 87731.8 -40.7144 1.102001 3.151300000000001 832.886 832.886 832.886 -39.7144 2.102001 2.151300000000001 1220.11 1220.11 1220.11 -40.7144 2.102001 2.151300000000001 23005.9 23005.9 23005.9 -40.7144 3.102001 2.151300000000001 33.5048 33.5048 33.5048 -39.7144 2.102001 3.151300000000001 17076.1 17076.1 17076.1 -39.7144 3.102001 3.151300000000001 2510.19 2510.19 2510.19 -39.7144 3.102001 4.151300000000001 -16763.3 -16763.3 -16763.3 -40.7144 2.102001 3.151300000000001 16983.5 16983.5 16983.5 -40.7144 3.102001 3.151300000000001 133.775 133.775 133.775 -40.7144 3.102001 4.151300000000001 2691.98 2691.98 2691.98 -37.7144 4.102001 -1.8486999999999991 5846.32 5846.32 5846.32 -37.7144 4.102001 -0.8486999999999991 2831.18 2831.18 2831.18 -37.7144 4.102001 0.15130000000000088 12834.4 12834.4 12834.4 -37.7144 5.102001 -0.8486999999999991 -28814.2 -28814.2 -28814.2 -37.7144 5.102001 0.15130000000000088 -14069.4 -14069.4 -14069.4 -37.7144 4.102001 1.1513000000000009 5352.18 5352.18 5352.18 -37.7144 5.102001 1.1513000000000009 -1512.88 -1512.88 -1512.88 -37.7144 5.102001 2.151300000000001 -28161.9 -28161.9 -28161.9 -38.7144 4.102001 1.1513000000000009 17078.2 17078.2 17078.2 -38.7144 4.102001 2.151300000000001 10922.6 10922.6 10922.6 -38.7144 5.102001 1.1513000000000009 4652.9 4652.9 4652.9 -38.7144 5.102001 2.151300000000001 30261.0 30261.0 30261.0 -37.7144 4.102001 3.151300000000001 54965.6 54965.6 54965.6 -37.7144 5.102001 3.151300000000001 -5228.54 -5228.54 -5228.54 -38.7144 4.102001 3.151300000000001 74042.4 74042.4 74042.4 -38.7144 4.102001 4.151300000000001 41930.3 41930.3 41930.3 -38.7144 5.102001 3.151300000000001 24580.4 24580.4 24580.4 -38.7144 5.102001 4.151300000000001 8631.25 8631.25 8631.25 -37.7144 6.102001 1.1513000000000009 8577.43 8577.43 8577.43 -37.7144 6.102001 2.151300000000001 1165.36 1165.36 1165.36 -37.7144 6.102001 3.151300000000001 1209.84 1209.84 1209.84 -37.7144 6.102001 4.151300000000001 -699.072 -699.072 -699.072 -37.7144 7.102001 4.151300000000001 -291.061 -291.061 -291.061 -38.7144 6.102001 4.151300000000001 -1255.82 -1255.82 -1255.82 -38.7144 7.102001 4.151300000000001 569.064 569.064 569.064 -39.7144 4.102001 4.151300000000001 -8660.04 -8660.04 -8660.04 -39.7144 5.102001 4.151300000000001 7497.94 7497.94 7497.94 -40.7144 4.102001 3.151300000000001 -949.601 -949.601 -949.601 -40.7144 4.102001 4.151300000000001 1446.52 1446.52 1446.52 -39.7144 6.102001 4.151300000000001 -683.283 -683.283 -683.283 -41.7144 0.10200100000000001 3.151300000000001 -25659.0 -25659.0 -25659.0 -41.7144 0.10200100000000001 4.151300000000001 -2230.02 -2230.02 -2230.02 -41.7144 1.102001 3.151300000000001 -5596.42 -5596.42 -5596.42 -42.7144 0.10200100000000001 3.151300000000001 -7315.51 -7315.51 -7315.51 -42.7144 0.10200100000000001 4.151300000000001 646.919 646.919 646.919 -42.7144 1.102001 3.151300000000001 -1471.52 -1471.52 -1471.52 -42.7144 1.102001 4.151300000000001 -4509.92 -4509.92 -4509.92 -41.7144 2.102001 2.151300000000001 345.375 345.375 345.375 -41.7144 3.102001 2.151300000000001 -1516.66 -1516.66 -1516.66 -42.7144 2.102001 2.151300000000001 2404.59 2404.59 2404.59 -42.7144 3.102001 2.151300000000001 -86.8833 -86.8833 -86.8833 -41.7144 2.102001 3.151300000000001 -22410.7 -22410.7 -22410.7 -41.7144 3.102001 3.151300000000001 1822.85 1822.85 1822.85 -42.7144 2.102001 3.151300000000001 2312.98 2312.98 2312.98 -42.7144 2.102001 4.151300000000001 475.071 475.071 475.071 -42.7144 3.102001 3.151300000000001 328.578 328.578 328.578 -42.7144 3.102001 4.151300000000001 125.535 125.535 125.535 -43.7144 1.102001 4.151300000000001 -519873.0 -519873.0 -519873.0 -44.7144 0.10200100000000001 4.151300000000001 519737.0 519737.0 519737.0 -44.7144 1.102001 4.151300000000001 -283157.0 -283157.0 -283157.0 -43.7144 2.102001 3.151300000000001 27.8691 27.8691 27.8691 -43.7144 2.102001 4.151300000000001 -2298.04 -2298.04 -2298.04 -43.7144 3.102001 3.151300000000001 245.549 245.549 245.549 -43.7144 3.102001 4.151300000000001 114.86 114.86 114.86 -44.7144 2.102001 4.151300000000001 -7188.89 -7188.89 -7188.89 -44.7144 3.102001 4.151300000000001 -431.444 -431.444 -431.444 -41.7144 4.102001 3.151300000000001 88.4958 88.4958 88.4958 -41.7144 4.102001 4.151300000000001 -1725.53 -1725.53 -1725.53 -41.7144 5.102001 4.151300000000001 -557.023 -557.023 -557.023 -42.7144 4.102001 3.151300000000001 7.44034 7.44034 7.44034 -42.7144 4.102001 4.151300000000001 67.0549 67.0549 67.0549 -42.7144 5.102001 4.151300000000001 -24.8187 -24.8187 -24.8187 -41.7144 6.102001 4.151300000000001 -448.911 -448.911 -448.911 -43.7144 5.102001 4.151300000000001 -99.8169 -99.8169 -99.8169 -44.7144 5.102001 4.151300000000001 -171.399 -171.399 -171.399 -43.7144 6.102001 4.151300000000001 42.5105 42.5105 42.5105 -44.7144 6.102001 4.151300000000001 -83.4751 -83.4751 -83.4751 -37.7144 0.10200100000000001 5.151300000000001 -1929.07 -1929.07 -1929.07 -37.7144 0.10200100000000001 6.151300000000001 326.507 326.507 326.507 -37.7144 1.102001 5.151300000000001 -1288.96 -1288.96 -1288.96 -37.7144 1.102001 6.151300000000001 2019.09 2019.09 2019.09 -38.7144 0.10200100000000001 5.151300000000001 -1702.02 -1702.02 -1702.02 -38.7144 0.10200100000000001 6.151300000000001 -1952.18 -1952.18 -1952.18 -38.7144 1.102001 5.151300000000001 -80.1631 -80.1631 -80.1631 -38.7144 1.102001 6.151300000000001 1040.65 1040.65 1040.65 -37.7144 0.10200100000000001 7.151300000000001 4366.95 4366.95 4366.95 -37.7144 0.10200100000000001 8.1513 -49881.4 -49881.4 -49881.4 -37.7144 1.102001 7.151300000000001 1714.15 1714.15 1714.15 -37.7144 1.102001 8.1513 -5762.98 -5762.98 -5762.98 -38.7144 0.10200100000000001 7.151300000000001 2917.63 2917.63 2917.63 -38.7144 0.10200100000000001 8.1513 81945.6 81945.6 81945.6 -38.7144 1.102001 7.151300000000001 4933.38 4933.38 4933.38 -38.7144 1.102001 8.1513 -9972.1 -9972.1 -9972.1 -37.7144 2.102001 5.151300000000001 -682.393 -682.393 -682.393 -37.7144 2.102001 6.151300000000001 -34.9581 -34.9581 -34.9581 -37.7144 3.102001 5.151300000000001 1281.07 1281.07 1281.07 -37.7144 3.102001 6.151300000000001 -2221.38 -2221.38 -2221.38 -38.7144 2.102001 5.151300000000001 -1214.82 -1214.82 -1214.82 -38.7144 2.102001 6.151300000000001 -939.216 -939.216 -939.216 -38.7144 3.102001 5.151300000000001 -683.75 -683.75 -683.75 -38.7144 3.102001 6.151300000000001 63.3824 63.3824 63.3824 -37.7144 2.102001 7.151300000000001 1961.26 1961.26 1961.26 -37.7144 2.102001 8.1513 4321.47 4321.47 4321.47 -38.7144 2.102001 7.151300000000001 2518.8 2518.8 2518.8 -38.7144 2.102001 8.1513 9505.62 9505.62 9505.62 -38.7144 3.102001 7.151300000000001 335.653 335.653 335.653 -38.7144 3.102001 8.1513 -152.939 -152.939 -152.939 -39.7144 0.10200100000000001 5.151300000000001 -1611.92 -1611.92 -1611.92 -39.7144 1.102001 5.151300000000001 -1675.48 -1675.48 -1675.48 -39.7144 1.102001 6.151300000000001 1058.05 1058.05 1058.05 -40.7144 0.10200100000000001 5.151300000000001 -1911.97 -1911.97 -1911.97 -39.7144 1.102001 7.151300000000001 2353.36 2353.36 2353.36 -39.7144 1.102001 8.1513 -3976.91 -3976.91 -3976.91 -40.7144 1.102001 8.1513 129.675 129.675 129.675 -39.7144 2.102001 5.151300000000001 642.142 642.142 642.142 -39.7144 2.102001 6.151300000000001 -822.633 -822.633 -822.633 -39.7144 3.102001 5.151300000000001 1237.62 1237.62 1237.62 -39.7144 3.102001 6.151300000000001 1860.17 1860.17 1860.17 -40.7144 2.102001 5.151300000000001 37.4998 37.4998 37.4998 -40.7144 2.102001 6.151300000000001 1013.43 1013.43 1013.43 -40.7144 3.102001 5.151300000000001 249.597 249.597 249.597 -40.7144 3.102001 6.151300000000001 -269.395 -269.395 -269.395 -39.7144 2.102001 7.151300000000001 1334.8 1334.8 1334.8 -39.7144 2.102001 8.1513 -12211.5 -12211.5 -12211.5 -39.7144 3.102001 7.151300000000001 458.604 458.604 458.604 -39.7144 3.102001 8.1513 -840.798 -840.798 -840.798 -40.7144 2.102001 7.151300000000001 1221.02 1221.02 1221.02 -40.7144 2.102001 8.1513 -1111.18 -1111.18 -1111.18 -40.7144 3.102001 7.151300000000001 -472.965 -472.965 -472.965 -37.7144 0.10200100000000001 9.1513 21317.2 21317.2 21317.2 -37.7144 0.10200100000000001 10.1513 -25273.1 -25273.1 -25273.1 -37.7144 1.102001 9.1513 33069.1 33069.1 33069.1 -37.7144 1.102001 10.1513 2920.25 2920.25 2920.25 -38.7144 0.10200100000000001 9.1513 2452.93 2452.93 2452.93 -38.7144 0.10200100000000001 10.1513 -21871.6 -21871.6 -21871.6 -38.7144 1.102001 9.1513 28348.5 28348.5 28348.5 -38.7144 1.102001 10.1513 -6428.43 -6428.43 -6428.43 -37.7144 0.10200100000000001 11.1513 138.131 138.131 138.131 -37.7144 1.102001 11.1513 586.71 586.71 586.71 -37.7144 1.102001 12.1513 -2792.2 -2792.2 -2792.2 -38.7144 1.102001 11.1513 5211.94 5211.94 5211.94 -38.7144 1.102001 12.1513 -3001.74 -3001.74 -3001.74 -37.7144 2.102001 10.1513 4187.01 4187.01 4187.01 -38.7144 2.102001 9.1513 28752.4 28752.4 28752.4 -38.7144 2.102001 10.1513 2595.92 2595.92 2595.92 -38.7144 3.102001 9.1513 -606.113 -606.113 -606.113 -38.7144 3.102001 10.1513 1885.89 1885.89 1885.89 -37.7144 2.102001 11.1513 -2810.12 -2810.12 -2810.12 -37.7144 2.102001 12.1513 -1134.83 -1134.83 -1134.83 -37.7144 3.102001 11.1513 -1595.85 -1595.85 -1595.85 -37.7144 3.102001 12.1513 163.978 163.978 163.978 -38.7144 2.102001 11.1513 -3371.33 -3371.33 -3371.33 -38.7144 2.102001 12.1513 -377.058 -377.058 -377.058 -38.7144 3.102001 11.1513 -3494.93 -3494.93 -3494.93 -38.7144 3.102001 12.1513 1322.3 1322.3 1322.3 -39.7144 0.10200100000000001 9.1513 -58436.1 -58436.1 -58436.1 -39.7144 0.10200100000000001 10.1513 -36746.6 -36746.6 -36746.6 -39.7144 1.102001 9.1513 -10131.6 -10131.6 -10131.6 -39.7144 1.102001 10.1513 -6161.85 -6161.85 -6161.85 -40.7144 0.10200100000000001 9.1513 1584.79 1584.79 1584.79 -40.7144 0.10200100000000001 10.1513 -2371.87 -2371.87 -2371.87 -40.7144 1.102001 9.1513 3711.46 3711.46 3711.46 -40.7144 1.102001 10.1513 -593.024 -593.024 -593.024 -40.7144 0.10200100000000001 11.1513 2791.55 2791.55 2791.55 -39.7144 2.102001 9.1513 20411.0 20411.0 20411.0 -39.7144 2.102001 10.1513 249.097 249.097 249.097 -39.7144 3.102001 9.1513 2429.35 2429.35 2429.35 -39.7144 3.102001 10.1513 1785.92 1785.92 1785.92 -40.7144 2.102001 9.1513 3159.41 3159.41 3159.41 -40.7144 2.102001 10.1513 942.233 942.233 942.233 -40.7144 3.102001 10.1513 223.712 223.712 223.712 -39.7144 2.102001 11.1513 2994.84 2994.84 2994.84 -39.7144 2.102001 12.1513 2917.16 2917.16 2917.16 -39.7144 3.102001 11.1513 477.312 477.312 477.312 -39.7144 3.102001 12.1513 1259.29 1259.29 1259.29 -40.7144 2.102001 11.1513 992.703 992.703 992.703 -40.7144 2.102001 12.1513 -6397.55 -6397.55 -6397.55 -40.7144 3.102001 11.1513 1630.37 1630.37 1630.37 -40.7144 3.102001 12.1513 -760.549 -760.549 -760.549 -37.7144 4.102001 6.151300000000001 -3324.34 -3324.34 -3324.34 -38.7144 4.102001 6.151300000000001 26.7766 26.7766 26.7766 -37.7144 5.102001 7.151300000000001 -251.382 -251.382 -251.382 -37.7144 7.102001 6.151300000000001 -1069.14 -1069.14 -1069.14 -38.7144 6.102001 5.151300000000001 -913.755 -913.755 -913.755 -38.7144 6.102001 6.151300000000001 885.722 885.722 885.722 -38.7144 7.102001 5.151300000000001 -54.0053 -54.0053 -54.0053 -38.7144 7.102001 6.151300000000001 -1155.63 -1155.63 -1155.63 -37.7144 6.102001 7.151300000000001 1128.37 1128.37 1128.37 -37.7144 7.102001 7.151300000000001 -2352.32 -2352.32 -2352.32 -37.7144 7.102001 8.1513 -1120.25 -1120.25 -1120.25 -38.7144 6.102001 7.151300000000001 211.892 211.892 211.892 -38.7144 7.102001 7.151300000000001 1026.65 1026.65 1026.65 -38.7144 7.102001 8.1513 -652.888 -652.888 -652.888 -39.7144 4.102001 5.151300000000001 -861.899 -861.899 -861.899 -39.7144 5.102001 5.151300000000001 940.552 940.552 940.552 -40.7144 4.102001 5.151300000000001 -1072.81 -1072.81 -1072.81 -40.7144 4.102001 6.151300000000001 312.122 312.122 312.122 -40.7144 5.102001 5.151300000000001 63.2419 63.2419 63.2419 -39.7144 4.102001 7.151300000000001 -668.949 -668.949 -668.949 -39.7144 4.102001 8.1513 880.744 880.744 880.744 -39.7144 5.102001 8.1513 188.75 188.75 188.75 -40.7144 4.102001 7.151300000000001 28.9735 28.9735 28.9735 -40.7144 4.102001 8.1513 -817.269 -817.269 -817.269 -40.7144 5.102001 7.151300000000001 928.194 928.194 928.194 -40.7144 5.102001 8.1513 -154.63 -154.63 -154.63 -39.7144 6.102001 5.151300000000001 719.585 719.585 719.585 -39.7144 7.102001 5.151300000000001 310.072 310.072 310.072 -39.7144 7.102001 6.151300000000001 -142.483 -142.483 -142.483 -40.7144 6.102001 5.151300000000001 1401.62 1401.62 1401.62 -40.7144 7.102001 5.151300000000001 819.096 819.096 819.096 -40.7144 7.102001 6.151300000000001 1054.71 1054.71 1054.71 -39.7144 6.102001 7.151300000000001 173.81 173.81 173.81 -39.7144 6.102001 8.1513 -762.045 -762.045 -762.045 -39.7144 7.102001 7.151300000000001 379.676 379.676 379.676 -39.7144 7.102001 8.1513 -111.998 -111.998 -111.998 -40.7144 6.102001 8.1513 262.507 262.507 262.507 -40.7144 7.102001 7.151300000000001 852.742 852.742 852.742 -40.7144 7.102001 8.1513 2690.31 2690.31 2690.31 -37.7144 4.102001 9.1513 -2153.9 -2153.9 -2153.9 -37.7144 4.102001 10.1513 -2126.78 -2126.78 -2126.78 -37.7144 5.102001 9.1513 623.877 623.877 623.877 -37.7144 5.102001 10.1513 -2685.51 -2685.51 -2685.51 -38.7144 4.102001 9.1513 2334.32 2334.32 2334.32 -38.7144 4.102001 10.1513 162.631 162.631 162.631 -38.7144 5.102001 9.1513 -49.2126 -49.2126 -49.2126 -38.7144 5.102001 10.1513 -546.684 -546.684 -546.684 -37.7144 4.102001 11.1513 2315.21 2315.21 2315.21 -37.7144 4.102001 12.1513 -4758.85 -4758.85 -4758.85 -37.7144 5.102001 11.1513 1636.78 1636.78 1636.78 -37.7144 5.102001 12.1513 -744.607 -744.607 -744.607 -38.7144 4.102001 11.1513 1232.51 1232.51 1232.51 -38.7144 4.102001 12.1513 -2925.08 -2925.08 -2925.08 -38.7144 5.102001 11.1513 3585.42 3585.42 3585.42 -38.7144 5.102001 12.1513 -3547.03 -3547.03 -3547.03 -37.7144 6.102001 10.1513 152.692 152.692 152.692 -37.7144 7.102001 9.1513 325.536 325.536 325.536 -37.7144 7.102001 10.1513 1114.79 1114.79 1114.79 -38.7144 6.102001 10.1513 -1364.88 -1364.88 -1364.88 -38.7144 7.102001 9.1513 829.158 829.158 829.158 -38.7144 7.102001 10.1513 73.6633 73.6633 73.6633 -37.7144 6.102001 11.1513 -2626.91 -2626.91 -2626.91 -37.7144 6.102001 12.1513 -821.238 -821.238 -821.238 -37.7144 7.102001 11.1513 16.0911 16.0911 16.0911 -38.7144 6.102001 11.1513 12.4418 12.4418 12.4418 -38.7144 6.102001 12.1513 1673.19 1673.19 1673.19 -38.7144 7.102001 11.1513 -933.048 -933.048 -933.048 -38.7144 7.102001 12.1513 427.785 427.785 427.785 -39.7144 4.102001 9.1513 1553.67 1553.67 1553.67 -39.7144 4.102001 10.1513 566.45 566.45 566.45 -39.7144 5.102001 9.1513 -1087.05 -1087.05 -1087.05 -39.7144 5.102001 10.1513 -386.064 -386.064 -386.064 -40.7144 4.102001 9.1513 -2171.28 -2171.28 -2171.28 -40.7144 4.102001 10.1513 891.683 891.683 891.683 -40.7144 5.102001 9.1513 1212.04 1212.04 1212.04 -40.7144 5.102001 10.1513 -855.099 -855.099 -855.099 -39.7144 4.102001 11.1513 1634.96 1634.96 1634.96 -39.7144 5.102001 11.1513 8787.28 8787.28 8787.28 -39.7144 5.102001 12.1513 1635.18 1635.18 1635.18 -39.7144 6.102001 9.1513 -261.044 -261.044 -261.044 -39.7144 6.102001 10.1513 -858.239 -858.239 -858.239 -39.7144 7.102001 9.1513 -163.733 -163.733 -163.733 -40.7144 6.102001 10.1513 -723.082 -723.082 -723.082 -40.7144 7.102001 10.1513 857.755 857.755 857.755 -39.7144 6.102001 11.1513 -2430.29 -2430.29 -2430.29 -39.7144 6.102001 12.1513 798.642 798.642 798.642 -39.7144 7.102001 12.1513 -419.137 -419.137 -419.137 -40.7144 6.102001 11.1513 -463.247 -463.247 -463.247 -40.7144 6.102001 12.1513 236.017 236.017 236.017 -40.7144 7.102001 11.1513 1029.55 1029.55 1029.55 -40.7144 7.102001 12.1513 1110.43 1110.43 1110.43 -41.7144 0.10200100000000001 5.151300000000001 248.612 248.612 248.612 -42.7144 0.10200100000000001 5.151300000000001 1819.15 1819.15 1819.15 -42.7144 0.10200100000000001 6.151300000000001 2859.98 2859.98 2859.98 -42.7144 1.102001 5.151300000000001 -638.193 -638.193 -638.193 -42.7144 1.102001 6.151300000000001 845.216 845.216 845.216 -41.7144 0.10200100000000001 7.151300000000001 156.777 156.777 156.777 -41.7144 0.10200100000000001 8.1513 2506.02 2506.02 2506.02 -41.7144 1.102001 7.151300000000001 -4868.1 -4868.1 -4868.1 -41.7144 1.102001 8.1513 -3019.89 -3019.89 -3019.89 -42.7144 0.10200100000000001 7.151300000000001 -1826.61 -1826.61 -1826.61 -42.7144 0.10200100000000001 8.1513 1830.09 1830.09 1830.09 -42.7144 1.102001 7.151300000000001 -3465.11 -3465.11 -3465.11 -42.7144 1.102001 8.1513 3344.26 3344.26 3344.26 -41.7144 2.102001 6.151300000000001 521.276 521.276 521.276 -41.7144 3.102001 6.151300000000001 -73.5238 -73.5238 -73.5238 -42.7144 2.102001 5.151300000000001 -59.5171 -59.5171 -59.5171 -42.7144 2.102001 6.151300000000001 -117.781 -117.781 -117.781 -42.7144 3.102001 5.151300000000001 -626.009 -626.009 -626.009 -42.7144 3.102001 6.151300000000001 -88.4603 -88.4603 -88.4603 -41.7144 2.102001 7.151300000000001 -3047.04 -3047.04 -3047.04 -41.7144 2.102001 8.1513 -4405.2 -4405.2 -4405.2 -41.7144 3.102001 7.151300000000001 -93.5239 -93.5239 -93.5239 -41.7144 3.102001 8.1513 -114.426 -114.426 -114.426 -42.7144 2.102001 7.151300000000001 -1014.47 -1014.47 -1014.47 -42.7144 2.102001 8.1513 -1581.34 -1581.34 -1581.34 -42.7144 3.102001 7.151300000000001 343.946 343.946 343.946 -42.7144 3.102001 8.1513 -132.893 -132.893 -132.893 -43.7144 0.10200100000000001 5.151300000000001 344.478 344.478 344.478 -43.7144 0.10200100000000001 6.151300000000001 -5234.59 -5234.59 -5234.59 -43.7144 1.102001 5.151300000000001 -152.49 -152.49 -152.49 -43.7144 1.102001 6.151300000000001 3642.12 3642.12 3642.12 -44.7144 0.10200100000000001 5.151300000000001 -13701.4 -13701.4 -13701.4 -44.7144 1.102001 5.151300000000001 17019.4 17019.4 17019.4 -43.7144 0.10200100000000001 7.151300000000001 -4338.92 -4338.92 -4338.92 -43.7144 0.10200100000000001 8.1513 -2821.07 -2821.07 -2821.07 -43.7144 1.102001 7.151300000000001 -1700.21 -1700.21 -1700.21 -43.7144 2.102001 5.151300000000001 316.859 316.859 316.859 -43.7144 2.102001 6.151300000000001 1974.38 1974.38 1974.38 -43.7144 3.102001 5.151300000000001 -280.943 -280.943 -280.943 -43.7144 3.102001 6.151300000000001 -666.054 -666.054 -666.054 -44.7144 2.102001 6.151300000000001 1386.59 1386.59 1386.59 -44.7144 3.102001 5.151300000000001 203.381 203.381 203.381 -44.7144 3.102001 6.151300000000001 1204.4 1204.4 1204.4 -43.7144 2.102001 7.151300000000001 -3109.52 -3109.52 -3109.52 -43.7144 3.102001 7.151300000000001 -130.386 -130.386 -130.386 -44.7144 3.102001 7.151300000000001 -1638.88 -1638.88 -1638.88 -41.7144 0.10200100000000001 9.1513 -835.345 -835.345 -835.345 -41.7144 0.10200100000000001 10.1513 -5422.64 -5422.64 -5422.64 -41.7144 1.102001 9.1513 -1586.24 -1586.24 -1586.24 -41.7144 1.102001 10.1513 -647.32 -647.32 -647.32 -42.7144 0.10200100000000001 9.1513 240.76 240.76 240.76 -42.7144 0.10200100000000001 10.1513 1480.77 1480.77 1480.77 -42.7144 1.102001 9.1513 730.039 730.039 730.039 -42.7144 1.102001 10.1513 -389.547 -389.547 -389.547 -41.7144 0.10200100000000001 11.1513 4050.55 4050.55 4050.55 -41.7144 0.10200100000000001 12.1513 2939.73 2939.73 2939.73 -41.7144 1.102001 11.1513 773.41 773.41 773.41 -41.7144 1.102001 12.1513 1898.44 1898.44 1898.44 -42.7144 0.10200100000000001 11.1513 -1100.67 -1100.67 -1100.67 -42.7144 0.10200100000000001 12.1513 -2292.76 -2292.76 -2292.76 -42.7144 1.102001 11.1513 1399.72 1399.72 1399.72 -42.7144 1.102001 12.1513 1128.91 1128.91 1128.91 -41.7144 2.102001 9.1513 2075.38 2075.38 2075.38 -41.7144 2.102001 10.1513 -282.3 -282.3 -282.3 -41.7144 3.102001 9.1513 191.746 191.746 191.746 -41.7144 3.102001 10.1513 -56.8791 -56.8791 -56.8791 -42.7144 2.102001 9.1513 1164.48 1164.48 1164.48 -42.7144 3.102001 9.1513 -170.525 -170.525 -170.525 -42.7144 3.102001 10.1513 -2003.9 -2003.9 -2003.9 -41.7144 2.102001 11.1513 -1082.56 -1082.56 -1082.56 -41.7144 2.102001 12.1513 -760.695 -760.695 -760.695 -41.7144 3.102001 11.1513 -956.85 -956.85 -956.85 -41.7144 3.102001 12.1513 -198.793 -198.793 -198.793 -42.7144 2.102001 11.1513 -154.895 -154.895 -154.895 -42.7144 2.102001 12.1513 366.304 366.304 366.304 -42.7144 3.102001 11.1513 1727.27 1727.27 1727.27 -42.7144 3.102001 12.1513 1641.57 1641.57 1641.57 -44.7144 0.10200100000000001 10.1513 -2830.92 -2830.92 -2830.92 -44.7144 1.102001 10.1513 -8771.21 -8771.21 -8771.21 -43.7144 0.10200100000000001 11.1513 -1402.87 -1402.87 -1402.87 -43.7144 1.102001 11.1513 54.8877 54.8877 54.8877 -43.7144 1.102001 12.1513 -529.242 -529.242 -529.242 -44.7144 0.10200100000000001 11.1513 2099.74 2099.74 2099.74 -44.7144 0.10200100000000001 12.1513 -12712.2 -12712.2 -12712.2 -44.7144 1.102001 11.1513 -2234.48 -2234.48 -2234.48 -44.7144 1.102001 12.1513 -495.856 -495.856 -495.856 -44.7144 2.102001 9.1513 -811.183 -811.183 -811.183 -44.7144 2.102001 10.1513 1221.37 1221.37 1221.37 -44.7144 3.102001 10.1513 1246.52 1246.52 1246.52 -43.7144 2.102001 11.1513 1853.5 1853.5 1853.5 -43.7144 2.102001 12.1513 -449.743 -449.743 -449.743 -43.7144 3.102001 11.1513 406.278 406.278 406.278 -43.7144 3.102001 12.1513 -418.16 -418.16 -418.16 -44.7144 2.102001 11.1513 452.851 452.851 452.851 -44.7144 2.102001 12.1513 88.8415 88.8415 88.8415 -44.7144 3.102001 11.1513 -2195.42 -2195.42 -2195.42 -44.7144 3.102001 12.1513 -2020.69 -2020.69 -2020.69 -41.7144 4.102001 5.151300000000001 -1594.18 -1594.18 -1594.18 -41.7144 5.102001 5.151300000000001 -205.737 -205.737 -205.737 -42.7144 4.102001 5.151300000000001 -159.566 -159.566 -159.566 -42.7144 5.102001 5.151300000000001 -448.291 -448.291 -448.291 -41.7144 4.102001 7.151300000000001 214.331 214.331 214.331 -41.7144 4.102001 8.1513 -794.989 -794.989 -794.989 -41.7144 5.102001 8.1513 145.946 145.946 145.946 -42.7144 4.102001 7.151300000000001 97.3646 97.3646 97.3646 -42.7144 4.102001 8.1513 144.67 144.67 144.67 -42.7144 5.102001 7.151300000000001 -252.42 -252.42 -252.42 -42.7144 5.102001 8.1513 22.0172 22.0172 22.0172 -41.7144 6.102001 5.151300000000001 -899.916 -899.916 -899.916 -41.7144 7.102001 5.151300000000001 -2225.98 -2225.98 -2225.98 -41.7144 7.102001 6.151300000000001 194.614 194.614 194.614 -42.7144 6.102001 5.151300000000001 202.422 202.422 202.422 -42.7144 7.102001 5.151300000000001 317.125 317.125 317.125 -41.7144 6.102001 7.151300000000001 -387.21 -387.21 -387.21 -41.7144 6.102001 8.1513 -305.828 -305.828 -305.828 -41.7144 7.102001 7.151300000000001 -129.812 -129.812 -129.812 -41.7144 7.102001 8.1513 596.248 596.248 596.248 -42.7144 6.102001 8.1513 -340.067 -340.067 -340.067 -42.7144 7.102001 8.1513 -1543.02 -1543.02 -1543.02 -43.7144 4.102001 5.151300000000001 235.232 235.232 235.232 -43.7144 4.102001 6.151300000000001 -949.35 -949.35 -949.35 -43.7144 5.102001 5.151300000000001 71.2533 71.2533 71.2533 -43.7144 5.102001 6.151300000000001 44.1826 44.1826 44.1826 -44.7144 4.102001 5.151300000000001 -260.329 -260.329 -260.329 -44.7144 4.102001 6.151300000000001 -760.152 -760.152 -760.152 -44.7144 5.102001 5.151300000000001 161.461 161.461 161.461 -44.7144 5.102001 6.151300000000001 49.1754 49.1754 49.1754 -43.7144 4.102001 7.151300000000001 700.983 700.983 700.983 -43.7144 4.102001 8.1513 -148.265 -148.265 -148.265 -43.7144 5.102001 7.151300000000001 -306.159 -306.159 -306.159 -43.7144 5.102001 8.1513 -370.306 -370.306 -370.306 -44.7144 4.102001 7.151300000000001 -602.782 -602.782 -602.782 -44.7144 4.102001 8.1513 -199.732 -199.732 -199.732 -44.7144 5.102001 7.151300000000001 -130.344 -130.344 -130.344 -44.7144 5.102001 8.1513 48.6257 48.6257 48.6257 -43.7144 6.102001 5.151300000000001 61.4962 61.4962 61.4962 -43.7144 7.102001 5.151300000000001 116.705 116.705 116.705 -44.7144 6.102001 5.151300000000001 -56.0441 -56.0441 -56.0441 -44.7144 7.102001 5.151300000000001 -32.8072 -32.8072 -32.8072 -44.7144 7.102001 6.151300000000001 -144.747 -144.747 -144.747 -43.7144 6.102001 7.151300000000001 -181.331 -181.331 -181.331 -43.7144 6.102001 8.1513 103.423 103.423 103.423 -43.7144 7.102001 7.151300000000001 110.038 110.038 110.038 -43.7144 7.102001 8.1513 -83.3125 -83.3125 -83.3125 -44.7144 6.102001 7.151300000000001 63.2213 63.2213 63.2213 -44.7144 6.102001 8.1513 -100.07 -100.07 -100.07 -44.7144 7.102001 7.151300000000001 -10.0129 -10.0129 -10.0129 -44.7144 7.102001 8.1513 2706.39 2706.39 2706.39 -41.7144 4.102001 9.1513 684.982 684.982 684.982 -41.7144 4.102001 10.1513 842.948 842.948 842.948 -41.7144 5.102001 10.1513 29.3796 29.3796 29.3796 -42.7144 4.102001 9.1513 376.246 376.246 376.246 -42.7144 4.102001 10.1513 -1804.6 -1804.6 -1804.6 -42.7144 5.102001 9.1513 -181.142 -181.142 -181.142 -42.7144 5.102001 10.1513 -869.172 -869.172 -869.172 -41.7144 4.102001 11.1513 -655.07 -655.07 -655.07 -41.7144 4.102001 12.1513 -62.11 -62.11 -62.11 -42.7144 4.102001 11.1513 2362.0 2362.0 2362.0 -42.7144 4.102001 12.1513 79.6699 79.6699 79.6699 -42.7144 5.102001 11.1513 5118.85 5118.85 5118.85 -42.7144 5.102001 12.1513 1447.06 1447.06 1447.06 -41.7144 6.102001 10.1513 -1601.44 -1601.44 -1601.44 -41.7144 7.102001 10.1513 -600.004 -600.004 -600.004 -42.7144 6.102001 10.1513 -1043.41 -1043.41 -1043.41 -42.7144 7.102001 10.1513 70.6093 70.6093 70.6093 -41.7144 7.102001 11.1513 -333.836 -333.836 -333.836 -41.7144 7.102001 12.1513 468.497 468.497 468.497 -42.7144 6.102001 11.1513 1872.87 1872.87 1872.87 -42.7144 7.102001 11.1513 17.5246 17.5246 17.5246 -42.7144 7.102001 12.1513 -0.233459 -0.233459 -0.233459 -43.7144 4.102001 9.1513 997.222 997.222 997.222 -43.7144 4.102001 10.1513 -1489.17 -1489.17 -1489.17 -43.7144 5.102001 9.1513 -2048.24 -2048.24 -2048.24 -43.7144 5.102001 10.1513 -4821.21 -4821.21 -4821.21 -44.7144 4.102001 9.1513 -815.775 -815.775 -815.775 -44.7144 4.102001 10.1513 -1692.47 -1692.47 -1692.47 -44.7144 5.102001 9.1513 -877.743 -877.743 -877.743 -44.7144 5.102001 10.1513 -1009.5 -1009.5 -1009.5 -43.7144 4.102001 11.1513 1574.18 1574.18 1574.18 -43.7144 4.102001 12.1513 155.814 155.814 155.814 -43.7144 5.102001 11.1513 6105.19 6105.19 6105.19 -43.7144 5.102001 12.1513 3154.93 3154.93 3154.93 -44.7144 4.102001 11.1513 -343.581 -343.581 -343.581 -44.7144 4.102001 12.1513 -1593.07 -1593.07 -1593.07 -44.7144 5.102001 11.1513 7493.8 7493.8 7493.8 -44.7144 5.102001 12.1513 541.438 541.438 541.438 -43.7144 6.102001 9.1513 710.595 710.595 710.595 -43.7144 6.102001 10.1513 -2665.72 -2665.72 -2665.72 -43.7144 7.102001 9.1513 1073.87 1073.87 1073.87 -43.7144 7.102001 10.1513 -2750.38 -2750.38 -2750.38 -44.7144 6.102001 9.1513 -2105.01 -2105.01 -2105.01 -44.7144 7.102001 9.1513 277.18 277.18 277.18 -43.7144 6.102001 11.1513 3051.3 3051.3 3051.3 -43.7144 6.102001 12.1513 17.4828 17.4828 17.4828 -43.7144 7.102001 11.1513 869.703 869.703 869.703 -43.7144 7.102001 12.1513 967.226 967.226 967.226 -44.7144 6.102001 11.1513 4247.29 4247.29 4247.29 -44.7144 6.102001 12.1513 -989.25 -989.25 -989.25 -44.7144 7.102001 12.1513 816.397 816.397 816.397 -37.7144 8.102001 4.151300000000001 215.713 215.713 215.713 -38.7144 8.102001 4.151300000000001 -139.439 -139.439 -139.439 -37.7144 8.102001 5.151300000000001 -906.022 -906.022 -906.022 -37.7144 8.102001 6.151300000000001 212.481 212.481 212.481 -38.7144 8.102001 5.151300000000001 -268.097 -268.097 -268.097 -38.7144 8.102001 6.151300000000001 -2564.12 -2564.12 -2564.12 -39.7144 8.102001 5.151300000000001 -62.0218 -62.0218 -62.0218 -39.7144 8.102001 6.151300000000001 -2325.52 -2325.52 -2325.52 -40.7144 8.102001 5.151300000000001 -55.6435 -55.6435 -55.6435 -40.7144 8.102001 6.151300000000001 -1579.75 -1579.75 -1579.75 -39.7144 8.102001 7.151300000000001 1211.22 1211.22 1211.22 -40.7144 8.102001 7.151300000000001 -13111.6 -13111.6 -13111.6 -37.7144 8.102001 10.1513 -150.203 -150.203 -150.203 -37.7144 9.102001 10.1513 -1259.44 -1259.44 -1259.44 -37.7144 8.102001 11.1513 1167.25 1167.25 1167.25 -37.7144 9.102001 11.1513 -1549.56 -1549.56 -1549.56 -38.7144 8.102001 11.1513 625.753 625.753 625.753 -38.7144 8.102001 12.1513 -1025.26 -1025.26 -1025.26 -38.7144 9.102001 11.1513 -3080.06 -3080.06 -3080.06 -38.7144 9.102001 12.1513 63.1996 63.1996 63.1996 -37.7144 10.102001 10.1513 636.472 636.472 636.472 -37.7144 11.102001 10.1513 -1445.09 -1445.09 -1445.09 -37.7144 10.102001 11.1513 984.851 984.851 984.851 -37.7144 10.102001 12.1513 -1242.41 -1242.41 -1242.41 -37.7144 11.102001 11.1513 -25.8233 -25.8233 -25.8233 -38.7144 10.102001 11.1513 -3336.41 -3336.41 -3336.41 -38.7144 10.102001 12.1513 2132.88 2132.88 2132.88 -38.7144 11.102001 11.1513 -1094.08 -1094.08 -1094.08 -38.7144 11.102001 12.1513 311.93 311.93 311.93 -39.7144 8.102001 12.1513 -1636.06 -1636.06 -1636.06 -39.7144 9.102001 12.1513 -0.640659 -0.640659 -0.640659 -39.7144 10.102001 12.1513 -274.751 -274.751 -274.751 -39.7144 11.102001 12.1513 1065.45 1065.45 1065.45 -37.7144 12.102001 11.1513 405.195 405.195 405.195 -37.7144 12.102001 12.1513 -785.076 -785.076 -785.076 -37.7144 13.102001 11.1513 1181.5 1181.5 1181.5 -37.7144 13.102001 12.1513 580.984 580.984 580.984 -38.7144 12.102001 11.1513 329.303 329.303 329.303 -38.7144 12.102001 12.1513 340.841 340.841 340.841 -39.7144 12.102001 12.1513 568.69 568.69 568.69 -41.7144 8.102001 5.151300000000001 1286.99 1286.99 1286.99 -41.7144 8.102001 6.151300000000001 783.111 783.111 783.111 -42.7144 8.102001 5.151300000000001 674.631 674.631 674.631 -42.7144 8.102001 6.151300000000001 64.6122 64.6122 64.6122 -41.7144 8.102001 7.151300000000001 10851.1 10851.1 10851.1 -41.7144 8.102001 8.1513 16870.7 16870.7 16870.7 -42.7144 8.102001 7.151300000000001 -12379.6 -12379.6 -12379.6 -42.7144 8.102001 8.1513 -2078.53 -2078.53 -2078.53 -43.7144 8.102001 5.151300000000001 708.021 708.021 708.021 -43.7144 8.102001 6.151300000000001 -988.568 -988.568 -988.568 -44.7144 8.102001 5.151300000000001 -372.588 -372.588 -372.588 -44.7144 8.102001 6.151300000000001 14.3942 14.3942 14.3942 -43.7144 8.102001 7.151300000000001 -1377.08 -1377.08 -1377.08 -43.7144 8.102001 8.1513 2703.33 2703.33 2703.33 -44.7144 8.102001 7.151300000000001 514.891 514.891 514.891 -43.7144 8.102001 9.1513 886.619 886.619 886.619 -43.7144 8.102001 10.1513 1041.87 1041.87 1041.87 -43.7144 9.102001 10.1513 -3962.37 -3962.37 -3962.37 -44.7144 8.102001 9.1513 2842.25 2842.25 2842.25 -44.7144 8.102001 10.1513 -1500.59 -1500.59 -1500.59 -44.7144 9.102001 10.1513 -1803.72 -1803.72 -1803.72 -43.7144 8.102001 11.1513 812.412 812.412 812.412 -43.7144 8.102001 12.1513 873.593 873.593 873.593 -43.7144 9.102001 11.1513 -53.2828 -53.2828 -53.2828 -43.7144 9.102001 12.1513 161.723 161.723 161.723 -44.7144 9.102001 11.1513 -798.742 -798.742 -798.742 -44.7144 9.102001 12.1513 56.6065 56.6065 56.6065 -44.7144 10.102001 11.1513 -1083.26 -1083.26 -1083.26 -44.7144 10.102001 12.1513 98.3233 98.3233 98.3233 -45.7144 0.10200100000000001 4.151300000000001 235458.0 235458.0 235458.0 -45.7144 1.102001 4.151300000000001 61657.2 61657.2 61657.2 -46.7144 1.102001 4.151300000000001 5539.05 5539.05 5539.05 -45.7144 2.102001 4.151300000000001 -10265.7 -10265.7 -10265.7 -45.7144 3.102001 4.151300000000001 577.601 577.601 577.601 -46.7144 2.102001 4.151300000000001 1317.89 1317.89 1317.89 -46.7144 3.102001 4.151300000000001 816.863 816.863 816.863 -47.7144 1.102001 4.151300000000001 18.3618 18.3618 18.3618 -48.7144 1.102001 4.151300000000001 -7358.87 -7358.87 -7358.87 -47.7144 2.102001 4.151300000000001 1679.45 1679.45 1679.45 -47.7144 3.102001 4.151300000000001 -376.816 -376.816 -376.816 -48.7144 2.102001 4.151300000000001 -178.709 -178.709 -178.709 -48.7144 3.102001 4.151300000000001 -698.506 -698.506 -698.506 -45.7144 4.102001 4.151300000000001 -374.842 -374.842 -374.842 -46.7144 4.102001 4.151300000000001 441.636 441.636 441.636 -47.7144 4.102001 4.151300000000001 323.878 323.878 323.878 -49.7144 2.102001 4.151300000000001 -17830.6 -17830.6 -17830.6 -45.7144 0.10200100000000001 5.151300000000001 16746.1 16746.1 16746.1 -46.7144 0.10200100000000001 5.151300000000001 6991.79 6991.79 6991.79 -46.7144 0.10200100000000001 6.151300000000001 10812.1 10812.1 10812.1 -46.7144 1.102001 5.151300000000001 15980.7 15980.7 15980.7 -46.7144 1.102001 6.151300000000001 4108.9 4108.9 4108.9 -45.7144 0.10200100000000001 8.1513 25944.7 25944.7 25944.7 -45.7144 1.102001 8.1513 -1630.03 -1630.03 -1630.03 -46.7144 0.10200100000000001 7.151300000000001 -2476.14 -2476.14 -2476.14 -46.7144 0.10200100000000001 8.1513 12931.6 12931.6 12931.6 -46.7144 1.102001 7.151300000000001 -870.423 -870.423 -870.423 -46.7144 1.102001 8.1513 -341.395 -341.395 -341.395 -45.7144 3.102001 5.151300000000001 879.232 879.232 879.232 -45.7144 3.102001 6.151300000000001 -1459.49 -1459.49 -1459.49 -45.7144 2.102001 7.151300000000001 2390.26 2390.26 2390.26 -45.7144 2.102001 8.1513 775.859 775.859 775.859 -45.7144 3.102001 7.151300000000001 -1576.96 -1576.96 -1576.96 -45.7144 3.102001 8.1513 769.092 769.092 769.092 -46.7144 2.102001 7.151300000000001 3195.83 3195.83 3195.83 -46.7144 2.102001 8.1513 2651.3 2651.3 2651.3 -46.7144 3.102001 7.151300000000001 1285.72 1285.72 1285.72 -46.7144 3.102001 8.1513 -218.603 -218.603 -218.603 -47.7144 0.10200100000000001 5.151300000000001 -4679.82 -4679.82 -4679.82 -47.7144 0.10200100000000001 6.151300000000001 -14125.4 -14125.4 -14125.4 -47.7144 1.102001 5.151300000000001 863.575 863.575 863.575 -48.7144 0.10200100000000001 5.151300000000001 2369.77 2369.77 2369.77 -48.7144 0.10200100000000001 6.151300000000001 -1598.42 -1598.42 -1598.42 -48.7144 1.102001 5.151300000000001 4544.63 4544.63 4544.63 -48.7144 1.102001 6.151300000000001 887.596 887.596 887.596 -47.7144 0.10200100000000001 7.151300000000001 8816.0 8816.0 8816.0 -47.7144 1.102001 7.151300000000001 1951.65 1951.65 1951.65 -47.7144 1.102001 8.1513 2165.48 2165.48 2165.48 -48.7144 0.10200100000000001 7.151300000000001 -2608.6 -2608.6 -2608.6 -48.7144 1.102001 7.151300000000001 1208.22 1208.22 1208.22 -48.7144 1.102001 8.1513 -2544.89 -2544.89 -2544.89 -48.7144 2.102001 5.151300000000001 -12740.6 -12740.6 -12740.6 -48.7144 3.102001 5.151300000000001 -29284.3 -29284.3 -29284.3 -48.7144 3.102001 6.151300000000001 -45916.6 -45916.6 -45916.6 -47.7144 2.102001 7.151300000000001 584.715 584.715 584.715 -47.7144 2.102001 8.1513 -781.637 -781.637 -781.637 -47.7144 3.102001 7.151300000000001 -12337.0 -12337.0 -12337.0 -47.7144 3.102001 8.1513 -82.8406 -82.8406 -82.8406 -48.7144 2.102001 7.151300000000001 681.325 681.325 681.325 -48.7144 2.102001 8.1513 2462.28 2462.28 2462.28 -48.7144 3.102001 7.151300000000001 17740.3 17740.3 17740.3 -48.7144 3.102001 8.1513 -1991.95 -1991.95 -1991.95 -45.7144 0.10200100000000001 9.1513 26585.7 26585.7 26585.7 -45.7144 0.10200100000000001 10.1513 5904.85 5904.85 5904.85 -45.7144 1.102001 9.1513 1128.01 1128.01 1128.01 -45.7144 1.102001 10.1513 -311.928 -311.928 -311.928 -46.7144 1.102001 9.1513 924.284 924.284 924.284 -46.7144 1.102001 10.1513 150.329 150.329 150.329 -45.7144 0.10200100000000001 11.1513 -79.1931 -79.1931 -79.1931 -45.7144 0.10200100000000001 12.1513 3332.63 3332.63 3332.63 -45.7144 1.102001 11.1513 840.647 840.647 840.647 -45.7144 1.102001 12.1513 -717.539 -717.539 -717.539 -46.7144 0.10200100000000001 11.1513 -244.364 -244.364 -244.364 -46.7144 0.10200100000000001 12.1513 -65.4806 -65.4806 -65.4806 -46.7144 1.102001 11.1513 -435.288 -435.288 -435.288 -46.7144 1.102001 12.1513 -402.481 -402.481 -402.481 -45.7144 2.102001 9.1513 420.617 420.617 420.617 -45.7144 2.102001 10.1513 687.535 687.535 687.535 -45.7144 3.102001 9.1513 -300.3 -300.3 -300.3 -45.7144 3.102001 10.1513 -214.302 -214.302 -214.302 -46.7144 2.102001 9.1513 2125.8 2125.8 2125.8 -46.7144 3.102001 9.1513 1462.84 1462.84 1462.84 -45.7144 2.102001 11.1513 -310.597 -310.597 -310.597 -45.7144 2.102001 12.1513 810.035 810.035 810.035 -45.7144 3.102001 11.1513 -1976.52 -1976.52 -1976.52 -45.7144 3.102001 12.1513 -1061.96 -1061.96 -1061.96 -46.7144 2.102001 11.1513 215.517 215.517 215.517 -46.7144 2.102001 12.1513 1035.41 1035.41 1035.41 -46.7144 3.102001 11.1513 -530.62 -530.62 -530.62 -46.7144 3.102001 12.1513 157.559 157.559 157.559 -47.7144 1.102001 9.1513 -2624.5 -2624.5 -2624.5 -47.7144 1.102001 10.1513 -1569.85 -1569.85 -1569.85 -48.7144 0.10200100000000001 10.1513 -6022.36 -6022.36 -6022.36 -48.7144 1.102001 10.1513 -652.361 -652.361 -652.361 -47.7144 0.10200100000000001 11.1513 -1768.32 -1768.32 -1768.32 -47.7144 1.102001 11.1513 -224.723 -224.723 -224.723 -48.7144 0.10200100000000001 11.1513 -483.757 -483.757 -483.757 -48.7144 1.102001 11.1513 -817.876 -817.876 -817.876 -48.7144 1.102001 12.1513 1174.24 1174.24 1174.24 -47.7144 2.102001 9.1513 972.535 972.535 972.535 -47.7144 2.102001 10.1513 -546.072 -546.072 -546.072 -47.7144 3.102001 9.1513 927.293 927.293 927.293 -47.7144 3.102001 10.1513 604.404 604.404 604.404 -48.7144 2.102001 9.1513 5490.18 5490.18 5490.18 -48.7144 2.102001 10.1513 1121.87 1121.87 1121.87 -48.7144 3.102001 9.1513 53.1148 53.1148 53.1148 -48.7144 3.102001 10.1513 3017.81 3017.81 3017.81 -47.7144 2.102001 11.1513 216.335 216.335 216.335 -47.7144 2.102001 12.1513 56.2984 56.2984 56.2984 -47.7144 3.102001 11.1513 -46.9561 -46.9561 -46.9561 -47.7144 3.102001 12.1513 344.741 344.741 344.741 -48.7144 2.102001 11.1513 2393.61 2393.61 2393.61 -48.7144 2.102001 12.1513 7854.75 7854.75 7854.75 -48.7144 3.102001 11.1513 -3399.48 -3399.48 -3399.48 -48.7144 3.102001 12.1513 -4111.63 -4111.63 -4111.63 -45.7144 4.102001 5.151300000000001 -160.429 -160.429 -160.429 -45.7144 4.102001 6.151300000000001 -1017.86 -1017.86 -1017.86 -45.7144 5.102001 5.151300000000001 57.2299 57.2299 57.2299 -45.7144 5.102001 6.151300000000001 180.534 180.534 180.534 -46.7144 4.102001 5.151300000000001 433.352 433.352 433.352 -46.7144 5.102001 5.151300000000001 -310.392 -310.392 -310.392 -46.7144 5.102001 6.151300000000001 -274.793 -274.793 -274.793 -45.7144 4.102001 7.151300000000001 -1068.3 -1068.3 -1068.3 -45.7144 4.102001 8.1513 -136.599 -136.599 -136.599 -45.7144 5.102001 7.151300000000001 -41.6794 -41.6794 -41.6794 -45.7144 5.102001 8.1513 -149.771 -149.771 -149.771 -46.7144 4.102001 8.1513 -2014.62 -2014.62 -2014.62 -46.7144 5.102001 7.151300000000001 69.9143 69.9143 69.9143 -46.7144 5.102001 8.1513 -43.5646 -43.5646 -43.5646 -45.7144 6.102001 5.151300000000001 -214.764 -214.764 -214.764 -45.7144 6.102001 6.151300000000001 205.479 205.479 205.479 -45.7144 7.102001 5.151300000000001 36.1531 36.1531 36.1531 -45.7144 7.102001 6.151300000000001 54.6313 54.6313 54.6313 -46.7144 6.102001 6.151300000000001 -118.958 -118.958 -118.958 -45.7144 6.102001 7.151300000000001 9.26753 9.26753 9.26753 -45.7144 7.102001 7.151300000000001 201.559 201.559 201.559 -46.7144 6.102001 7.151300000000001 -35.8516 -35.8516 -35.8516 -47.7144 4.102001 5.151300000000001 6928.78 6928.78 6928.78 -47.7144 5.102001 5.151300000000001 142.925 142.925 142.925 -47.7144 5.102001 6.151300000000001 229.02 229.02 229.02 -48.7144 4.102001 5.151300000000001 -1261.65 -1261.65 -1261.65 -48.7144 4.102001 6.151300000000001 -35672.1 -35672.1 -35672.1 -48.7144 5.102001 5.151300000000001 97.7479 97.7479 97.7479 -48.7144 5.102001 6.151300000000001 21.5004 21.5004 21.5004 -47.7144 5.102001 7.151300000000001 -450.775 -450.775 -450.775 -47.7144 5.102001 8.1513 -897.638 -897.638 -897.638 -48.7144 4.102001 7.151300000000001 -4910.88 -4910.88 -4910.88 -48.7144 4.102001 8.1513 -364.349 -364.349 -364.349 -48.7144 5.102001 7.151300000000001 -274.159 -274.159 -274.159 -48.7144 5.102001 8.1513 935.161 935.161 935.161 -47.7144 6.102001 6.151300000000001 -133.463 -133.463 -133.463 -47.7144 6.102001 7.151300000000001 -634.067 -634.067 -634.067 -45.7144 4.102001 9.1513 -1153.21 -1153.21 -1153.21 -45.7144 4.102001 10.1513 1615.42 1615.42 1615.42 -45.7144 5.102001 9.1513 -440.853 -440.853 -440.853 -45.7144 5.102001 10.1513 -827.888 -827.888 -827.888 -46.7144 4.102001 9.1513 3004.28 3004.28 3004.28 -46.7144 4.102001 10.1513 96.8224 96.8224 96.8224 -46.7144 5.102001 9.1513 376.803 376.803 376.803 -46.7144 5.102001 10.1513 -932.595 -932.595 -932.595 -45.7144 4.102001 11.1513 -247.506 -247.506 -247.506 -45.7144 4.102001 12.1513 -82.9775 -82.9775 -82.9775 -46.7144 4.102001 11.1513 -373.898 -373.898 -373.898 -46.7144 5.102001 11.1513 -1302.51 -1302.51 -1302.51 -45.7144 6.102001 9.1513 181.987 181.987 181.987 -45.7144 7.102001 9.1513 -154.904 -154.904 -154.904 -46.7144 6.102001 9.1513 -525.611 -525.611 -525.611 -46.7144 6.102001 10.1513 -2370.76 -2370.76 -2370.76 -46.7144 7.102001 9.1513 -469.572 -469.572 -469.572 -46.7144 7.102001 10.1513 2992.13 2992.13 2992.13 -46.7144 7.102001 11.1513 107.273 107.273 107.273 -47.7144 4.102001 9.1513 -1600.51 -1600.51 -1600.51 -47.7144 4.102001 10.1513 505.462 505.462 505.462 -47.7144 5.102001 9.1513 1428.27 1428.27 1428.27 -47.7144 5.102001 10.1513 -760.189 -760.189 -760.189 -48.7144 4.102001 9.1513 -4194.82 -4194.82 -4194.82 -48.7144 5.102001 9.1513 -199.324 -199.324 -199.324 -47.7144 4.102001 11.1513 -78.6959 -78.6959 -78.6959 -47.7144 4.102001 12.1513 722.621 722.621 722.621 -47.7144 5.102001 11.1513 -937.189 -937.189 -937.189 -47.7144 5.102001 12.1513 -658.395 -658.395 -658.395 -48.7144 4.102001 11.1513 -2176.38 -2176.38 -2176.38 -48.7144 4.102001 12.1513 -1558.95 -1558.95 -1558.95 -48.7144 5.102001 11.1513 -227.939 -227.939 -227.939 -48.7144 5.102001 12.1513 -1556.57 -1556.57 -1556.57 -47.7144 6.102001 10.1513 78.8063 78.8063 78.8063 -47.7144 6.102001 11.1513 -1673.74 -1673.74 -1673.74 -47.7144 6.102001 12.1513 2899.42 2899.42 2899.42 -47.7144 7.102001 11.1513 -493.869 -493.869 -493.869 -47.7144 7.102001 12.1513 1817.37 1817.37 1817.37 -48.7144 6.102001 12.1513 -19.2957 -19.2957 -19.2957 -49.7144 1.102001 5.151300000000001 -27264.4 -27264.4 -27264.4 -49.7144 1.102001 6.151300000000001 107.414 107.414 107.414 -49.7144 1.102001 7.151300000000001 6685.32 6685.32 6685.32 -49.7144 2.102001 5.151300000000001 -9773.35 -9773.35 -9773.35 -49.7144 2.102001 6.151300000000001 55348.9 55348.9 55348.9 -49.7144 3.102001 5.151300000000001 23049.2 23049.2 23049.2 -49.7144 3.102001 6.151300000000001 78235.1 78235.1 78235.1 -49.7144 2.102001 7.151300000000001 21812.3 21812.3 21812.3 -49.7144 0.10200100000000001 9.1513 -8070.5 -8070.5 -8070.5 -49.7144 0.10200100000000001 10.1513 258.23 258.23 258.23 -49.7144 1.102001 9.1513 -906.035 -906.035 -906.035 -49.7144 1.102001 10.1513 -482.558 -482.558 -482.558 -50.7144 0.10200100000000001 10.1513 -1597.12 -1597.12 -1597.12 -50.7144 1.102001 10.1513 -394.254 -394.254 -394.254 -50.7144 0.10200100000000001 11.1513 227.081 227.081 227.081 -50.7144 0.10200100000000001 12.1513 -6497.67 -6497.67 -6497.67 -50.7144 1.102001 11.1513 889.892 889.892 889.892 -50.7144 1.102001 12.1513 -3024.24 -3024.24 -3024.24 -49.7144 2.102001 10.1513 -5848.28 -5848.28 -5848.28 -50.7144 2.102001 10.1513 -9679.79 -9679.79 -9679.79 -49.7144 2.102001 11.1513 -9123.11 -9123.11 -9123.11 -49.7144 2.102001 12.1513 1169.76 1169.76 1169.76 -50.7144 2.102001 11.1513 3199.96 3199.96 3199.96 -50.7144 2.102001 12.1513 12241.7 12241.7 12241.7 -51.7144 0.10200100000000001 11.1513 639.698 639.698 639.698 -45.7144 8.102001 9.1513 -250.932 -250.932 -250.932 -45.7144 8.102001 10.1513 809.438 809.438 809.438 -45.7144 9.102001 10.1513 -804.166 -804.166 -804.166 -46.7144 8.102001 9.1513 -771.521 -771.521 -771.521 -46.7144 8.102001 10.1513 -802.651 -802.651 -802.651 -46.7144 9.102001 10.1513 -2186.71 -2186.71 -2186.71 -45.7144 9.102001 11.1513 -926.378 -926.378 -926.378 -45.7144 9.102001 12.1513 596.543 596.543 596.543 -46.7144 8.102001 11.1513 46.058 46.058 46.058 -46.7144 8.102001 12.1513 197.3 197.3 197.3 -46.7144 9.102001 11.1513 -245.986 -245.986 -245.986 -46.7144 9.102001 12.1513 1043.92 1043.92 1043.92 -45.7144 10.102001 11.1513 -337.578 -337.578 -337.578 -45.7144 10.102001 12.1513 -0.754375 -0.754375 -0.754375 -46.7144 10.102001 12.1513 314.01 314.01 314.01 -47.7144 8.102001 12.1513 817.686 817.686 817.686 -47.7144 9.102001 12.1513 -335.133 -335.133 -335.133 -37.7144 1.102001 13.1513 1774.17 1774.17 1774.17 -37.7144 1.102001 14.1513 2254.84 2254.84 2254.84 -38.7144 1.102001 13.1513 1639.48 1639.48 1639.48 -38.7144 1.102001 14.1513 1122.37 1122.37 1122.37 -37.7144 0.10200100000000001 16.1513 1297.78 1297.78 1297.78 -37.7144 1.102001 15.1513 -2302.17 -2302.17 -2302.17 -37.7144 1.102001 16.1513 -2165.3 -2165.3 -2165.3 -38.7144 0.10200100000000001 15.1513 3744.65 3744.65 3744.65 -38.7144 0.10200100000000001 16.1513 -676.809 -676.809 -676.809 -38.7144 1.102001 15.1513 6250.81 6250.81 6250.81 -38.7144 1.102001 16.1513 -5201.22 -5201.22 -5201.22 -37.7144 2.102001 13.1513 2973.74 2973.74 2973.74 -37.7144 2.102001 14.1513 -85.2586 -85.2586 -85.2586 -37.7144 3.102001 13.1513 -2557.18 -2557.18 -2557.18 -38.7144 2.102001 13.1513 -3944.66 -3944.66 -3944.66 -38.7144 2.102001 14.1513 -1379.35 -1379.35 -1379.35 -38.7144 3.102001 13.1513 680.429 680.429 680.429 -38.7144 3.102001 14.1513 -231.32 -231.32 -231.32 -37.7144 2.102001 15.1513 933.078 933.078 933.078 -37.7144 2.102001 16.1513 -2409.27 -2409.27 -2409.27 -37.7144 3.102001 16.1513 1097.95 1097.95 1097.95 -38.7144 2.102001 15.1513 -3430.75 -3430.75 -3430.75 -38.7144 2.102001 16.1513 -870.737 -870.737 -870.737 -38.7144 3.102001 15.1513 102.089 102.089 102.089 -38.7144 3.102001 16.1513 -66.2664 -66.2664 -66.2664 -40.7144 1.102001 14.1513 8459.84 8459.84 8459.84 -39.7144 0.10200100000000001 15.1513 5863.34 5863.34 5863.34 -39.7144 0.10200100000000001 16.1513 -3446.47 -3446.47 -3446.47 -39.7144 1.102001 15.1513 1651.48 1651.48 1651.48 -39.7144 1.102001 16.1513 -1575.51 -1575.51 -1575.51 -40.7144 0.10200100000000001 15.1513 4602.86 4602.86 4602.86 -40.7144 0.10200100000000001 16.1513 1332.91 1332.91 1332.91 -40.7144 1.102001 15.1513 1438.21 1438.21 1438.21 -40.7144 1.102001 16.1513 -2495.58 -2495.58 -2495.58 -39.7144 2.102001 13.1513 -5453.76 -5453.76 -5453.76 -39.7144 2.102001 14.1513 -3623.93 -3623.93 -3623.93 -39.7144 3.102001 13.1513 818.585 818.585 818.585 -39.7144 3.102001 14.1513 1724.63 1724.63 1724.63 -40.7144 2.102001 13.1513 -729.179 -729.179 -729.179 -40.7144 2.102001 14.1513 719.438 719.438 719.438 -40.7144 3.102001 14.1513 -389.344 -389.344 -389.344 -39.7144 2.102001 15.1513 5377.73 5377.73 5377.73 -39.7144 2.102001 16.1513 -3091.26 -3091.26 -3091.26 -39.7144 3.102001 15.1513 640.101 640.101 640.101 -40.7144 2.102001 15.1513 2788.62 2788.62 2788.62 -40.7144 2.102001 16.1513 -761.248 -761.248 -761.248 -40.7144 3.102001 15.1513 -1467.66 -1467.66 -1467.66 -37.7144 0.10200100000000001 17.1513 -2212.62 -2212.62 -2212.62 -37.7144 0.10200100000000001 18.1513 -2162.2 -2162.2 -2162.2 -37.7144 1.102001 17.1513 2076.15 2076.15 2076.15 -37.7144 1.102001 18.1513 286.357 286.357 286.357 -38.7144 0.10200100000000001 17.1513 -1758.26 -1758.26 -1758.26 -38.7144 1.102001 17.1513 -5746.79 -5746.79 -5746.79 -38.7144 1.102001 18.1513 -6472.05 -6472.05 -6472.05 -37.7144 0.10200100000000001 19.1513 -5429.51 -5429.51 -5429.51 -37.7144 0.10200100000000001 20.1513 2735.59 2735.59 2735.59 -37.7144 1.102001 19.1513 1706.89 1706.89 1706.89 -37.7144 1.102001 20.1513 3803.88 3803.88 3803.88 -38.7144 0.10200100000000001 20.1513 924.116 924.116 924.116 -38.7144 1.102001 20.1513 6988.73 6988.73 6988.73 -37.7144 2.102001 17.1513 -924.944 -924.944 -924.944 -37.7144 2.102001 18.1513 559.725 559.725 559.725 -37.7144 3.102001 17.1513 -80.0376 -80.0376 -80.0376 -38.7144 2.102001 17.1513 2283.79 2283.79 2283.79 -38.7144 2.102001 18.1513 -3619.88 -3619.88 -3619.88 -38.7144 3.102001 17.1513 100.095 100.095 100.095 -37.7144 2.102001 19.1513 5467.02 5467.02 5467.02 -37.7144 2.102001 20.1513 12303.0 12303.0 12303.0 -37.7144 3.102001 20.1513 2743.47 2743.47 2743.47 -38.7144 2.102001 19.1513 729.78 729.78 729.78 -38.7144 2.102001 20.1513 -5786.95 -5786.95 -5786.95 -38.7144 3.102001 20.1513 3264.04 3264.04 3264.04 -39.7144 0.10200100000000001 17.1513 80.6979 80.6979 80.6979 -39.7144 1.102001 17.1513 -6136.42 -6136.42 -6136.42 -40.7144 0.10200100000000001 17.1513 -3755.5 -3755.5 -3755.5 -40.7144 0.10200100000000001 18.1513 -5263.21 -5263.21 -5263.21 -40.7144 1.102001 17.1513 2554.21 2554.21 2554.21 -40.7144 1.102001 18.1513 7530.4 7530.4 7530.4 -39.7144 0.10200100000000001 20.1513 -1326.21 -1326.21 -1326.21 -40.7144 0.10200100000000001 19.1513 4975.01 4975.01 4975.01 -40.7144 0.10200100000000001 20.1513 5647.94 5647.94 5647.94 -40.7144 1.102001 19.1513 10668.5 10668.5 10668.5 -40.7144 1.102001 20.1513 -47.1278 -47.1278 -47.1278 -39.7144 2.102001 17.1513 -1519.47 -1519.47 -1519.47 -39.7144 3.102001 17.1513 -707.837 -707.837 -707.837 -40.7144 2.102001 17.1513 4401.67 4401.67 4401.67 -40.7144 3.102001 17.1513 634.267 634.267 634.267 -40.7144 3.102001 18.1513 -2714.98 -2714.98 -2714.98 -39.7144 2.102001 20.1513 10943.0 10943.0 10943.0 -39.7144 3.102001 20.1513 15393.0 15393.0 15393.0 -40.7144 2.102001 20.1513 -6736.98 -6736.98 -6736.98 -40.7144 3.102001 19.1513 3059.21 3059.21 3059.21 -40.7144 3.102001 20.1513 -8195.67 -8195.67 -8195.67 -37.7144 4.102001 13.1513 -3052.57 -3052.57 -3052.57 -37.7144 5.102001 13.1513 -7890.79 -7890.79 -7890.79 -37.7144 5.102001 14.1513 2980.16 2980.16 2980.16 -38.7144 4.102001 13.1513 -1563.07 -1563.07 -1563.07 -38.7144 4.102001 14.1513 -375.352 -375.352 -375.352 -38.7144 5.102001 13.1513 -825.895 -825.895 -825.895 -38.7144 5.102001 14.1513 1524.58 1524.58 1524.58 -37.7144 4.102001 15.1513 5390.63 5390.63 5390.63 -37.7144 4.102001 16.1513 136.408 136.408 136.408 -37.7144 5.102001 15.1513 2828.4 2828.4 2828.4 -37.7144 5.102001 16.1513 -59.431 -59.431 -59.431 -38.7144 4.102001 15.1513 487.223 487.223 487.223 -38.7144 4.102001 16.1513 458.621 458.621 458.621 -38.7144 5.102001 15.1513 -224.007 -224.007 -224.007 -37.7144 6.102001 13.1513 -2833.33 -2833.33 -2833.33 -37.7144 6.102001 14.1513 15181.3 15181.3 15181.3 -37.7144 7.102001 14.1513 96.7145 96.7145 96.7145 -38.7144 6.102001 13.1513 1246.12 1246.12 1246.12 -38.7144 6.102001 14.1513 -228.361 -228.361 -228.361 -37.7144 6.102001 15.1513 1556.91 1556.91 1556.91 -37.7144 6.102001 16.1513 515.947 515.947 515.947 -37.7144 7.102001 15.1513 -39.9869 -39.9869 -39.9869 -37.7144 7.102001 16.1513 257.067 257.067 257.067 -38.7144 6.102001 15.1513 -835.874 -835.874 -835.874 -38.7144 6.102001 16.1513 -388.362 -388.362 -388.362 -38.7144 7.102001 15.1513 -123.869 -123.869 -123.869 -38.7144 7.102001 16.1513 -109.362 -109.362 -109.362 -39.7144 4.102001 14.1513 1803.86 1803.86 1803.86 -39.7144 5.102001 13.1513 -124.797 -124.797 -124.797 -39.7144 5.102001 14.1513 -2084.83 -2084.83 -2084.83 -40.7144 5.102001 13.1513 890.744 890.744 890.744 -40.7144 5.102001 14.1513 299.528 299.528 299.528 -39.7144 4.102001 15.1513 -2728.12 -2728.12 -2728.12 -39.7144 5.102001 15.1513 -2455.83 -2455.83 -2455.83 -40.7144 4.102001 15.1513 -2157.16 -2157.16 -2157.16 -40.7144 4.102001 16.1513 -1788.92 -1788.92 -1788.92 -40.7144 5.102001 15.1513 1542.88 1542.88 1542.88 -40.7144 5.102001 16.1513 -170.742 -170.742 -170.742 -39.7144 6.102001 13.1513 4071.75 4071.75 4071.75 -39.7144 6.102001 14.1513 -1217.32 -1217.32 -1217.32 -39.7144 7.102001 13.1513 503.591 503.591 503.591 -39.7144 7.102001 14.1513 380.567 380.567 380.567 -40.7144 6.102001 13.1513 486.172 486.172 486.172 -40.7144 6.102001 14.1513 375.095 375.095 375.095 -40.7144 7.102001 13.1513 -264.475 -264.475 -264.475 -40.7144 7.102001 14.1513 -14.7242 -14.7242 -14.7242 -39.7144 6.102001 15.1513 1340.75 1340.75 1340.75 -39.7144 6.102001 16.1513 1654.94 1654.94 1654.94 -39.7144 7.102001 15.1513 -372.925 -372.925 -372.925 -39.7144 7.102001 16.1513 283.949 283.949 283.949 -40.7144 6.102001 15.1513 1465.13 1465.13 1465.13 -40.7144 6.102001 16.1513 3059.53 3059.53 3059.53 -40.7144 7.102001 15.1513 -22.8981 -22.8981 -22.8981 -40.7144 7.102001 16.1513 -52.1866 -52.1866 -52.1866 -37.7144 4.102001 17.1513 -870.755 -870.755 -870.755 -37.7144 4.102001 18.1513 -350.058 -350.058 -350.058 -37.7144 5.102001 17.1513 31.9042 31.9042 31.9042 -37.7144 5.102001 18.1513 43.7765 43.7765 43.7765 -38.7144 4.102001 17.1513 -574.392 -574.392 -574.392 -38.7144 5.102001 17.1513 153.535 153.535 153.535 -37.7144 4.102001 19.1513 1191.48 1191.48 1191.48 -37.7144 4.102001 20.1513 739.755 739.755 739.755 -37.7144 5.102001 19.1513 1903.5 1903.5 1903.5 -37.7144 5.102001 20.1513 1760.0 1760.0 1760.0 -38.7144 4.102001 19.1513 -340.547 -340.547 -340.547 -38.7144 4.102001 20.1513 -1856.89 -1856.89 -1856.89 -38.7144 5.102001 19.1513 2647.96 2647.96 2647.96 -38.7144 5.102001 20.1513 -4670.23 -4670.23 -4670.23 -37.7144 6.102001 17.1513 33.522 33.522 33.522 -37.7144 6.102001 18.1513 -5519.57 -5519.57 -5519.57 -37.7144 7.102001 17.1513 -198.749 -198.749 -198.749 -37.7144 7.102001 18.1513 -1496.52 -1496.52 -1496.52 -38.7144 6.102001 17.1513 95.293 95.293 95.293 -38.7144 7.102001 17.1513 355.396 355.396 355.396 -38.7144 7.102001 18.1513 -7381.17 -7381.17 -7381.17 -37.7144 6.102001 19.1513 1042.91 1042.91 1042.91 -37.7144 6.102001 20.1513 3083.83 3083.83 3083.83 -37.7144 7.102001 19.1513 -1053.01 -1053.01 -1053.01 -37.7144 7.102001 20.1513 -5338.48 -5338.48 -5338.48 -39.7144 4.102001 17.1513 202.33 202.33 202.33 -39.7144 5.102001 17.1513 -198.807 -198.807 -198.807 -40.7144 4.102001 17.1513 -240.75 -240.75 -240.75 -40.7144 4.102001 18.1513 3.11258 3.11258 3.11258 -40.7144 5.102001 17.1513 228.08 228.08 228.08 -39.7144 4.102001 20.1513 -2380.37 -2380.37 -2380.37 -39.7144 5.102001 20.1513 378.628 378.628 378.628 -40.7144 4.102001 19.1513 904.127 904.127 904.127 -40.7144 4.102001 20.1513 208.487 208.487 208.487 -40.7144 5.102001 19.1513 -4317.88 -4317.88 -4317.88 -40.7144 5.102001 20.1513 1631.04 1631.04 1631.04 -39.7144 6.102001 17.1513 -286.014 -286.014 -286.014 -40.7144 6.102001 17.1513 35.8173 35.8173 35.8173 -40.7144 6.102001 19.1513 12111.7 12111.7 12111.7 -40.7144 6.102001 20.1513 -20297.5 -20297.5 -20297.5 -40.7144 7.102001 19.1513 30649.6 30649.6 30649.6 -40.7144 7.102001 20.1513 42090.4 42090.4 42090.4 -41.7144 0.10200100000000001 13.1513 3108.58 3108.58 3108.58 -41.7144 0.10200100000000001 14.1513 -2250.93 -2250.93 -2250.93 -41.7144 1.102001 14.1513 1755.98 1755.98 1755.98 -42.7144 0.10200100000000001 13.1513 347.735 347.735 347.735 -42.7144 0.10200100000000001 14.1513 574.434 574.434 574.434 -42.7144 1.102001 13.1513 1431.58 1431.58 1431.58 -42.7144 1.102001 14.1513 665.253 665.253 665.253 -41.7144 0.10200100000000001 15.1513 -598.619 -598.619 -598.619 -41.7144 0.10200100000000001 16.1513 2189.28 2189.28 2189.28 -41.7144 1.102001 15.1513 -4892.21 -4892.21 -4892.21 -41.7144 1.102001 16.1513 -823.86 -823.86 -823.86 -42.7144 0.10200100000000001 15.1513 -2222.23 -2222.23 -2222.23 -42.7144 0.10200100000000001 16.1513 6424.86 6424.86 6424.86 -42.7144 1.102001 15.1513 4782.93 4782.93 4782.93 -42.7144 1.102001 16.1513 4093.38 4093.38 4093.38 -41.7144 2.102001 13.1513 1875.12 1875.12 1875.12 -41.7144 2.102001 14.1513 -1428.45 -1428.45 -1428.45 -41.7144 3.102001 13.1513 607.93 607.93 607.93 -41.7144 3.102001 14.1513 670.701 670.701 670.701 -42.7144 2.102001 13.1513 54.6994 54.6994 54.6994 -42.7144 2.102001 14.1513 792.27 792.27 792.27 -42.7144 3.102001 13.1513 1294.56 1294.56 1294.56 -42.7144 3.102001 14.1513 -138.438 -138.438 -138.438 -41.7144 2.102001 15.1513 711.079 711.079 711.079 -41.7144 2.102001 16.1513 -684.681 -684.681 -684.681 -41.7144 3.102001 15.1513 1489.14 1489.14 1489.14 -41.7144 3.102001 16.1513 800.987 800.987 800.987 -42.7144 2.102001 15.1513 -1082.71 -1082.71 -1082.71 -42.7144 2.102001 16.1513 -91.2043 -91.2043 -91.2043 -43.7144 0.10200100000000001 13.1513 2100.97 2100.97 2100.97 -43.7144 0.10200100000000001 14.1513 -5.14819 -5.14819 -5.14819 -43.7144 1.102001 13.1513 1172.08 1172.08 1172.08 -43.7144 1.102001 14.1513 1425.01 1425.01 1425.01 -44.7144 0.10200100000000001 13.1513 -6883.47 -6883.47 -6883.47 -44.7144 0.10200100000000001 14.1513 -1720.79 -1720.79 -1720.79 -44.7144 1.102001 13.1513 -104.298 -104.298 -104.298 -44.7144 1.102001 14.1513 -209.117 -209.117 -209.117 -43.7144 0.10200100000000001 16.1513 -3727.49 -3727.49 -3727.49 -43.7144 1.102001 15.1513 4460.14 4460.14 4460.14 -43.7144 1.102001 16.1513 3032.05 3032.05 3032.05 -44.7144 0.10200100000000001 15.1513 -2803.04 -2803.04 -2803.04 -44.7144 0.10200100000000001 16.1513 -12465.0 -12465.0 -12465.0 -44.7144 1.102001 15.1513 -1302.95 -1302.95 -1302.95 -44.7144 1.102001 16.1513 -13552.8 -13552.8 -13552.8 -43.7144 2.102001 13.1513 -439.063 -439.063 -439.063 -43.7144 3.102001 13.1513 -38.0523 -38.0523 -38.0523 -44.7144 2.102001 13.1513 873.541 873.541 873.541 -44.7144 3.102001 13.1513 -672.946 -672.946 -672.946 -43.7144 2.102001 15.1513 2940.74 2940.74 2940.74 -43.7144 2.102001 16.1513 1092.19 1092.19 1092.19 -44.7144 2.102001 15.1513 -371.721 -371.721 -371.721 -44.7144 2.102001 16.1513 -2765.64 -2765.64 -2765.64 -44.7144 3.102001 16.1513 309.307 309.307 309.307 -41.7144 0.10200100000000001 17.1513 -4812.03 -4812.03 -4812.03 -41.7144 0.10200100000000001 18.1513 6851.83 6851.83 6851.83 -41.7144 1.102001 17.1513 1848.13 1848.13 1848.13 -41.7144 1.102001 18.1513 1507.77 1507.77 1507.77 -42.7144 0.10200100000000001 17.1513 -476.687 -476.687 -476.687 -42.7144 0.10200100000000001 18.1513 -1546.79 -1546.79 -1546.79 -41.7144 1.102001 19.1513 -6932.26 -6932.26 -6932.26 -41.7144 1.102001 20.1513 -14502.2 -14502.2 -14502.2 -42.7144 0.10200100000000001 19.1513 3995.29 3995.29 3995.29 -42.7144 0.10200100000000001 20.1513 -2978.78 -2978.78 -2978.78 -42.7144 1.102001 19.1513 -9852.01 -9852.01 -9852.01 -42.7144 1.102001 20.1513 -2011.28 -2011.28 -2011.28 -41.7144 2.102001 17.1513 1462.99 1462.99 1462.99 -41.7144 2.102001 18.1513 -391.559 -391.559 -391.559 -41.7144 3.102001 17.1513 -470.413 -470.413 -470.413 -41.7144 3.102001 18.1513 3177.06 3177.06 3177.06 -42.7144 2.102001 17.1513 3902.88 3902.88 3902.88 -42.7144 2.102001 18.1513 9596.01 9596.01 9596.01 -42.7144 3.102001 17.1513 -65.8937 -65.8937 -65.8937 -42.7144 3.102001 18.1513 1103.17 1103.17 1103.17 -41.7144 2.102001 19.1513 1704.45 1704.45 1704.45 -41.7144 2.102001 20.1513 6467.0 6467.0 6467.0 -41.7144 3.102001 19.1513 3178.87 3178.87 3178.87 -41.7144 3.102001 20.1513 -284.517 -284.517 -284.517 -42.7144 2.102001 19.1513 -5568.86 -5568.86 -5568.86 -42.7144 2.102001 20.1513 3978.91 3978.91 3978.91 -42.7144 3.102001 19.1513 -916.943 -916.943 -916.943 -42.7144 3.102001 20.1513 -951.825 -951.825 -951.825 -43.7144 0.10200100000000001 17.1513 2641.46 2641.46 2641.46 -43.7144 0.10200100000000001 18.1513 3684.61 3684.61 3684.61 -43.7144 1.102001 17.1513 3035.15 3035.15 3035.15 -43.7144 1.102001 18.1513 6051.94 6051.94 6051.94 -44.7144 0.10200100000000001 17.1513 -6957.73 -6957.73 -6957.73 -44.7144 0.10200100000000001 18.1513 -378.351 -378.351 -378.351 -44.7144 1.102001 17.1513 -6720.31 -6720.31 -6720.31 -44.7144 1.102001 18.1513 4292.02 4292.02 4292.02 -43.7144 0.10200100000000001 19.1513 -11715.8 -11715.8 -11715.8 -43.7144 0.10200100000000001 20.1513 1879.86 1879.86 1879.86 -43.7144 1.102001 19.1513 -8069.35 -8069.35 -8069.35 -44.7144 0.10200100000000001 19.1513 -1991.13 -1991.13 -1991.13 -44.7144 0.10200100000000001 20.1513 -426.43 -426.43 -426.43 -44.7144 1.102001 19.1513 -1476.59 -1476.59 -1476.59 -44.7144 2.102001 17.1513 -4121.35 -4121.35 -4121.35 -43.7144 3.102001 20.1513 -3011.32 -3011.32 -3011.32 -41.7144 4.102001 13.1513 497.377 497.377 497.377 -42.7144 4.102001 13.1513 797.522 797.522 797.522 -41.7144 4.102001 15.1513 1033.59 1033.59 1033.59 -41.7144 4.102001 16.1513 -2605.52 -2605.52 -2605.52 -41.7144 5.102001 16.1513 -337.329 -337.329 -337.329 -42.7144 5.102001 16.1513 -113.777 -113.777 -113.777 -41.7144 6.102001 14.1513 5753.49 5753.49 5753.49 -41.7144 7.102001 13.1513 -4032.51 -4032.51 -4032.51 -41.7144 7.102001 14.1513 -3756.62 -3756.62 -3756.62 -42.7144 6.102001 14.1513 2302.09 2302.09 2302.09 -42.7144 7.102001 13.1513 -4960.11 -4960.11 -4960.11 -42.7144 7.102001 14.1513 -4085.67 -4085.67 -4085.67 -41.7144 6.102001 15.1513 11103.8 11103.8 11103.8 -41.7144 6.102001 16.1513 -1599.6 -1599.6 -1599.6 -41.7144 7.102001 15.1513 3011.73 3011.73 3011.73 -41.7144 7.102001 16.1513 51.1839 51.1839 51.1839 -42.7144 6.102001 15.1513 5459.89 5459.89 5459.89 -42.7144 6.102001 16.1513 -2.49593 -2.49593 -2.49593 -43.7144 4.102001 13.1513 155.923 155.923 155.923 -43.7144 4.102001 14.1513 -339.54 -339.54 -339.54 -43.7144 5.102001 13.1513 -874.676 -874.676 -874.676 -43.7144 5.102001 14.1513 -540.536 -540.536 -540.536 -44.7144 4.102001 13.1513 1145.73 1145.73 1145.73 -44.7144 5.102001 13.1513 -362.206 -362.206 -362.206 -44.7144 5.102001 14.1513 -114.523 -114.523 -114.523 -43.7144 5.102001 15.1513 -846.406 -846.406 -846.406 -43.7144 5.102001 16.1513 -40.3587 -40.3587 -40.3587 -44.7144 4.102001 15.1513 -281.245 -281.245 -281.245 -44.7144 4.102001 16.1513 365.432 365.432 365.432 -44.7144 5.102001 15.1513 -18.1247 -18.1247 -18.1247 -44.7144 5.102001 16.1513 27.9436 27.9436 27.9436 -43.7144 6.102001 13.1513 -1797.26 -1797.26 -1797.26 -43.7144 6.102001 14.1513 2904.05 2904.05 2904.05 -43.7144 7.102001 13.1513 -4647.19 -4647.19 -4647.19 -43.7144 7.102001 14.1513 -1812.48 -1812.48 -1812.48 -44.7144 6.102001 13.1513 -516.868 -516.868 -516.868 -44.7144 6.102001 14.1513 62.736 62.736 62.736 -44.7144 7.102001 13.1513 -503.294 -503.294 -503.294 -44.7144 7.102001 14.1513 -85.8379 -85.8379 -85.8379 -43.7144 6.102001 15.1513 2493.98 2493.98 2493.98 -43.7144 6.102001 16.1513 31.7825 31.7825 31.7825 -44.7144 6.102001 15.1513 -47.2169 -47.2169 -47.2169 -44.7144 6.102001 16.1513 -35.3812 -35.3812 -35.3812 -44.7144 7.102001 15.1513 60.7639 60.7639 60.7639 -44.7144 7.102001 16.1513 13.5421 13.5421 13.5421 -41.7144 4.102001 17.1513 -16.9995 -16.9995 -16.9995 -41.7144 4.102001 18.1513 1542.14 1542.14 1542.14 -41.7144 5.102001 17.1513 71.5983 71.5983 71.5983 -41.7144 5.102001 18.1513 576.346 576.346 576.346 -42.7144 4.102001 17.1513 -255.052 -255.052 -255.052 -42.7144 4.102001 18.1513 333.54 333.54 333.54 -42.7144 5.102001 17.1513 -185.762 -185.762 -185.762 -42.7144 5.102001 18.1513 284.017 284.017 284.017 -41.7144 4.102001 19.1513 964.653 964.653 964.653 -41.7144 4.102001 20.1513 -517.246 -517.246 -517.246 -41.7144 5.102001 19.1513 243.665 243.665 243.665 -41.7144 5.102001 20.1513 -1484.12 -1484.12 -1484.12 -42.7144 4.102001 20.1513 1011.6 1011.6 1011.6 -42.7144 5.102001 20.1513 684.69 684.69 684.69 -41.7144 6.102001 17.1513 -52.3841 -52.3841 -52.3841 -41.7144 6.102001 18.1513 1127.45 1127.45 1127.45 -41.7144 7.102001 17.1513 -36.661 -36.661 -36.661 -42.7144 6.102001 17.1513 151.361 151.361 151.361 -42.7144 6.102001 18.1513 256.714 256.714 256.714 -42.7144 7.102001 17.1513 58.4143 58.4143 58.4143 -41.7144 6.102001 19.1513 -6.98462 -6.98462 -6.98462 -41.7144 6.102001 20.1513 -599.822 -599.822 -599.822 -41.7144 7.102001 19.1513 339.825 339.825 339.825 -41.7144 7.102001 20.1513 938.995 938.995 938.995 -42.7144 6.102001 19.1513 -377.706 -377.706 -377.706 -42.7144 6.102001 20.1513 719.62 719.62 719.62 -42.7144 7.102001 19.1513 -203.303 -203.303 -203.303 -42.7144 7.102001 20.1513 215.363 215.363 215.363 -43.7144 4.102001 17.1513 707.974 707.974 707.974 -43.7144 4.102001 18.1513 -1947.64 -1947.64 -1947.64 -43.7144 5.102001 17.1513 34.3524 34.3524 34.3524 -43.7144 5.102001 18.1513 -28.0348 -28.0348 -28.0348 -44.7144 5.102001 17.1513 90.1203 90.1203 90.1203 -44.7144 5.102001 18.1513 -42.0438 -42.0438 -42.0438 -44.7144 5.102001 19.1513 -104.618 -104.618 -104.618 -44.7144 5.102001 20.1513 -1535.75 -1535.75 -1535.75 -43.7144 6.102001 17.1513 -63.1863 -63.1863 -63.1863 -43.7144 6.102001 18.1513 -15.4431 -15.4431 -15.4431 -43.7144 7.102001 17.1513 2.40043 2.40043 2.40043 -44.7144 6.102001 17.1513 -46.3201 -46.3201 -46.3201 -44.7144 6.102001 18.1513 -18.5979 -18.5979 -18.5979 -44.7144 7.102001 17.1513 -35.8518 -35.8518 -35.8518 -44.7144 7.102001 18.1513 -258.504 -258.504 -258.504 -44.7144 6.102001 19.1513 -69.4233 -69.4233 -69.4233 -44.7144 7.102001 19.1513 -163.258 -163.258 -163.258 -44.7144 7.102001 20.1513 934.547 934.547 934.547 -37.7144 0.10200100000000001 21.1513 2405.01 2405.01 2405.01 -37.7144 0.10200100000000001 22.1513 4438.62 4438.62 4438.62 -37.7144 1.102001 21.1513 989.573 989.573 989.573 -37.7144 1.102001 22.1513 1512.18 1512.18 1512.18 -38.7144 0.10200100000000001 21.1513 -12404.4 -12404.4 -12404.4 -38.7144 0.10200100000000001 22.1513 -2753.95 -2753.95 -2753.95 -38.7144 1.102001 21.1513 -752.35 -752.35 -752.35 -38.7144 1.102001 22.1513 -3533.49 -3533.49 -3533.49 -37.7144 0.10200100000000001 23.1513 1624.22 1624.22 1624.22 -37.7144 1.102001 23.1513 693.781 693.781 693.781 -38.7144 0.10200100000000001 23.1513 -1032.31 -1032.31 -1032.31 -37.7144 2.102001 21.1513 -2832.95 -2832.95 -2832.95 -38.7144 2.102001 21.1513 6175.16 6175.16 6175.16 -39.7144 0.10200100000000001 21.1513 -4032.46 -4032.46 -4032.46 -39.7144 1.102001 21.1513 -1469.37 -1469.37 -1469.37 -40.7144 0.10200100000000001 21.1513 5249.69 5249.69 5249.69 -40.7144 1.102001 21.1513 8414.22 8414.22 8414.22 -39.7144 2.102001 21.1513 -1642.59 -1642.59 -1642.59 -40.7144 2.102001 21.1513 2114.45 2114.45 2114.45 -37.7144 5.102001 21.1513 -1710.78 -1710.78 -1710.78 -38.7144 5.102001 21.1513 -2785.39 -2785.39 -2785.39 -37.7144 6.102001 21.1513 -1867.95 -1867.95 -1867.95 -37.7144 6.102001 22.1513 -639.522 -639.522 -639.522 -37.7144 7.102001 21.1513 -212.693 -212.693 -212.693 -37.7144 7.102001 22.1513 -173.333 -173.333 -173.333 -38.7144 6.102001 21.1513 22705.2 22705.2 22705.2 -38.7144 6.102001 22.1513 -595.693 -595.693 -595.693 -37.7144 6.102001 23.1513 1476.81 1476.81 1476.81 -37.7144 7.102001 23.1513 -1640.78 -1640.78 -1640.78 -38.7144 6.102001 23.1513 4614.06 4614.06 4614.06 -38.7144 7.102001 23.1513 129.152 129.152 129.152 -38.7144 7.102001 24.1513 75.2619 75.2619 75.2619 -39.7144 5.102001 21.1513 3574.91 3574.91 3574.91 -39.7144 5.102001 22.1513 2762.23 2762.23 2762.23 -40.7144 5.102001 21.1513 -388.573 -388.573 -388.573 -40.7144 5.102001 22.1513 -109.943 -109.943 -109.943 -39.7144 5.102001 23.1513 -464.953 -464.953 -464.953 -39.7144 5.102001 24.1513 1453.13 1453.13 1453.13 -40.7144 5.102001 23.1513 -298.591 -298.591 -298.591 -40.7144 5.102001 24.1513 -243.509 -243.509 -243.509 -39.7144 6.102001 22.1513 -301.253 -301.253 -301.253 -40.7144 6.102001 21.1513 -54957.6 -54957.6 -54957.6 -40.7144 6.102001 22.1513 3148.27 3148.27 3148.27 -40.7144 7.102001 21.1513 -64157.6 -64157.6 -64157.6 -39.7144 6.102001 23.1513 371.102 371.102 371.102 -39.7144 6.102001 24.1513 -402.897 -402.897 -402.897 -39.7144 7.102001 23.1513 -2273.47 -2273.47 -2273.47 -39.7144 7.102001 24.1513 756.526 756.526 756.526 -40.7144 6.102001 23.1513 3580.73 3580.73 3580.73 -40.7144 6.102001 24.1513 1563.55 1563.55 1563.55 -40.7144 7.102001 24.1513 2202.34 2202.34 2202.34 -40.7144 5.102001 25.1513 12834.6 12834.6 12834.6 -39.7144 6.102001 25.1513 -8410.38 -8410.38 -8410.38 -39.7144 7.102001 25.1513 -1664.7 -1664.7 -1664.7 -40.7144 6.102001 25.1513 932.833 932.833 932.833 -40.7144 7.102001 25.1513 6466.08 6466.08 6466.08 -42.7144 0.10200100000000001 21.1513 11276.8 11276.8 11276.8 -42.7144 0.10200100000000001 22.1513 5639.61 5639.61 5639.61 -42.7144 1.102001 21.1513 1098.69 1098.69 1098.69 -42.7144 1.102001 22.1513 -8407.88 -8407.88 -8407.88 -42.7144 0.10200100000000001 23.1513 -749.592 -749.592 -749.592 -42.7144 1.102001 23.1513 -1676.43 -1676.43 -1676.43 -42.7144 1.102001 24.1513 2401.33 2401.33 2401.33 -42.7144 2.102001 21.1513 -693.267 -693.267 -693.267 -42.7144 2.102001 22.1513 -2941.61 -2941.61 -2941.61 -42.7144 3.102001 21.1513 -433.407 -433.407 -433.407 -42.7144 3.102001 22.1513 -5900.86 -5900.86 -5900.86 -42.7144 2.102001 23.1513 471.563 471.563 471.563 -42.7144 2.102001 24.1513 -21.5438 -21.5438 -21.5438 -42.7144 3.102001 23.1513 -542.462 -542.462 -542.462 -43.7144 0.10200100000000001 21.1513 -2252.04 -2252.04 -2252.04 -43.7144 0.10200100000000001 22.1513 -5298.71 -5298.71 -5298.71 -43.7144 1.102001 21.1513 -3274.4 -3274.4 -3274.4 -44.7144 0.10200100000000001 21.1513 -3098.7 -3098.7 -3098.7 -44.7144 0.10200100000000001 22.1513 -3206.03 -3206.03 -3206.03 -43.7144 0.10200100000000001 23.1513 -480.331 -480.331 -480.331 -43.7144 0.10200100000000001 24.1513 -1830.0 -1830.0 -1830.0 -43.7144 1.102001 24.1513 -5194.37 -5194.37 -5194.37 -44.7144 0.10200100000000001 23.1513 -2074.17 -2074.17 -2074.17 -44.7144 0.10200100000000001 24.1513 9667.81 9667.81 9667.81 -43.7144 2.102001 21.1513 4166.81 4166.81 4166.81 -43.7144 2.102001 22.1513 2527.24 2527.24 2527.24 -43.7144 3.102001 21.1513 1597.36 1597.36 1597.36 -43.7144 3.102001 22.1513 -2441.23 -2441.23 -2441.23 -44.7144 3.102001 21.1513 -1121.72 -1121.72 -1121.72 -44.7144 3.102001 22.1513 -8136.48 -8136.48 -8136.48 -43.7144 2.102001 23.1513 6457.66 6457.66 6457.66 -43.7144 2.102001 24.1513 -6545.35 -6545.35 -6545.35 -43.7144 3.102001 23.1513 2398.19 2398.19 2398.19 -43.7144 3.102001 24.1513 3849.57 3849.57 3849.57 -44.7144 3.102001 23.1513 -2511.78 -2511.78 -2511.78 -43.7144 0.10200100000000001 25.1513 1687.95 1687.95 1687.95 -43.7144 1.102001 25.1513 -2182.46 -2182.46 -2182.46 -44.7144 0.10200100000000001 25.1513 -357.439 -357.439 -357.439 -44.7144 1.102001 25.1513 22579.9 22579.9 22579.9 -43.7144 2.102001 25.1513 -2576.38 -2576.38 -2576.38 -43.7144 3.102001 25.1513 -3490.45 -3490.45 -3490.45 -44.7144 2.102001 25.1513 4050.08 4050.08 4050.08 -44.7144 2.102001 26.1513 -2137.4 -2137.4 -2137.4 -44.7144 3.102001 25.1513 3421.28 3421.28 3421.28 -44.7144 3.102001 26.1513 -6973.56 -6973.56 -6973.56 -41.7144 4.102001 21.1513 783.433 783.433 783.433 -41.7144 5.102001 21.1513 1560.78 1560.78 1560.78 -41.7144 5.102001 22.1513 -699.396 -699.396 -699.396 -42.7144 4.102001 21.1513 607.749 607.749 607.749 -42.7144 4.102001 22.1513 -4023.45 -4023.45 -4023.45 -42.7144 5.102001 21.1513 1306.66 1306.66 1306.66 -42.7144 5.102001 22.1513 -11.482 -11.482 -11.482 -41.7144 5.102001 23.1513 -4322.06 -4322.06 -4322.06 -41.7144 5.102001 24.1513 -321.78 -321.78 -321.78 -42.7144 4.102001 23.1513 -564.972 -564.972 -564.972 -42.7144 4.102001 24.1513 -1290.83 -1290.83 -1290.83 -42.7144 5.102001 23.1513 -749.856 -749.856 -749.856 -42.7144 5.102001 24.1513 1637.94 1637.94 1637.94 -41.7144 6.102001 21.1513 67.2388 67.2388 67.2388 -41.7144 6.102001 22.1513 82821.3 82821.3 82821.3 -41.7144 7.102001 21.1513 226.301 226.301 226.301 -41.7144 7.102001 22.1513 -27346.3 -27346.3 -27346.3 -42.7144 6.102001 21.1513 -701.68 -701.68 -701.68 -42.7144 6.102001 22.1513 -10797.2 -10797.2 -10797.2 -42.7144 7.102001 21.1513 547.869 547.869 547.869 -42.7144 7.102001 22.1513 -24216.1 -24216.1 -24216.1 -41.7144 6.102001 23.1513 375377.0 375377.0 375377.0 -41.7144 6.102001 24.1513 292272.0 292272.0 292272.0 -41.7144 7.102001 24.1513 -5725.21 -5725.21 -5725.21 -42.7144 6.102001 23.1513 -323610.0 -323610.0 -323610.0 -42.7144 6.102001 24.1513 5872.55 5872.55 5872.55 -42.7144 7.102001 23.1513 -422821.0 -422821.0 -422821.0 -42.7144 7.102001 24.1513 -147969.0 -147969.0 -147969.0 -43.7144 4.102001 21.1513 -636.739 -636.739 -636.739 -43.7144 4.102001 22.1513 -7030.07 -7030.07 -7030.07 -43.7144 5.102001 21.1513 3077.78 3077.78 3077.78 -44.7144 4.102001 21.1513 -3503.59 -3503.59 -3503.59 -44.7144 4.102001 22.1513 471.372 471.372 471.372 -44.7144 5.102001 21.1513 5640.58 5640.58 5640.58 -43.7144 4.102001 24.1513 2999.56 2999.56 2999.56 -43.7144 5.102001 24.1513 571.64 571.64 571.64 -44.7144 4.102001 24.1513 -883.212 -883.212 -883.212 -44.7144 5.102001 24.1513 -305.393 -305.393 -305.393 -43.7144 7.102001 22.1513 -105311.0 -105311.0 -105311.0 -44.7144 7.102001 21.1513 -626.149 -626.149 -626.149 -44.7144 7.102001 22.1513 -687.23 -687.23 -687.23 -43.7144 6.102001 23.1513 -367830.0 -367830.0 -367830.0 -43.7144 6.102001 24.1513 77201.3 77201.3 77201.3 -43.7144 7.102001 23.1513 -58472.6 -58472.6 -58472.6 -43.7144 7.102001 24.1513 -277379.0 -277379.0 -277379.0 -44.7144 6.102001 24.1513 -237.723 -237.723 -237.723 -44.7144 7.102001 23.1513 -3.69693 -3.69693 -3.69693 -44.7144 7.102001 24.1513 -214.154 -214.154 -214.154 -41.7144 5.102001 25.1513 5191.55 5191.55 5191.55 -41.7144 6.102001 25.1513 11213.0 11213.0 11213.0 -41.7144 7.102001 25.1513 5227.72 5227.72 5227.72 -42.7144 7.102001 25.1513 -22269.3 -22269.3 -22269.3 -43.7144 4.102001 25.1513 4593.67 4593.67 4593.67 -44.7144 4.102001 25.1513 1653.4 1653.4 1653.4 -44.7144 5.102001 25.1513 3133.76 3133.76 3133.76 -37.7144 8.102001 14.1513 -1959.89 -1959.89 -1959.89 -37.7144 9.102001 14.1513 -1316.48 -1316.48 -1316.48 -37.7144 8.102001 15.1513 -981.569 -981.569 -981.569 -37.7144 8.102001 16.1513 1306.62 1306.62 1306.62 -37.7144 9.102001 15.1513 -309.977 -309.977 -309.977 -37.7144 9.102001 16.1513 596.073 596.073 596.073 -38.7144 8.102001 15.1513 -1120.2 -1120.2 -1120.2 -38.7144 8.102001 16.1513 494.617 494.617 494.617 -38.7144 9.102001 15.1513 856.768 856.768 856.768 -38.7144 9.102001 16.1513 95.74 95.74 95.74 -37.7144 10.102001 14.1513 -2879.67 -2879.67 -2879.67 -37.7144 11.102001 14.1513 296.138 296.138 296.138 -38.7144 10.102001 14.1513 -261.569 -261.569 -261.569 -38.7144 11.102001 14.1513 48.2489 48.2489 48.2489 -37.7144 10.102001 15.1513 -63.1544 -63.1544 -63.1544 -37.7144 11.102001 15.1513 946.899 946.899 946.899 -37.7144 11.102001 16.1513 -136.904 -136.904 -136.904 -38.7144 10.102001 15.1513 694.31 694.31 694.31 -38.7144 11.102001 15.1513 -116.3 -116.3 -116.3 -39.7144 8.102001 13.1513 -15.4866 -15.4866 -15.4866 -39.7144 9.102001 13.1513 3225.76 3225.76 3225.76 -40.7144 8.102001 13.1513 -1073.84 -1073.84 -1073.84 -40.7144 8.102001 14.1513 1991.76 1991.76 1991.76 -40.7144 9.102001 13.1513 472.546 472.546 472.546 -40.7144 9.102001 14.1513 -119.091 -119.091 -119.091 -40.7144 8.102001 15.1513 84.592 84.592 84.592 -40.7144 8.102001 16.1513 -145.024 -145.024 -145.024 -39.7144 10.102001 13.1513 -976.036 -976.036 -976.036 -39.7144 10.102001 14.1513 255.315 255.315 255.315 -39.7144 11.102001 13.1513 811.308 811.308 811.308 -39.7144 11.102001 14.1513 187.878 187.878 187.878 -40.7144 10.102001 13.1513 -1954.28 -1954.28 -1954.28 -40.7144 10.102001 14.1513 -1488.51 -1488.51 -1488.51 -39.7144 10.102001 15.1513 -31.4381 -31.4381 -31.4381 -39.7144 11.102001 15.1513 -78.4937 -78.4937 -78.4937 -39.7144 11.102001 16.1513 -47.4194 -47.4194 -47.4194 -40.7144 10.102001 15.1513 1062.1 1062.1 1062.1 -40.7144 10.102001 16.1513 1.79176 1.79176 1.79176 -40.7144 11.102001 15.1513 593.884 593.884 593.884 -40.7144 11.102001 16.1513 -12.6734 -12.6734 -12.6734 -37.7144 8.102001 18.1513 1922.09 1922.09 1922.09 -37.7144 9.102001 17.1513 458.25 458.25 458.25 -37.7144 9.102001 18.1513 913.053 913.053 913.053 -38.7144 8.102001 18.1513 -893.517 -893.517 -893.517 -38.7144 9.102001 18.1513 1144.0 1144.0 1144.0 -37.7144 8.102001 19.1513 3545.53 3545.53 3545.53 -37.7144 8.102001 20.1513 1383.88 1383.88 1383.88 -38.7144 8.102001 19.1513 39165.6 39165.6 39165.6 -38.7144 8.102001 20.1513 -12647.0 -12647.0 -12647.0 -37.7144 10.102001 18.1513 655.559 655.559 655.559 -37.7144 11.102001 18.1513 -67.7981 -67.7981 -67.7981 -38.7144 10.102001 18.1513 -762.647 -762.647 -762.647 -38.7144 11.102001 18.1513 -32.1444 -32.1444 -32.1444 -39.7144 8.102001 18.1513 -888.032 -888.032 -888.032 -39.7144 9.102001 18.1513 -481.385 -481.385 -481.385 -40.7144 8.102001 17.1513 -32.2389 -32.2389 -32.2389 -40.7144 8.102001 18.1513 192.213 192.213 192.213 -40.7144 9.102001 17.1513 -35.4352 -35.4352 -35.4352 -40.7144 9.102001 18.1513 12.1338 12.1338 12.1338 -39.7144 8.102001 19.1513 -4329.5 -4329.5 -4329.5 -39.7144 8.102001 20.1513 6065.73 6065.73 6065.73 -40.7144 8.102001 19.1513 -7236.1 -7236.1 -7236.1 -40.7144 8.102001 20.1513 33818.1 33818.1 33818.1 -39.7144 10.102001 18.1513 -634.498 -634.498 -634.498 -39.7144 11.102001 17.1513 -27.1246 -27.1246 -27.1246 -39.7144 11.102001 18.1513 -45.9939 -45.9939 -45.9939 -40.7144 10.102001 17.1513 32.7811 32.7811 32.7811 -40.7144 10.102001 18.1513 26.2602 26.2602 26.2602 -40.7144 11.102001 17.1513 -3.14759 -3.14759 -3.14759 -37.7144 12.102001 13.1513 -482.757 -482.757 -482.757 -37.7144 12.102001 14.1513 71.8889 71.8889 71.8889 -37.7144 13.102001 13.1513 733.638 733.638 733.638 -38.7144 12.102001 13.1513 -359.592 -359.592 -359.592 -38.7144 12.102001 14.1513 -238.688 -238.688 -238.688 -37.7144 12.102001 15.1513 -835.841 -835.841 -835.841 -37.7144 12.102001 16.1513 -9.51379 -9.51379 -9.51379 -38.7144 12.102001 15.1513 -98.6633 -98.6633 -98.6633 -38.7144 12.102001 16.1513 -36.1785 -36.1785 -36.1785 -39.7144 12.102001 13.1513 1723.62 1723.62 1723.62 -39.7144 12.102001 14.1513 -75.7718 -75.7718 -75.7718 -39.7144 12.102001 15.1513 2.94555 2.94555 2.94555 -39.7144 12.102001 16.1513 3.59768 3.59768 3.59768 -37.7144 12.102001 17.1513 323.718 323.718 323.718 -37.7144 12.102001 18.1513 40.3116 40.3116 40.3116 -38.7144 12.102001 17.1513 179.588 179.588 179.588 -38.7144 12.102001 18.1513 55.6071 55.6071 55.6071 -39.7144 12.102001 17.1513 -33.6978 -33.6978 -33.6978 -39.7144 12.102001 18.1513 -51.6925 -51.6925 -51.6925 -41.7144 8.102001 14.1513 -1607.68 -1607.68 -1607.68 -41.7144 9.102001 14.1513 2306.31 2306.31 2306.31 -41.7144 8.102001 15.1513 252.326 252.326 252.326 -41.7144 8.102001 16.1513 -57.3866 -57.3866 -57.3866 -41.7144 9.102001 15.1513 124.747 124.747 124.747 -41.7144 9.102001 16.1513 -84.3089 -84.3089 -84.3089 -41.7144 10.102001 14.1513 -919.709 -919.709 -919.709 -41.7144 10.102001 15.1513 -768.028 -768.028 -768.028 -41.7144 10.102001 16.1513 -44.4309 -44.4309 -44.4309 -43.7144 8.102001 13.1513 -1491.34 -1491.34 -1491.34 -43.7144 9.102001 13.1513 -386.221 -386.221 -386.221 -44.7144 8.102001 13.1513 75.7901 75.7901 75.7901 -44.7144 8.102001 14.1513 -168.965 -168.965 -168.965 -44.7144 9.102001 13.1513 -564.117 -564.117 -564.117 -44.7144 9.102001 14.1513 -567.162 -567.162 -567.162 -44.7144 10.102001 13.1513 532.82 532.82 532.82 -41.7144 8.102001 17.1513 -64.7272 -64.7272 -64.7272 -41.7144 8.102001 18.1513 102.843 102.843 102.843 -41.7144 9.102001 17.1513 47.8063 47.8063 47.8063 -42.7144 8.102001 17.1513 -58.3616 -58.3616 -58.3616 -42.7144 8.102001 18.1513 140.003 140.003 140.003 -41.7144 8.102001 19.1513 67.1071 67.1071 67.1071 -41.7144 8.102001 20.1513 -1064.48 -1064.48 -1064.48 -42.7144 8.102001 19.1513 -664.053 -664.053 -664.053 -42.7144 8.102001 20.1513 -1796.17 -1796.17 -1796.17 -42.7144 9.102001 19.1513 26.4205 26.4205 26.4205 -41.7144 10.102001 17.1513 5.81192 5.81192 5.81192 -43.7144 8.102001 17.1513 -24.643 -24.643 -24.643 -43.7144 8.102001 18.1513 15.6242 15.6242 15.6242 -43.7144 9.102001 18.1513 211.852 211.852 211.852 -44.7144 8.102001 17.1513 -62.0552 -62.0552 -62.0552 -44.7144 8.102001 18.1513 87.0889 87.0889 87.0889 -43.7144 8.102001 19.1513 282.013 282.013 282.013 -43.7144 8.102001 20.1513 -987.709 -987.709 -987.709 -43.7144 9.102001 19.1513 471.679 471.679 471.679 -43.7144 9.102001 20.1513 -42.0987 -42.0987 -42.0987 -44.7144 8.102001 19.1513 -240.529 -240.529 -240.529 -44.7144 8.102001 20.1513 -658.317 -658.317 -658.317 -44.7144 9.102001 19.1513 581.488 581.488 581.488 -37.7144 8.102001 21.1513 386.609 386.609 386.609 -37.7144 8.102001 22.1513 490.713 490.713 490.713 -37.7144 9.102001 21.1513 -180.005 -180.005 -180.005 -37.7144 9.102001 22.1513 835.238 835.238 835.238 -38.7144 8.102001 21.1513 6771.75 6771.75 6771.75 -38.7144 9.102001 21.1513 -11.6246 -11.6246 -11.6246 -38.7144 9.102001 22.1513 416.932 416.932 416.932 -37.7144 8.102001 23.1513 -86.5797 -86.5797 -86.5797 -37.7144 9.102001 23.1513 47.4722 47.4722 47.4722 -38.7144 8.102001 23.1513 -1056.2 -1056.2 -1056.2 -38.7144 8.102001 24.1513 609.524 609.524 609.524 -38.7144 9.102001 23.1513 -591.208 -591.208 -591.208 -38.7144 9.102001 24.1513 -661.531 -661.531 -661.531 -39.7144 8.102001 21.1513 -4888.11 -4888.11 -4888.11 -39.7144 9.102001 21.1513 -18.9067 -18.9067 -18.9067 -39.7144 9.102001 22.1513 1207.71 1207.71 1207.71 -40.7144 8.102001 21.1513 -22936.8 -22936.8 -22936.8 -40.7144 9.102001 21.1513 420.093 420.093 420.093 -40.7144 9.102001 22.1513 161.17 161.17 161.17 -39.7144 8.102001 24.1513 -3373.26 -3373.26 -3373.26 -39.7144 9.102001 23.1513 668.848 668.848 668.848 -39.7144 9.102001 24.1513 -120.417 -120.417 -120.417 -40.7144 8.102001 24.1513 1652.35 1652.35 1652.35 -40.7144 9.102001 23.1513 91.7476 91.7476 91.7476 -40.7144 9.102001 24.1513 -828.725 -828.725 -828.725 -39.7144 10.102001 22.1513 -851.336 -851.336 -851.336 -40.7144 10.102001 22.1513 -1455.7 -1455.7 -1455.7 -39.7144 10.102001 23.1513 946.582 946.582 946.582 -40.7144 10.102001 23.1513 -126.411 -126.411 -126.411 -40.7144 8.102001 25.1513 5508.4 5508.4 5508.4 -41.7144 8.102001 21.1513 2232.13 2232.13 2232.13 -41.7144 8.102001 22.1513 -7115.9 -7115.9 -7115.9 -41.7144 9.102001 21.1513 -1190.03 -1190.03 -1190.03 -41.7144 9.102001 22.1513 1844.62 1844.62 1844.62 -42.7144 8.102001 21.1513 640.856 640.856 640.856 -42.7144 8.102001 22.1513 232980.0 232980.0 232980.0 -41.7144 8.102001 23.1513 377409.0 377409.0 377409.0 -41.7144 8.102001 24.1513 244515.0 244515.0 244515.0 -41.7144 9.102001 23.1513 -84.2991 -84.2991 -84.2991 -41.7144 9.102001 24.1513 469.073 469.073 469.073 -42.7144 8.102001 23.1513 -81325.4 -81325.4 -81325.4 -42.7144 8.102001 24.1513 318519.0 318519.0 318519.0 -42.7144 9.102001 23.1513 246.88 246.88 246.88 -42.7144 9.102001 24.1513 2053.93 2053.93 2053.93 -43.7144 8.102001 21.1513 33.5476 33.5476 33.5476 -43.7144 8.102001 22.1513 -43895.4 -43895.4 -43895.4 -44.7144 8.102001 21.1513 110.094 110.094 110.094 -44.7144 8.102001 22.1513 110.602 110.602 110.602 -43.7144 8.102001 23.1513 -27512.1 -27512.1 -27512.1 -43.7144 8.102001 24.1513 -77682.2 -77682.2 -77682.2 -44.7144 8.102001 23.1513 -1041.42 -1041.42 -1041.42 -44.7144 8.102001 24.1513 -693.864 -693.864 -693.864 -41.7144 8.102001 25.1513 -1458.7 -1458.7 -1458.7 -42.7144 8.102001 25.1513 -12488.0 -12488.0 -12488.0 -45.7144 0.10200100000000001 13.1513 -8976.42 -8976.42 -8976.42 -45.7144 0.10200100000000001 14.1513 -4077.13 -4077.13 -4077.13 -45.7144 1.102001 13.1513 -187.094 -187.094 -187.094 -45.7144 1.102001 14.1513 186.806 186.806 186.806 -46.7144 0.10200100000000001 13.1513 -671.225 -671.225 -671.225 -46.7144 0.10200100000000001 14.1513 400.196 400.196 400.196 -46.7144 1.102001 13.1513 -2077.08 -2077.08 -2077.08 -46.7144 1.102001 14.1513 -174.66 -174.66 -174.66 -45.7144 0.10200100000000001 15.1513 -1941.7 -1941.7 -1941.7 -45.7144 0.10200100000000001 16.1513 1687.08 1687.08 1687.08 -45.7144 1.102001 15.1513 1262.47 1262.47 1262.47 -45.7144 1.102001 16.1513 -4096.78 -4096.78 -4096.78 -46.7144 0.10200100000000001 15.1513 -779.013 -779.013 -779.013 -46.7144 0.10200100000000001 16.1513 -830.882 -830.882 -830.882 -46.7144 1.102001 15.1513 0.984055 0.984055 0.984055 -46.7144 1.102001 16.1513 -282.726 -282.726 -282.726 -45.7144 2.102001 13.1513 316.88 316.88 316.88 -45.7144 2.102001 14.1513 -221.988 -221.988 -221.988 -46.7144 3.102001 14.1513 -28.1105 -28.1105 -28.1105 -45.7144 2.102001 15.1513 3687.67 3687.67 3687.67 -45.7144 2.102001 16.1513 -3260.5 -3260.5 -3260.5 -45.7144 3.102001 15.1513 -56.1855 -56.1855 -56.1855 -45.7144 3.102001 16.1513 -239.843 -239.843 -239.843 -46.7144 2.102001 16.1513 444.056 444.056 444.056 -46.7144 3.102001 15.1513 -751.832 -751.832 -751.832 -46.7144 3.102001 16.1513 -404.836 -404.836 -404.836 -47.7144 0.10200100000000001 14.1513 736.704 736.704 736.704 -47.7144 1.102001 14.1513 784.317 784.317 784.317 -48.7144 0.10200100000000001 14.1513 9615.57 9615.57 9615.57 -48.7144 1.102001 13.1513 9225.5 9225.5 9225.5 -48.7144 1.102001 14.1513 4868.83 4868.83 4868.83 -47.7144 0.10200100000000001 15.1513 919.788 919.788 919.788 -47.7144 0.10200100000000001 16.1513 803.529 803.529 803.529 -47.7144 1.102001 15.1513 -961.716 -961.716 -961.716 -47.7144 1.102001 16.1513 -485.288 -485.288 -485.288 -48.7144 0.10200100000000001 15.1513 1392.36 1392.36 1392.36 -48.7144 0.10200100000000001 16.1513 -668.227 -668.227 -668.227 -48.7144 1.102001 15.1513 4115.46 4115.46 4115.46 -48.7144 1.102001 16.1513 -3.72429 -3.72429 -3.72429 -47.7144 3.102001 13.1513 623.435 623.435 623.435 -47.7144 3.102001 14.1513 179.244 179.244 179.244 -48.7144 2.102001 13.1513 6157.14 6157.14 6157.14 -48.7144 2.102001 14.1513 -7406.49 -7406.49 -7406.49 -48.7144 3.102001 13.1513 -4052.43 -4052.43 -4052.43 -48.7144 3.102001 14.1513 -5226.48 -5226.48 -5226.48 -47.7144 2.102001 16.1513 138.261 138.261 138.261 -47.7144 3.102001 15.1513 97.1195 97.1195 97.1195 -47.7144 3.102001 16.1513 99.0544 99.0544 99.0544 -48.7144 2.102001 15.1513 647.333 647.333 647.333 -48.7144 2.102001 16.1513 -305.532 -305.532 -305.532 -48.7144 3.102001 15.1513 -169.395 -169.395 -169.395 -48.7144 3.102001 16.1513 227.055 227.055 227.055 -45.7144 0.10200100000000001 17.1513 -889.187 -889.187 -889.187 -45.7144 0.10200100000000001 18.1513 5530.74 5530.74 5530.74 -45.7144 1.102001 17.1513 5984.29 5984.29 5984.29 -45.7144 1.102001 18.1513 2064.68 2064.68 2064.68 -46.7144 0.10200100000000001 18.1513 86.1375 86.1375 86.1375 -46.7144 1.102001 17.1513 332.514 332.514 332.514 -46.7144 1.102001 18.1513 889.019 889.019 889.019 -45.7144 0.10200100000000001 20.1513 343.84 343.84 343.84 -45.7144 1.102001 19.1513 1422.68 1422.68 1422.68 -45.7144 1.102001 20.1513 -854.565 -854.565 -854.565 -46.7144 1.102001 20.1513 731.524 731.524 731.524 -45.7144 2.102001 17.1513 1109.61 1109.61 1109.61 -45.7144 2.102001 18.1513 -587.085 -587.085 -587.085 -45.7144 3.102001 17.1513 -88.0626 -88.0626 -88.0626 -45.7144 3.102001 18.1513 880.965 880.965 880.965 -46.7144 2.102001 17.1513 674.238 674.238 674.238 -46.7144 2.102001 18.1513 -806.779 -806.779 -806.779 -46.7144 3.102001 18.1513 -360.462 -360.462 -360.462 -45.7144 2.102001 19.1513 -2197.78 -2197.78 -2197.78 -45.7144 2.102001 20.1513 1988.28 1988.28 1988.28 -45.7144 3.102001 19.1513 1265.18 1265.18 1265.18 -45.7144 3.102001 20.1513 -1182.8 -1182.8 -1182.8 -46.7144 2.102001 19.1513 -867.623 -867.623 -867.623 -46.7144 2.102001 20.1513 586.327 586.327 586.327 -46.7144 3.102001 19.1513 96.8888 96.8888 96.8888 -46.7144 3.102001 20.1513 1880.15 1880.15 1880.15 -47.7144 0.10200100000000001 17.1513 1321.11 1321.11 1321.11 -47.7144 0.10200100000000001 18.1513 109.455 109.455 109.455 -47.7144 1.102001 17.1513 176.532 176.532 176.532 -47.7144 1.102001 18.1513 -898.069 -898.069 -898.069 -48.7144 0.10200100000000001 17.1513 -975.979 -975.979 -975.979 -48.7144 0.10200100000000001 18.1513 -620.899 -620.899 -620.899 -48.7144 1.102001 17.1513 74.441 74.441 74.441 -48.7144 1.102001 18.1513 58.0552 58.0552 58.0552 -47.7144 2.102001 17.1513 243.223 243.223 243.223 -47.7144 2.102001 18.1513 -2477.83 -2477.83 -2477.83 -45.7144 5.102001 13.1513 288.123 288.123 288.123 -45.7144 5.102001 14.1513 -371.853 -371.853 -371.853 -46.7144 4.102001 14.1513 -146.333 -146.333 -146.333 -46.7144 5.102001 14.1513 220.127 220.127 220.127 -45.7144 4.102001 15.1513 -547.185 -547.185 -547.185 -45.7144 4.102001 16.1513 145.226 145.226 145.226 -45.7144 5.102001 15.1513 255.802 255.802 255.802 -46.7144 4.102001 15.1513 -0.927307 -0.927307 -0.927307 -46.7144 4.102001 16.1513 -76.0489 -76.0489 -76.0489 -46.7144 5.102001 15.1513 -27.674 -27.674 -27.674 -46.7144 5.102001 16.1513 -298.781 -298.781 -298.781 -45.7144 6.102001 13.1513 322.565 322.565 322.565 -45.7144 6.102001 14.1513 18.0123 18.0123 18.0123 -45.7144 7.102001 14.1513 2475.94 2475.94 2475.94 -46.7144 6.102001 14.1513 -517.359 -517.359 -517.359 -46.7144 7.102001 14.1513 -310.725 -310.725 -310.725 -45.7144 6.102001 15.1513 362.659 362.659 362.659 -45.7144 7.102001 15.1513 -1589.8 -1589.8 -1589.8 -45.7144 7.102001 16.1513 79.598 79.598 79.598 -46.7144 6.102001 15.1513 276.232 276.232 276.232 -46.7144 6.102001 16.1513 -161.207 -161.207 -161.207 -46.7144 7.102001 15.1513 -1509.46 -1509.46 -1509.46 -46.7144 7.102001 16.1513 25.7429 25.7429 25.7429 -47.7144 4.102001 14.1513 289.512 289.512 289.512 -47.7144 5.102001 14.1513 344.192 344.192 344.192 -48.7144 4.102001 13.1513 -3071.87 -3071.87 -3071.87 -48.7144 4.102001 14.1513 -909.29 -909.29 -909.29 -48.7144 5.102001 13.1513 -2006.47 -2006.47 -2006.47 -48.7144 5.102001 14.1513 840.115 840.115 840.115 -47.7144 5.102001 16.1513 -104.526 -104.526 -104.526 -47.7144 6.102001 13.1513 -504.386 -504.386 -504.386 -47.7144 6.102001 14.1513 -731.749 -731.749 -731.749 -47.7144 7.102001 13.1513 640.783 640.783 640.783 -47.7144 7.102001 14.1513 -1186.91 -1186.91 -1186.91 -48.7144 6.102001 13.1513 -1246.44 -1246.44 -1246.44 -48.7144 6.102001 14.1513 229.036 229.036 229.036 -47.7144 6.102001 16.1513 -22.8519 -22.8519 -22.8519 -45.7144 4.102001 17.1513 398.762 398.762 398.762 -45.7144 4.102001 18.1513 -210.872 -210.872 -210.872 -45.7144 5.102001 17.1513 -232.561 -232.561 -232.561 -45.7144 5.102001 18.1513 67.7463 67.7463 67.7463 -46.7144 4.102001 17.1513 138.297 138.297 138.297 -46.7144 4.102001 18.1513 170.051 170.051 170.051 -46.7144 5.102001 17.1513 -1.54934 -1.54934 -1.54934 -46.7144 5.102001 18.1513 109.743 109.743 109.743 -45.7144 4.102001 20.1513 -2974.54 -2974.54 -2974.54 -45.7144 5.102001 19.1513 11.7264 11.7264 11.7264 -45.7144 5.102001 20.1513 -854.738 -854.738 -854.738 -46.7144 4.102001 19.1513 -2.10313 -2.10313 -2.10313 -46.7144 4.102001 20.1513 -3821.71 -3821.71 -3821.71 -46.7144 5.102001 19.1513 49.3245 49.3245 49.3245 -46.7144 5.102001 20.1513 -3103.5 -3103.5 -3103.5 -45.7144 6.102001 17.1513 -165.549 -165.549 -165.549 -45.7144 6.102001 18.1513 -130.297 -130.297 -130.297 -45.7144 7.102001 17.1513 -177.287 -177.287 -177.287 -46.7144 6.102001 17.1513 73.2716 73.2716 73.2716 -46.7144 6.102001 18.1513 77.2842 77.2842 77.2842 -46.7144 7.102001 17.1513 50.83 50.83 50.83 -45.7144 6.102001 19.1513 -6.13152 -6.13152 -6.13152 -45.7144 6.102001 20.1513 -160.034 -160.034 -160.034 -45.7144 7.102001 19.1513 10.66 10.66 10.66 -45.7144 7.102001 20.1513 -263.943 -263.943 -263.943 -47.7144 5.102001 17.1513 158.508 158.508 158.508 -47.7144 6.102001 17.1513 140.85 140.85 140.85 -49.7144 0.10200100000000001 14.1513 -48592.7 -48592.7 -48592.7 -49.7144 1.102001 13.1513 540.027 540.027 540.027 -49.7144 1.102001 14.1513 -17438.4 -17438.4 -17438.4 -50.7144 0.10200100000000001 13.1513 -10959.1 -10959.1 -10959.1 -50.7144 0.10200100000000001 14.1513 19375.5 19375.5 19375.5 -50.7144 1.102001 13.1513 16845.9 16845.9 16845.9 -50.7144 1.102001 14.1513 46803.6 46803.6 46803.6 -49.7144 2.102001 13.1513 -28722.7 -28722.7 -28722.7 -50.7144 2.102001 13.1513 2454.15 2454.15 2454.15 -45.7144 0.10200100000000001 21.1513 -1531.5 -1531.5 -1531.5 -45.7144 0.10200100000000001 22.1513 11606.4 11606.4 11606.4 -45.7144 1.102001 21.1513 -1764.33 -1764.33 -1764.33 -45.7144 1.102001 22.1513 -4957.87 -4957.87 -4957.87 -46.7144 1.102001 21.1513 -831.592 -831.592 -831.592 -46.7144 1.102001 22.1513 4110.44 4110.44 4110.44 -45.7144 0.10200100000000001 23.1513 6618.04 6618.04 6618.04 -45.7144 0.10200100000000001 24.1513 -29982.6 -29982.6 -29982.6 -45.7144 1.102001 23.1513 -10511.8 -10511.8 -10511.8 -46.7144 0.10200100000000001 23.1513 20336.7 20336.7 20336.7 -46.7144 0.10200100000000001 24.1513 -12427.2 -12427.2 -12427.2 -46.7144 1.102001 23.1513 8640.55 8640.55 8640.55 -46.7144 1.102001 24.1513 4184.71 4184.71 4184.71 -45.7144 2.102001 22.1513 -161.783 -161.783 -161.783 -45.7144 3.102001 21.1513 2129.46 2129.46 2129.46 -45.7144 3.102001 22.1513 -866.049 -866.049 -866.049 -46.7144 2.102001 21.1513 -328.576 -328.576 -328.576 -46.7144 2.102001 22.1513 -1321.23 -1321.23 -1321.23 -46.7144 3.102001 21.1513 1798.19 1798.19 1798.19 -46.7144 3.102001 22.1513 1712.77 1712.77 1712.77 -45.7144 2.102001 23.1513 1651.58 1651.58 1651.58 -45.7144 3.102001 23.1513 -2946.23 -2946.23 -2946.23 -46.7144 2.102001 23.1513 594.1 594.1 594.1 -46.7144 2.102001 24.1513 -767.61 -767.61 -767.61 -46.7144 3.102001 23.1513 1224.39 1224.39 1224.39 -46.7144 3.102001 24.1513 -3103.17 -3103.17 -3103.17 -47.7144 2.102001 24.1513 1012.91 1012.91 1012.91 -47.7144 3.102001 23.1513 -1145.87 -1145.87 -1145.87 -47.7144 3.102001 24.1513 10.1583 10.1583 10.1583 -45.7144 0.10200100000000001 25.1513 4274.95 4274.95 4274.95 -45.7144 1.102001 25.1513 5314.28 5314.28 5314.28 -46.7144 0.10200100000000001 25.1513 2061.79 2061.79 2061.79 -46.7144 1.102001 25.1513 -3391.2 -3391.2 -3391.2 -45.7144 2.102001 25.1513 -4138.04 -4138.04 -4138.04 -45.7144 2.102001 26.1513 -502.943 -502.943 -502.943 -45.7144 3.102001 25.1513 -2719.74 -2719.74 -2719.74 -45.7144 3.102001 26.1513 -1946.71 -1946.71 -1946.71 -46.7144 2.102001 25.1513 -6726.64 -6726.64 -6726.64 -46.7144 2.102001 26.1513 -7328.58 -7328.58 -7328.58 -46.7144 3.102001 25.1513 -3553.65 -3553.65 -3553.65 -46.7144 3.102001 26.1513 -2375.19 -2375.19 -2375.19 -47.7144 2.102001 25.1513 734.087 734.087 734.087 -47.7144 2.102001 26.1513 382.205 382.205 382.205 -47.7144 3.102001 25.1513 361.141 361.141 361.141 -47.7144 3.102001 26.1513 -52.2986 -52.2986 -52.2986 -45.7144 4.102001 21.1513 2632.55 2632.55 2632.55 -45.7144 4.102001 22.1513 864.29 864.29 864.29 -45.7144 5.102001 21.1513 2115.36 2115.36 2115.36 -45.7144 5.102001 22.1513 8479.56 8479.56 8479.56 -46.7144 4.102001 22.1513 692.995 692.995 692.995 -46.7144 5.102001 22.1513 -461.235 -461.235 -461.235 -45.7144 4.102001 23.1513 2561.87 2561.87 2561.87 -45.7144 4.102001 24.1513 -1830.85 -1830.85 -1830.85 -45.7144 5.102001 23.1513 -1064.37 -1064.37 -1064.37 -45.7144 5.102001 24.1513 -2148.93 -2148.93 -2148.93 -46.7144 4.102001 23.1513 -968.107 -968.107 -968.107 -46.7144 4.102001 24.1513 837.957 837.957 837.957 -46.7144 5.102001 23.1513 -2470.82 -2470.82 -2470.82 -46.7144 5.102001 24.1513 871.926 871.926 871.926 -45.7144 6.102001 21.1513 -235.792 -235.792 -235.792 -45.7144 6.102001 22.1513 601.359 601.359 601.359 -45.7144 7.102001 21.1513 -492.096 -492.096 -492.096 -45.7144 7.102001 22.1513 -842.875 -842.875 -842.875 -46.7144 6.102001 21.1513 -452.865 -452.865 -452.865 -46.7144 6.102001 22.1513 -971.236 -971.236 -971.236 -46.7144 7.102001 21.1513 734.644 734.644 734.644 -46.7144 7.102001 22.1513 521.756 521.756 521.756 -45.7144 6.102001 24.1513 -2013.54 -2013.54 -2013.54 -45.7144 7.102001 23.1513 1236.67 1236.67 1236.67 -45.7144 7.102001 24.1513 1757.85 1757.85 1757.85 -46.7144 6.102001 23.1513 -1512.71 -1512.71 -1512.71 -46.7144 6.102001 24.1513 -592.588 -592.588 -592.588 -46.7144 7.102001 23.1513 1935.14 1935.14 1935.14 -46.7144 7.102001 24.1513 -2180.56 -2180.56 -2180.56 -47.7144 4.102001 23.1513 911.638 911.638 911.638 -47.7144 4.102001 24.1513 3055.75 3055.75 3055.75 -45.7144 4.102001 25.1513 -1491.42 -1491.42 -1491.42 -45.7144 4.102001 26.1513 -2087.68 -2087.68 -2087.68 -46.7144 4.102001 25.1513 314.502 314.502 314.502 -46.7144 4.102001 26.1513 477.904 477.904 477.904 -45.7144 8.102001 14.1513 2141.86 2141.86 2141.86 -45.7144 9.102001 13.1513 2910.49 2910.49 2910.49 -45.7144 9.102001 14.1513 1213.56 1213.56 1213.56 -46.7144 8.102001 13.1513 -206.751 -206.751 -206.751 -46.7144 8.102001 14.1513 -2369.47 -2369.47 -2369.47 -46.7144 9.102001 13.1513 1052.62 1052.62 1052.62 -46.7144 9.102001 14.1513 -2047.53 -2047.53 -2047.53 -45.7144 10.102001 13.1513 232.309 232.309 232.309 -47.7144 8.102001 13.1513 50.6521 50.6521 50.6521 -47.7144 8.102001 14.1513 -1868.27 -1868.27 -1868.27 -47.7144 9.102001 13.1513 327.283 327.283 327.283 -45.7144 8.102001 22.1513 -1416.3 -1416.3 -1416.3 -46.7144 8.102001 22.1513 -1240.16 -1240.16 -1240.16 -45.7144 8.102001 23.1513 -1358.19 -1358.19 -1358.19 -45.7144 8.102001 24.1513 939.471 939.471 939.471 -46.7144 8.102001 23.1513 981.17 981.17 981.17 diff --git a/tensorflow/script/ocnn_lrp_results/3udh.ply b/tensorflow/script/ocnn_lrp_results/3udh.ply deleted file mode 100644 index 1f8007a..0000000 --- a/tensorflow/script/ocnn_lrp_results/3udh.ply +++ /dev/null @@ -1,5505 +0,0 @@ -ply -format ascii 1.0 -element vertex 5493 -property float x -property float y -property float z -property float nx -property float ny -property float nz -element face 0 -property list uchar int vertex_indices -end_header -9.129100000000001 26.138599999999997 38.6921 -9.92836 -9.92836 -9.92836 -9.129100000000001 26.138599999999997 39.6921 -253.114 -253.114 -253.114 -9.129100000000001 26.138599999999997 40.6921 101.743 101.743 101.743 -9.129100000000001 27.138599999999997 38.6921 14.7938 14.7938 14.7938 -9.129100000000001 28.138599999999997 38.6921 12.984 12.984 12.984 -9.129100000000001 27.138599999999997 39.6921 133.906 133.906 133.906 -9.129100000000001 27.138599999999997 40.6921 68.2286 68.2286 68.2286 -9.129100000000001 28.138599999999997 39.6921 285.609 285.609 285.609 -9.129100000000001 28.138599999999997 40.6921 -371.142 -371.142 -371.142 -10.129100000000001 26.138599999999997 38.6921 1487.43 1487.43 1487.43 -11.129100000000001 26.138599999999997 38.6921 3654.32 3654.32 3654.32 -10.129100000000001 26.138599999999997 39.6921 617.815 617.815 617.815 -10.129100000000001 26.138599999999997 40.6921 -19.2983 -19.2983 -19.2983 -11.129100000000001 25.138599999999997 39.6921 0.516032 0.516032 0.516032 -11.129100000000001 25.138599999999997 40.6921 1.07441 1.07441 1.07441 -11.129100000000001 26.138599999999997 39.6921 203.335 203.335 203.335 -11.129100000000001 26.138599999999997 40.6921 10.0427 10.0427 10.0427 -10.129100000000001 27.138599999999997 38.6921 1089.9 1089.9 1089.9 -10.129100000000001 28.138599999999997 38.6921 1375.51 1375.51 1375.51 -11.129100000000001 27.138599999999997 38.6921 -2183.16 -2183.16 -2183.16 -11.129100000000001 28.138599999999997 38.6921 528.065 528.065 528.065 -10.129100000000001 27.138599999999997 40.6921 -0.331589 -0.331589 -0.331589 -10.129100000000001 28.138599999999997 40.6921 -23.3431 -23.3431 -23.3431 -12.129100000000001 24.138599999999997 39.6921 2.99828 2.99828 2.99828 -12.129100000000001 24.138599999999997 40.6921 -10.8188 -10.8188 -10.8188 -13.129100000000001 24.138599999999997 39.6921 -3.75321 -3.75321 -3.75321 -13.129100000000001 24.138599999999997 40.6921 3.22731 3.22731 3.22731 -14.129100000000001 24.138599999999997 38.6921 2.74893 2.74893 2.74893 -15.129100000000001 24.138599999999997 38.6921 4.18329 4.18329 4.18329 -14.129100000000001 24.138599999999997 39.6921 1.65414 1.65414 1.65414 -14.129100000000001 24.138599999999997 40.6921 -14.2988 -14.2988 -14.2988 -15.129100000000001 24.138599999999997 39.6921 2.25967 2.25967 2.25967 -15.129100000000001 24.138599999999997 40.6921 23.9757 23.9757 23.9757 -12.129100000000001 28.138599999999997 33.6921 20.0887 20.0887 20.0887 -12.129100000000001 28.138599999999997 34.6921 -14.4285 -14.4285 -14.4285 -13.129100000000001 28.138599999999997 33.6921 -23.6471 -23.6471 -23.6471 -13.129100000000001 28.138599999999997 34.6921 -16.1699 -16.1699 -16.1699 -13.129100000000001 28.138599999999997 36.6921 105.592 105.592 105.592 -14.129100000000001 28.138599999999997 36.6921 -151.773 -151.773 -151.773 -12.129100000000001 25.138599999999997 38.6921 0.0271316 0.0271316 0.0271316 -12.129100000000001 26.138599999999997 38.6921 -1304.09 -1304.09 -1304.09 -13.129100000000001 25.138599999999997 38.6921 -1.73993 -1.73993 -1.73993 -13.129100000000001 26.138599999999997 38.6921 3.01115 3.01115 3.01115 -12.129100000000001 25.138599999999997 39.6921 13.4009 13.4009 13.4009 -12.129100000000001 25.138599999999997 40.6921 7.42316 7.42316 7.42316 -12.129100000000001 26.138599999999997 39.6921 -59.4555 -59.4555 -59.4555 -12.129100000000001 26.138599999999997 40.6921 6.27528 6.27528 6.27528 -13.129100000000001 25.138599999999997 39.6921 -18.9602 -18.9602 -18.9602 -13.129100000000001 25.138599999999997 40.6921 -3.56015 -3.56015 -3.56015 -12.129100000000001 27.138599999999997 38.6921 -2031.58 -2031.58 -2031.58 -12.129100000000001 28.138599999999997 38.6921 -1102.43 -1102.43 -1102.43 -13.129100000000001 27.138599999999997 38.6921 34.79 34.79 34.79 -13.129100000000001 28.138599999999997 37.6921 -53.5151 -53.5151 -53.5151 -13.129100000000001 28.138599999999997 38.6921 -15.8764 -15.8764 -15.8764 -12.129100000000001 27.138599999999997 39.6921 -257.529 -257.529 -257.529 -12.129100000000001 28.138599999999997 39.6921 -1930.27 -1930.27 -1930.27 -12.129100000000001 28.138599999999997 40.6921 -48.9575 -48.9575 -48.9575 -13.129100000000001 27.138599999999997 39.6921 47.3844 47.3844 47.3844 -13.129100000000001 28.138599999999997 39.6921 12.4486 12.4486 12.4486 -13.129100000000001 28.138599999999997 40.6921 -1325.25 -1325.25 -1325.25 -14.129100000000001 25.138599999999997 38.6921 -3.99568 -3.99568 -3.99568 -14.129100000000001 26.138599999999997 38.6921 -2.52942 -2.52942 -2.52942 -15.129100000000001 25.138599999999997 38.6921 -4.43326 -4.43326 -4.43326 -15.129100000000001 26.138599999999997 38.6921 8.57578 8.57578 8.57578 -14.129100000000001 25.138599999999997 39.6921 -8.58892 -8.58892 -8.58892 -14.129100000000001 25.138599999999997 40.6921 -7.43571 -7.43571 -7.43571 -15.129100000000001 25.138599999999997 39.6921 2.15291 2.15291 2.15291 -14.129100000000001 27.138599999999997 38.6921 4.57187 4.57187 4.57187 -14.129100000000001 28.138599999999997 37.6921 -118.575 -118.575 -118.575 -14.129100000000001 28.138599999999997 38.6921 -6.24742 -6.24742 -6.24742 -15.129100000000001 27.138599999999997 38.6921 16.005 16.005 16.005 -15.129100000000001 28.138599999999997 37.6921 -85.4865 -85.4865 -85.4865 -15.129100000000001 28.138599999999997 38.6921 -27.7731 -27.7731 -27.7731 -14.129100000000001 27.138599999999997 39.6921 -1.4693 -1.4693 -1.4693 -14.129100000000001 27.138599999999997 40.6921 -1240.01 -1240.01 -1240.01 -14.129100000000001 28.138599999999997 39.6921 18.0112 18.0112 18.0112 -14.129100000000001 28.138599999999997 40.6921 -330.977 -330.977 -330.977 -15.129100000000001 27.138599999999997 39.6921 -15.1486 -15.1486 -15.1486 -15.129100000000001 27.138599999999997 40.6921 1593.68 1593.68 1593.68 -15.129100000000001 28.138599999999997 39.6921 -36.0196 -36.0196 -36.0196 -15.129100000000001 28.138599999999997 40.6921 105.9 105.9 105.9 -13.129100000000001 30.138599999999997 30.692100000000003 -184.84 -184.84 -184.84 -12.129100000000001 29.138599999999997 32.6921 14.9319 14.9319 14.9319 -12.129100000000001 30.138599999999997 32.6921 -181.522 -181.522 -181.522 -13.129100000000001 29.138599999999997 32.6921 12.9996 12.9996 12.9996 -13.129100000000001 30.138599999999997 31.692100000000003 24.2407 24.2407 24.2407 -13.129100000000001 30.138599999999997 32.6921 -214.559 -214.559 -214.559 -12.129100000000001 31.138599999999997 30.692100000000003 151.121 151.121 151.121 -12.129100000000001 32.1386 30.692100000000003 -127.975 -127.975 -127.975 -13.129100000000001 31.138599999999997 29.692100000000003 -5.45925 -5.45925 -5.45925 -13.129100000000001 31.138599999999997 30.692100000000003 -150.903 -150.903 -150.903 -13.129100000000001 32.1386 29.692100000000003 -658.402 -658.402 -658.402 -13.129100000000001 32.1386 30.692100000000003 760.012 760.012 760.012 -12.129100000000001 31.138599999999997 31.692100000000003 73.4934 73.4934 73.4934 -12.129100000000001 31.138599999999997 32.6921 -54.5183 -54.5183 -54.5183 -12.129100000000001 32.1386 31.692100000000003 5.09429 5.09429 5.09429 -12.129100000000001 32.1386 32.6921 137.108 137.108 137.108 -13.129100000000001 31.138599999999997 31.692100000000003 152.163 152.163 152.163 -13.129100000000001 31.138599999999997 32.6921 55.9303 55.9303 55.9303 -13.129100000000001 32.1386 32.6921 108.357 108.357 108.357 -14.129100000000001 30.138599999999997 30.692100000000003 72.8248 72.8248 72.8248 -15.129100000000001 30.138599999999997 29.692100000000003 73.9476 73.9476 73.9476 -15.129100000000001 30.138599999999997 30.692100000000003 76.9889 76.9889 76.9889 -14.129100000000001 29.138599999999997 32.6921 67.2191 67.2191 67.2191 -14.129100000000001 30.138599999999997 31.692100000000003 57.1486 57.1486 57.1486 -14.129100000000001 30.138599999999997 32.6921 9.61958 9.61958 9.61958 -15.129100000000001 30.138599999999997 31.692100000000003 85.2391 85.2391 85.2391 -15.129100000000001 30.138599999999997 32.6921 -103.566 -103.566 -103.566 -14.129100000000001 31.138599999999997 29.692100000000003 59.2449 59.2449 59.2449 -14.129100000000001 31.138599999999997 30.692100000000003 154.054 154.054 154.054 -14.129100000000001 32.1386 29.692100000000003 60.6916 60.6916 60.6916 -14.129100000000001 32.1386 30.692100000000003 77.0714 77.0714 77.0714 -15.129100000000001 31.138599999999997 29.692100000000003 36.6851 36.6851 36.6851 -15.129100000000001 31.138599999999997 30.692100000000003 123.418 123.418 123.418 -15.129100000000001 32.1386 29.692100000000003 147.054 147.054 147.054 -15.129100000000001 32.1386 30.692100000000003 118.051 118.051 118.051 -14.129100000000001 31.138599999999997 31.692100000000003 61.9755 61.9755 61.9755 -14.129100000000001 31.138599999999997 32.6921 -30.0835 -30.0835 -30.0835 -12.129100000000001 33.1386 30.692100000000003 -35.1198 -35.1198 -35.1198 -13.129100000000001 33.1386 29.692100000000003 -1100.71 -1100.71 -1100.71 -13.129100000000001 33.1386 30.692100000000003 -3.24072 -3.24072 -3.24072 -12.129100000000001 33.1386 31.692100000000003 361.469 361.469 361.469 -12.129100000000001 33.1386 32.6921 -290.531 -290.531 -290.531 -13.129100000000001 33.1386 31.692100000000003 385.605 385.605 385.605 -13.129100000000001 33.1386 32.6921 112.713 112.713 112.713 -14.129100000000001 33.1386 29.692100000000003 150.11 150.11 150.11 -14.129100000000001 33.1386 30.692100000000003 120.416 120.416 120.416 -15.129100000000001 33.1386 29.692100000000003 201.982 201.982 201.982 -15.129100000000001 33.1386 30.692100000000003 -131.945 -131.945 -131.945 -15.129100000000001 34.1386 30.692100000000003 -13.7595 -13.7595 -13.7595 -14.129100000000001 33.1386 31.692100000000003 263.42 263.42 263.42 -14.129100000000001 33.1386 32.6921 -80.3092 -80.3092 -80.3092 -14.129100000000001 34.1386 31.692100000000003 -208.616 -208.616 -208.616 -14.129100000000001 34.1386 32.6921 -483.332 -483.332 -483.332 -15.129100000000001 33.1386 32.6921 705.586 705.586 705.586 -15.129100000000001 34.1386 31.692100000000003 -53.2076 -53.2076 -53.2076 -15.129100000000001 34.1386 32.6921 -316.448 -316.448 -316.448 -14.129100000000001 35.1386 31.692100000000003 -265.966 -265.966 -265.966 -14.129100000000001 35.1386 32.6921 -250.593 -250.593 -250.593 -14.129100000000001 36.1386 31.692100000000003 1500.67 1500.67 1500.67 -14.129100000000001 36.1386 32.6921 347.159 347.159 347.159 -15.129100000000001 35.1386 31.692100000000003 -23.142 -23.142 -23.142 -15.129100000000001 35.1386 32.6921 -405.587 -405.587 -405.587 -15.129100000000001 36.1386 31.692100000000003 498.591 498.591 498.591 -9.129100000000001 30.138599999999997 35.6921 -42.4382 -42.4382 -42.4382 -9.129100000000001 31.138599999999997 35.6921 -46.2435 -46.2435 -46.2435 -9.129100000000001 31.138599999999997 36.6921 -54.9248 -54.9248 -54.9248 -10.129100000000001 29.138599999999997 34.6921 -7.58007 -7.58007 -7.58007 -10.129100000000001 30.138599999999997 34.6921 -1476.25 -1476.25 -1476.25 -11.129100000000001 29.138599999999997 33.6921 25.5817 25.5817 25.5817 -11.129100000000001 29.138599999999997 34.6921 -9.57959 -9.57959 -9.57959 -11.129100000000001 30.138599999999997 33.6921 -2096.16 -2096.16 -2096.16 -11.129100000000001 30.138599999999997 34.6921 -175.413 -175.413 -175.413 -10.129100000000001 29.138599999999997 35.6921 18.4153 18.4153 18.4153 -10.129100000000001 29.138599999999997 36.6921 -46.0013 -46.0013 -46.0013 -10.129100000000001 30.138599999999997 35.6921 -3531.67 -3531.67 -3531.67 -10.129100000000001 30.138599999999997 36.6921 -23.4814 -23.4814 -23.4814 -11.129100000000001 29.138599999999997 35.6921 -11.6984 -11.6984 -11.6984 -11.129100000000001 29.138599999999997 36.6921 -40.4182 -40.4182 -40.4182 -11.129100000000001 30.138599999999997 36.6921 -38.7154 -38.7154 -38.7154 -10.129100000000001 31.138599999999997 34.6921 970.637 970.637 970.637 -10.129100000000001 32.1386 34.6921 -2422.61 -2422.61 -2422.61 -11.129100000000001 31.138599999999997 33.6921 1251.49 1251.49 1251.49 -11.129100000000001 31.138599999999997 34.6921 848.268 848.268 848.268 -11.129100000000001 32.1386 34.6921 2317.31 2317.31 2317.31 -10.129100000000001 31.138599999999997 35.6921 -49.4947 -49.4947 -49.4947 -10.129100000000001 31.138599999999997 36.6921 16.7186 16.7186 16.7186 -10.129100000000001 32.1386 35.6921 58.9967 58.9967 58.9967 -10.129100000000001 32.1386 36.6921 -34.8774 -34.8774 -34.8774 -11.129100000000001 32.1386 35.6921 1086.91 1086.91 1086.91 -11.129100000000001 32.1386 36.6921 43.7496 43.7496 43.7496 -9.129100000000001 29.138599999999997 38.6921 -6.71841 -6.71841 -6.71841 -9.129100000000001 29.138599999999997 39.6921 -1.29061 -1.29061 -1.29061 -9.129100000000001 29.138599999999997 40.6921 19.1089 19.1089 19.1089 -9.129100000000001 30.138599999999997 40.6921 -1504.48 -1504.48 -1504.48 -9.129100000000001 31.138599999999997 40.6921 -1038.91 -1038.91 -1038.91 -10.129100000000001 29.138599999999997 38.6921 -30.3345 -30.3345 -30.3345 -10.129100000000001 30.138599999999997 37.6921 39.9424 39.9424 39.9424 -11.129100000000001 29.138599999999997 38.6921 -17.0854 -17.0854 -17.0854 -11.129100000000001 30.138599999999997 37.6921 -69.8866 -69.8866 -69.8866 -10.129100000000001 29.138599999999997 39.6921 -45.8981 -45.8981 -45.8981 -10.129100000000001 29.138599999999997 40.6921 -13.5968 -13.5968 -13.5968 -10.129100000000001 30.138599999999997 39.6921 -237.718 -237.718 -237.718 -10.129100000000001 30.138599999999997 40.6921 545.436 545.436 545.436 -11.129100000000001 29.138599999999997 39.6921 52.6765 52.6765 52.6765 -11.129100000000001 29.138599999999997 40.6921 6.51601 6.51601 6.51601 -11.129100000000001 30.138599999999997 39.6921 2.08737 2.08737 2.08737 -11.129100000000001 30.138599999999997 40.6921 25.9359 25.9359 25.9359 -10.129100000000001 31.138599999999997 37.6921 39.2475 39.2475 39.2475 -10.129100000000001 32.1386 37.6921 -28.3561 -28.3561 -28.3561 -11.129100000000001 31.138599999999997 37.6921 -27.7798 -27.7798 -27.7798 -11.129100000000001 31.138599999999997 38.6921 239.684 239.684 239.684 -11.129100000000001 32.1386 37.6921 14.6847 14.6847 14.6847 -11.129100000000001 32.1386 38.6921 -4.8669 -4.8669 -4.8669 -10.129100000000001 31.138599999999997 40.6921 -1192.04 -1192.04 -1192.04 -11.129100000000001 31.138599999999997 39.6921 -101.366 -101.366 -101.366 -11.129100000000001 31.138599999999997 40.6921 -233.0 -233.0 -233.0 -11.129100000000001 32.1386 39.6921 25.1869 25.1869 25.1869 -11.129100000000001 32.1386 40.6921 30.8776 30.8776 30.8776 -9.129100000000001 35.1386 34.6921 38.9536 38.9536 38.9536 -9.129100000000001 36.1386 34.6921 229.182 229.182 229.182 -9.129100000000001 35.1386 35.6921 82.9616 82.9616 82.9616 -9.129100000000001 35.1386 36.6921 -91.114 -91.114 -91.114 -9.129100000000001 36.1386 35.6921 90.8965 90.8965 90.8965 -9.129100000000001 36.1386 36.6921 -77.2125 -77.2125 -77.2125 -11.129100000000001 33.1386 34.6921 67.6525 67.6525 67.6525 -11.129100000000001 33.1386 35.6921 -282.358 -282.358 -282.358 -11.129100000000001 33.1386 36.6921 86.9234 86.9234 86.9234 -11.129100000000001 34.1386 35.6921 91.2895 91.2895 91.2895 -11.129100000000001 34.1386 36.6921 90.4296 90.4296 90.4296 -10.129100000000001 35.1386 34.6921 -440.108 -440.108 -440.108 -10.129100000000001 36.1386 33.6921 -43.5276 -43.5276 -43.5276 -10.129100000000001 36.1386 34.6921 -46.186 -46.186 -46.186 -11.129100000000001 35.1386 34.6921 -543.933 -543.933 -543.933 -11.129100000000001 36.1386 33.6921 70.136 70.136 70.136 -11.129100000000001 36.1386 34.6921 20.9092 20.9092 20.9092 -10.129100000000001 35.1386 35.6921 -111.049 -111.049 -111.049 -10.129100000000001 35.1386 36.6921 25.4261 25.4261 25.4261 -10.129100000000001 36.1386 36.6921 17.375 17.375 17.375 -11.129100000000001 35.1386 35.6921 153.554 153.554 153.554 -11.129100000000001 35.1386 36.6921 -15.1599 -15.1599 -15.1599 -9.129100000000001 35.1386 37.6921 -776.822 -776.822 -776.822 -9.129100000000001 35.1386 38.6921 -1288.85 -1288.85 -1288.85 -9.129100000000001 36.1386 37.6921 1296.27 1296.27 1296.27 -9.129100000000001 36.1386 38.6921 1112.62 1112.62 1112.62 -9.129100000000001 35.1386 39.6921 -772.328 -772.328 -772.328 -9.129100000000001 36.1386 39.6921 365.606 365.606 365.606 -10.129100000000001 34.1386 37.6921 1109.19 1109.19 1109.19 -10.129100000000001 34.1386 38.6921 -328.729 -328.729 -328.729 -11.129100000000001 33.1386 37.6921 64.9445 64.9445 64.9445 -11.129100000000001 33.1386 38.6921 99.6304 99.6304 99.6304 -11.129100000000001 34.1386 37.6921 151.64 151.64 151.64 -11.129100000000001 34.1386 38.6921 37.2138 37.2138 37.2138 -11.129100000000001 33.1386 39.6921 -20.6014 -20.6014 -20.6014 -11.129100000000001 33.1386 40.6921 177.733 177.733 177.733 -11.129100000000001 34.1386 40.6921 -11.6798 -11.6798 -11.6798 -10.129100000000001 35.1386 37.6921 -630.398 -630.398 -630.398 -10.129100000000001 35.1386 38.6921 -172.034 -172.034 -172.034 -11.129100000000001 35.1386 37.6921 149.142 149.142 149.142 -11.129100000000001 35.1386 38.6921 -34.9579 -34.9579 -34.9579 -10.129100000000001 35.1386 39.6921 -4.21242 -4.21242 -4.21242 -10.129100000000001 36.1386 39.6921 -505.195 -505.195 -505.195 -10.129100000000001 36.1386 40.6921 -25.1921 -25.1921 -25.1921 -11.129100000000001 35.1386 39.6921 -98.5448 -98.5448 -98.5448 -11.129100000000001 36.1386 39.6921 -96.1 -96.1 -96.1 -11.129100000000001 36.1386 40.6921 -105.051 -105.051 -105.051 -12.129100000000001 29.138599999999997 33.6921 14.1158 14.1158 14.1158 -12.129100000000001 29.138599999999997 34.6921 -12.482 -12.482 -12.482 -12.129100000000001 30.138599999999997 33.6921 1793.57 1793.57 1793.57 -12.129100000000001 30.138599999999997 34.6921 222.888 222.888 222.888 -13.129100000000001 29.138599999999997 33.6921 1.47808 1.47808 1.47808 -13.129100000000001 29.138599999999997 34.6921 -41.6301 -41.6301 -41.6301 -12.129100000000001 29.138599999999997 35.6921 24.2283 24.2283 24.2283 -12.129100000000001 29.138599999999997 36.6921 -17.41 -17.41 -17.41 -12.129100000000001 30.138599999999997 35.6921 -2423.54 -2423.54 -2423.54 -12.129100000000001 30.138599999999997 36.6921 4.90051 4.90051 4.90051 -13.129100000000001 29.138599999999997 35.6921 49.0275 49.0275 49.0275 -13.129100000000001 29.138599999999997 36.6921 7.99977 7.99977 7.99977 -13.129100000000001 30.138599999999997 35.6921 96.0322 96.0322 96.0322 -12.129100000000001 31.138599999999997 33.6921 777.35 777.35 777.35 -12.129100000000001 31.138599999999997 34.6921 778.123 778.123 778.123 -12.129100000000001 32.1386 33.6921 699.782 699.782 699.782 -12.129100000000001 32.1386 34.6921 1351.52 1351.52 1351.52 -13.129100000000001 32.1386 33.6921 168.003 168.003 168.003 -14.129100000000001 29.138599999999997 33.6921 42.9218 42.9218 42.9218 -14.129100000000001 29.138599999999997 34.6921 43.3484 43.3484 43.3484 -14.129100000000001 30.138599999999997 33.6921 114.168 114.168 114.168 -14.129100000000001 30.138599999999997 34.6921 -124.759 -124.759 -124.759 -15.129100000000001 30.138599999999997 33.6921 -98.9686 -98.9686 -98.9686 -15.129100000000001 30.138599999999997 34.6921 33.7905 33.7905 33.7905 -14.129100000000001 29.138599999999997 35.6921 94.0549 94.0549 94.0549 -14.129100000000001 29.138599999999997 36.6921 -14.2127 -14.2127 -14.2127 -14.129100000000001 30.138599999999997 35.6921 106.191 106.191 106.191 -15.129100000000001 29.138599999999997 35.6921 49.1226 49.1226 49.1226 -15.129100000000001 29.138599999999997 36.6921 -65.2499 -65.2499 -65.2499 -15.129100000000001 30.138599999999997 35.6921 55.5694 55.5694 55.5694 -15.129100000000001 30.138599999999997 36.6921 54.9757 54.9757 54.9757 -15.129100000000001 31.138599999999997 34.6921 -11.3951 -11.3951 -11.3951 -15.129100000000001 32.1386 34.6921 -20.1639 -20.1639 -20.1639 -14.129100000000001 31.138599999999997 35.6921 24.1194 24.1194 24.1194 -14.129100000000001 31.138599999999997 36.6921 44.6852 44.6852 44.6852 -14.129100000000001 32.1386 35.6921 -88.9901 -88.9901 -88.9901 -14.129100000000001 32.1386 36.6921 31.8792 31.8792 31.8792 -15.129100000000001 31.138599999999997 35.6921 -40.4245 -40.4245 -40.4245 -15.129100000000001 31.138599999999997 36.6921 92.3891 92.3891 92.3891 -15.129100000000001 32.1386 35.6921 6.60701 6.60701 6.60701 -15.129100000000001 32.1386 36.6921 -108.19 -108.19 -108.19 -12.129100000000001 29.138599999999997 37.6921 -13.1727 -13.1727 -13.1727 -12.129100000000001 29.138599999999997 38.6921 -4.39133 -4.39133 -4.39133 -12.129100000000001 30.138599999999997 37.6921 26.952 26.952 26.952 -12.129100000000001 30.138599999999997 38.6921 65.3818 65.3818 65.3818 -13.129100000000001 29.138599999999997 37.6921 -62.7004 -62.7004 -62.7004 -13.129100000000001 29.138599999999997 38.6921 -48.1163 -48.1163 -48.1163 -13.129100000000001 30.138599999999997 38.6921 -39.3114 -39.3114 -39.3114 -12.129100000000001 29.138599999999997 39.6921 12.6779 12.6779 12.6779 -12.129100000000001 29.138599999999997 40.6921 4.8723 4.8723 4.8723 -12.129100000000001 30.138599999999997 40.6921 23.6779 23.6779 23.6779 -13.129100000000001 29.138599999999997 39.6921 -25.8386 -25.8386 -25.8386 -13.129100000000001 29.138599999999997 40.6921 694.797 694.797 694.797 -13.129100000000001 30.138599999999997 39.6921 -7.61469 -7.61469 -7.61469 -12.129100000000001 31.138599999999997 37.6921 9.51796 9.51796 9.51796 -12.129100000000001 31.138599999999997 38.6921 87.0344 87.0344 87.0344 -13.129100000000001 31.138599999999997 38.6921 -10.368 -10.368 -10.368 -12.129100000000001 31.138599999999997 39.6921 -22.7792 -22.7792 -22.7792 -12.129100000000001 31.138599999999997 40.6921 21.0179 21.0179 21.0179 -12.129100000000001 32.1386 39.6921 4.2591 4.2591 4.2591 -12.129100000000001 32.1386 40.6921 15.8739 15.8739 15.8739 -13.129100000000001 31.138599999999997 39.6921 -48.7457 -48.7457 -48.7457 -13.129100000000001 31.138599999999997 40.6921 -12.3674 -12.3674 -12.3674 -13.129100000000001 32.1386 39.6921 -8.25151 -8.25151 -8.25151 -13.129100000000001 32.1386 40.6921 -15.9008 -15.9008 -15.9008 -14.129100000000001 29.138599999999997 37.6921 -82.24 -82.24 -82.24 -14.129100000000001 29.138599999999997 38.6921 -4.74924 -4.74924 -4.74924 -15.129100000000001 29.138599999999997 37.6921 2.4616 2.4616 2.4616 -15.129100000000001 29.138599999999997 38.6921 -46.6253 -46.6253 -46.6253 -15.129100000000001 30.138599999999997 37.6921 22.7153 22.7153 22.7153 -14.129100000000001 29.138599999999997 39.6921 5.94091 5.94091 5.94091 -14.129100000000001 29.138599999999997 40.6921 2146.34 2146.34 2146.34 -14.129100000000001 30.138599999999997 39.6921 2.64258 2.64258 2.64258 -14.129100000000001 30.138599999999997 40.6921 -5.30075 -5.30075 -5.30075 -15.129100000000001 29.138599999999997 39.6921 -33.9139 -33.9139 -33.9139 -15.129100000000001 29.138599999999997 40.6921 1519.36 1519.36 1519.36 -15.129100000000001 30.138599999999997 39.6921 -37.0598 -37.0598 -37.0598 -15.129100000000001 30.138599999999997 40.6921 -5.6526 -5.6526 -5.6526 -14.129100000000001 31.138599999999997 38.6921 -15.1167 -15.1167 -15.1167 -14.129100000000001 32.1386 37.6921 -38.0066 -38.0066 -38.0066 -14.129100000000001 32.1386 38.6921 2.01473 2.01473 2.01473 -15.129100000000001 31.138599999999997 37.6921 17.3213 17.3213 17.3213 -15.129100000000001 31.138599999999997 38.6921 -4.14306 -4.14306 -4.14306 -15.129100000000001 32.1386 37.6921 -32.2989 -32.2989 -32.2989 -15.129100000000001 32.1386 38.6921 -10.0713 -10.0713 -10.0713 -14.129100000000001 31.138599999999997 39.6921 10.2517 10.2517 10.2517 -14.129100000000001 32.1386 39.6921 -22.2917 -22.2917 -22.2917 -14.129100000000001 32.1386 40.6921 -9.63008 -9.63008 -9.63008 -15.129100000000001 31.138599999999997 39.6921 -26.6685 -26.6685 -26.6685 -15.129100000000001 31.138599999999997 40.6921 -7.79024 -7.79024 -7.79024 -15.129100000000001 32.1386 40.6921 -19.1966 -19.1966 -19.1966 -12.129100000000001 33.1386 33.6921 -610.044 -610.044 -610.044 -12.129100000000001 33.1386 34.6921 -265.986 -265.986 -265.986 -12.129100000000001 34.1386 34.6921 344.462 344.462 344.462 -13.129100000000001 33.1386 33.6921 182.559 182.559 182.559 -13.129100000000001 33.1386 34.6921 543.297 543.297 543.297 -13.129100000000001 34.1386 33.6921 475.191 475.191 475.191 -13.129100000000001 34.1386 34.6921 419.273 419.273 419.273 -12.129100000000001 33.1386 35.6921 -1543.48 -1543.48 -1543.48 -12.129100000000001 33.1386 36.6921 -130.668 -130.668 -130.668 -12.129100000000001 34.1386 35.6921 -65.6412 -65.6412 -65.6412 -12.129100000000001 34.1386 36.6921 89.9195 89.9195 89.9195 -13.129100000000001 33.1386 35.6921 -1445.43 -1445.43 -1445.43 -13.129100000000001 33.1386 36.6921 -63.2562 -63.2562 -63.2562 -13.129100000000001 34.1386 35.6921 -497.535 -497.535 -497.535 -13.129100000000001 34.1386 36.6921 -151.737 -151.737 -151.737 -12.129100000000001 35.1386 34.6921 406.122 406.122 406.122 -12.129100000000001 36.1386 34.6921 81.2837 81.2837 81.2837 -13.129100000000001 35.1386 33.6921 822.061 822.061 822.061 -13.129100000000001 35.1386 34.6921 334.244 334.244 334.244 -13.129100000000001 36.1386 33.6921 131.267 131.267 131.267 -13.129100000000001 36.1386 34.6921 204.295 204.295 204.295 -12.129100000000001 35.1386 35.6921 458.791 458.791 458.791 -12.129100000000001 35.1386 36.6921 321.559 321.559 321.559 -13.129100000000001 35.1386 36.6921 -278.702 -278.702 -278.702 -14.129100000000001 33.1386 33.6921 6.95966 6.95966 6.95966 -14.129100000000001 34.1386 33.6921 624.091 624.091 624.091 -15.129100000000001 33.1386 33.6921 -108.005 -108.005 -108.005 -15.129100000000001 33.1386 34.6921 382.123 382.123 382.123 -15.129100000000001 34.1386 33.6921 -97.2424 -97.2424 -97.2424 -15.129100000000001 34.1386 34.6921 69.4692 69.4692 69.4692 -14.129100000000001 33.1386 35.6921 -412.465 -412.465 -412.465 -14.129100000000001 33.1386 36.6921 -35.1063 -35.1063 -35.1063 -14.129100000000001 34.1386 36.6921 138.76 138.76 138.76 -15.129100000000001 33.1386 35.6921 137.156 137.156 137.156 -15.129100000000001 33.1386 36.6921 -5.8636 -5.8636 -5.8636 -15.129100000000001 34.1386 35.6921 -55.3818 -55.3818 -55.3818 -15.129100000000001 34.1386 36.6921 -109.037 -109.037 -109.037 -14.129100000000001 35.1386 33.6921 370.635 370.635 370.635 -14.129100000000001 36.1386 33.6921 670.826 670.826 670.826 -15.129100000000001 35.1386 33.6921 -63.6915 -63.6915 -63.6915 -15.129100000000001 35.1386 34.6921 -24.576 -24.576 -24.576 -14.129100000000001 35.1386 36.6921 -86.713 -86.713 -86.713 -14.129100000000001 36.1386 36.6921 -666.853 -666.853 -666.853 -15.129100000000001 35.1386 35.6921 66.156 66.156 66.156 -15.129100000000001 35.1386 36.6921 46.1944 46.1944 46.1944 -15.129100000000001 36.1386 36.6921 17.6872 17.6872 17.6872 -12.129100000000001 33.1386 37.6921 -57.5946 -57.5946 -57.5946 -12.129100000000001 33.1386 38.6921 120.968 120.968 120.968 -12.129100000000001 34.1386 37.6921 3.3651 3.3651 3.3651 -12.129100000000001 34.1386 38.6921 -33.4198 -33.4198 -33.4198 -13.129100000000001 33.1386 37.6921 -29.1529 -29.1529 -29.1529 -13.129100000000001 33.1386 38.6921 93.6944 93.6944 93.6944 -13.129100000000001 34.1386 37.6921 -168.794 -168.794 -168.794 -13.129100000000001 34.1386 38.6921 29.2009 29.2009 29.2009 -12.129100000000001 33.1386 39.6921 -3.0573 -3.0573 -3.0573 -12.129100000000001 33.1386 40.6921 25.2309 25.2309 25.2309 -12.129100000000001 34.1386 39.6921 42.9496 42.9496 42.9496 -12.129100000000001 34.1386 40.6921 15.7145 15.7145 15.7145 -13.129100000000001 33.1386 39.6921 59.0868 59.0868 59.0868 -13.129100000000001 33.1386 40.6921 38.3448 38.3448 38.3448 -13.129100000000001 34.1386 39.6921 -10.5951 -10.5951 -10.5951 -13.129100000000001 34.1386 40.6921 58.2061 58.2061 58.2061 -12.129100000000001 35.1386 37.6921 5.09714 5.09714 5.09714 -12.129100000000001 35.1386 38.6921 28.8555 28.8555 28.8555 -13.129100000000001 35.1386 37.6921 -166.321 -166.321 -166.321 -13.129100000000001 35.1386 38.6921 -5.18324 -5.18324 -5.18324 -13.129100000000001 36.1386 37.6921 -44.565 -44.565 -44.565 -12.129100000000001 35.1386 39.6921 -8.8362 -8.8362 -8.8362 -12.129100000000001 35.1386 40.6921 20.947 20.947 20.947 -12.129100000000001 36.1386 39.6921 44.1134 44.1134 44.1134 -12.129100000000001 36.1386 40.6921 21.0537 21.0537 21.0537 -13.129100000000001 35.1386 39.6921 9.56309 9.56309 9.56309 -13.129100000000001 35.1386 40.6921 33.5126 33.5126 33.5126 -13.129100000000001 36.1386 40.6921 18.3011 18.3011 18.3011 -14.129100000000001 33.1386 37.6921 28.4998 28.4998 28.4998 -14.129100000000001 33.1386 38.6921 62.7521 62.7521 62.7521 -15.129100000000001 33.1386 37.6921 -127.499 -127.499 -127.499 -15.129100000000001 33.1386 38.6921 -62.3855 -62.3855 -62.3855 -15.129100000000001 34.1386 37.6921 -23.5139 -23.5139 -23.5139 -15.129100000000001 34.1386 38.6921 -32.1589 -32.1589 -32.1589 -14.129100000000001 33.1386 39.6921 55.4095 55.4095 55.4095 -14.129100000000001 33.1386 40.6921 3.3526 3.3526 3.3526 -14.129100000000001 34.1386 39.6921 -35.8275 -35.8275 -35.8275 -14.129100000000001 34.1386 40.6921 1.88606 1.88606 1.88606 -15.129100000000001 33.1386 39.6921 -12.704 -12.704 -12.704 -15.129100000000001 33.1386 40.6921 -12.0893 -12.0893 -12.0893 -15.129100000000001 34.1386 39.6921 -76.5767 -76.5767 -76.5767 -15.129100000000001 34.1386 40.6921 -36.9838 -36.9838 -36.9838 -14.129100000000001 35.1386 37.6921 -16.284 -16.284 -16.284 -14.129100000000001 35.1386 38.6921 3.00576 3.00576 3.00576 -14.129100000000001 36.1386 37.6921 188.795 188.795 188.795 -14.129100000000001 36.1386 38.6921 -74.2724 -74.2724 -74.2724 -15.129100000000001 35.1386 37.6921 106.877 106.877 106.877 -15.129100000000001 35.1386 38.6921 95.5244 95.5244 95.5244 -15.129100000000001 36.1386 38.6921 5.08187 5.08187 5.08187 -14.129100000000001 35.1386 39.6921 24.0486 24.0486 24.0486 -14.129100000000001 35.1386 40.6921 49.3866 49.3866 49.3866 -14.129100000000001 36.1386 39.6921 -29.7879 -29.7879 -29.7879 -14.129100000000001 36.1386 40.6921 25.7218 25.7218 25.7218 -15.129100000000001 35.1386 39.6921 80.9342 80.9342 80.9342 -15.129100000000001 36.1386 39.6921 45.6286 45.6286 45.6286 -15.129100000000001 36.1386 40.6921 34.6448 34.6448 34.6448 -17.1291 28.138599999999997 32.6921 -397.409 -397.409 -397.409 -23.1291 28.138599999999997 32.6921 -22.3265 -22.3265 -22.3265 -16.1291 24.138599999999997 39.6921 -0.393601 -0.393601 -0.393601 -16.1291 24.138599999999997 40.6921 -34.5717 -34.5717 -34.5717 -17.1291 24.138599999999997 39.6921 379.802 379.802 379.802 -17.1291 24.138599999999997 40.6921 251.01 251.01 251.01 -18.1291 24.138599999999997 39.6921 -508.394 -508.394 -508.394 -18.1291 24.138599999999997 40.6921 -95.1801 -95.1801 -95.1801 -16.1291 28.138599999999997 33.6921 186.685 186.685 186.685 -17.1291 28.138599999999997 33.6921 -739.409 -739.409 -739.409 -17.1291 28.138599999999997 34.6921 136.085 136.085 136.085 -17.1291 27.138599999999997 35.6921 84.449 84.449 84.449 -17.1291 27.138599999999997 36.6921 126.794 126.794 126.794 -17.1291 28.138599999999997 35.6921 16.3666 16.3666 16.3666 -17.1291 28.138599999999997 36.6921 146.524 146.524 146.524 -18.1291 28.138599999999997 33.6921 -130.491 -130.491 -130.491 -18.1291 28.138599999999997 34.6921 575.164 575.164 575.164 -19.1291 28.138599999999997 33.6921 41.8672 41.8672 41.8672 -19.1291 28.138599999999997 34.6921 3.72131 3.72131 3.72131 -18.1291 27.138599999999997 35.6921 -49.9451 -49.9451 -49.9451 -18.1291 27.138599999999997 36.6921 6.01954 6.01954 6.01954 -18.1291 28.138599999999997 35.6921 -109.133 -109.133 -109.133 -19.1291 27.138599999999997 35.6921 -3.03231 -3.03231 -3.03231 -19.1291 27.138599999999997 36.6921 -43.7237 -43.7237 -43.7237 -19.1291 28.138599999999997 35.6921 -11.3185 -11.3185 -11.3185 -19.1291 28.138599999999997 36.6921 38.2735 38.2735 38.2735 -16.1291 25.138599999999997 38.6921 -6.23076 -6.23076 -6.23076 -16.1291 26.138599999999997 38.6921 -25.4898 -25.4898 -25.4898 -16.1291 25.138599999999997 39.6921 3.56033 3.56033 3.56033 -16.1291 26.138599999999997 39.6921 -13.3682 -13.3682 -13.3682 -17.1291 25.138599999999997 39.6921 -1.39031 -1.39031 -1.39031 -17.1291 26.138599999999997 39.6921 6.13039 6.13039 6.13039 -16.1291 27.138599999999997 38.6921 1.66654 1.66654 1.66654 -17.1291 27.138599999999997 37.6921 105.332 105.332 105.332 -17.1291 28.138599999999997 37.6921 -11.3382 -11.3382 -11.3382 -17.1291 28.138599999999997 38.6921 12.8435 12.8435 12.8435 -16.1291 27.138599999999997 39.6921 -0.675797 -0.675797 -0.675797 -16.1291 27.138599999999997 40.6921 -2.2368 -2.2368 -2.2368 -16.1291 28.138599999999997 39.6921 -15.8875 -15.8875 -15.8875 -16.1291 28.138599999999997 40.6921 -16.0002 -16.0002 -16.0002 -17.1291 27.138599999999997 39.6921 24.1803 24.1803 24.1803 -17.1291 27.138599999999997 40.6921 37.0804 37.0804 37.0804 -17.1291 28.138599999999997 39.6921 24.3288 24.3288 24.3288 -17.1291 28.138599999999997 40.6921 -29.11 -29.11 -29.11 -18.1291 25.138599999999997 39.6921 -13.9489 -13.9489 -13.9489 -18.1291 25.138599999999997 40.6921 -10.1881 -10.1881 -10.1881 -18.1291 26.138599999999997 39.6921 35.1029 35.1029 35.1029 -18.1291 26.138599999999997 40.6921 24.4849 24.4849 24.4849 -18.1291 27.138599999999997 37.6921 72.566 72.566 72.566 -18.1291 27.138599999999997 38.6921 22.4118 22.4118 22.4118 -18.1291 28.138599999999997 37.6921 25.239 25.239 25.239 -18.1291 28.138599999999997 38.6921 104.104 104.104 104.104 -19.1291 27.138599999999997 37.6921 57.2343 57.2343 57.2343 -19.1291 27.138599999999997 38.6921 20.666 20.666 20.666 -19.1291 28.138599999999997 37.6921 28.9818 28.9818 28.9818 -19.1291 28.138599999999997 38.6921 -37.4425 -37.4425 -37.4425 -18.1291 27.138599999999997 39.6921 27.2123 27.2123 27.2123 -18.1291 27.138599999999997 40.6921 -4.10041 -4.10041 -4.10041 -18.1291 28.138599999999997 39.6921 -42.4017 -42.4017 -42.4017 -18.1291 28.138599999999997 40.6921 -33.6917 -33.6917 -33.6917 -19.1291 28.138599999999997 40.6921 71.0366 71.0366 71.0366 -20.1291 28.138599999999997 33.6921 -14.261 -14.261 -14.261 -20.1291 28.138599999999997 34.6921 254.794 254.794 254.794 -21.1291 28.138599999999997 34.6921 118.939 118.939 118.939 -20.1291 27.138599999999997 36.6921 -169.177 -169.177 -169.177 -20.1291 28.138599999999997 35.6921 43.5854 43.5854 43.5854 -20.1291 28.138599999999997 36.6921 3.12595 3.12595 3.12595 -21.1291 28.138599999999997 35.6921 -86.5957 -86.5957 -86.5957 -23.1291 28.138599999999997 33.6921 222.851 222.851 222.851 -20.1291 28.138599999999997 37.6921 119.724 119.724 119.724 -16.1291 30.138599999999997 29.692100000000003 83.8145 83.8145 83.8145 -16.1291 30.138599999999997 30.692100000000003 -6.61059 -6.61059 -6.61059 -17.1291 30.138599999999997 29.692100000000003 8.3392 8.3392 8.3392 -17.1291 30.138599999999997 30.692100000000003 -45.0939 -45.0939 -45.0939 -16.1291 29.138599999999997 32.6921 240.587 240.587 240.587 -16.1291 30.138599999999997 31.692100000000003 181.886 181.886 181.886 -16.1291 30.138599999999997 32.6921 -1.66438 -1.66438 -1.66438 -17.1291 29.138599999999997 32.6921 -182.649 -182.649 -182.649 -17.1291 30.138599999999997 31.692100000000003 -41.4058 -41.4058 -41.4058 -17.1291 30.138599999999997 32.6921 -38.2136 -38.2136 -38.2136 -16.1291 31.138599999999997 29.692100000000003 -63.9437 -63.9437 -63.9437 -16.1291 32.1386 29.692100000000003 -1427.17 -1427.17 -1427.17 -17.1291 31.138599999999997 29.692100000000003 -632.105 -632.105 -632.105 -17.1291 31.138599999999997 30.692100000000003 392.484 392.484 392.484 -17.1291 32.1386 29.692100000000003 695.392 695.392 695.392 -17.1291 32.1386 30.692100000000003 2778.64 2778.64 2778.64 -16.1291 31.138599999999997 32.6921 10.1404 10.1404 10.1404 -16.1291 32.1386 32.6921 13.1721 13.1721 13.1721 -17.1291 31.138599999999997 31.692100000000003 -1271.64 -1271.64 -1271.64 -17.1291 31.138599999999997 32.6921 1.1453 1.1453 1.1453 -17.1291 32.1386 31.692100000000003 1625.27 1625.27 1625.27 -17.1291 32.1386 32.6921 -17.4336 -17.4336 -17.4336 -18.1291 29.138599999999997 30.692100000000003 39.3483 39.3483 39.3483 -18.1291 30.138599999999997 30.692100000000003 -115.571 -115.571 -115.571 -19.1291 29.138599999999997 30.692100000000003 29.6557 29.6557 29.6557 -19.1291 30.138599999999997 30.692100000000003 -18.4686 -18.4686 -18.4686 -18.1291 29.138599999999997 31.692100000000003 42.1496 42.1496 42.1496 -18.1291 29.138599999999997 32.6921 -14.3205 -14.3205 -14.3205 -18.1291 30.138599999999997 31.692100000000003 -48.6347 -48.6347 -48.6347 -18.1291 30.138599999999997 32.6921 22.9301 22.9301 22.9301 -19.1291 29.138599999999997 31.692100000000003 62.2386 62.2386 62.2386 -19.1291 29.138599999999997 32.6921 39.4468 39.4468 39.4468 -18.1291 31.138599999999997 30.692100000000003 1309.7 1309.7 1309.7 -18.1291 32.1386 30.692100000000003 419.176 419.176 419.176 -19.1291 31.138599999999997 30.692100000000003 11.7995 11.7995 11.7995 -19.1291 32.1386 29.692100000000003 93.5458 93.5458 93.5458 -19.1291 32.1386 30.692100000000003 -10.4346 -10.4346 -10.4346 -18.1291 31.138599999999997 31.692100000000003 449.216 449.216 449.216 -18.1291 31.138599999999997 32.6921 -8.02889 -8.02889 -8.02889 -18.1291 32.1386 31.692100000000003 -2087.89 -2087.89 -2087.89 -18.1291 32.1386 32.6921 -456.561 -456.561 -456.561 -19.1291 31.138599999999997 31.692100000000003 -62.5803 -62.5803 -62.5803 -19.1291 32.1386 31.692100000000003 -107.11 -107.11 -107.11 -19.1291 32.1386 32.6921 -295.052 -295.052 -295.052 -19.1291 33.1386 28.692100000000003 30.0256 30.0256 30.0256 -19.1291 34.1386 28.692100000000003 -5.66289 -5.66289 -5.66289 -16.1291 33.1386 29.692100000000003 -197.3 -197.3 -197.3 -16.1291 33.1386 30.692100000000003 -2424.72 -2424.72 -2424.72 -17.1291 33.1386 29.692100000000003 103.892 103.892 103.892 -17.1291 33.1386 30.692100000000003 1552.85 1552.85 1552.85 -16.1291 33.1386 31.692100000000003 -1169.92 -1169.92 -1169.92 -16.1291 33.1386 32.6921 5.61738 5.61738 5.61738 -16.1291 34.1386 31.692100000000003 -16.2251 -16.2251 -16.2251 -16.1291 34.1386 32.6921 91.4028 91.4028 91.4028 -17.1291 33.1386 31.692100000000003 82.9765 82.9765 82.9765 -17.1291 33.1386 32.6921 104.366 104.366 104.366 -17.1291 34.1386 32.6921 89.6398 89.6398 89.6398 -16.1291 36.1386 30.692100000000003 -170.267 -170.267 -170.267 -17.1291 35.1386 30.692100000000003 -33.5763 -33.5763 -33.5763 -17.1291 36.1386 30.692100000000003 -15.2317 -15.2317 -15.2317 -16.1291 35.1386 31.692100000000003 56.4426 56.4426 56.4426 -16.1291 35.1386 32.6921 152.217 152.217 152.217 -16.1291 36.1386 31.692100000000003 -26.6271 -26.6271 -26.6271 -16.1291 36.1386 32.6921 574.566 574.566 574.566 -17.1291 35.1386 31.692100000000003 -7.83425 -7.83425 -7.83425 -17.1291 35.1386 32.6921 8.91925 8.91925 8.91925 -17.1291 36.1386 31.692100000000003 23.7946 23.7946 23.7946 -17.1291 36.1386 32.6921 419.506 419.506 419.506 -18.1291 33.1386 29.692100000000003 -1129.19 -1129.19 -1129.19 -18.1291 33.1386 30.692100000000003 1001.24 1001.24 1001.24 -18.1291 34.1386 29.692100000000003 -109.003 -109.003 -109.003 -18.1291 34.1386 30.692100000000003 -9.50784 -9.50784 -9.50784 -19.1291 33.1386 29.692100000000003 45.6604 45.6604 45.6604 -19.1291 33.1386 30.692100000000003 -272.931 -272.931 -272.931 -19.1291 34.1386 29.692100000000003 0.707342 0.707342 0.707342 -18.1291 33.1386 31.692100000000003 428.273 428.273 428.273 -18.1291 33.1386 32.6921 -145.444 -145.444 -145.444 -18.1291 34.1386 31.692100000000003 558.154 558.154 558.154 -18.1291 34.1386 32.6921 3.08313 3.08313 3.08313 -19.1291 33.1386 31.692100000000003 -524.651 -524.651 -524.651 -19.1291 33.1386 32.6921 -354.767 -354.767 -354.767 -19.1291 34.1386 31.692100000000003 188.854 188.854 188.854 -19.1291 34.1386 32.6921 -45.5613 -45.5613 -45.5613 -18.1291 35.1386 29.692100000000003 46.067 46.067 46.067 -18.1291 35.1386 30.692100000000003 -39.3721 -39.3721 -39.3721 -18.1291 36.1386 30.692100000000003 -14.1837 -14.1837 -14.1837 -19.1291 35.1386 29.692100000000003 11.7885 11.7885 11.7885 -19.1291 35.1386 30.692100000000003 -10.8735 -10.8735 -10.8735 -19.1291 36.1386 30.692100000000003 -4.4679 -4.4679 -4.4679 -18.1291 35.1386 31.692100000000003 -16.4586 -16.4586 -16.4586 -18.1291 35.1386 32.6921 -116.879 -116.879 -116.879 -18.1291 36.1386 31.692100000000003 -16.1898 -16.1898 -16.1898 -18.1291 36.1386 32.6921 46.0983 46.0983 46.0983 -19.1291 35.1386 31.692100000000003 -9.07126 -9.07126 -9.07126 -19.1291 35.1386 32.6921 1.63489 1.63489 1.63489 -19.1291 36.1386 31.692100000000003 5.18622 5.18622 5.18622 -19.1291 36.1386 32.6921 4.80799 4.80799 4.80799 -20.1291 29.138599999999997 30.692100000000003 11.8641 11.8641 11.8641 -20.1291 30.138599999999997 30.692100000000003 -15.8139 -15.8139 -15.8139 -21.1291 30.138599999999997 30.692100000000003 -77.9682 -77.9682 -77.9682 -20.1291 29.138599999999997 31.692100000000003 -6.15915 -6.15915 -6.15915 -20.1291 29.138599999999997 32.6921 -70.2543 -70.2543 -70.2543 -21.1291 29.138599999999997 31.692100000000003 31.623 31.623 31.623 -21.1291 29.138599999999997 32.6921 42.4358 42.4358 42.4358 -21.1291 30.138599999999997 31.692100000000003 -57.0204 -57.0204 -57.0204 -21.1291 30.138599999999997 32.6921 -103.531 -103.531 -103.531 -20.1291 31.138599999999997 30.692100000000003 71.6479 71.6479 71.6479 -20.1291 32.1386 29.692100000000003 173.484 173.484 173.484 -20.1291 32.1386 30.692100000000003 -76.4148 -76.4148 -76.4148 -21.1291 31.138599999999997 30.692100000000003 163.461 163.461 163.461 -21.1291 32.1386 29.692100000000003 147.148 147.148 147.148 -21.1291 32.1386 30.692100000000003 83.9477 83.9477 83.9477 -20.1291 31.138599999999997 31.692100000000003 4.82956 4.82956 4.82956 -20.1291 32.1386 31.692100000000003 65.2862 65.2862 65.2862 -20.1291 32.1386 32.6921 -39.1577 -39.1577 -39.1577 -21.1291 31.138599999999997 31.692100000000003 6.56841 6.56841 6.56841 -22.1291 29.138599999999997 30.692100000000003 111.058 111.058 111.058 -22.1291 30.138599999999997 30.692100000000003 -126.378 -126.378 -126.378 -23.1291 29.138599999999997 30.692100000000003 5963.93 5963.93 5963.93 -23.1291 30.138599999999997 29.692100000000003 -6334.4 -6334.4 -6334.4 -23.1291 30.138599999999997 30.692100000000003 535.62 535.62 535.62 -22.1291 29.138599999999997 31.692100000000003 46.4178 46.4178 46.4178 -22.1291 30.138599999999997 31.692100000000003 -69.467 -69.467 -69.467 -22.1291 30.138599999999997 32.6921 -94.4659 -94.4659 -94.4659 -23.1291 29.138599999999997 31.692100000000003 4.10117 4.10117 4.10117 -23.1291 29.138599999999997 32.6921 -104.97 -104.97 -104.97 -23.1291 30.138599999999997 32.6921 -36.7565 -36.7565 -36.7565 -22.1291 31.138599999999997 30.692100000000003 16.2021 16.2021 16.2021 -22.1291 32.1386 30.692100000000003 1.35767 1.35767 1.35767 -23.1291 31.138599999999997 30.692100000000003 -676.171 -676.171 -676.171 -23.1291 32.1386 30.692100000000003 0.184445 0.184445 0.184445 -22.1291 31.138599999999997 31.692100000000003 -149.307 -149.307 -149.307 -22.1291 31.138599999999997 32.6921 -27.2317 -27.2317 -27.2317 -23.1291 32.1386 31.692100000000003 274.734 274.734 274.734 -20.1291 33.1386 28.692100000000003 19.023 19.023 19.023 -20.1291 34.1386 28.692100000000003 16.1646 16.1646 16.1646 -21.1291 36.1386 28.692100000000003 -70.5369 -70.5369 -70.5369 -22.1291 35.1386 28.692100000000003 -12.493 -12.493 -12.493 -22.1291 36.1386 27.692100000000003 -13.1244 -13.1244 -13.1244 -22.1291 36.1386 28.692100000000003 -28.3369 -28.3369 -28.3369 -23.1291 35.1386 28.692100000000003 55.8923 55.8923 55.8923 -23.1291 36.1386 27.692100000000003 -122.482 -122.482 -122.482 -23.1291 36.1386 28.692100000000003 171.368 171.368 171.368 -20.1291 33.1386 29.692100000000003 192.621 192.621 192.621 -20.1291 34.1386 29.692100000000003 -60.2928 -60.2928 -60.2928 -21.1291 33.1386 29.692100000000003 226.807 226.807 226.807 -21.1291 33.1386 30.692100000000003 35.2945 35.2945 35.2945 -21.1291 34.1386 29.692100000000003 -38.1209 -38.1209 -38.1209 -21.1291 34.1386 30.692100000000003 22.7351 22.7351 22.7351 -20.1291 33.1386 31.692100000000003 -158.649 -158.649 -158.649 -20.1291 33.1386 32.6921 -26.5519 -26.5519 -26.5519 -20.1291 34.1386 32.6921 -17.3578 -17.3578 -17.3578 -21.1291 33.1386 32.6921 -383.594 -383.594 -383.594 -21.1291 34.1386 32.6921 54.6134 54.6134 54.6134 -20.1291 35.1386 29.692100000000003 24.9024 24.9024 24.9024 -20.1291 35.1386 30.692100000000003 -6.46374 -6.46374 -6.46374 -20.1291 36.1386 29.692100000000003 -18.3232 -18.3232 -18.3232 -20.1291 36.1386 30.692100000000003 -23.7195 -23.7195 -23.7195 -21.1291 35.1386 29.692100000000003 13.9549 13.9549 13.9549 -21.1291 35.1386 30.692100000000003 21.0416 21.0416 21.0416 -21.1291 36.1386 29.692100000000003 -4.30216 -4.30216 -4.30216 -21.1291 36.1386 30.692100000000003 -78.8142 -78.8142 -78.8142 -20.1291 35.1386 31.692100000000003 14.8488 14.8488 14.8488 -20.1291 35.1386 32.6921 -8.52445 -8.52445 -8.52445 -20.1291 36.1386 31.692100000000003 4.48847 4.48847 4.48847 -20.1291 36.1386 32.6921 4.55144 4.55144 4.55144 -21.1291 35.1386 31.692100000000003 -32.1048 -32.1048 -32.1048 -21.1291 35.1386 32.6921 -22.5633 -22.5633 -22.5633 -21.1291 36.1386 31.692100000000003 48.0319 48.0319 48.0319 -21.1291 36.1386 32.6921 13.2596 13.2596 13.2596 -22.1291 33.1386 29.692100000000003 71.5716 71.5716 71.5716 -22.1291 33.1386 30.692100000000003 13.4448 13.4448 13.4448 -22.1291 34.1386 29.692100000000003 27.3218 27.3218 27.3218 -22.1291 34.1386 30.692100000000003 -66.1523 -66.1523 -66.1523 -23.1291 33.1386 30.692100000000003 402.215 402.215 402.215 -23.1291 34.1386 30.692100000000003 8.39152 8.39152 8.39152 -22.1291 33.1386 32.6921 -20.4085 -20.4085 -20.4085 -22.1291 34.1386 32.6921 -63.3417 -63.3417 -63.3417 -23.1291 33.1386 31.692100000000003 383.861 383.861 383.861 -23.1291 33.1386 32.6921 71.5005 71.5005 71.5005 -23.1291 34.1386 31.692100000000003 58.5118 58.5118 58.5118 -23.1291 34.1386 32.6921 64.0941 64.0941 64.0941 -22.1291 35.1386 29.692100000000003 -23.211 -23.211 -23.211 -22.1291 35.1386 30.692100000000003 -36.5868 -36.5868 -36.5868 -22.1291 36.1386 29.692100000000003 42.5948 42.5948 42.5948 -22.1291 36.1386 30.692100000000003 24.7625 24.7625 24.7625 -23.1291 35.1386 29.692100000000003 -7.9055 -7.9055 -7.9055 -23.1291 35.1386 30.692100000000003 -16.6353 -16.6353 -16.6353 -23.1291 36.1386 30.692100000000003 6.47911 6.47911 6.47911 -22.1291 35.1386 31.692100000000003 23.9586 23.9586 23.9586 -22.1291 35.1386 32.6921 -4.07757 -4.07757 -4.07757 -22.1291 36.1386 31.692100000000003 -82.6935 -82.6935 -82.6935 -22.1291 36.1386 32.6921 20.3242 20.3242 20.3242 -23.1291 35.1386 31.692100000000003 -44.3275 -44.3275 -44.3275 -23.1291 36.1386 31.692100000000003 -6.84848 -6.84848 -6.84848 -23.1291 36.1386 32.6921 14.876 14.876 14.876 -16.1291 29.138599999999997 33.6921 16.3325 16.3325 16.3325 -16.1291 29.138599999999997 34.6921 -61.4013 -61.4013 -61.4013 -16.1291 30.138599999999997 33.6921 -55.129 -55.129 -55.129 -16.1291 30.138599999999997 34.6921 -3.18633 -3.18633 -3.18633 -17.1291 29.138599999999997 33.6921 -138.361 -138.361 -138.361 -17.1291 29.138599999999997 34.6921 -217.669 -217.669 -217.669 -17.1291 30.138599999999997 34.6921 28.6627 28.6627 28.6627 -16.1291 30.138599999999997 35.6921 -4.89507 -4.89507 -4.89507 -17.1291 29.138599999999997 35.6921 31.6744 31.6744 31.6744 -17.1291 29.138599999999997 36.6921 -55.7337 -55.7337 -55.7337 -17.1291 30.138599999999997 35.6921 -7.4945 -7.4945 -7.4945 -17.1291 30.138599999999997 36.6921 19.6898 19.6898 19.6898 -16.1291 31.138599999999997 34.6921 43.9182 43.9182 43.9182 -16.1291 32.1386 34.6921 70.7455 70.7455 70.7455 -17.1291 32.1386 34.6921 -27.0154 -27.0154 -27.0154 -16.1291 31.138599999999997 35.6921 3.64323 3.64323 3.64323 -16.1291 32.1386 35.6921 -7.85325 -7.85325 -7.85325 -16.1291 32.1386 36.6921 -274.369 -274.369 -274.369 -17.1291 31.138599999999997 35.6921 9.48597 9.48597 9.48597 -17.1291 31.138599999999997 36.6921 11.904 11.904 11.904 -17.1291 32.1386 35.6921 1.58375 1.58375 1.58375 -17.1291 32.1386 36.6921 7.28368 7.28368 7.28368 -18.1291 29.138599999999997 33.6921 108.514 108.514 108.514 -18.1291 29.138599999999997 34.6921 -12.5403 -12.5403 -12.5403 -19.1291 29.138599999999997 33.6921 89.2196 89.2196 89.2196 -18.1291 29.138599999999997 35.6921 -103.924 -103.924 -103.924 -18.1291 30.138599999999997 35.6921 -23.7171 -23.7171 -23.7171 -18.1291 32.1386 33.6921 -77.7294 -77.7294 -77.7294 -18.1291 32.1386 34.6921 3.01412 3.01412 3.01412 -19.1291 32.1386 33.6921 -23.3449 -23.3449 -23.3449 -19.1291 32.1386 34.6921 -12.3343 -12.3343 -12.3343 -18.1291 31.138599999999997 35.6921 -4.1291 -4.1291 -4.1291 -18.1291 31.138599999999997 36.6921 41.9091 41.9091 41.9091 -18.1291 32.1386 35.6921 2.05713 2.05713 2.05713 -18.1291 32.1386 36.6921 -15.2328 -15.2328 -15.2328 -19.1291 31.138599999999997 35.6921 -12.1348 -12.1348 -12.1348 -19.1291 31.138599999999997 36.6921 118.157 118.157 118.157 -19.1291 32.1386 35.6921 -1.51725 -1.51725 -1.51725 -19.1291 32.1386 36.6921 152.179 152.179 152.179 -16.1291 29.138599999999997 37.6921 -124.874 -124.874 -124.874 -16.1291 29.138599999999997 38.6921 -11.2747 -11.2747 -11.2747 -16.1291 30.138599999999997 37.6921 -14.2273 -14.2273 -14.2273 -16.1291 30.138599999999997 38.6921 -12.7794 -12.7794 -12.7794 -17.1291 29.138599999999997 37.6921 40.6627 40.6627 40.6627 -17.1291 29.138599999999997 38.6921 -16.6269 -16.6269 -16.6269 -17.1291 30.138599999999997 37.6921 -10.1217 -10.1217 -10.1217 -17.1291 30.138599999999997 38.6921 -13.5965 -13.5965 -13.5965 -16.1291 29.138599999999997 39.6921 -15.9385 -15.9385 -15.9385 -16.1291 29.138599999999997 40.6921 10.4192 10.4192 10.4192 -16.1291 30.138599999999997 39.6921 -19.6466 -19.6466 -19.6466 -16.1291 30.138599999999997 40.6921 12.4713 12.4713 12.4713 -17.1291 29.138599999999997 39.6921 -21.8425 -21.8425 -21.8425 -17.1291 30.138599999999997 39.6921 -2.57159 -2.57159 -2.57159 -17.1291 30.138599999999997 40.6921 2.88887 2.88887 2.88887 -16.1291 31.138599999999997 37.6921 -14.4752 -14.4752 -14.4752 -16.1291 31.138599999999997 38.6921 -7.98569 -7.98569 -7.98569 -16.1291 32.1386 37.6921 29.4725 29.4725 29.4725 -16.1291 32.1386 38.6921 -36.4333 -36.4333 -36.4333 -17.1291 31.138599999999997 37.6921 0.167607 0.167607 0.167607 -17.1291 31.138599999999997 38.6921 -0.731066 -0.731066 -0.731066 -17.1291 32.1386 37.6921 -19.1292 -19.1292 -19.1292 -17.1291 32.1386 38.6921 4.60219 4.60219 4.60219 -16.1291 31.138599999999997 39.6921 -16.8781 -16.8781 -16.8781 -16.1291 31.138599999999997 40.6921 -11.1198 -11.1198 -11.1198 -16.1291 32.1386 39.6921 -8.51219 -8.51219 -8.51219 -16.1291 32.1386 40.6921 7.86822 7.86822 7.86822 -17.1291 31.138599999999997 39.6921 1.48878 1.48878 1.48878 -17.1291 31.138599999999997 40.6921 35.2673 35.2673 35.2673 -17.1291 32.1386 39.6921 5.55841 5.55841 5.55841 -17.1291 32.1386 40.6921 -12.0315 -12.0315 -12.0315 -18.1291 29.138599999999997 37.6921 -2.41988 -2.41988 -2.41988 -18.1291 29.138599999999997 38.6921 -50.1698 -50.1698 -50.1698 -18.1291 30.138599999999997 37.6921 40.0297 40.0297 40.0297 -18.1291 30.138599999999997 38.6921 50.5888 50.5888 50.5888 -19.1291 29.138599999999997 37.6921 -0.934752 -0.934752 -0.934752 -19.1291 29.138599999999997 38.6921 -87.1043 -87.1043 -87.1043 -19.1291 30.138599999999997 37.6921 -11.1218 -11.1218 -11.1218 -19.1291 30.138599999999997 38.6921 -22.8334 -22.8334 -22.8334 -18.1291 29.138599999999997 39.6921 -73.4944 -73.4944 -73.4944 -18.1291 29.138599999999997 40.6921 -2.62165 -2.62165 -2.62165 -18.1291 30.138599999999997 40.6921 -46.8957 -46.8957 -46.8957 -19.1291 29.138599999999997 39.6921 343.106 343.106 343.106 -19.1291 29.138599999999997 40.6921 174.214 174.214 174.214 -19.1291 30.138599999999997 40.6921 214.529 214.529 214.529 -18.1291 31.138599999999997 37.6921 27.9868 27.9868 27.9868 -18.1291 31.138599999999997 38.6921 87.6025 87.6025 87.6025 -18.1291 32.1386 37.6921 9.92021 9.92021 9.92021 -18.1291 32.1386 38.6921 159.937 159.937 159.937 -19.1291 31.138599999999997 37.6921 -83.2559 -83.2559 -83.2559 -19.1291 31.138599999999997 38.6921 -52.7776 -52.7776 -52.7776 -19.1291 32.1386 38.6921 56.3025 56.3025 56.3025 -18.1291 31.138599999999997 39.6921 80.0692 80.0692 80.0692 -18.1291 31.138599999999997 40.6921 -493.359 -493.359 -493.359 -18.1291 32.1386 39.6921 169.228 169.228 169.228 -18.1291 32.1386 40.6921 -145.761 -145.761 -145.761 -19.1291 31.138599999999997 39.6921 135.383 135.383 135.383 -19.1291 31.138599999999997 40.6921 108.834 108.834 108.834 -19.1291 32.1386 39.6921 202.367 202.367 202.367 -19.1291 32.1386 40.6921 131.391 131.391 131.391 -16.1291 33.1386 33.6921 -86.3974 -86.3974 -86.3974 -16.1291 33.1386 34.6921 216.324 216.324 216.324 -16.1291 34.1386 33.6921 109.305 109.305 109.305 -16.1291 34.1386 34.6921 170.243 170.243 170.243 -17.1291 34.1386 33.6921 -16.9444 -16.9444 -16.9444 -17.1291 34.1386 34.6921 134.345 134.345 134.345 -16.1291 33.1386 35.6921 -240.969 -240.969 -240.969 -16.1291 33.1386 36.6921 -719.788 -719.788 -719.788 -16.1291 34.1386 35.6921 -72.6298 -72.6298 -72.6298 -16.1291 34.1386 36.6921 -647.605 -647.605 -647.605 -17.1291 33.1386 35.6921 230.669 230.669 230.669 -17.1291 33.1386 36.6921 -439.946 -439.946 -439.946 -17.1291 34.1386 35.6921 576.946 576.946 576.946 -17.1291 34.1386 36.6921 390.878 390.878 390.878 -16.1291 35.1386 33.6921 67.1289 67.1289 67.1289 -17.1291 35.1386 33.6921 -41.7784 -41.7784 -41.7784 -17.1291 35.1386 34.6921 -144.385 -144.385 -144.385 -17.1291 36.1386 33.6921 -76.1035 -76.1035 -76.1035 -17.1291 36.1386 34.6921 -157.22 -157.22 -157.22 -16.1291 35.1386 36.6921 -284.71 -284.71 -284.71 -16.1291 36.1386 36.6921 -100.996 -100.996 -100.996 -18.1291 33.1386 33.6921 164.114 164.114 164.114 -18.1291 33.1386 34.6921 198.05 198.05 198.05 -18.1291 34.1386 33.6921 -118.759 -118.759 -118.759 -18.1291 34.1386 34.6921 268.894 268.894 268.894 -19.1291 33.1386 33.6921 93.5342 93.5342 93.5342 -19.1291 33.1386 34.6921 -11.4151 -11.4151 -11.4151 -19.1291 34.1386 33.6921 -62.4127 -62.4127 -62.4127 -19.1291 34.1386 34.6921 -0.587937 -0.587937 -0.587937 -18.1291 33.1386 35.6921 341.584 341.584 341.584 -18.1291 33.1386 36.6921 -73.3797 -73.3797 -73.3797 -18.1291 34.1386 35.6921 297.679 297.679 297.679 -19.1291 33.1386 35.6921 -7.87959 -7.87959 -7.87959 -19.1291 33.1386 36.6921 -46.2369 -46.2369 -46.2369 -19.1291 34.1386 35.6921 2.77593 2.77593 2.77593 -18.1291 35.1386 33.6921 -48.5284 -48.5284 -48.5284 -18.1291 35.1386 34.6921 162.676 162.676 162.676 -18.1291 36.1386 33.6921 -82.6687 -82.6687 -82.6687 -18.1291 36.1386 34.6921 5.91308 5.91308 5.91308 -19.1291 35.1386 33.6921 -4.78002 -4.78002 -4.78002 -19.1291 35.1386 34.6921 1.27314 1.27314 1.27314 -19.1291 36.1386 33.6921 -12.132 -12.132 -12.132 -19.1291 36.1386 34.6921 -5.48083 -5.48083 -5.48083 -19.1291 36.1386 35.6921 -3.26154 -3.26154 -3.26154 -19.1291 36.1386 36.6921 1.73239 1.73239 1.73239 -16.1291 33.1386 38.6921 48.867 48.867 48.867 -16.1291 34.1386 38.6921 -5.33855 -5.33855 -5.33855 -17.1291 33.1386 38.6921 -27.5304 -27.5304 -27.5304 -17.1291 34.1386 38.6921 -7.50874 -7.50874 -7.50874 -16.1291 33.1386 39.6921 -48.9518 -48.9518 -48.9518 -16.1291 33.1386 40.6921 38.0003 38.0003 38.0003 -16.1291 34.1386 39.6921 -16.5523 -16.5523 -16.5523 -17.1291 33.1386 39.6921 -25.7864 -25.7864 -25.7864 -17.1291 33.1386 40.6921 -11.2034 -11.2034 -11.2034 -17.1291 34.1386 39.6921 -12.8641 -12.8641 -12.8641 -16.1291 35.1386 37.6921 -41.7862 -41.7862 -41.7862 -16.1291 35.1386 38.6921 11.8568 11.8568 11.8568 -16.1291 36.1386 37.6921 -100.836 -100.836 -100.836 -17.1291 35.1386 37.6921 -11.8422 -11.8422 -11.8422 -17.1291 35.1386 38.6921 -2.22228 -2.22228 -2.22228 -17.1291 36.1386 37.6921 -15.7794 -15.7794 -15.7794 -17.1291 36.1386 38.6921 17.1763 17.1763 17.1763 -16.1291 35.1386 39.6921 83.1067 83.1067 83.1067 -16.1291 36.1386 39.6921 25.3473 25.3473 25.3473 -17.1291 35.1386 39.6921 26.9672 26.9672 26.9672 -17.1291 35.1386 40.6921 69.9271 69.9271 69.9271 -17.1291 36.1386 39.6921 -29.2999 -29.2999 -29.2999 -18.1291 33.1386 38.6921 -4.28663 -4.28663 -4.28663 -19.1291 33.1386 38.6921 -47.1126 -47.1126 -47.1126 -19.1291 34.1386 37.6921 -38.6596 -38.6596 -38.6596 -19.1291 34.1386 38.6921 -65.0247 -65.0247 -65.0247 -18.1291 33.1386 39.6921 68.7501 68.7501 68.7501 -18.1291 33.1386 40.6921 -690.084 -690.084 -690.084 -18.1291 34.1386 39.6921 -39.9507 -39.9507 -39.9507 -19.1291 33.1386 39.6921 29.8605 29.8605 29.8605 -19.1291 33.1386 40.6921 316.229 316.229 316.229 -19.1291 34.1386 39.6921 53.3556 53.3556 53.3556 -19.1291 34.1386 40.6921 -271.553 -271.553 -271.553 -18.1291 35.1386 37.6921 -2.41937 -2.41937 -2.41937 -18.1291 35.1386 38.6921 -4.43404 -4.43404 -4.43404 -18.1291 36.1386 37.6921 6.06441 6.06441 6.06441 -18.1291 36.1386 38.6921 20.1125 20.1125 20.1125 -19.1291 35.1386 37.6921 7.67954 7.67954 7.67954 -19.1291 35.1386 38.6921 -3.25537 -3.25537 -3.25537 -19.1291 36.1386 37.6921 -9.51673 -9.51673 -9.51673 -19.1291 36.1386 38.6921 2.70535 2.70535 2.70535 -18.1291 35.1386 39.6921 -14.2898 -14.2898 -14.2898 -18.1291 35.1386 40.6921 2095.58 2095.58 2095.58 -18.1291 36.1386 39.6921 37.3965 37.3965 37.3965 -18.1291 36.1386 40.6921 -12.4186 -12.4186 -12.4186 -19.1291 35.1386 39.6921 -43.574 -43.574 -43.574 -19.1291 35.1386 40.6921 1194.72 1194.72 1194.72 -19.1291 36.1386 39.6921 -0.0564418 -0.0564418 -0.0564418 -19.1291 36.1386 40.6921 1.27628 1.27628 1.27628 -20.1291 29.138599999999997 33.6921 -8.60778 -8.60778 -8.60778 -20.1291 29.138599999999997 34.6921 129.459 129.459 129.459 -20.1291 30.138599999999997 33.6921 -0.161047 -0.161047 -0.161047 -20.1291 30.138599999999997 34.6921 2.78576 2.78576 2.78576 -21.1291 29.138599999999997 33.6921 50.1329 50.1329 50.1329 -21.1291 29.138599999999997 34.6921 77.7466 77.7466 77.7466 -21.1291 30.138599999999997 33.6921 15.8278 15.8278 15.8278 -21.1291 30.138599999999997 34.6921 -149.116 -149.116 -149.116 -20.1291 29.138599999999997 35.6921 -25.762 -25.762 -25.762 -20.1291 29.138599999999997 36.6921 55.2955 55.2955 55.2955 -20.1291 30.138599999999997 35.6921 -3.04637 -3.04637 -3.04637 -20.1291 30.138599999999997 36.6921 3.44176 3.44176 3.44176 -21.1291 29.138599999999997 35.6921 -2.19941 -2.19941 -2.19941 -21.1291 30.138599999999997 35.6921 -392.612 -392.612 -392.612 -20.1291 31.138599999999997 34.6921 5.17852 5.17852 5.17852 -20.1291 32.1386 34.6921 -9.46588 -9.46588 -9.46588 -21.1291 31.138599999999997 33.6921 -30.4958 -30.4958 -30.4958 -21.1291 31.138599999999997 34.6921 -23.4365 -23.4365 -23.4365 -21.1291 32.1386 34.6921 -88.0346 -88.0346 -88.0346 -20.1291 31.138599999999997 35.6921 -2.76234 -2.76234 -2.76234 -20.1291 31.138599999999997 36.6921 -110.268 -110.268 -110.268 -20.1291 32.1386 35.6921 -0.808205 -0.808205 -0.808205 -20.1291 32.1386 36.6921 334.72 334.72 334.72 -21.1291 32.1386 35.6921 -31.5095 -31.5095 -31.5095 -22.1291 30.138599999999997 33.6921 -18.5306 -18.5306 -18.5306 -23.1291 29.138599999999997 33.6921 54.2935 54.2935 54.2935 -23.1291 30.138599999999997 33.6921 225.713 225.713 225.713 -23.1291 30.138599999999997 36.6921 625.649 625.649 625.649 -22.1291 31.138599999999997 33.6921 5.02154 5.02154 5.02154 -22.1291 31.138599999999997 34.6921 -32.6847 -32.6847 -32.6847 -22.1291 32.1386 33.6921 -5.9186 -5.9186 -5.9186 -22.1291 32.1386 34.6921 193.997 193.997 193.997 -23.1291 31.138599999999997 33.6921 -62.7527 -62.7527 -62.7527 -23.1291 31.138599999999997 34.6921 -266.066 -266.066 -266.066 -23.1291 32.1386 34.6921 107.741 107.741 107.741 -22.1291 31.138599999999997 36.6921 95.3782 95.3782 95.3782 -22.1291 32.1386 35.6921 159.903 159.903 159.903 -22.1291 32.1386 36.6921 -55.1311 -55.1311 -55.1311 -23.1291 31.138599999999997 35.6921 -4.6712 -4.6712 -4.6712 -23.1291 31.138599999999997 36.6921 1004.89 1004.89 1004.89 -23.1291 32.1386 35.6921 -252.395 -252.395 -252.395 -23.1291 32.1386 36.6921 -323.43 -323.43 -323.43 -20.1291 29.138599999999997 37.6921 84.4472 84.4472 84.4472 -20.1291 29.138599999999997 38.6921 -18.4942 -18.4942 -18.4942 -20.1291 30.138599999999997 37.6921 -138.522 -138.522 -138.522 -20.1291 30.138599999999997 38.6921 202.669 202.669 202.669 -20.1291 29.138599999999997 39.6921 -125.549 -125.549 -125.549 -20.1291 29.138599999999997 40.6921 -240.99 -240.99 -240.99 -20.1291 30.138599999999997 39.6921 150.64 150.64 150.64 -20.1291 30.138599999999997 40.6921 -77.236 -77.236 -77.236 -21.1291 30.138599999999997 39.6921 178.447 178.447 178.447 -21.1291 30.138599999999997 40.6921 646.53 646.53 646.53 -20.1291 31.138599999999997 37.6921 -407.992 -407.992 -407.992 -20.1291 31.138599999999997 38.6921 217.935 217.935 217.935 -20.1291 32.1386 37.6921 -403.852 -403.852 -403.852 -20.1291 32.1386 38.6921 0.180597 0.180597 0.180597 -21.1291 31.138599999999997 38.6921 -102.467 -102.467 -102.467 -21.1291 32.1386 38.6921 -189.853 -189.853 -189.853 -20.1291 31.138599999999997 39.6921 431.789 431.789 431.789 -20.1291 31.138599999999997 40.6921 -65.1741 -65.1741 -65.1741 -20.1291 32.1386 39.6921 202.995 202.995 202.995 -20.1291 32.1386 40.6921 277.003 277.003 277.003 -21.1291 31.138599999999997 39.6921 -5529.36 -5529.36 -5529.36 -23.1291 30.138599999999997 37.6921 357.738 357.738 357.738 -23.1291 30.138599999999997 38.6921 -18.2991 -18.2991 -18.2991 -22.1291 30.138599999999997 39.6921 -154.556 -154.556 -154.556 -22.1291 30.138599999999997 40.6921 1487.07 1487.07 1487.07 -22.1291 31.138599999999997 37.6921 -146.239 -146.239 -146.239 -22.1291 31.138599999999997 38.6921 82.3685 82.3685 82.3685 -22.1291 32.1386 37.6921 420.011 420.011 420.011 -22.1291 32.1386 38.6921 -215.531 -215.531 -215.531 -23.1291 31.138599999999997 37.6921 1269.13 1269.13 1269.13 -23.1291 31.138599999999997 38.6921 275.963 275.963 275.963 -23.1291 32.1386 38.6921 284.688 284.688 284.688 -22.1291 31.138599999999997 39.6921 113.403 113.403 113.403 -22.1291 31.138599999999997 40.6921 -1268.37 -1268.37 -1268.37 -22.1291 32.1386 39.6921 7263.69 7263.69 7263.69 -23.1291 31.138599999999997 39.6921 -2679.94 -2679.94 -2679.94 -23.1291 31.138599999999997 40.6921 1998.06 1998.06 1998.06 -23.1291 32.1386 39.6921 6675.95 6675.95 6675.95 -20.1291 33.1386 33.6921 11.7204 11.7204 11.7204 -20.1291 33.1386 34.6921 -15.2628 -15.2628 -15.2628 -20.1291 34.1386 33.6921 4.85757 4.85757 4.85757 -21.1291 33.1386 33.6921 149.337 149.337 149.337 -21.1291 33.1386 34.6921 81.0152 81.0152 81.0152 -21.1291 34.1386 33.6921 147.137 147.137 147.137 -20.1291 33.1386 35.6921 -0.515644 -0.515644 -0.515644 -20.1291 33.1386 36.6921 -153.173 -153.173 -153.173 -20.1291 34.1386 35.6921 0.841544 0.841544 0.841544 -20.1291 34.1386 36.6921 -114.181 -114.181 -114.181 -21.1291 33.1386 35.6921 13.5306 13.5306 13.5306 -21.1291 33.1386 36.6921 132.143 132.143 132.143 -21.1291 34.1386 36.6921 28.7223 28.7223 28.7223 -20.1291 35.1386 33.6921 -11.1273 -11.1273 -11.1273 -20.1291 35.1386 34.6921 3.72172 3.72172 3.72172 -20.1291 36.1386 33.6921 75.1323 75.1323 75.1323 -20.1291 36.1386 34.6921 91.1807 91.1807 91.1807 -21.1291 35.1386 33.6921 6.70767 6.70767 6.70767 -21.1291 35.1386 34.6921 3.23372 3.23372 3.23372 -21.1291 36.1386 33.6921 50.6228 50.6228 50.6228 -21.1291 36.1386 34.6921 -3.94283 -3.94283 -3.94283 -20.1291 36.1386 35.6921 203.758 203.758 203.758 -20.1291 36.1386 36.6921 -45.7815 -45.7815 -45.7815 -21.1291 36.1386 36.6921 152.301 152.301 152.301 -22.1291 33.1386 33.6921 27.9587 27.9587 27.9587 -22.1291 33.1386 34.6921 181.471 181.471 181.471 -22.1291 34.1386 33.6921 -1.49801 -1.49801 -1.49801 -22.1291 34.1386 34.6921 -20.7415 -20.7415 -20.7415 -23.1291 33.1386 34.6921 81.1673 81.1673 81.1673 -23.1291 34.1386 33.6921 108.76 108.76 108.76 -23.1291 34.1386 34.6921 -32.1033 -32.1033 -32.1033 -22.1291 33.1386 35.6921 65.7298 65.7298 65.7298 -22.1291 33.1386 36.6921 26.0741 26.0741 26.0741 -22.1291 34.1386 35.6921 -33.256 -33.256 -33.256 -22.1291 34.1386 36.6921 -30.0686 -30.0686 -30.0686 -23.1291 33.1386 35.6921 -135.729 -135.729 -135.729 -23.1291 33.1386 36.6921 -54.16 -54.16 -54.16 -23.1291 34.1386 36.6921 9.72105 9.72105 9.72105 -22.1291 35.1386 33.6921 -23.7249 -23.7249 -23.7249 -22.1291 35.1386 34.6921 22.8581 22.8581 22.8581 -22.1291 36.1386 33.6921 -37.7276 -37.7276 -37.7276 -23.1291 35.1386 33.6921 36.7921 36.7921 36.7921 -23.1291 35.1386 34.6921 3.62084 3.62084 3.62084 -23.1291 36.1386 33.6921 15.9088 15.9088 15.9088 -23.1291 36.1386 34.6921 2.29147 2.29147 2.29147 -23.1291 36.1386 35.6921 6.28875 6.28875 6.28875 -23.1291 36.1386 36.6921 -146.189 -146.189 -146.189 -20.1291 33.1386 37.6921 -168.713 -168.713 -168.713 -20.1291 33.1386 38.6921 49.089 49.089 49.089 -20.1291 34.1386 37.6921 -75.4589 -75.4589 -75.4589 -20.1291 34.1386 38.6921 -2.12152 -2.12152 -2.12152 -21.1291 33.1386 38.6921 -237.711 -237.711 -237.711 -21.1291 34.1386 37.6921 -63.4242 -63.4242 -63.4242 -21.1291 34.1386 38.6921 -43.2571 -43.2571 -43.2571 -20.1291 33.1386 39.6921 -75.7152 -75.7152 -75.7152 -20.1291 33.1386 40.6921 2032.3 2032.3 2032.3 -20.1291 34.1386 39.6921 -14.0245 -14.0245 -14.0245 -20.1291 34.1386 40.6921 -585.066 -585.066 -585.066 -21.1291 34.1386 40.6921 -20.3124 -20.3124 -20.3124 -20.1291 35.1386 37.6921 -14.2581 -14.2581 -14.2581 -20.1291 35.1386 38.6921 18.1121 18.1121 18.1121 -20.1291 36.1386 37.6921 8.02403 8.02403 8.02403 -20.1291 36.1386 38.6921 -0.916672 -0.916672 -0.916672 -21.1291 35.1386 37.6921 -2.86536 -2.86536 -2.86536 -21.1291 35.1386 38.6921 12.6782 12.6782 12.6782 -21.1291 36.1386 37.6921 62.2817 62.2817 62.2817 -21.1291 36.1386 38.6921 -222.676 -222.676 -222.676 -20.1291 35.1386 39.6921 -11.4339 -11.4339 -11.4339 -20.1291 35.1386 40.6921 370.238 370.238 370.238 -20.1291 36.1386 39.6921 7.00327 7.00327 7.00327 -20.1291 36.1386 40.6921 7.24343 7.24343 7.24343 -21.1291 35.1386 40.6921 -12.9592 -12.9592 -12.9592 -21.1291 36.1386 40.6921 -11.7369 -11.7369 -11.7369 -22.1291 33.1386 37.6921 -85.2972 -85.2972 -85.2972 -22.1291 33.1386 38.6921 76.5757 76.5757 76.5757 -22.1291 34.1386 37.6921 -64.1431 -64.1431 -64.1431 -22.1291 34.1386 38.6921 117.261 117.261 117.261 -23.1291 33.1386 37.6921 58.5544 58.5544 58.5544 -23.1291 33.1386 38.6921 -103.47 -103.47 -103.47 -23.1291 34.1386 37.6921 -95.2033 -95.2033 -95.2033 -23.1291 34.1386 38.6921 -62.0317 -62.0317 -62.0317 -22.1291 33.1386 39.6921 -2500.7 -2500.7 -2500.7 -23.1291 33.1386 39.6921 7754.52 7754.52 7754.52 -23.1291 34.1386 39.6921 60.4171 60.4171 60.4171 -22.1291 35.1386 37.6921 43.5414 43.5414 43.5414 -22.1291 35.1386 38.6921 54.2639 54.2639 54.2639 -22.1291 36.1386 37.6921 163.67 163.67 163.67 -22.1291 36.1386 38.6921 2.3557 2.3557 2.3557 -23.1291 35.1386 37.6921 -15.1235 -15.1235 -15.1235 -23.1291 35.1386 38.6921 -86.116 -86.116 -86.116 -23.1291 36.1386 37.6921 117.605 117.605 117.605 -23.1291 36.1386 38.6921 112.016 112.016 112.016 -22.1291 36.1386 39.6921 -20.102 -20.102 -20.102 -22.1291 36.1386 40.6921 -79.0648 -79.0648 -79.0648 -9.129100000000001 27.138599999999997 41.6921 296.184 296.184 296.184 -9.129100000000001 27.138599999999997 42.6921 42.8715 42.8715 42.8715 -9.129100000000001 28.138599999999997 41.6921 -231.086 -231.086 -231.086 -9.129100000000001 28.138599999999997 42.6921 -73.9767 -73.9767 -73.9767 -9.129100000000001 28.138599999999997 43.6921 -119.398 -119.398 -119.398 -10.129100000000001 26.138599999999997 41.6921 -14.842 -14.842 -14.842 -10.129100000000001 26.138599999999997 42.6921 -21.6119 -21.6119 -21.6119 -11.129100000000001 25.138599999999997 41.6921 1.63369 1.63369 1.63369 -11.129100000000001 26.138599999999997 41.6921 8.27309 8.27309 8.27309 -11.129100000000001 26.138599999999997 42.6921 -57.2486 -57.2486 -57.2486 -11.129100000000001 25.138599999999997 43.6921 -0.258072 -0.258072 -0.258072 -11.129100000000001 25.138599999999997 44.6921 0.219377 0.219377 0.219377 -11.129100000000001 26.138599999999997 43.6921 28.8316 28.8316 28.8316 -11.129100000000001 26.138599999999997 44.6921 -8.16708 -8.16708 -8.16708 -10.129100000000001 27.138599999999997 41.6921 12.6057 12.6057 12.6057 -10.129100000000001 27.138599999999997 42.6921 9.78849 9.78849 9.78849 -10.129100000000001 28.138599999999997 42.6921 -20.3756 -20.3756 -20.3756 -11.129100000000001 27.138599999999997 42.6921 -10.5728 -10.5728 -10.5728 -10.129100000000001 27.138599999999997 43.6921 -19.9103 -19.9103 -19.9103 -10.129100000000001 28.138599999999997 43.6921 -8.13003 -8.13003 -8.13003 -11.129100000000001 27.138599999999997 43.6921 -3.76405 -3.76405 -3.76405 -11.129100000000001 27.138599999999997 44.6921 4.96731 4.96731 4.96731 -11.129100000000001 28.138599999999997 43.6921 -11.1831 -11.1831 -11.1831 -12.129100000000001 23.138599999999997 44.6921 -0.844033 -0.844033 -0.844033 -12.129100000000001 24.138599999999997 43.6921 5.68548 5.68548 5.68548 -12.129100000000001 24.138599999999997 44.6921 -0.852915 -0.852915 -0.852915 -13.129100000000001 23.138599999999997 43.6921 0.84849 0.84849 0.84849 -13.129100000000001 23.138599999999997 44.6921 0.256198 0.256198 0.256198 -13.129100000000001 24.138599999999997 43.6921 0.79283 0.79283 0.79283 -13.129100000000001 24.138599999999997 44.6921 -0.89399 -0.89399 -0.89399 -14.129100000000001 24.138599999999997 41.6921 -12.4793 -12.4793 -12.4793 -14.129100000000001 24.138599999999997 42.6921 -8.4931 -8.4931 -8.4931 -15.129100000000001 24.138599999999997 41.6921 -3.32873 -3.32873 -3.32873 -15.129100000000001 24.138599999999997 42.6921 8.58392 8.58392 8.58392 -14.129100000000001 23.138599999999997 43.6921 0.746076 0.746076 0.746076 -14.129100000000001 23.138599999999997 44.6921 0.414926 0.414926 0.414926 -14.129100000000001 24.138599999999997 43.6921 0.585582 0.585582 0.585582 -15.129100000000001 23.138599999999997 43.6921 -6.23291 -6.23291 -6.23291 -15.129100000000001 23.138599999999997 44.6921 2.70349 2.70349 2.70349 -15.129100000000001 24.138599999999997 43.6921 6.51344 6.51344 6.51344 -15.129100000000001 24.138599999999997 44.6921 1.55379 1.55379 1.55379 -12.129100000000001 23.138599999999997 45.6921 -0.212236 -0.212236 -0.212236 -12.129100000000001 24.138599999999997 45.6921 0.373778 0.373778 0.373778 -13.129100000000001 23.138599999999997 45.6921 -3.56573 -3.56573 -3.56573 -13.129100000000001 23.138599999999997 46.6921 -2.05094 -2.05094 -2.05094 -13.129100000000001 24.138599999999997 45.6921 -0.301319 -0.301319 -0.301319 -13.129100000000001 24.138599999999997 46.6921 5.29484 5.29484 5.29484 -14.129100000000001 23.138599999999997 45.6921 -5.89854 -5.89854 -5.89854 -14.129100000000001 23.138599999999997 46.6921 4.76045 4.76045 4.76045 -14.129100000000001 24.138599999999997 45.6921 -0.154804 -0.154804 -0.154804 -14.129100000000001 24.138599999999997 46.6921 -10.2815 -10.2815 -10.2815 -15.129100000000001 23.138599999999997 45.6921 2.69124 2.69124 2.69124 -15.129100000000001 24.138599999999997 45.6921 2.42367 2.42367 2.42367 -15.129100000000001 24.138599999999997 46.6921 2.48993 2.48993 2.48993 -12.129100000000001 25.138599999999997 41.6921 5.99953 5.99953 5.99953 -12.129100000000001 25.138599999999997 42.6921 0.0974616 0.0974616 0.0974616 -12.129100000000001 26.138599999999997 41.6921 -4.5655 -4.5655 -4.5655 -12.129100000000001 26.138599999999997 42.6921 43.4105 43.4105 43.4105 -13.129100000000001 25.138599999999997 41.6921 7.31196 7.31196 7.31196 -13.129100000000001 25.138599999999997 42.6921 -9.42191 -9.42191 -9.42191 -13.129100000000001 26.138599999999997 41.6921 36.8954 36.8954 36.8954 -13.129100000000001 26.138599999999997 42.6921 68.5926 68.5926 68.5926 -12.129100000000001 25.138599999999997 43.6921 4.11949 4.11949 4.11949 -12.129100000000001 25.138599999999997 44.6921 5.27711 5.27711 5.27711 -12.129100000000001 26.138599999999997 43.6921 4.60235 4.60235 4.60235 -12.129100000000001 26.138599999999997 44.6921 -9.30497 -9.30497 -9.30497 -13.129100000000001 25.138599999999997 43.6921 -7.57491 -7.57491 -7.57491 -12.129100000000001 27.138599999999997 42.6921 19.2579 19.2579 19.2579 -12.129100000000001 28.138599999999997 41.6921 -36.8444 -36.8444 -36.8444 -12.129100000000001 28.138599999999997 42.6921 -84.8912 -84.8912 -84.8912 -13.129100000000001 27.138599999999997 42.6921 -1137.04 -1137.04 -1137.04 -13.129100000000001 28.138599999999997 41.6921 -851.182 -851.182 -851.182 -13.129100000000001 28.138599999999997 42.6921 2602.56 2602.56 2602.56 -12.129100000000001 27.138599999999997 43.6921 6.63444 6.63444 6.63444 -12.129100000000001 27.138599999999997 44.6921 4.93765 4.93765 4.93765 -12.129100000000001 28.138599999999997 43.6921 15.7125 15.7125 15.7125 -12.129100000000001 28.138599999999997 44.6921 -1.67592 -1.67592 -1.67592 -13.129100000000001 27.138599999999997 43.6921 8.76851 8.76851 8.76851 -13.129100000000001 27.138599999999997 44.6921 -4.81593 -4.81593 -4.81593 -13.129100000000001 28.138599999999997 43.6921 -2.9896 -2.9896 -2.9896 -13.129100000000001 28.138599999999997 44.6921 -7.89037 -7.89037 -7.89037 -14.129100000000001 25.138599999999997 41.6921 -4.08914 -4.08914 -4.08914 -14.129100000000001 25.138599999999997 42.6921 1.37871 1.37871 1.37871 -14.129100000000001 26.138599999999997 41.6921 -3.83674 -3.83674 -3.83674 -14.129100000000001 26.138599999999997 42.6921 -4.12867 -4.12867 -4.12867 -15.129100000000001 25.138599999999997 42.6921 -2.6658 -2.6658 -2.6658 -15.129100000000001 26.138599999999997 42.6921 -2.64093 -2.64093 -2.64093 -14.129100000000001 25.138599999999997 43.6921 3.03482 3.03482 3.03482 -14.129100000000001 26.138599999999997 43.6921 15.3484 15.3484 15.3484 -15.129100000000001 25.138599999999997 43.6921 12.0816 12.0816 12.0816 -15.129100000000001 25.138599999999997 44.6921 4.11826 4.11826 4.11826 -15.129100000000001 26.138599999999997 43.6921 -3.86323 -3.86323 -3.86323 -14.129100000000001 27.138599999999997 41.6921 -571.414 -571.414 -571.414 -14.129100000000001 27.138599999999997 42.6921 -1590.77 -1590.77 -1590.77 -14.129100000000001 28.138599999999997 41.6921 -1494.2 -1494.2 -1494.2 -14.129100000000001 28.138599999999997 42.6921 439.162 439.162 439.162 -15.129100000000001 27.138599999999997 41.6921 -2948.77 -2948.77 -2948.77 -15.129100000000001 27.138599999999997 42.6921 -2320.37 -2320.37 -2320.37 -15.129100000000001 28.138599999999997 41.6921 1472.74 1472.74 1472.74 -15.129100000000001 28.138599999999997 42.6921 2014.02 2014.02 2014.02 -14.129100000000001 27.138599999999997 43.6921 -0.217476 -0.217476 -0.217476 -14.129100000000001 27.138599999999997 44.6921 2.58796 2.58796 2.58796 -14.129100000000001 28.138599999999997 43.6921 -1.62416 -1.62416 -1.62416 -14.129100000000001 28.138599999999997 44.6921 2.66975 2.66975 2.66975 -15.129100000000001 27.138599999999997 43.6921 6.17219 6.17219 6.17219 -15.129100000000001 28.138599999999997 43.6921 -4.54731 -4.54731 -4.54731 -12.129100000000001 25.138599999999997 45.6921 -16.947 -16.947 -16.947 -12.129100000000001 26.138599999999997 45.6921 -0.204638 -0.204638 -0.204638 -12.129100000000001 26.138599999999997 46.6921 -39.7589 -39.7589 -39.7589 -13.129100000000001 25.138599999999997 45.6921 22.4377 22.4377 22.4377 -13.129100000000001 25.138599999999997 46.6921 -1.61133 -1.61133 -1.61133 -13.129100000000001 26.138599999999997 45.6921 27.9952 27.9952 27.9952 -13.129100000000001 26.138599999999997 46.6921 14.3388 14.3388 14.3388 -12.129100000000001 26.138599999999997 47.6921 -79.7815 -79.7815 -79.7815 -13.129100000000001 25.138599999999997 47.6921 -48.9692 -48.9692 -48.9692 -13.129100000000001 26.138599999999997 47.6921 -30.3883 -30.3883 -30.3883 -13.129100000000001 26.138599999999997 48.6921 -23.8421 -23.8421 -23.8421 -12.129100000000001 27.138599999999997 45.6921 24.1673 24.1673 24.1673 -12.129100000000001 27.138599999999997 46.6921 55.012 55.012 55.012 -12.129100000000001 28.138599999999997 46.6921 52.3531 52.3531 52.3531 -13.129100000000001 27.138599999999997 45.6921 -15.6068 -15.6068 -15.6068 -13.129100000000001 27.138599999999997 46.6921 22.1127 22.1127 22.1127 -13.129100000000001 28.138599999999997 45.6921 -0.0708728 -0.0708728 -0.0708728 -13.129100000000001 28.138599999999997 46.6921 19.8675 19.8675 19.8675 -12.129100000000001 27.138599999999997 47.6921 45.9382 45.9382 45.9382 -12.129100000000001 28.138599999999997 47.6921 160.757 160.757 160.757 -13.129100000000001 27.138599999999997 47.6921 110.189 110.189 110.189 -13.129100000000001 27.138599999999997 48.6921 -48.13 -48.13 -48.13 -13.129100000000001 28.138599999999997 47.6921 76.8266 76.8266 76.8266 -13.129100000000001 28.138599999999997 48.6921 -62.2762 -62.2762 -62.2762 -14.129100000000001 25.138599999999997 46.6921 10.0728 10.0728 10.0728 -15.129100000000001 25.138599999999997 45.6921 11.5673 11.5673 11.5673 -15.129100000000001 25.138599999999997 46.6921 7.93973 7.93973 7.93973 -14.129100000000001 25.138599999999997 47.6921 -0.61431 -0.61431 -0.61431 -14.129100000000001 26.138599999999997 47.6921 10.8046 10.8046 10.8046 -14.129100000000001 26.138599999999997 48.6921 40.8566 40.8566 40.8566 -15.129100000000001 25.138599999999997 47.6921 -5.13478 -5.13478 -5.13478 -15.129100000000001 26.138599999999997 47.6921 -38.6487 -38.6487 -38.6487 -15.129100000000001 26.138599999999997 48.6921 -15.6167 -15.6167 -15.6167 -14.129100000000001 27.138599999999997 45.6921 0.325627 0.325627 0.325627 -14.129100000000001 28.138599999999997 45.6921 22.1451 22.1451 22.1451 -14.129100000000001 28.138599999999997 46.6921 33.9668 33.9668 33.9668 -15.129100000000001 28.138599999999997 45.6921 23.2962 23.2962 23.2962 -15.129100000000001 28.138599999999997 46.6921 57.6103 57.6103 57.6103 -14.129100000000001 27.138599999999997 48.6921 55.269 55.269 55.269 -14.129100000000001 28.138599999999997 47.6921 -70.854 -70.854 -70.854 -14.129100000000001 28.138599999999997 48.6921 -66.1937 -66.1937 -66.1937 -15.129100000000001 27.138599999999997 47.6921 -42.7921 -42.7921 -42.7921 -15.129100000000001 27.138599999999997 48.6921 -39.9838 -39.9838 -39.9838 -15.129100000000001 28.138599999999997 47.6921 -33.5067 -33.5067 -33.5067 -15.129100000000001 28.138599999999997 48.6921 -76.0367 -76.0367 -76.0367 -9.129100000000001 29.138599999999997 41.6921 -99.4653 -99.4653 -99.4653 -9.129100000000001 29.138599999999997 42.6921 -1.82417 -1.82417 -1.82417 -9.129100000000001 30.138599999999997 41.6921 2435.52 2435.52 2435.52 -9.129100000000001 30.138599999999997 42.6921 65.0713 65.0713 65.0713 -9.129100000000001 31.138599999999997 41.6921 491.096 491.096 491.096 -9.129100000000001 31.138599999999997 42.6921 19.5535 19.5535 19.5535 -10.129100000000001 29.138599999999997 42.6921 -13.8171 -13.8171 -13.8171 -10.129100000000001 30.138599999999997 42.6921 -12.7036 -12.7036 -12.7036 -11.129100000000001 30.138599999999997 41.6921 37.3031 37.3031 37.3031 -11.129100000000001 30.138599999999997 42.6921 36.1792 36.1792 36.1792 -10.129100000000001 29.138599999999997 43.6921 -26.114 -26.114 -26.114 -10.129100000000001 30.138599999999997 43.6921 -15.8439 -15.8439 -15.8439 -10.129100000000001 30.138599999999997 44.6921 -19.6347 -19.6347 -19.6347 -11.129100000000001 29.138599999999997 43.6921 -16.6146 -16.6146 -16.6146 -11.129100000000001 30.138599999999997 43.6921 42.6084 42.6084 42.6084 -11.129100000000001 30.138599999999997 44.6921 102.923 102.923 102.923 -10.129100000000001 31.138599999999997 41.6921 335.531 335.531 335.531 -10.129100000000001 31.138599999999997 42.6921 57.93 57.93 57.93 -10.129100000000001 32.1386 42.6921 3.94878 3.94878 3.94878 -11.129100000000001 31.138599999999997 41.6921 25.8415 25.8415 25.8415 -11.129100000000001 31.138599999999997 42.6921 -21.7637 -21.7637 -21.7637 -11.129100000000001 32.1386 41.6921 59.608 59.608 59.608 -11.129100000000001 32.1386 42.6921 -75.366 -75.366 -75.366 -10.129100000000001 31.138599999999997 43.6921 -79.5461 -79.5461 -79.5461 -10.129100000000001 31.138599999999997 44.6921 -160.409 -160.409 -160.409 -10.129100000000001 32.1386 43.6921 29.7036 29.7036 29.7036 -10.129100000000001 32.1386 44.6921 -308.627 -308.627 -308.627 -11.129100000000001 31.138599999999997 43.6921 -12.7531 -12.7531 -12.7531 -11.129100000000001 31.138599999999997 44.6921 -325.099 -325.099 -325.099 -11.129100000000001 32.1386 43.6921 31.7932 31.7932 31.7932 -11.129100000000001 30.138599999999997 45.6921 74.0252 74.0252 74.0252 -10.129100000000001 31.138599999999997 45.6921 -42.5826 -42.5826 -42.5826 -10.129100000000001 32.1386 45.6921 -386.971 -386.971 -386.971 -11.129100000000001 31.138599999999997 45.6921 -70.4333 -70.4333 -70.4333 -11.129100000000001 32.1386 45.6921 -744.334 -744.334 -744.334 -11.129100000000001 32.1386 46.6921 109.125 109.125 109.125 -11.129100000000001 32.1386 47.6921 -504.307 -504.307 -504.307 -10.129100000000001 33.1386 42.6921 -7.20418 -7.20418 -7.20418 -10.129100000000001 34.1386 42.6921 567.376 567.376 567.376 -11.129100000000001 33.1386 41.6921 6.09789 6.09789 6.09789 -11.129100000000001 33.1386 42.6921 -34.8529 -34.8529 -34.8529 -11.129100000000001 34.1386 41.6921 526.272 526.272 526.272 -11.129100000000001 34.1386 42.6921 736.15 736.15 736.15 -10.129100000000001 33.1386 43.6921 18.3532 18.3532 18.3532 -10.129100000000001 33.1386 44.6921 665.374 665.374 665.374 -10.129100000000001 34.1386 43.6921 -229.543 -229.543 -229.543 -10.129100000000001 34.1386 44.6921 -416.553 -416.553 -416.553 -11.129100000000001 33.1386 43.6921 -40.1082 -40.1082 -40.1082 -11.129100000000001 33.1386 44.6921 871.593 871.593 871.593 -11.129100000000001 34.1386 44.6921 -126.567 -126.567 -126.567 -10.129100000000001 35.1386 41.6921 1505.69 1505.69 1505.69 -10.129100000000001 35.1386 42.6921 -1371.7 -1371.7 -1371.7 -10.129100000000001 36.1386 41.6921 -2864.96 -2864.96 -2864.96 -10.129100000000001 36.1386 42.6921 -1085.99 -1085.99 -1085.99 -11.129100000000001 35.1386 41.6921 1867.58 1867.58 1867.58 -11.129100000000001 35.1386 42.6921 586.625 586.625 586.625 -11.129100000000001 36.1386 41.6921 -495.131 -495.131 -495.131 -10.129100000000001 35.1386 43.6921 -2102.74 -2102.74 -2102.74 -10.129100000000001 35.1386 44.6921 -493.937 -493.937 -493.937 -10.129100000000001 36.1386 43.6921 116.604 116.604 116.604 -10.129100000000001 36.1386 44.6921 -502.807 -502.807 -502.807 -11.129100000000001 35.1386 44.6921 936.11 936.11 936.11 -11.129100000000001 36.1386 44.6921 -335.374 -335.374 -335.374 -11.129100000000001 33.1386 45.6921 -683.341 -683.341 -683.341 -11.129100000000001 33.1386 46.6921 718.452 718.452 718.452 -11.129100000000001 34.1386 45.6921 -728.618 -728.618 -728.618 -11.129100000000001 34.1386 46.6921 -1690.27 -1690.27 -1690.27 -11.129100000000001 33.1386 47.6921 -832.229 -832.229 -832.229 -11.129100000000001 34.1386 47.6921 148.882 148.882 148.882 -11.129100000000001 35.1386 45.6921 -1099.31 -1099.31 -1099.31 -12.129100000000001 29.138599999999997 41.6921 -12.3903 -12.3903 -12.3903 -12.129100000000001 29.138599999999997 42.6921 -31.0649 -31.0649 -31.0649 -12.129100000000001 30.138599999999997 41.6921 -15.0283 -15.0283 -15.0283 -12.129100000000001 30.138599999999997 42.6921 2.3394 2.3394 2.3394 -13.129100000000001 29.138599999999997 41.6921 -470.838 -470.838 -470.838 -13.129100000000001 30.138599999999997 42.6921 -2.47335 -2.47335 -2.47335 -12.129100000000001 29.138599999999997 43.6921 -7.55224 -7.55224 -7.55224 -12.129100000000001 30.138599999999997 43.6921 11.2082 11.2082 11.2082 -12.129100000000001 30.138599999999997 44.6921 -5.47815 -5.47815 -5.47815 -13.129100000000001 29.138599999999997 43.6921 -10.4034 -10.4034 -10.4034 -13.129100000000001 29.138599999999997 44.6921 -25.0815 -25.0815 -25.0815 -13.129100000000001 30.138599999999997 43.6921 -7.59881 -7.59881 -7.59881 -13.129100000000001 30.138599999999997 44.6921 -46.2393 -46.2393 -46.2393 -12.129100000000001 31.138599999999997 41.6921 49.8813 49.8813 49.8813 -12.129100000000001 31.138599999999997 42.6921 8.10197 8.10197 8.10197 -12.129100000000001 32.1386 41.6921 60.6487 60.6487 60.6487 -12.129100000000001 32.1386 42.6921 -30.4366 -30.4366 -30.4366 -13.129100000000001 31.138599999999997 41.6921 22.657 22.657 22.657 -13.129100000000001 31.138599999999997 42.6921 5.37369 5.37369 5.37369 -13.129100000000001 32.1386 41.6921 0.900467 0.900467 0.900467 -13.129100000000001 32.1386 42.6921 12.8298 12.8298 12.8298 -13.129100000000001 31.138599999999997 43.6921 5.24034 5.24034 5.24034 -13.129100000000001 31.138599999999997 44.6921 10.7518 10.7518 10.7518 -14.129100000000001 29.138599999999997 41.6921 950.29 950.29 950.29 -14.129100000000001 29.138599999999997 42.6921 678.027 678.027 678.027 -14.129100000000001 30.138599999999997 41.6921 61.6497 61.6497 61.6497 -14.129100000000001 30.138599999999997 42.6921 23.1132 23.1132 23.1132 -15.129100000000001 29.138599999999997 41.6921 -803.347 -803.347 -803.347 -15.129100000000001 29.138599999999997 42.6921 854.917 854.917 854.917 -15.129100000000001 30.138599999999997 41.6921 21.458 21.458 21.458 -15.129100000000001 30.138599999999997 42.6921 0.382541 0.382541 0.382541 -14.129100000000001 29.138599999999997 43.6921 -6.33669 -6.33669 -6.33669 -14.129100000000001 29.138599999999997 44.6921 -3.44045 -3.44045 -3.44045 -14.129100000000001 30.138599999999997 43.6921 -14.56 -14.56 -14.56 -15.129100000000001 29.138599999999997 43.6921 -16.401 -16.401 -16.401 -15.129100000000001 29.138599999999997 44.6921 -38.2619 -38.2619 -38.2619 -15.129100000000001 30.138599999999997 43.6921 -14.2714 -14.2714 -14.2714 -15.129100000000001 30.138599999999997 44.6921 5.20892 5.20892 5.20892 -14.129100000000001 31.138599999999997 42.6921 18.4519 18.4519 18.4519 -14.129100000000001 32.1386 41.6921 2.61481 2.61481 2.61481 -14.129100000000001 32.1386 42.6921 21.6914 21.6914 21.6914 -15.129100000000001 31.138599999999997 41.6921 -6.83866 -6.83866 -6.83866 -15.129100000000001 31.138599999999997 42.6921 -14.4791 -14.4791 -14.4791 -15.129100000000001 32.1386 41.6921 -24.591 -24.591 -24.591 -14.129100000000001 31.138599999999997 43.6921 14.746 14.746 14.746 -14.129100000000001 31.138599999999997 44.6921 10.6603 10.6603 10.6603 -14.129100000000001 32.1386 43.6921 39.8862 39.8862 39.8862 -14.129100000000001 32.1386 44.6921 -1910.88 -1910.88 -1910.88 -15.129100000000001 31.138599999999997 43.6921 8.25781 8.25781 8.25781 -15.129100000000001 31.138599999999997 44.6921 -0.0204653 -0.0204653 -0.0204653 -15.129100000000001 32.1386 43.6921 4.56216 4.56216 4.56216 -15.129100000000001 32.1386 44.6921 -12.3944 -12.3944 -12.3944 -12.129100000000001 30.138599999999997 45.6921 8.1005 8.1005 8.1005 -13.129100000000001 29.138599999999997 45.6921 -25.3563 -25.3563 -25.3563 -13.129100000000001 29.138599999999997 46.6921 -34.7436 -34.7436 -34.7436 -13.129100000000001 30.138599999999997 45.6921 -37.5186 -37.5186 -37.5186 -13.129100000000001 29.138599999999997 47.6921 -43.5583 -43.5583 -43.5583 -12.129100000000001 31.138599999999997 45.6921 43.7469 43.7469 43.7469 -12.129100000000001 31.138599999999997 46.6921 -27.4267 -27.4267 -27.4267 -12.129100000000001 32.1386 45.6921 163.545 163.545 163.545 -12.129100000000001 32.1386 46.6921 -1494.97 -1494.97 -1494.97 -13.129100000000001 31.138599999999997 45.6921 13.574 13.574 13.574 -13.129100000000001 31.138599999999997 46.6921 17.357 17.357 17.357 -13.129100000000001 32.1386 46.6921 274.746 274.746 274.746 -12.129100000000001 32.1386 47.6921 527.88 527.88 527.88 -13.129100000000001 32.1386 47.6921 -382.544 -382.544 -382.544 -14.129100000000001 29.138599999999997 45.6921 8.27071 8.27071 8.27071 -14.129100000000001 29.138599999999997 46.6921 116.529 116.529 116.529 -15.129100000000001 29.138599999999997 45.6921 12.1337 12.1337 12.1337 -15.129100000000001 29.138599999999997 46.6921 69.9916 69.9916 69.9916 -15.129100000000001 30.138599999999997 46.6921 34.3313 34.3313 34.3313 -14.129100000000001 29.138599999999997 47.6921 7.23156 7.23156 7.23156 -14.129100000000001 30.138599999999997 47.6921 112.744 112.744 112.744 -14.129100000000001 30.138599999999997 48.6921 21.7525 21.7525 21.7525 -15.129100000000001 29.138599999999997 47.6921 39.9266 39.9266 39.9266 -15.129100000000001 29.138599999999997 48.6921 11.6925 11.6925 11.6925 -15.129100000000001 30.138599999999997 47.6921 68.7172 68.7172 68.7172 -15.129100000000001 30.138599999999997 48.6921 -49.0084 -49.0084 -49.0084 -14.129100000000001 31.138599999999997 45.6921 -11.3702 -11.3702 -11.3702 -14.129100000000001 31.138599999999997 46.6921 -41.5491 -41.5491 -41.5491 -14.129100000000001 32.1386 45.6921 -205.232 -205.232 -205.232 -14.129100000000001 32.1386 46.6921 974.056 974.056 974.056 -15.129100000000001 31.138599999999997 45.6921 0.507464 0.507464 0.507464 -15.129100000000001 31.138599999999997 46.6921 -40.9697 -40.9697 -40.9697 -15.129100000000001 32.1386 45.6921 6.14357 6.14357 6.14357 -15.129100000000001 32.1386 46.6921 -56.2556 -56.2556 -56.2556 -14.129100000000001 31.138599999999997 47.6921 24.6617 24.6617 24.6617 -14.129100000000001 31.138599999999997 48.6921 66.4779 66.4779 66.4779 -14.129100000000001 32.1386 47.6921 -51.2155 -51.2155 -51.2155 -14.129100000000001 32.1386 48.6921 110.657 110.657 110.657 -15.129100000000001 31.138599999999997 48.6921 115.334 115.334 115.334 -12.129100000000001 34.1386 41.6921 30.362 30.362 30.362 -13.129100000000001 34.1386 41.6921 -94.4997 -94.4997 -94.4997 -12.129100000000001 33.1386 44.6921 248.304 248.304 248.304 -13.129100000000001 34.1386 44.6921 555.504 555.504 555.504 -12.129100000000001 35.1386 41.6921 48.0065 48.0065 48.0065 -12.129100000000001 36.1386 41.6921 17.8956 17.8956 17.8956 -13.129100000000001 35.1386 41.6921 13.5512 13.5512 13.5512 -13.129100000000001 35.1386 42.6921 22.9906 22.9906 22.9906 -13.129100000000001 36.1386 41.6921 5.89141 5.89141 5.89141 -13.129100000000001 36.1386 42.6921 14.1221 14.1221 14.1221 -12.129100000000001 35.1386 44.6921 2215.79 2215.79 2215.79 -12.129100000000001 36.1386 44.6921 2056.71 2056.71 2056.71 -13.129100000000001 35.1386 43.6921 1.75312 1.75312 1.75312 -13.129100000000001 35.1386 44.6921 408.096 408.096 408.096 -13.129100000000001 36.1386 43.6921 -97.2297 -97.2297 -97.2297 -13.129100000000001 36.1386 44.6921 467.098 467.098 467.098 -14.129100000000001 33.1386 41.6921 -3.83669 -3.83669 -3.83669 -14.129100000000001 33.1386 42.6921 4.55592 4.55592 4.55592 -14.129100000000001 34.1386 41.6921 -90.0091 -90.0091 -90.0091 -14.129100000000001 34.1386 42.6921 -28.5559 -28.5559 -28.5559 -15.129100000000001 33.1386 41.6921 -31.6069 -31.6069 -31.6069 -15.129100000000001 33.1386 42.6921 -31.4579 -31.4579 -31.4579 -15.129100000000001 34.1386 41.6921 32.8637 32.8637 32.8637 -15.129100000000001 34.1386 42.6921 -12.314 -12.314 -12.314 -14.129100000000001 33.1386 43.6921 -0.233153 -0.233153 -0.233153 -14.129100000000001 34.1386 43.6921 -24.3933 -24.3933 -24.3933 -14.129100000000001 34.1386 44.6921 -1070.13 -1070.13 -1070.13 -15.129100000000001 33.1386 43.6921 12.7851 12.7851 12.7851 -15.129100000000001 34.1386 43.6921 6.89009 6.89009 6.89009 -15.129100000000001 34.1386 44.6921 -31.0252 -31.0252 -31.0252 -14.129100000000001 35.1386 41.6921 -38.9666 -38.9666 -38.9666 -14.129100000000001 35.1386 42.6921 30.6885 30.6885 30.6885 -14.129100000000001 36.1386 41.6921 20.321 20.321 20.321 -14.129100000000001 36.1386 42.6921 0.977631 0.977631 0.977631 -15.129100000000001 35.1386 42.6921 30.4745 30.4745 30.4745 -15.129100000000001 36.1386 41.6921 -44.32 -44.32 -44.32 -15.129100000000001 36.1386 42.6921 -23.6728 -23.6728 -23.6728 -14.129100000000001 35.1386 43.6921 58.577 58.577 58.577 -14.129100000000001 35.1386 44.6921 85.0568 85.0568 85.0568 -14.129100000000001 36.1386 43.6921 -115.9 -115.9 -115.9 -14.129100000000001 36.1386 44.6921 428.894 428.894 428.894 -15.129100000000001 35.1386 44.6921 -5.14347 -5.14347 -5.14347 -15.129100000000001 36.1386 43.6921 19.603 19.603 19.603 -15.129100000000001 36.1386 44.6921 -7.59368 -7.59368 -7.59368 -12.129100000000001 33.1386 45.6921 2143.2 2143.2 2143.2 -12.129100000000001 34.1386 45.6921 1782.15 1782.15 1782.15 -12.129100000000001 34.1386 46.6921 1674.98 1674.98 1674.98 -13.129100000000001 34.1386 45.6921 -88.8614 -88.8614 -88.8614 -13.129100000000001 34.1386 46.6921 -15.6841 -15.6841 -15.6841 -12.129100000000001 33.1386 47.6921 -180.703 -180.703 -180.703 -12.129100000000001 34.1386 47.6921 -727.253 -727.253 -727.253 -13.129100000000001 33.1386 47.6921 -449.282 -449.282 -449.282 -13.129100000000001 34.1386 47.6921 36.0347 36.0347 36.0347 -12.129100000000001 35.1386 45.6921 2380.88 2380.88 2380.88 -13.129100000000001 35.1386 45.6921 298.682 298.682 298.682 -13.129100000000001 36.1386 46.6921 861.962 861.962 861.962 -13.129100000000001 35.1386 47.6921 285.098 285.098 285.098 -13.129100000000001 36.1386 47.6921 1127.67 1127.67 1127.67 -13.129100000000001 36.1386 48.6921 -484.57 -484.57 -484.57 -14.129100000000001 33.1386 46.6921 1719.87 1719.87 1719.87 -14.129100000000001 34.1386 45.6921 -1647.7 -1647.7 -1647.7 -14.129100000000001 34.1386 46.6921 -789.759 -789.759 -789.759 -14.129100000000001 33.1386 47.6921 -547.355 -547.355 -547.355 -14.129100000000001 33.1386 48.6921 132.505 132.505 132.505 -14.129100000000001 34.1386 47.6921 -1243.85 -1243.85 -1243.85 -14.129100000000001 34.1386 48.6921 -1049.94 -1049.94 -1049.94 -15.129100000000001 33.1386 48.6921 25.8512 25.8512 25.8512 -15.129100000000001 34.1386 48.6921 -26.76 -26.76 -26.76 -14.129100000000001 35.1386 45.6921 -92.4814 -92.4814 -92.4814 -14.129100000000001 35.1386 46.6921 -655.176 -655.176 -655.176 -14.129100000000001 36.1386 45.6921 -223.134 -223.134 -223.134 -14.129100000000001 36.1386 46.6921 107.436 107.436 107.436 -15.129100000000001 35.1386 45.6921 -10.7136 -10.7136 -10.7136 -15.129100000000001 36.1386 45.6921 -25.0338 -25.0338 -25.0338 -14.129100000000001 35.1386 47.6921 -220.082 -220.082 -220.082 -14.129100000000001 35.1386 48.6921 39.7952 39.7952 39.7952 -14.129100000000001 36.1386 47.6921 1032.05 1032.05 1032.05 -14.129100000000001 36.1386 48.6921 560.808 560.808 560.808 -15.129100000000001 35.1386 47.6921 -33.1786 -33.1786 -33.1786 -15.129100000000001 35.1386 48.6921 -1.39606 -1.39606 -1.39606 -15.129100000000001 36.1386 48.6921 1.62767 1.62767 1.62767 -15.129100000000001 29.138599999999997 49.6921 -430.164 -430.164 -430.164 -15.129100000000001 30.138599999999997 49.6921 -21.9693 -21.9693 -21.9693 -15.129100000000001 30.138599999999997 50.6921 321.673 321.673 321.673 -14.129100000000001 31.138599999999997 49.6921 192.291 192.291 192.291 -14.129100000000001 32.1386 49.6921 -130.838 -130.838 -130.838 -15.129100000000001 31.138599999999997 49.6921 -72.0854 -72.0854 -72.0854 -15.129100000000001 31.138599999999997 50.6921 -18.6395 -18.6395 -18.6395 -15.129100000000001 32.1386 49.6921 145.223 145.223 145.223 -15.129100000000001 33.1386 49.6921 13.4622 13.4622 13.4622 -15.129100000000001 33.1386 50.6921 9.92653 9.92653 9.92653 -15.129100000000001 34.1386 49.6921 19.3656 19.3656 19.3656 -15.129100000000001 34.1386 50.6921 -1.1326 -1.1326 -1.1326 -15.129100000000001 35.1386 49.6921 29.8377 29.8377 29.8377 -15.129100000000001 36.1386 49.6921 55.7817 55.7817 55.7817 -16.1291 24.138599999999997 41.6921 24.65 24.65 24.65 -16.1291 24.138599999999997 42.6921 32.0446 32.0446 32.0446 -17.1291 24.138599999999997 41.6921 -10.1768 -10.1768 -10.1768 -17.1291 24.138599999999997 42.6921 -1.5824 -1.5824 -1.5824 -18.1291 24.138599999999997 41.6921 20.0185 20.0185 20.0185 -18.1291 24.138599999999997 42.6921 -6.54352 -6.54352 -6.54352 -16.1291 25.138599999999997 42.6921 12.1375 12.1375 12.1375 -16.1291 26.138599999999997 42.6921 -0.15778 -0.15778 -0.15778 -17.1291 25.138599999999997 42.6921 -0.0747216 -0.0747216 -0.0747216 -17.1291 26.138599999999997 42.6921 0.65521 0.65521 0.65521 -16.1291 25.138599999999997 43.6921 9.61476 9.61476 9.61476 -16.1291 25.138599999999997 44.6921 15.6578 15.6578 15.6578 -16.1291 26.138599999999997 43.6921 1.19737 1.19737 1.19737 -16.1291 26.138599999999997 44.6921 -17.6322 -17.6322 -17.6322 -17.1291 25.138599999999997 43.6921 -18.3843 -18.3843 -18.3843 -17.1291 25.138599999999997 44.6921 8.4377 8.4377 8.4377 -17.1291 26.138599999999997 43.6921 -14.9491 -14.9491 -14.9491 -17.1291 26.138599999999997 44.6921 -19.9605 -19.9605 -19.9605 -16.1291 27.138599999999997 41.6921 1.95963 1.95963 1.95963 -16.1291 27.138599999999997 42.6921 10.6016 10.6016 10.6016 -16.1291 28.138599999999997 41.6921 -14.0997 -14.0997 -14.0997 -16.1291 28.138599999999997 42.6921 -10.7487 -10.7487 -10.7487 -17.1291 27.138599999999997 41.6921 7.52705 7.52705 7.52705 -17.1291 27.138599999999997 42.6921 8.08604 8.08604 8.08604 -17.1291 28.138599999999997 42.6921 -19.633 -19.633 -19.633 -16.1291 27.138599999999997 43.6921 9.19276 9.19276 9.19276 -17.1291 27.138599999999997 44.6921 5.46696 5.46696 5.46696 -17.1291 28.138599999999997 44.6921 20.1686 20.1686 20.1686 -18.1291 25.138599999999997 41.6921 -0.611415 -0.611415 -0.611415 -18.1291 25.138599999999997 42.6921 1.3871 1.3871 1.3871 -18.1291 26.138599999999997 41.6921 -21.6216 -21.6216 -21.6216 -18.1291 26.138599999999997 42.6921 -60.8174 -60.8174 -60.8174 -18.1291 25.138599999999997 43.6921 -11.1131 -11.1131 -11.1131 -18.1291 26.138599999999997 43.6921 15.9813 15.9813 15.9813 -18.1291 26.138599999999997 44.6921 -31.2517 -31.2517 -31.2517 -18.1291 27.138599999999997 41.6921 -50.488 -50.488 -50.488 -18.1291 27.138599999999997 42.6921 -28.8403 -28.8403 -28.8403 -18.1291 28.138599999999997 41.6921 -14.2818 -14.2818 -14.2818 -18.1291 28.138599999999997 42.6921 -65.6828 -65.6828 -65.6828 -19.1291 27.138599999999997 42.6921 -89.4223 -89.4223 -89.4223 -19.1291 28.138599999999997 41.6921 -30.28 -30.28 -30.28 -19.1291 28.138599999999997 42.6921 4.84036 4.84036 4.84036 -18.1291 27.138599999999997 43.6921 33.1216 33.1216 33.1216 -18.1291 27.138599999999997 44.6921 22.8565 22.8565 22.8565 -18.1291 28.138599999999997 43.6921 -14.8576 -14.8576 -14.8576 -18.1291 28.138599999999997 44.6921 6.36177 6.36177 6.36177 -19.1291 27.138599999999997 43.6921 98.8045 98.8045 98.8045 -19.1291 27.138599999999997 44.6921 -92.9258 -92.9258 -92.9258 -19.1291 28.138599999999997 43.6921 74.7957 74.7957 74.7957 -19.1291 28.138599999999997 44.6921 21.5964 21.5964 21.5964 -16.1291 25.138599999999997 45.6921 0.136158 0.136158 0.136158 -16.1291 25.138599999999997 46.6921 -17.0553 -17.0553 -17.0553 -17.1291 25.138599999999997 45.6921 6.35601 6.35601 6.35601 -17.1291 25.138599999999997 46.6921 38.7588 38.7588 38.7588 -17.1291 26.138599999999997 45.6921 18.4307 18.4307 18.4307 -17.1291 26.138599999999997 46.6921 -1.54594 -1.54594 -1.54594 -16.1291 25.138599999999997 47.6921 3.09834 3.09834 3.09834 -16.1291 26.138599999999997 47.6921 -25.1177 -25.1177 -25.1177 -16.1291 26.138599999999997 48.6921 -42.2537 -42.2537 -42.2537 -17.1291 25.138599999999997 47.6921 9.02864 9.02864 9.02864 -17.1291 26.138599999999997 47.6921 6.45586 6.45586 6.45586 -17.1291 26.138599999999997 48.6921 -4.1805 -4.1805 -4.1805 -16.1291 28.138599999999997 45.6921 -1.73895 -1.73895 -1.73895 -16.1291 28.138599999999997 46.6921 41.6663 41.6663 41.6663 -17.1291 27.138599999999997 45.6921 3.72293 3.72293 3.72293 -17.1291 28.138599999999997 45.6921 -25.4393 -25.4393 -25.4393 -17.1291 28.138599999999997 46.6921 1.7682 1.7682 1.7682 -16.1291 27.138599999999997 48.6921 -87.9229 -87.9229 -87.9229 -16.1291 28.138599999999997 47.6921 35.373 35.373 35.373 -16.1291 28.138599999999997 48.6921 -34.745 -34.745 -34.745 -17.1291 27.138599999999997 48.6921 1.36291 1.36291 1.36291 -17.1291 28.138599999999997 47.6921 -6.88067 -6.88067 -6.88067 -17.1291 28.138599999999997 48.6921 -2.76254 -2.76254 -2.76254 -18.1291 26.138599999999997 45.6921 28.7329 28.7329 28.7329 -18.1291 26.138599999999997 46.6921 35.5251 35.5251 35.5251 -18.1291 26.138599999999997 47.6921 8.7844 8.7844 8.7844 -18.1291 27.138599999999997 45.6921 64.5481 64.5481 64.5481 -18.1291 27.138599999999997 46.6921 64.8049 64.8049 64.8049 -18.1291 28.138599999999997 45.6921 64.1795 64.1795 64.1795 -18.1291 28.138599999999997 46.6921 58.2239 58.2239 58.2239 -18.1291 27.138599999999997 47.6921 -48.731 -48.731 -48.731 -18.1291 27.138599999999997 48.6921 5.11939 5.11939 5.11939 -18.1291 28.138599999999997 47.6921 -89.9981 -89.9981 -89.9981 -18.1291 28.138599999999997 48.6921 7.97054 7.97054 7.97054 -20.1291 27.138599999999997 42.6921 -4.65845 -4.65845 -4.65845 -20.1291 28.138599999999997 41.6921 74.2726 74.2726 74.2726 -20.1291 28.138599999999997 42.6921 7.80877 7.80877 7.80877 -21.1291 27.138599999999997 42.6921 82.8105 82.8105 82.8105 -21.1291 28.138599999999997 41.6921 -345.353 -345.353 -345.353 -21.1291 28.138599999999997 42.6921 -21.2985 -21.2985 -21.2985 -20.1291 27.138599999999997 43.6921 0.1609 0.1609 0.1609 -20.1291 28.138599999999997 43.6921 47.1502 47.1502 47.1502 -20.1291 28.138599999999997 44.6921 -132.636 -132.636 -132.636 -21.1291 27.138599999999997 43.6921 17.8038 17.8038 17.8038 -21.1291 28.138599999999997 43.6921 -53.1878 -53.1878 -53.1878 -21.1291 28.138599999999997 44.6921 28.2646 28.2646 28.2646 -22.1291 28.138599999999997 41.6921 68.8941 68.8941 68.8941 -22.1291 28.138599999999997 42.6921 -82.7089 -82.7089 -82.7089 -22.1291 28.138599999999997 43.6921 -32.0213 -32.0213 -32.0213 -22.1291 28.138599999999997 44.6921 52.7595 52.7595 52.7595 -23.1291 28.138599999999997 44.6921 -6.79277 -6.79277 -6.79277 -22.1291 28.138599999999997 45.6921 104.952 104.952 104.952 -22.1291 28.138599999999997 46.6921 -123.175 -123.175 -123.175 -23.1291 28.138599999999997 45.6921 210.631 210.631 210.631 -23.1291 28.138599999999997 46.6921 5.47041 5.47041 5.47041 -22.1291 28.138599999999997 47.6921 69.5411 69.5411 69.5411 -23.1291 28.138599999999997 47.6921 142.719 142.719 142.719 -17.1291 29.138599999999997 42.6921 2.176 2.176 2.176 -17.1291 30.138599999999997 41.6921 18.7428 18.7428 18.7428 -17.1291 30.138599999999997 42.6921 2.16139 2.16139 2.16139 -16.1291 29.138599999999997 44.6921 -4.52193 -4.52193 -4.52193 -16.1291 30.138599999999997 44.6921 1.10905 1.10905 1.10905 -17.1291 29.138599999999997 44.6921 28.5944 28.5944 28.5944 -17.1291 30.138599999999997 44.6921 23.8155 23.8155 23.8155 -16.1291 31.138599999999997 41.6921 -27.329 -27.329 -27.329 -16.1291 31.138599999999997 42.6921 -13.2824 -13.2824 -13.2824 -16.1291 32.1386 41.6921 48.348 48.348 48.348 -16.1291 32.1386 42.6921 -13.622 -13.622 -13.622 -17.1291 31.138599999999997 41.6921 -3.56278 -3.56278 -3.56278 -17.1291 31.138599999999997 42.6921 24.4509 24.4509 24.4509 -17.1291 32.1386 41.6921 -8.26814 -8.26814 -8.26814 -17.1291 32.1386 42.6921 -7.76572 -7.76572 -7.76572 -16.1291 31.138599999999997 43.6921 -11.512 -11.512 -11.512 -16.1291 31.138599999999997 44.6921 -2.16198 -2.16198 -2.16198 -16.1291 32.1386 43.6921 7.21419 7.21419 7.21419 -18.1291 29.138599999999997 42.6921 -40.1498 -40.1498 -40.1498 -18.1291 30.138599999999997 41.6921 18.9613 18.9613 18.9613 -18.1291 30.138599999999997 42.6921 -59.5018 -59.5018 -59.5018 -19.1291 29.138599999999997 41.6921 -78.4345 -78.4345 -78.4345 -19.1291 29.138599999999997 42.6921 -3.94266 -3.94266 -3.94266 -19.1291 30.138599999999997 41.6921 120.993 120.993 120.993 -19.1291 30.138599999999997 42.6921 13.7065 13.7065 13.7065 -18.1291 29.138599999999997 44.6921 28.2597 28.2597 28.2597 -18.1291 30.138599999999997 44.6921 -29.683 -29.683 -29.683 -19.1291 29.138599999999997 43.6921 -0.159509 -0.159509 -0.159509 -19.1291 29.138599999999997 44.6921 -8.63475 -8.63475 -8.63475 -19.1291 30.138599999999997 43.6921 -44.3961 -44.3961 -44.3961 -19.1291 30.138599999999997 44.6921 -193.558 -193.558 -193.558 -18.1291 31.138599999999997 41.6921 -169.718 -169.718 -169.718 -18.1291 31.138599999999997 42.6921 -35.1807 -35.1807 -35.1807 -18.1291 32.1386 41.6921 32.3976 32.3976 32.3976 -18.1291 32.1386 42.6921 -310.285 -310.285 -310.285 -19.1291 31.138599999999997 41.6921 126.364 126.364 126.364 -19.1291 31.138599999999997 42.6921 -46.5496 -46.5496 -46.5496 -19.1291 32.1386 41.6921 -220.189 -220.189 -220.189 -19.1291 32.1386 42.6921 156.599 156.599 156.599 -18.1291 32.1386 43.6921 -73.5801 -73.5801 -73.5801 -19.1291 31.138599999999997 43.6921 27.4949 27.4949 27.4949 -19.1291 32.1386 43.6921 30.0835 30.0835 30.0835 -16.1291 29.138599999999997 45.6921 -5.56079 -5.56079 -5.56079 -16.1291 29.138599999999997 46.6921 -1.72616 -1.72616 -1.72616 -16.1291 30.138599999999997 45.6921 -2.58609 -2.58609 -2.58609 -16.1291 30.138599999999997 46.6921 -53.2224 -53.2224 -53.2224 -17.1291 29.138599999999997 45.6921 6.98863 6.98863 6.98863 -17.1291 29.138599999999997 46.6921 2.52198 2.52198 2.52198 -17.1291 30.138599999999997 45.6921 -0.700727 -0.700727 -0.700727 -17.1291 30.138599999999997 46.6921 11.8699 11.8699 11.8699 -16.1291 29.138599999999997 47.6921 -5.14983 -5.14983 -5.14983 -16.1291 29.138599999999997 48.6921 34.3375 34.3375 34.3375 -16.1291 30.138599999999997 47.6921 14.7755 14.7755 14.7755 -17.1291 29.138599999999997 47.6921 2.57815 2.57815 2.57815 -17.1291 29.138599999999997 48.6921 -0.731178 -0.731178 -0.731178 -17.1291 30.138599999999997 47.6921 1.4978 1.4978 1.4978 -17.1291 30.138599999999997 48.6921 14.779 14.779 14.779 -16.1291 31.138599999999997 45.6921 7.05314 7.05314 7.05314 -16.1291 31.138599999999997 46.6921 -78.4672 -78.4672 -78.4672 -16.1291 32.1386 45.6921 -16.1631 -16.1631 -16.1631 -16.1291 32.1386 46.6921 -57.1492 -57.1492 -57.1492 -17.1291 31.138599999999997 45.6921 37.367 37.367 37.367 -17.1291 31.138599999999997 46.6921 -14.9321 -14.9321 -14.9321 -17.1291 32.1386 45.6921 -29.3346 -29.3346 -29.3346 -17.1291 32.1386 46.6921 -89.7836 -89.7836 -89.7836 -17.1291 31.138599999999997 47.6921 5.01562 5.01562 5.01562 -17.1291 32.1386 47.6921 -27.8837 -27.8837 -27.8837 -17.1291 32.1386 48.6921 66.6092 66.6092 66.6092 -18.1291 29.138599999999997 45.6921 33.9177 33.9177 33.9177 -18.1291 30.138599999999997 45.6921 30.4764 30.4764 30.4764 -18.1291 30.138599999999997 46.6921 9.93741 9.93741 9.93741 -19.1291 29.138599999999997 45.6921 -22.3335 -22.3335 -22.3335 -19.1291 29.138599999999997 46.6921 14.2719 14.2719 14.2719 -19.1291 30.138599999999997 46.6921 68.7625 68.7625 68.7625 -18.1291 29.138599999999997 48.6921 -3.95577 -3.95577 -3.95577 -18.1291 30.138599999999997 47.6921 -2.36933 -2.36933 -2.36933 -18.1291 30.138599999999997 48.6921 10.3879 10.3879 10.3879 -19.1291 30.138599999999997 47.6921 100.615 100.615 100.615 -18.1291 31.138599999999997 45.6921 -9.11082 -9.11082 -9.11082 -18.1291 31.138599999999997 46.6921 15.0029 15.0029 15.0029 -18.1291 32.1386 45.6921 -57.1957 -57.1957 -57.1957 -18.1291 32.1386 46.6921 -29.041 -29.041 -29.041 -19.1291 31.138599999999997 46.6921 36.2311 36.2311 36.2311 -19.1291 32.1386 46.6921 41.6316 41.6316 41.6316 -18.1291 31.138599999999997 47.6921 -13.3928 -13.3928 -13.3928 -18.1291 31.138599999999997 48.6921 16.493 16.493 16.493 -18.1291 32.1386 47.6921 1.35261 1.35261 1.35261 -18.1291 32.1386 48.6921 29.1439 29.1439 29.1439 -19.1291 31.138599999999997 47.6921 10.1172 10.1172 10.1172 -19.1291 32.1386 47.6921 25.5103 25.5103 25.5103 -16.1291 33.1386 42.6921 -24.4042 -24.4042 -24.4042 -16.1291 34.1386 42.6921 -27.2295 -27.2295 -27.2295 -17.1291 33.1386 42.6921 77.2624 77.2624 77.2624 -17.1291 34.1386 42.6921 4.91533 4.91533 4.91533 -16.1291 33.1386 43.6921 -35.5821 -35.5821 -35.5821 -16.1291 33.1386 44.6921 -38.8835 -38.8835 -38.8835 -16.1291 34.1386 43.6921 -29.4357 -29.4357 -29.4357 -16.1291 34.1386 44.6921 -16.6808 -16.6808 -16.6808 -17.1291 33.1386 43.6921 -26.0312 -26.0312 -26.0312 -17.1291 33.1386 44.6921 -33.1027 -33.1027 -33.1027 -17.1291 34.1386 43.6921 -44.753 -44.753 -44.753 -17.1291 34.1386 44.6921 -54.6054 -54.6054 -54.6054 -16.1291 35.1386 42.6921 -26.9785 -26.9785 -26.9785 -16.1291 36.1386 42.6921 -49.5396 -49.5396 -49.5396 -17.1291 35.1386 42.6921 -85.2896 -85.2896 -85.2896 -17.1291 36.1386 42.6921 -32.9017 -32.9017 -32.9017 -16.1291 35.1386 44.6921 12.276 12.276 12.276 -16.1291 36.1386 43.6921 -10.4256 -10.4256 -10.4256 -16.1291 36.1386 44.6921 -5.58636 -5.58636 -5.58636 -17.1291 35.1386 43.6921 -9.64995 -9.64995 -9.64995 -17.1291 35.1386 44.6921 46.268 46.268 46.268 -17.1291 36.1386 43.6921 10.8682 10.8682 10.8682 -17.1291 36.1386 44.6921 1.34998 1.34998 1.34998 -18.1291 33.1386 42.6921 495.186 495.186 495.186 -18.1291 34.1386 42.6921 2431.52 2431.52 2431.52 -19.1291 33.1386 41.6921 -1350.7 -1350.7 -1350.7 -19.1291 33.1386 42.6921 28.3768 28.3768 28.3768 -19.1291 34.1386 41.6921 -2322.14 -2322.14 -2322.14 -19.1291 34.1386 42.6921 -2168.64 -2168.64 -2168.64 -18.1291 33.1386 43.6921 49.6371 49.6371 49.6371 -18.1291 33.1386 44.6921 -56.8762 -56.8762 -56.8762 -18.1291 34.1386 43.6921 -8.70928 -8.70928 -8.70928 -18.1291 34.1386 44.6921 -104.05 -104.05 -104.05 -19.1291 33.1386 43.6921 -77.3198 -77.3198 -77.3198 -19.1291 34.1386 43.6921 -39.9101 -39.9101 -39.9101 -19.1291 34.1386 44.6921 -182.024 -182.024 -182.024 -18.1291 35.1386 42.6921 1484.1 1484.1 1484.1 -19.1291 35.1386 42.6921 2651.07 2651.07 2651.07 -19.1291 36.1386 42.6921 21.9706 21.9706 21.9706 -18.1291 35.1386 43.6921 -82.4529 -82.4529 -82.4529 -18.1291 35.1386 44.6921 -99.8965 -99.8965 -99.8965 -18.1291 36.1386 43.6921 19.0279 19.0279 19.0279 -18.1291 36.1386 44.6921 -10.323 -10.323 -10.323 -19.1291 35.1386 43.6921 9.27351 9.27351 9.27351 -19.1291 35.1386 44.6921 58.7341 58.7341 58.7341 -19.1291 36.1386 43.6921 21.7408 21.7408 21.7408 -16.1291 33.1386 45.6921 17.1505 17.1505 17.1505 -16.1291 34.1386 45.6921 24.2169 24.2169 24.2169 -17.1291 33.1386 45.6921 110.542 110.542 110.542 -17.1291 33.1386 46.6921 -102.738 -102.738 -102.738 -17.1291 34.1386 45.6921 72.1411 72.1411 72.1411 -17.1291 34.1386 46.6921 -31.7119 -31.7119 -31.7119 -17.1291 34.1386 47.6921 45.6773 45.6773 45.6773 -16.1291 36.1386 45.6921 7.17233 7.17233 7.17233 -17.1291 35.1386 46.6921 33.5624 33.5624 33.5624 -17.1291 36.1386 46.6921 -5.58556 -5.58556 -5.58556 -16.1291 35.1386 47.6921 -27.998 -27.998 -27.998 -16.1291 35.1386 48.6921 -64.0951 -64.0951 -64.0951 -16.1291 36.1386 47.6921 21.8544 21.8544 21.8544 -16.1291 36.1386 48.6921 37.5337 37.5337 37.5337 -17.1291 35.1386 47.6921 -140.154 -140.154 -140.154 -17.1291 35.1386 48.6921 67.0985 67.0985 67.0985 -17.1291 36.1386 47.6921 6.48818 6.48818 6.48818 -18.1291 33.1386 45.6921 93.0112 93.0112 93.0112 -18.1291 33.1386 46.6921 -7.38679 -7.38679 -7.38679 -18.1291 34.1386 45.6921 -45.4581 -45.4581 -45.4581 -18.1291 34.1386 46.6921 -83.4347 -83.4347 -83.4347 -19.1291 33.1386 46.6921 246.766 246.766 246.766 -19.1291 34.1386 45.6921 -53.0141 -53.0141 -53.0141 -19.1291 34.1386 46.6921 -254.304 -254.304 -254.304 -18.1291 33.1386 47.6921 68.4698 68.4698 68.4698 -18.1291 33.1386 48.6921 37.7443 37.7443 37.7443 -18.1291 34.1386 47.6921 -0.703889 -0.703889 -0.703889 -18.1291 34.1386 48.6921 1.86427 1.86427 1.86427 -19.1291 33.1386 47.6921 273.841 273.841 273.841 -19.1291 33.1386 48.6921 -22.2893 -22.2893 -22.2893 -19.1291 34.1386 47.6921 149.082 149.082 149.082 -19.1291 34.1386 48.6921 -98.6293 -98.6293 -98.6293 -18.1291 35.1386 45.6921 80.5688 80.5688 80.5688 -18.1291 35.1386 46.6921 31.6621 31.6621 31.6621 -18.1291 36.1386 46.6921 -0.756663 -0.756663 -0.756663 -19.1291 35.1386 45.6921 3.15498 3.15498 3.15498 -19.1291 35.1386 46.6921 -46.3437 -46.3437 -46.3437 -19.1291 36.1386 46.6921 11.762 11.762 11.762 -18.1291 35.1386 47.6921 24.9533 24.9533 24.9533 -18.1291 35.1386 48.6921 -25.9395 -25.9395 -25.9395 -18.1291 36.1386 47.6921 0.169075 0.169075 0.169075 -18.1291 36.1386 48.6921 91.1255 91.1255 91.1255 -19.1291 35.1386 48.6921 112.561 112.561 112.561 -19.1291 36.1386 47.6921 20.3864 20.3864 20.3864 -19.1291 36.1386 48.6921 3.30099 3.30099 3.30099 -20.1291 29.138599999999997 41.6921 -258.761 -258.761 -258.761 -20.1291 30.138599999999997 41.6921 -138.785 -138.785 -138.785 -20.1291 30.138599999999997 42.6921 89.8104 89.8104 89.8104 -21.1291 29.138599999999997 41.6921 -458.668 -458.668 -458.668 -21.1291 30.138599999999997 41.6921 -524.049 -524.049 -524.049 -21.1291 30.138599999999997 42.6921 -69.3691 -69.3691 -69.3691 -20.1291 29.138599999999997 43.6921 1.8677 1.8677 1.8677 -20.1291 29.138599999999997 44.6921 146.866 146.866 146.866 -20.1291 30.138599999999997 43.6921 5.07842 5.07842 5.07842 -20.1291 30.138599999999997 44.6921 -96.176 -96.176 -96.176 -21.1291 29.138599999999997 43.6921 -99.772 -99.772 -99.772 -21.1291 29.138599999999997 44.6921 50.4009 50.4009 50.4009 -21.1291 30.138599999999997 43.6921 -42.5535 -42.5535 -42.5535 -21.1291 30.138599999999997 44.6921 -95.4687 -95.4687 -95.4687 -20.1291 31.138599999999997 41.6921 34.3964 34.3964 34.3964 -20.1291 31.138599999999997 42.6921 1.6634 1.6634 1.6634 -20.1291 32.1386 41.6921 21.0833 21.0833 21.0833 -20.1291 32.1386 42.6921 -18.6122 -18.6122 -18.6122 -21.1291 31.138599999999997 41.6921 -2109.26 -2109.26 -2109.26 -21.1291 32.1386 41.6921 -154.359 -154.359 -154.359 -21.1291 32.1386 42.6921 220.611 220.611 220.611 -20.1291 31.138599999999997 43.6921 173.959 173.959 173.959 -20.1291 31.138599999999997 44.6921 -99.2861 -99.2861 -99.2861 -20.1291 32.1386 43.6921 193.854 193.854 193.854 -21.1291 31.138599999999997 43.6921 -30.1434 -30.1434 -30.1434 -21.1291 31.138599999999997 44.6921 -34.0025 -34.0025 -34.0025 -21.1291 32.1386 43.6921 -137.796 -137.796 -137.796 -21.1291 32.1386 44.6921 -241.032 -241.032 -241.032 -22.1291 29.138599999999997 41.6921 164.503 164.503 164.503 -22.1291 29.138599999999997 42.6921 -97.9857 -97.9857 -97.9857 -22.1291 30.138599999999997 41.6921 606.172 606.172 606.172 -22.1291 30.138599999999997 42.6921 7.75708 7.75708 7.75708 -22.1291 29.138599999999997 43.6921 -107.28 -107.28 -107.28 -22.1291 29.138599999999997 44.6921 40.6188 40.6188 40.6188 -22.1291 30.138599999999997 43.6921 38.3358 38.3358 38.3358 -22.1291 30.138599999999997 44.6921 221.875 221.875 221.875 -23.1291 29.138599999999997 43.6921 -55.1277 -55.1277 -55.1277 -23.1291 29.138599999999997 44.6921 -38.714 -38.714 -38.714 -23.1291 30.138599999999997 43.6921 36.5614 36.5614 36.5614 -23.1291 30.138599999999997 44.6921 181.051 181.051 181.051 -22.1291 31.138599999999997 41.6921 -5082.09 -5082.09 -5082.09 -22.1291 31.138599999999997 42.6921 -75.5505 -75.5505 -75.5505 -22.1291 32.1386 41.6921 -1777.44 -1777.44 -1777.44 -22.1291 32.1386 42.6921 365.679 365.679 365.679 -23.1291 31.138599999999997 41.6921 1069.31 1069.31 1069.31 -23.1291 31.138599999999997 42.6921 94.5569 94.5569 94.5569 -23.1291 32.1386 42.6921 -114.657 -114.657 -114.657 -22.1291 31.138599999999997 43.6921 -16.2801 -16.2801 -16.2801 -22.1291 31.138599999999997 44.6921 -122.642 -122.642 -122.642 -22.1291 32.1386 43.6921 -58.3224 -58.3224 -58.3224 -22.1291 32.1386 44.6921 -171.941 -171.941 -171.941 -23.1291 31.138599999999997 43.6921 22.4268 22.4268 22.4268 -23.1291 31.138599999999997 44.6921 -142.479 -142.479 -142.479 -23.1291 32.1386 44.6921 26.2547 26.2547 26.2547 -20.1291 29.138599999999997 45.6921 162.227 162.227 162.227 -20.1291 29.138599999999997 46.6921 -51.4225 -51.4225 -51.4225 -20.1291 30.138599999999997 46.6921 207.265 207.265 207.265 -21.1291 29.138599999999997 45.6921 -78.5093 -78.5093 -78.5093 -21.1291 29.138599999999997 46.6921 116.944 116.944 116.944 -21.1291 30.138599999999997 45.6921 -185.288 -185.288 -185.288 -21.1291 30.138599999999997 46.6921 -3.30893 -3.30893 -3.30893 -20.1291 30.138599999999997 47.6921 20.5165 20.5165 20.5165 -21.1291 29.138599999999997 47.6921 -65.0773 -65.0773 -65.0773 -21.1291 30.138599999999997 47.6921 44.2361 44.2361 44.2361 -20.1291 31.138599999999997 46.6921 -121.154 -121.154 -121.154 -20.1291 32.1386 45.6921 176.866 176.866 176.866 -20.1291 32.1386 46.6921 -364.68 -364.68 -364.68 -21.1291 31.138599999999997 45.6921 -164.887 -164.887 -164.887 -21.1291 31.138599999999997 46.6921 -199.029 -199.029 -199.029 -21.1291 32.1386 45.6921 -13.7136 -13.7136 -13.7136 -21.1291 32.1386 46.6921 236.946 236.946 236.946 -20.1291 31.138599999999997 47.6921 39.0843 39.0843 39.0843 -20.1291 32.1386 47.6921 -18.1917 -18.1917 -18.1917 -20.1291 32.1386 48.6921 4.06058 4.06058 4.06058 -21.1291 32.1386 48.6921 53.3395 53.3395 53.3395 -22.1291 29.138599999999997 45.6921 8.19244 8.19244 8.19244 -22.1291 29.138599999999997 46.6921 98.2815 98.2815 98.2815 -22.1291 30.138599999999997 45.6921 -139.77 -139.77 -139.77 -22.1291 30.138599999999997 46.6921 130.228 130.228 130.228 -22.1291 29.138599999999997 47.6921 3.72476 3.72476 3.72476 -22.1291 29.138599999999997 48.6921 85.4449 85.4449 85.4449 -22.1291 30.138599999999997 47.6921 43.9767 43.9767 43.9767 -22.1291 30.138599999999997 48.6921 -15.834 -15.834 -15.834 -23.1291 29.138599999999997 47.6921 182.091 182.091 182.091 -23.1291 29.138599999999997 48.6921 -114.616 -114.616 -114.616 -23.1291 30.138599999999997 48.6921 -243.318 -243.318 -243.318 -22.1291 31.138599999999997 45.6921 -14.037 -14.037 -14.037 -22.1291 31.138599999999997 46.6921 3.90495 3.90495 3.90495 -22.1291 32.1386 45.6921 -33.2738 -33.2738 -33.2738 -22.1291 32.1386 46.6921 -120.928 -120.928 -120.928 -23.1291 31.138599999999997 45.6921 -72.2628 -72.2628 -72.2628 -23.1291 31.138599999999997 46.6921 -253.102 -253.102 -253.102 -23.1291 32.1386 45.6921 -204.95 -204.95 -204.95 -23.1291 32.1386 46.6921 -194.619 -194.619 -194.619 -22.1291 31.138599999999997 47.6921 57.788 57.788 57.788 -22.1291 31.138599999999997 48.6921 18.4655 18.4655 18.4655 -22.1291 32.1386 47.6921 59.9832 59.9832 59.9832 -22.1291 32.1386 48.6921 -14.0354 -14.0354 -14.0354 -23.1291 32.1386 47.6921 14.0276 14.0276 14.0276 -20.1291 33.1386 41.6921 -3641.41 -3641.41 -3641.41 -20.1291 34.1386 41.6921 964.992 964.992 964.992 -20.1291 34.1386 42.6921 -1689.41 -1689.41 -1689.41 -21.1291 33.1386 41.6921 -5010.84 -5010.84 -5010.84 -21.1291 33.1386 42.6921 78.1648 78.1648 78.1648 -21.1291 34.1386 41.6921 -16.692 -16.692 -16.692 -20.1291 33.1386 43.6921 211.607 211.607 211.607 -20.1291 34.1386 43.6921 -90.6055 -90.6055 -90.6055 -21.1291 33.1386 43.6921 -255.402 -255.402 -255.402 -21.1291 34.1386 43.6921 51.2325 51.2325 51.2325 -21.1291 34.1386 44.6921 162.758 162.758 162.758 -20.1291 35.1386 41.6921 716.918 716.918 716.918 -20.1291 35.1386 42.6921 -1713.58 -1713.58 -1713.58 -20.1291 36.1386 41.6921 -18.2459 -18.2459 -18.2459 -20.1291 36.1386 42.6921 13.4356 13.4356 13.4356 -21.1291 35.1386 41.6921 -1.23552 -1.23552 -1.23552 -21.1291 35.1386 42.6921 -74.4695 -74.4695 -74.4695 -21.1291 36.1386 41.6921 -12.4196 -12.4196 -12.4196 -21.1291 36.1386 42.6921 2.0986 2.0986 2.0986 -20.1291 35.1386 43.6921 109.904 109.904 109.904 -21.1291 35.1386 43.6921 9.03086 9.03086 9.03086 -21.1291 35.1386 44.6921 24.1727 24.1727 24.1727 -21.1291 36.1386 44.6921 -6.01065 -6.01065 -6.01065 -22.1291 33.1386 41.6921 -552.486 -552.486 -552.486 -22.1291 33.1386 42.6921 -122.751 -122.751 -122.751 -22.1291 34.1386 41.6921 -75.6638 -75.6638 -75.6638 -22.1291 34.1386 42.6921 69.8781 69.8781 69.8781 -23.1291 33.1386 42.6921 -12.8017 -12.8017 -12.8017 -23.1291 34.1386 42.6921 -166.42 -166.42 -166.42 -22.1291 33.1386 43.6921 253.597 253.597 253.597 -22.1291 33.1386 44.6921 -83.1336 -83.1336 -83.1336 -22.1291 34.1386 43.6921 -18.7671 -18.7671 -18.7671 -22.1291 34.1386 44.6921 19.4811 19.4811 19.4811 -23.1291 33.1386 43.6921 41.0988 41.0988 41.0988 -23.1291 33.1386 44.6921 -7.40465 -7.40465 -7.40465 -23.1291 34.1386 43.6921 -119.929 -119.929 -119.929 -23.1291 34.1386 44.6921 3.26931 3.26931 3.26931 -22.1291 35.1386 41.6921 -118.308 -118.308 -118.308 -22.1291 35.1386 42.6921 33.5059 33.5059 33.5059 -22.1291 36.1386 41.6921 4.01815 4.01815 4.01815 -22.1291 36.1386 42.6921 -17.1346 -17.1346 -17.1346 -23.1291 35.1386 41.6921 -8.8939 -8.8939 -8.8939 -23.1291 35.1386 42.6921 -14.0135 -14.0135 -14.0135 -22.1291 35.1386 43.6921 88.226 88.226 88.226 -22.1291 35.1386 44.6921 -35.0312 -35.0312 -35.0312 -22.1291 36.1386 43.6921 8.34242 8.34242 8.34242 -22.1291 36.1386 44.6921 4.60695 4.60695 4.60695 -23.1291 35.1386 43.6921 -48.4158 -48.4158 -48.4158 -23.1291 35.1386 44.6921 -45.7826 -45.7826 -45.7826 -23.1291 36.1386 44.6921 -87.1053 -87.1053 -87.1053 -20.1291 33.1386 46.6921 227.99 227.99 227.99 -20.1291 34.1386 46.6921 -228.255 -228.255 -228.255 -21.1291 33.1386 46.6921 46.5544 46.5544 46.5544 -21.1291 34.1386 46.6921 -147.108 -147.108 -147.108 -20.1291 33.1386 47.6921 12.0695 12.0695 12.0695 -20.1291 33.1386 48.6921 50.6468 50.6468 50.6468 -20.1291 34.1386 47.6921 -26.399 -26.399 -26.399 -20.1291 34.1386 48.6921 -24.807 -24.807 -24.807 -21.1291 33.1386 47.6921 -32.269 -32.269 -32.269 -21.1291 33.1386 48.6921 -62.7013 -62.7013 -62.7013 -21.1291 36.1386 45.6921 6.12067 6.12067 6.12067 -21.1291 36.1386 46.6921 4.53292 4.53292 4.53292 -20.1291 35.1386 48.6921 -127.799 -127.799 -127.799 -20.1291 36.1386 47.6921 30.7291 30.7291 30.7291 -20.1291 36.1386 48.6921 -67.9879 -67.9879 -67.9879 -21.1291 36.1386 47.6921 -9.31416 -9.31416 -9.31416 -21.1291 36.1386 48.6921 59.6197 59.6197 59.6197 -22.1291 33.1386 45.6921 135.03 135.03 135.03 -22.1291 33.1386 46.6921 -62.7181 -62.7181 -62.7181 -22.1291 34.1386 45.6921 90.6027 90.6027 90.6027 -22.1291 34.1386 46.6921 -206.191 -206.191 -206.191 -23.1291 33.1386 45.6921 -63.7133 -63.7133 -63.7133 -23.1291 33.1386 46.6921 171.05 171.05 171.05 -23.1291 34.1386 45.6921 5.2953 5.2953 5.2953 -23.1291 34.1386 46.6921 70.9296 70.9296 70.9296 -22.1291 33.1386 47.6921 47.3491 47.3491 47.3491 -22.1291 33.1386 48.6921 -102.665 -102.665 -102.665 -22.1291 34.1386 47.6921 95.6089 95.6089 95.6089 -22.1291 34.1386 48.6921 28.6501 28.6501 28.6501 -23.1291 33.1386 47.6921 -106.39 -106.39 -106.39 -23.1291 33.1386 48.6921 -19.2753 -19.2753 -19.2753 -23.1291 34.1386 47.6921 160.57 160.57 160.57 -23.1291 34.1386 48.6921 -24.3474 -24.3474 -24.3474 -22.1291 35.1386 45.6921 -172.724 -172.724 -172.724 -22.1291 35.1386 46.6921 -55.9014 -55.9014 -55.9014 -22.1291 36.1386 45.6921 -51.1332 -51.1332 -51.1332 -22.1291 36.1386 46.6921 -20.6501 -20.6501 -20.6501 -23.1291 35.1386 45.6921 -84.6972 -84.6972 -84.6972 -23.1291 35.1386 46.6921 -175.852 -175.852 -175.852 -23.1291 36.1386 45.6921 -19.6134 -19.6134 -19.6134 -23.1291 36.1386 46.6921 19.0256 19.0256 19.0256 -22.1291 35.1386 48.6921 2.06818 2.06818 2.06818 -22.1291 36.1386 48.6921 -10.3421 -10.3421 -10.3421 -23.1291 35.1386 47.6921 14.3964 14.3964 14.3964 -23.1291 35.1386 48.6921 90.6318 90.6318 90.6318 -23.1291 36.1386 47.6921 2.82935 2.82935 2.82935 -23.1291 36.1386 48.6921 148.237 148.237 148.237 -16.1291 29.138599999999997 49.6921 6.39798 6.39798 6.39798 -16.1291 30.138599999999997 49.6921 -0.637583 -0.637583 -0.637583 -16.1291 30.138599999999997 50.6921 -41.5694 -41.5694 -41.5694 -17.1291 29.138599999999997 49.6921 -2.30339 -2.30339 -2.30339 -17.1291 30.138599999999997 49.6921 1.45593 1.45593 1.45593 -17.1291 30.138599999999997 50.6921 -1.37142 -1.37142 -1.37142 -16.1291 31.138599999999997 49.6921 -71.3286 -71.3286 -71.3286 -16.1291 31.138599999999997 50.6921 -19.5388 -19.5388 -19.5388 -16.1291 32.1386 49.6921 92.5762 92.5762 92.5762 -16.1291 32.1386 50.6921 5.7351 5.7351 5.7351 -17.1291 31.138599999999997 49.6921 13.0344 13.0344 13.0344 -17.1291 31.138599999999997 50.6921 -3.37663 -3.37663 -3.37663 -17.1291 32.1386 49.6921 28.5487 28.5487 28.5487 -18.1291 30.138599999999997 49.6921 -15.115 -15.115 -15.115 -18.1291 31.138599999999997 49.6921 11.8424 11.8424 11.8424 -18.1291 32.1386 49.6921 2.29811 2.29811 2.29811 -16.1291 33.1386 49.6921 -128.074 -128.074 -128.074 -16.1291 33.1386 50.6921 2.52058 2.52058 2.52058 -16.1291 34.1386 49.6921 -6.75182 -6.75182 -6.75182 -16.1291 34.1386 50.6921 -38.523 -38.523 -38.523 -17.1291 33.1386 49.6921 -1.44038 -1.44038 -1.44038 -17.1291 33.1386 50.6921 -0.803649 -0.803649 -0.803649 -17.1291 34.1386 49.6921 60.7496 60.7496 60.7496 -17.1291 34.1386 50.6921 63.5521 63.5521 63.5521 -16.1291 35.1386 49.6921 54.5848 54.5848 54.5848 -16.1291 35.1386 50.6921 76.6734 76.6734 76.6734 -16.1291 36.1386 49.6921 -48.3885 -48.3885 -48.3885 -17.1291 35.1386 49.6921 74.252 74.252 74.252 -17.1291 35.1386 50.6921 -64.0141 -64.0141 -64.0141 -18.1291 33.1386 49.6921 81.8444 81.8444 81.8444 -18.1291 33.1386 50.6921 -81.3584 -81.3584 -81.3584 -18.1291 34.1386 49.6921 -20.4175 -20.4175 -20.4175 -18.1291 34.1386 50.6921 119.8 119.8 119.8 -19.1291 33.1386 49.6921 29.4149 29.4149 29.4149 -19.1291 34.1386 49.6921 -443.488 -443.488 -443.488 -18.1291 35.1386 49.6921 -198.303 -198.303 -198.303 -20.1291 32.1386 49.6921 42.2283 42.2283 42.2283 -21.1291 32.1386 49.6921 5.86095 5.86095 5.86095 -22.1291 30.138599999999997 49.6921 -131.27 -131.27 -131.27 -23.1291 30.138599999999997 49.6921 -97.5666 -97.5666 -97.5666 -23.1291 30.138599999999997 50.6921 195.877 195.877 195.877 -22.1291 31.138599999999997 49.6921 -54.9949 -54.9949 -54.9949 -22.1291 31.138599999999997 50.6921 -17.6601 -17.6601 -17.6601 -22.1291 32.1386 49.6921 -60.4487 -60.4487 -60.4487 -22.1291 32.1386 50.6921 124.43 124.43 124.43 -23.1291 31.138599999999997 49.6921 -27.4329 -27.4329 -27.4329 -23.1291 31.138599999999997 50.6921 1.17762 1.17762 1.17762 -23.1291 32.1386 49.6921 -15.0393 -15.0393 -15.0393 -23.1291 32.1386 50.6921 154.006 154.006 154.006 -22.1291 32.1386 51.6921 36.1948 36.1948 36.1948 -22.1291 32.1386 52.6921 -47.1958 -47.1958 -47.1958 -23.1291 31.138599999999997 51.6921 -414.255 -414.255 -414.255 -23.1291 32.1386 51.6921 442.968 442.968 442.968 -23.1291 32.1386 52.6921 -38.4686 -38.4686 -38.4686 -20.1291 33.1386 49.6921 57.6369 57.6369 57.6369 -20.1291 33.1386 50.6921 17.2145 17.2145 17.2145 -20.1291 34.1386 49.6921 -260.564 -260.564 -260.564 -20.1291 34.1386 50.6921 202.41 202.41 202.41 -21.1291 33.1386 49.6921 69.8545 69.8545 69.8545 -21.1291 33.1386 50.6921 19.7982 19.7982 19.7982 -21.1291 34.1386 50.6921 213.275 213.275 213.275 -21.1291 33.1386 51.6921 -8.48235 -8.48235 -8.48235 -21.1291 34.1386 51.6921 -145.41 -145.41 -145.41 -20.1291 35.1386 49.6921 148.986 148.986 148.986 -20.1291 35.1386 50.6921 51.6805 51.6805 51.6805 -20.1291 36.1386 49.6921 857.448 857.448 857.448 -21.1291 35.1386 49.6921 -175.063 -175.063 -175.063 -21.1291 35.1386 50.6921 86.4118 86.4118 86.4118 -21.1291 36.1386 49.6921 170.404 170.404 170.404 -22.1291 33.1386 49.6921 -12.2424 -12.2424 -12.2424 -22.1291 33.1386 50.6921 91.9929 91.9929 91.9929 -22.1291 34.1386 49.6921 -78.0866 -78.0866 -78.0866 -23.1291 33.1386 49.6921 -76.6908 -76.6908 -76.6908 -23.1291 34.1386 49.6921 -200.543 -200.543 -200.543 -22.1291 33.1386 51.6921 37.76 37.76 37.76 -22.1291 33.1386 52.6921 6.23528 6.23528 6.23528 -22.1291 34.1386 51.6921 -8.33258 -8.33258 -8.33258 -22.1291 34.1386 52.6921 86.8298 86.8298 86.8298 -23.1291 33.1386 52.6921 -6.5555 -6.5555 -6.5555 -23.1291 34.1386 52.6921 -73.9704 -73.9704 -73.9704 -22.1291 35.1386 49.6921 -0.0943651 -0.0943651 -0.0943651 -22.1291 35.1386 50.6921 11.7713 11.7713 11.7713 -22.1291 36.1386 49.6921 138.748 138.748 138.748 -22.1291 36.1386 50.6921 969.27 969.27 969.27 -23.1291 35.1386 49.6921 129.226 129.226 129.226 -23.1291 35.1386 50.6921 -206.091 -206.091 -206.091 -23.1291 36.1386 49.6921 11.2485 11.2485 11.2485 -23.1291 36.1386 50.6921 -125.269 -125.269 -125.269 -22.1291 35.1386 51.6921 38.3094 38.3094 38.3094 -22.1291 35.1386 52.6921 43.2727 43.2727 43.2727 -23.1291 35.1386 51.6921 109.468 109.468 109.468 -23.1291 35.1386 52.6921 269.931 269.931 269.931 -14.129100000000001 37.1386 31.692100000000003 -636.573 -636.573 -636.573 -14.129100000000001 37.1386 32.6921 -2674.72 -2674.72 -2674.72 -14.129100000000001 38.1386 32.6921 -2245.97 -2245.97 -2245.97 -15.129100000000001 37.1386 31.692100000000003 3303.54 3303.54 3303.54 -15.129100000000001 38.1386 31.692100000000003 3727.32 3727.32 3727.32 -15.129100000000001 38.1386 32.6921 -191.974 -191.974 -191.974 -15.129100000000001 39.1386 31.692100000000003 -665.804 -665.804 -665.804 -15.129100000000001 39.1386 32.6921 2865.07 2865.07 2865.07 -15.129100000000001 40.1386 31.692100000000003 -1631.75 -1631.75 -1631.75 -15.129100000000001 40.1386 32.6921 -921.723 -921.723 -921.723 -9.129100000000001 37.1386 34.6921 61.3058 61.3058 61.3058 -9.129100000000001 38.1386 34.6921 103.074 103.074 103.074 -9.129100000000001 37.1386 35.6921 182.248 182.248 182.248 -9.129100000000001 37.1386 36.6921 5.81481 5.81481 5.81481 -9.129100000000001 38.1386 35.6921 373.33 373.33 373.33 -9.129100000000001 38.1386 36.6921 -495.264 -495.264 -495.264 -9.129100000000001 39.1386 34.6921 -5.4849 -5.4849 -5.4849 -9.129100000000001 39.1386 35.6921 77.3501 77.3501 77.3501 -10.129100000000001 37.1386 33.6921 -19.2116 -19.2116 -19.2116 -10.129100000000001 37.1386 34.6921 -176.904 -176.904 -176.904 -10.129100000000001 38.1386 33.6921 -144.133 -144.133 -144.133 -10.129100000000001 38.1386 34.6921 207.713 207.713 207.713 -11.129100000000001 37.1386 33.6921 26.4935 26.4935 26.4935 -11.129100000000001 37.1386 34.6921 -90.1596 -90.1596 -90.1596 -11.129100000000001 38.1386 33.6921 -30.3361 -30.3361 -30.3361 -11.129100000000001 38.1386 34.6921 27.0118 27.0118 27.0118 -10.129100000000001 37.1386 36.6921 29.5533 29.5533 29.5533 -10.129100000000001 38.1386 36.6921 115.927 115.927 115.927 -11.129100000000001 38.1386 36.6921 -146.59 -146.59 -146.59 -10.129100000000001 39.1386 33.6921 -24.9401 -24.9401 -24.9401 -10.129100000000001 39.1386 34.6921 108.271 108.271 108.271 -11.129100000000001 39.1386 33.6921 -165.948 -165.948 -165.948 -11.129100000000001 39.1386 34.6921 147.984 147.984 147.984 -10.129100000000001 39.1386 35.6921 450.67 450.67 450.67 -10.129100000000001 39.1386 36.6921 -132.335 -132.335 -132.335 -11.129100000000001 39.1386 35.6921 50.9409 50.9409 50.9409 -11.129100000000001 39.1386 36.6921 -193.993 -193.993 -193.993 -9.129100000000001 37.1386 37.6921 -164.466 -164.466 -164.466 -9.129100000000001 37.1386 38.6921 -35.0734 -35.0734 -35.0734 -9.129100000000001 38.1386 38.6921 28.082 28.082 28.082 -9.129100000000001 37.1386 39.6921 -96.8517 -96.8517 -96.8517 -10.129100000000001 37.1386 37.6921 21.9948 21.9948 21.9948 -10.129100000000001 37.1386 38.6921 51.7504 51.7504 51.7504 -10.129100000000001 38.1386 37.6921 32.7034 32.7034 32.7034 -10.129100000000001 38.1386 38.6921 83.6705 83.6705 83.6705 -11.129100000000001 38.1386 37.6921 43.2833 43.2833 43.2833 -11.129100000000001 38.1386 38.6921 -57.1796 -57.1796 -57.1796 -10.129100000000001 37.1386 39.6921 -64.2593 -64.2593 -64.2593 -10.129100000000001 37.1386 40.6921 -267.374 -267.374 -267.374 -10.129100000000001 38.1386 39.6921 76.9518 76.9518 76.9518 -11.129100000000001 37.1386 39.6921 -70.2267 -70.2267 -70.2267 -11.129100000000001 38.1386 39.6921 52.6814 52.6814 52.6814 -12.129100000000001 37.1386 34.6921 53.912 53.912 53.912 -12.129100000000001 38.1386 34.6921 -93.6121 -93.6121 -93.6121 -13.129100000000001 37.1386 33.6921 -297.546 -297.546 -297.546 -13.129100000000001 37.1386 34.6921 143.406 143.406 143.406 -13.129100000000001 38.1386 34.6921 20.3169 20.3169 20.3169 -12.129100000000001 37.1386 35.6921 465.543 465.543 465.543 -12.129100000000001 38.1386 35.6921 -186.34 -186.34 -186.34 -12.129100000000001 38.1386 36.6921 35.9489 35.9489 35.9489 -13.129100000000001 38.1386 35.6921 -35.442 -35.442 -35.442 -13.129100000000001 38.1386 36.6921 -32.8121 -32.8121 -32.8121 -12.129100000000001 39.1386 34.6921 547.614 547.614 547.614 -12.129100000000001 39.1386 35.6921 235.272 235.272 235.272 -13.129100000000001 39.1386 35.6921 -10.0691 -10.0691 -10.0691 -13.129100000000001 39.1386 36.6921 295.483 295.483 295.483 -13.129100000000001 40.1386 35.6921 -35.6757 -35.6757 -35.6757 -13.129100000000001 40.1386 36.6921 51.6159 51.6159 51.6159 -14.129100000000001 37.1386 33.6921 2048.08 2048.08 2048.08 -14.129100000000001 37.1386 34.6921 -12.8549 -12.8549 -12.8549 -14.129100000000001 38.1386 33.6921 -6846.72 -6846.72 -6846.72 -14.129100000000001 38.1386 34.6921 41.9219 41.9219 41.9219 -15.129100000000001 38.1386 33.6921 -1342.96 -1342.96 -1342.96 -15.129100000000001 38.1386 34.6921 353.307 353.307 353.307 -14.129100000000001 37.1386 36.6921 234.472 234.472 234.472 -14.129100000000001 38.1386 35.6921 -236.884 -236.884 -236.884 -15.129100000000001 37.1386 35.6921 -147.795 -147.795 -147.795 -15.129100000000001 37.1386 36.6921 -25.6263 -25.6263 -25.6263 -15.129100000000001 38.1386 35.6921 42.4567 42.4567 42.4567 -15.129100000000001 38.1386 36.6921 -31.8645 -31.8645 -31.8645 -14.129100000000001 39.1386 34.6921 -548.081 -548.081 -548.081 -14.129100000000001 40.1386 34.6921 -458.671 -458.671 -458.671 -15.129100000000001 39.1386 33.6921 5359.64 5359.64 5359.64 -15.129100000000001 39.1386 34.6921 -32.798 -32.798 -32.798 -15.129100000000001 40.1386 33.6921 -1468.49 -1468.49 -1468.49 -15.129100000000001 40.1386 34.6921 -68.8212 -68.8212 -68.8212 -14.129100000000001 39.1386 35.6921 116.336 116.336 116.336 -14.129100000000001 40.1386 35.6921 -107.938 -107.938 -107.938 -15.129100000000001 39.1386 35.6921 28.3998 28.3998 28.3998 -12.129100000000001 38.1386 37.6921 525.751 525.751 525.751 -12.129100000000001 38.1386 38.6921 -45.396 -45.396 -45.396 -13.129100000000001 37.1386 37.6921 24.9385 24.9385 24.9385 -13.129100000000001 38.1386 37.6921 417.372 417.372 417.372 -13.129100000000001 38.1386 38.6921 -40.9655 -40.9655 -40.9655 -12.129100000000001 37.1386 39.6921 -22.0636 -22.0636 -22.0636 -12.129100000000001 37.1386 40.6921 18.5501 18.5501 18.5501 -12.129100000000001 38.1386 39.6921 21.4231 21.4231 21.4231 -13.129100000000001 37.1386 39.6921 94.9906 94.9906 94.9906 -13.129100000000001 37.1386 40.6921 -6.93924 -6.93924 -6.93924 -13.129100000000001 38.1386 39.6921 25.7528 25.7528 25.7528 -13.129100000000001 39.1386 37.6921 28.3219 28.3219 28.3219 -13.129100000000001 40.1386 37.6921 -239.399 -239.399 -239.399 -13.129100000000001 39.1386 40.6921 -11.9711 -11.9711 -11.9711 -13.129100000000001 40.1386 40.6921 51.1759 51.1759 51.1759 -14.129100000000001 37.1386 37.6921 77.7809 77.7809 77.7809 -14.129100000000001 37.1386 38.6921 -229.767 -229.767 -229.767 -14.129100000000001 38.1386 37.6921 -228.162 -228.162 -228.162 -14.129100000000001 38.1386 38.6921 -201.327 -201.327 -201.327 -15.129100000000001 37.1386 37.6921 -80.5277 -80.5277 -80.5277 -15.129100000000001 38.1386 37.6921 -26.4757 -26.4757 -26.4757 -15.129100000000001 38.1386 38.6921 -47.2101 -47.2101 -47.2101 -14.129100000000001 37.1386 39.6921 -100.448 -100.448 -100.448 -14.129100000000001 37.1386 40.6921 79.0115 79.0115 79.0115 -14.129100000000001 38.1386 39.6921 -2.67964 -2.67964 -2.67964 -15.129100000000001 37.1386 39.6921 -21.7132 -21.7132 -21.7132 -15.129100000000001 37.1386 40.6921 25.2961 25.2961 25.2961 -15.129100000000001 38.1386 39.6921 -59.1066 -59.1066 -59.1066 -14.129100000000001 39.1386 37.6921 0.0344086 0.0344086 0.0344086 -14.129100000000001 39.1386 38.6921 118.145 118.145 118.145 -14.129100000000001 40.1386 37.6921 -274.846 -274.846 -274.846 -15.129100000000001 39.1386 37.6921 19.7834 19.7834 19.7834 -15.129100000000001 39.1386 38.6921 115.125 115.125 115.125 -15.129100000000001 40.1386 37.6921 3.96277 3.96277 3.96277 -15.129100000000001 40.1386 38.6921 -80.2609 -80.2609 -80.2609 -14.129100000000001 39.1386 40.6921 -53.7353 -53.7353 -53.7353 -14.129100000000001 40.1386 39.6921 75.1989 75.1989 75.1989 -14.129100000000001 40.1386 40.6921 28.0035 28.0035 28.0035 -15.129100000000001 39.1386 39.6921 -69.1945 -69.1945 -69.1945 -15.129100000000001 39.1386 40.6921 -20.9574 -20.9574 -20.9574 -15.129100000000001 40.1386 39.6921 -163.748 -163.748 -163.748 -15.129100000000001 40.1386 40.6921 -21.1365 -21.1365 -21.1365 -13.129100000000001 41.1386 35.6921 -19.7334 -19.7334 -19.7334 -13.129100000000001 41.1386 36.6921 -127.102 -127.102 -127.102 -14.129100000000001 41.1386 34.6921 401.453 401.453 401.453 -15.129100000000001 41.1386 34.6921 -95.4245 -95.4245 -95.4245 -14.129100000000001 41.1386 35.6921 -9.85533 -9.85533 -9.85533 -14.129100000000001 41.1386 36.6921 -66.8349 -66.8349 -66.8349 -14.129100000000001 42.1386 35.6921 -38.4292 -38.4292 -38.4292 -14.129100000000001 42.1386 36.6921 70.7918 70.7918 70.7918 -15.129100000000001 41.1386 35.6921 270.987 270.987 270.987 -15.129100000000001 41.1386 36.6921 113.762 113.762 113.762 -15.129100000000001 42.1386 35.6921 -430.755 -430.755 -430.755 -15.129100000000001 42.1386 36.6921 -266.554 -266.554 -266.554 -15.129100000000001 43.1386 36.6921 -80.615 -80.615 -80.615 -15.129100000000001 44.1386 35.6921 33.0073 33.0073 33.0073 -15.129100000000001 44.1386 36.6921 284.12 284.12 284.12 -13.129100000000001 41.1386 37.6921 -180.244 -180.244 -180.244 -12.129100000000001 41.1386 40.6921 21.7779 21.7779 21.7779 -12.129100000000001 42.1386 40.6921 59.0385 59.0385 59.0385 -13.129100000000001 41.1386 39.6921 152.254 152.254 152.254 -13.129100000000001 41.1386 40.6921 7.17267 7.17267 7.17267 -13.129100000000001 42.1386 39.6921 157.489 157.489 157.489 -13.129100000000001 42.1386 40.6921 33.9686 33.9686 33.9686 -12.129100000000001 43.1386 40.6921 28.9136 28.9136 28.9136 -13.129100000000001 43.1386 39.6921 109.644 109.644 109.644 -13.129100000000001 43.1386 40.6921 67.4864 67.4864 67.4864 -13.129100000000001 44.1386 39.6921 112.899 112.899 112.899 -13.129100000000001 44.1386 40.6921 27.7207 27.7207 27.7207 -14.129100000000001 41.1386 37.6921 -49.3944 -49.3944 -49.3944 -15.129100000000001 41.1386 37.6921 125.209 125.209 125.209 -15.129100000000001 41.1386 38.6921 -49.9165 -49.9165 -49.9165 -15.129100000000001 42.1386 37.6921 179.54 179.54 179.54 -15.129100000000001 42.1386 38.6921 100.41 100.41 100.41 -14.129100000000001 41.1386 39.6921 -107.689 -107.689 -107.689 -14.129100000000001 41.1386 40.6921 -35.0111 -35.0111 -35.0111 -14.129100000000001 42.1386 39.6921 -110.217 -110.217 -110.217 -15.129100000000001 41.1386 39.6921 -138.846 -138.846 -138.846 -15.129100000000001 41.1386 40.6921 -16.9507 -16.9507 -16.9507 -15.129100000000001 42.1386 39.6921 -477.197 -477.197 -477.197 -15.129100000000001 42.1386 40.6921 -234.295 -234.295 -234.295 -15.129100000000001 43.1386 37.6921 253.911 253.911 253.911 -15.129100000000001 43.1386 38.6921 113.183 113.183 113.183 -15.129100000000001 44.1386 37.6921 110.193 110.193 110.193 -15.129100000000001 44.1386 38.6921 -146.736 -146.736 -146.736 -14.129100000000001 43.1386 39.6921 100.413 100.413 100.413 -14.129100000000001 44.1386 39.6921 -54.4777 -54.4777 -54.4777 -14.129100000000001 44.1386 40.6921 87.0061 87.0061 87.0061 -15.129100000000001 43.1386 39.6921 21.036 21.036 21.036 -15.129100000000001 44.1386 39.6921 -179.569 -179.569 -179.569 -15.129100000000001 44.1386 40.6921 -22.9377 -22.9377 -22.9377 -15.129100000000001 45.1386 34.6921 6.60401 6.60401 6.60401 -15.129100000000001 46.1386 34.6921 -117.23 -117.23 -117.23 -15.129100000000001 45.1386 35.6921 -50.8623 -50.8623 -50.8623 -15.129100000000001 45.1386 36.6921 -703.887 -703.887 -703.887 -15.129100000000001 46.1386 35.6921 855.449 855.449 855.449 -15.129100000000001 46.1386 36.6921 375.199 375.199 375.199 -15.129100000000001 47.1386 34.6921 -1169.03 -1169.03 -1169.03 -15.129100000000001 47.1386 35.6921 -14.5332 -14.5332 -14.5332 -15.129100000000001 47.1386 36.6921 303.675 303.675 303.675 -15.129100000000001 45.1386 37.6921 -251.533 -251.533 -251.533 -15.129100000000001 45.1386 38.6921 -14.1411 -14.1411 -14.1411 -15.129100000000001 46.1386 37.6921 307.985 307.985 307.985 -15.129100000000001 46.1386 38.6921 212.923 212.923 212.923 -14.129100000000001 45.1386 40.6921 1266.02 1266.02 1266.02 -15.129100000000001 45.1386 39.6921 1512.67 1512.67 1512.67 -15.129100000000001 45.1386 40.6921 3752.37 3752.37 3752.37 -15.129100000000001 46.1386 39.6921 -1357.8 -1357.8 -1357.8 -19.1291 38.1386 26.692100000000003 -22.6112 -22.6112 -22.6112 -19.1291 38.1386 27.692100000000003 25.4906 25.4906 25.4906 -19.1291 38.1386 28.692100000000003 20.0858 20.0858 20.0858 -19.1291 39.1386 26.692100000000003 -269.531 -269.531 -269.531 -19.1291 39.1386 27.692100000000003 37.7785 37.7785 37.7785 -19.1291 39.1386 28.692100000000003 9.6183 9.6183 9.6183 -19.1291 40.1386 27.692100000000003 -9.52202 -9.52202 -9.52202 -16.1291 37.1386 30.692100000000003 -1205.39 -1205.39 -1205.39 -16.1291 38.1386 30.692100000000003 -5.19787 -5.19787 -5.19787 -17.1291 37.1386 30.692100000000003 33.1877 33.1877 33.1877 -17.1291 38.1386 30.692100000000003 -47.376 -47.376 -47.376 -16.1291 37.1386 31.692100000000003 -55.6549 -55.6549 -55.6549 -16.1291 38.1386 31.692100000000003 -319.532 -319.532 -319.532 -17.1291 38.1386 31.692100000000003 -10.1431 -10.1431 -10.1431 -16.1291 39.1386 30.692100000000003 75.6704 75.6704 75.6704 -16.1291 40.1386 30.692100000000003 -469.565 -469.565 -469.565 -17.1291 39.1386 30.692100000000003 -63.5081 -63.5081 -63.5081 -17.1291 40.1386 30.692100000000003 -176.608 -176.608 -176.608 -16.1291 39.1386 31.692100000000003 496.887 496.887 496.887 -16.1291 40.1386 31.692100000000003 551.206 551.206 551.206 -16.1291 40.1386 32.6921 46.8467 46.8467 46.8467 -17.1291 40.1386 31.692100000000003 182.947 182.947 182.947 -18.1291 37.1386 29.692100000000003 27.9792 27.9792 27.9792 -18.1291 37.1386 30.692100000000003 -61.1442 -61.1442 -61.1442 -18.1291 38.1386 29.692100000000003 -43.1665 -43.1665 -43.1665 -18.1291 38.1386 30.692100000000003 1.0906 1.0906 1.0906 -19.1291 37.1386 29.692100000000003 0.41031 0.41031 0.41031 -19.1291 37.1386 30.692100000000003 14.4644 14.4644 14.4644 -19.1291 38.1386 29.692100000000003 -46.0327 -46.0327 -46.0327 -19.1291 38.1386 30.692100000000003 -60.2684 -60.2684 -60.2684 -18.1291 38.1386 32.6921 82.3783 82.3783 82.3783 -19.1291 37.1386 32.6921 15.3981 15.3981 15.3981 -19.1291 38.1386 32.6921 -3.18424 -3.18424 -3.18424 -18.1291 39.1386 29.692100000000003 -45.6084 -45.6084 -45.6084 -18.1291 39.1386 30.692100000000003 -10.3683 -10.3683 -10.3683 -18.1291 40.1386 30.692100000000003 -11.4243 -11.4243 -11.4243 -19.1291 39.1386 29.692100000000003 -27.3486 -27.3486 -27.3486 -19.1291 39.1386 30.692100000000003 -2.35482 -2.35482 -2.35482 -19.1291 40.1386 30.692100000000003 -50.1001 -50.1001 -50.1001 -18.1291 40.1386 31.692100000000003 -5.67083 -5.67083 -5.67083 -19.1291 39.1386 32.6921 -122.16 -122.16 -122.16 -19.1291 40.1386 31.692100000000003 23.8549 23.8549 23.8549 -19.1291 40.1386 32.6921 -1.06398 -1.06398 -1.06398 -17.1291 41.1386 30.692100000000003 72.9023 72.9023 72.9023 -16.1291 41.1386 31.692100000000003 -882.029 -882.029 -882.029 -16.1291 41.1386 32.6921 955.325 955.325 955.325 -17.1291 41.1386 31.692100000000003 -73.9916 -73.9916 -73.9916 -17.1291 41.1386 32.6921 -55.8781 -55.8781 -55.8781 -17.1291 42.1386 32.6921 -124.217 -124.217 -124.217 -16.1291 43.1386 32.6921 -6.21781 -6.21781 -6.21781 -16.1291 44.1386 32.6921 -1407.82 -1407.82 -1407.82 -17.1291 43.1386 31.692100000000003 542.526 542.526 542.526 -17.1291 43.1386 32.6921 814.629 814.629 814.629 -17.1291 44.1386 31.692100000000003 7.44553 7.44553 7.44553 -17.1291 44.1386 32.6921 -1832.19 -1832.19 -1832.19 -18.1291 41.1386 30.692100000000003 -12.0877 -12.0877 -12.0877 -18.1291 41.1386 31.692100000000003 -25.3758 -25.3758 -25.3758 -18.1291 41.1386 32.6921 -45.5159 -45.5159 -45.5159 -18.1291 42.1386 32.6921 -460.055 -460.055 -460.055 -19.1291 41.1386 31.692100000000003 40.0629 40.0629 40.0629 -19.1291 41.1386 32.6921 -38.5638 -38.5638 -38.5638 -19.1291 42.1386 32.6921 -736.202 -736.202 -736.202 -18.1291 43.1386 31.692100000000003 155.712 155.712 155.712 -18.1291 43.1386 32.6921 158.761 158.761 158.761 -18.1291 44.1386 31.692100000000003 1325.99 1325.99 1325.99 -18.1291 44.1386 32.6921 763.256 763.256 763.256 -19.1291 43.1386 31.692100000000003 -190.228 -190.228 -190.228 -19.1291 43.1386 32.6921 -818.534 -818.534 -818.534 -19.1291 44.1386 31.692100000000003 -202.212 -202.212 -202.212 -19.1291 44.1386 32.6921 -182.243 -182.243 -182.243 -20.1291 37.1386 26.692100000000003 11.6841 11.6841 11.6841 -20.1291 38.1386 26.692100000000003 -5.10829 -5.10829 -5.10829 -21.1291 37.1386 26.692100000000003 -1.79641 -1.79641 -1.79641 -21.1291 38.1386 26.692100000000003 -3.76284 -3.76284 -3.76284 -20.1291 37.1386 27.692100000000003 -4.25238 -4.25238 -4.25238 -20.1291 37.1386 28.692100000000003 5.95869 5.95869 5.95869 -20.1291 38.1386 27.692100000000003 -4.14612 -4.14612 -4.14612 -20.1291 38.1386 28.692100000000003 -10.5831 -10.5831 -10.5831 -21.1291 37.1386 27.692100000000003 17.0188 17.0188 17.0188 -21.1291 37.1386 28.692100000000003 10.0677 10.0677 10.0677 -21.1291 38.1386 28.692100000000003 -12.5108 -12.5108 -12.5108 -20.1291 39.1386 26.692100000000003 7.63937 7.63937 7.63937 -20.1291 40.1386 26.692100000000003 29.7714 29.7714 29.7714 -21.1291 39.1386 26.692100000000003 182.653 182.653 182.653 -21.1291 40.1386 26.692100000000003 115.131 115.131 115.131 -20.1291 39.1386 27.692100000000003 -8.09289 -8.09289 -8.09289 -20.1291 39.1386 28.692100000000003 -4.46276 -4.46276 -4.46276 -20.1291 40.1386 27.692100000000003 12.6687 12.6687 12.6687 -20.1291 40.1386 28.692100000000003 -5.70736 -5.70736 -5.70736 -21.1291 40.1386 27.692100000000003 -8.42897 -8.42897 -8.42897 -21.1291 40.1386 28.692100000000003 -17.8035 -17.8035 -17.8035 -22.1291 37.1386 26.692100000000003 3.2128 3.2128 3.2128 -22.1291 38.1386 26.692100000000003 13.1194 13.1194 13.1194 -23.1291 37.1386 26.692100000000003 93.1762 93.1762 93.1762 -23.1291 38.1386 26.692100000000003 -4.00999 -4.00999 -4.00999 -22.1291 37.1386 27.692100000000003 -0.844465 -0.844465 -0.844465 -22.1291 37.1386 28.692100000000003 7.06166 7.06166 7.06166 -22.1291 38.1386 27.692100000000003 -8.22815 -8.22815 -8.22815 -23.1291 37.1386 27.692100000000003 -71.9228 -71.9228 -71.9228 -23.1291 38.1386 27.692100000000003 -15.4196 -15.4196 -15.4196 -22.1291 39.1386 26.692100000000003 -2.77465 -2.77465 -2.77465 -22.1291 40.1386 26.692100000000003 2.1495 2.1495 2.1495 -23.1291 39.1386 26.692100000000003 25.1246 25.1246 25.1246 -23.1291 40.1386 26.692100000000003 213.266 213.266 213.266 -23.1291 39.1386 27.692100000000003 291.914 291.914 291.914 -20.1291 37.1386 30.692100000000003 -23.6378 -23.6378 -23.6378 -20.1291 38.1386 29.692100000000003 31.1539 31.1539 31.1539 -20.1291 38.1386 30.692100000000003 -73.0516 -73.0516 -73.0516 -21.1291 37.1386 29.692100000000003 19.3671 19.3671 19.3671 -21.1291 37.1386 30.692100000000003 -82.2483 -82.2483 -82.2483 -21.1291 38.1386 29.692100000000003 84.2155 84.2155 84.2155 -21.1291 38.1386 30.692100000000003 30.5703 30.5703 30.5703 -20.1291 37.1386 31.692100000000003 43.5843 43.5843 43.5843 -20.1291 37.1386 32.6921 28.6384 28.6384 28.6384 -20.1291 38.1386 31.692100000000003 -163.143 -163.143 -163.143 -20.1291 38.1386 32.6921 -64.2059 -64.2059 -64.2059 -21.1291 37.1386 31.692100000000003 -106.738 -106.738 -106.738 -21.1291 37.1386 32.6921 23.8019 23.8019 23.8019 -21.1291 38.1386 31.692100000000003 23.8948 23.8948 23.8948 -21.1291 38.1386 32.6921 -25.6604 -25.6604 -25.6604 -20.1291 39.1386 29.692100000000003 -57.2394 -57.2394 -57.2394 -20.1291 39.1386 30.692100000000003 69.1428 69.1428 69.1428 -20.1291 40.1386 29.692100000000003 -37.3184 -37.3184 -37.3184 -20.1291 40.1386 30.692100000000003 -58.7962 -58.7962 -58.7962 -21.1291 39.1386 29.692100000000003 23.1056 23.1056 23.1056 -21.1291 39.1386 30.692100000000003 220.838 220.838 220.838 -21.1291 40.1386 29.692100000000003 26.5 26.5 26.5 -21.1291 40.1386 30.692100000000003 69.505 69.505 69.505 -20.1291 39.1386 31.692100000000003 23.6938 23.6938 23.6938 -20.1291 39.1386 32.6921 -86.0347 -86.0347 -86.0347 -20.1291 40.1386 31.692100000000003 19.5148 19.5148 19.5148 -20.1291 40.1386 32.6921 4.65474 4.65474 4.65474 -21.1291 39.1386 31.692100000000003 122.812 122.812 122.812 -21.1291 39.1386 32.6921 8.30292 8.30292 8.30292 -21.1291 40.1386 31.692100000000003 50.2673 50.2673 50.2673 -21.1291 40.1386 32.6921 59.2532 59.2532 59.2532 -22.1291 38.1386 29.692100000000003 11.041 11.041 11.041 -22.1291 38.1386 30.692100000000003 59.8369 59.8369 59.8369 -23.1291 38.1386 30.692100000000003 4.97221 4.97221 4.97221 -22.1291 37.1386 32.6921 -12.2789 -12.2789 -12.2789 -22.1291 38.1386 32.6921 2.28942 2.28942 2.28942 -23.1291 37.1386 32.6921 6.29784 6.29784 6.29784 -23.1291 38.1386 32.6921 -2.86343 -2.86343 -2.86343 -22.1291 39.1386 30.692100000000003 95.8592 95.8592 95.8592 -22.1291 40.1386 29.692100000000003 -57.0464 -57.0464 -57.0464 -22.1291 40.1386 30.692100000000003 23.9705 23.9705 23.9705 -23.1291 39.1386 29.692100000000003 63.7711 63.7711 63.7711 -23.1291 39.1386 30.692100000000003 -9.33107 -9.33107 -9.33107 -23.1291 40.1386 29.692100000000003 7.14713 7.14713 7.14713 -23.1291 40.1386 30.692100000000003 -22.9354 -22.9354 -22.9354 -22.1291 39.1386 31.692100000000003 42.3152 42.3152 42.3152 -22.1291 39.1386 32.6921 14.4152 14.4152 14.4152 -22.1291 40.1386 31.692100000000003 -38.7943 -38.7943 -38.7943 -23.1291 39.1386 31.692100000000003 0.544109 0.544109 0.544109 -23.1291 39.1386 32.6921 18.2059 18.2059 18.2059 -23.1291 40.1386 31.692100000000003 -9.06945 -9.06945 -9.06945 -23.1291 40.1386 32.6921 -1.03591 -1.03591 -1.03591 -21.1291 41.1386 26.692100000000003 -101.841 -101.841 -101.841 -21.1291 41.1386 27.692100000000003 9.13924 9.13924 9.13924 -21.1291 41.1386 28.692100000000003 -31.9833 -31.9833 -31.9833 -21.1291 42.1386 27.692100000000003 27.755 27.755 27.755 -21.1291 42.1386 28.692100000000003 -53.3776 -53.3776 -53.3776 -22.1291 41.1386 26.692100000000003 31.8339 31.8339 31.8339 -22.1291 42.1386 26.692100000000003 34.618 34.618 34.618 -23.1291 41.1386 26.692100000000003 42.0087 42.0087 42.0087 -23.1291 42.1386 26.692100000000003 -64.9927 -64.9927 -64.9927 -22.1291 41.1386 27.692100000000003 -80.688 -80.688 -80.688 -22.1291 41.1386 28.692100000000003 7.23328 7.23328 7.23328 -22.1291 42.1386 27.692100000000003 63.3283 63.3283 63.3283 -22.1291 42.1386 28.692100000000003 13.1314 13.1314 13.1314 -23.1291 42.1386 27.692100000000003 -51.9061 -51.9061 -51.9061 -22.1291 43.1386 27.692100000000003 -46.6099 -46.6099 -46.6099 -22.1291 43.1386 28.692100000000003 -207.943 -207.943 -207.943 -23.1291 43.1386 27.692100000000003 -87.8156 -87.8156 -87.8156 -23.1291 43.1386 28.692100000000003 171.305 171.305 171.305 -23.1291 44.1386 28.692100000000003 570.902 570.902 570.902 -21.1291 41.1386 29.692100000000003 53.1448 53.1448 53.1448 -20.1291 41.1386 32.6921 23.5133 23.5133 23.5133 -21.1291 41.1386 31.692100000000003 15.7901 15.7901 15.7901 -21.1291 41.1386 32.6921 37.0049 37.0049 37.0049 -21.1291 42.1386 31.692100000000003 626.674 626.674 626.674 -21.1291 42.1386 32.6921 -183.929 -183.929 -183.929 -21.1291 43.1386 31.692100000000003 1846.17 1846.17 1846.17 -21.1291 43.1386 32.6921 625.23 625.23 625.23 -22.1291 41.1386 29.692100000000003 -39.1423 -39.1423 -39.1423 -22.1291 41.1386 30.692100000000003 16.0303 16.0303 16.0303 -22.1291 42.1386 29.692100000000003 117.716 117.716 117.716 -22.1291 42.1386 30.692100000000003 365.132 365.132 365.132 -23.1291 41.1386 29.692100000000003 -61.3671 -61.3671 -61.3671 -23.1291 41.1386 30.692100000000003 -39.4901 -39.4901 -39.4901 -23.1291 42.1386 29.692100000000003 192.141 192.141 192.141 -23.1291 42.1386 30.692100000000003 13.8882 13.8882 13.8882 -22.1291 41.1386 31.692100000000003 -58.2999 -58.2999 -58.2999 -22.1291 42.1386 31.692100000000003 54.4415 54.4415 54.4415 -23.1291 41.1386 31.692100000000003 -3.62008 -3.62008 -3.62008 -22.1291 43.1386 29.692100000000003 -259.064 -259.064 -259.064 -22.1291 43.1386 30.692100000000003 413.51 413.51 413.51 -23.1291 43.1386 29.692100000000003 114.025 114.025 114.025 -23.1291 43.1386 30.692100000000003 -316.3 -316.3 -316.3 -23.1291 44.1386 29.692100000000003 -308.695 -308.695 -308.695 -23.1291 44.1386 30.692100000000003 -887.571 -887.571 -887.571 -22.1291 43.1386 31.692100000000003 391.746 391.746 391.746 -22.1291 43.1386 32.6921 34.6824 34.6824 34.6824 -22.1291 44.1386 32.6921 20441.3 20441.3 20441.3 -23.1291 43.1386 31.692100000000003 -202.087 -202.087 -202.087 -23.1291 44.1386 31.692100000000003 12307.1 12307.1 12307.1 -23.1291 44.1386 32.6921 6199.9 6199.9 6199.9 -16.1291 37.1386 34.6921 15.4955 15.4955 15.4955 -16.1291 38.1386 34.6921 99.6557 99.6557 99.6557 -17.1291 37.1386 33.6921 25.4511 25.4511 25.4511 -17.1291 37.1386 34.6921 -253.14 -253.14 -253.14 -17.1291 38.1386 33.6921 54.05 54.05 54.05 -17.1291 38.1386 34.6921 -198.797 -198.797 -198.797 -16.1291 37.1386 35.6921 -77.6135 -77.6135 -77.6135 -16.1291 37.1386 36.6921 102.134 102.134 102.134 -16.1291 38.1386 35.6921 29.3324 29.3324 29.3324 -16.1291 38.1386 36.6921 -37.3821 -37.3821 -37.3821 -17.1291 37.1386 35.6921 -27.9517 -27.9517 -27.9517 -17.1291 38.1386 35.6921 -79.8787 -79.8787 -79.8787 -17.1291 38.1386 36.6921 -35.1082 -35.1082 -35.1082 -16.1291 39.1386 33.6921 -955.094 -955.094 -955.094 -16.1291 39.1386 34.6921 -106.614 -106.614 -106.614 -16.1291 40.1386 33.6921 -168.209 -168.209 -168.209 -16.1291 40.1386 34.6921 -17.2523 -17.2523 -17.2523 -17.1291 39.1386 33.6921 52.1762 52.1762 52.1762 -17.1291 39.1386 34.6921 -106.259 -106.259 -106.259 -17.1291 40.1386 33.6921 134.241 134.241 134.241 -17.1291 40.1386 34.6921 -47.747 -47.747 -47.747 -16.1291 39.1386 35.6921 137.478 137.478 137.478 -16.1291 40.1386 35.6921 -5.44955 -5.44955 -5.44955 -17.1291 39.1386 35.6921 24.3266 24.3266 24.3266 -17.1291 39.1386 36.6921 69.1882 69.1882 69.1882 -17.1291 40.1386 35.6921 -82.1943 -82.1943 -82.1943 -18.1291 37.1386 33.6921 87.0478 87.0478 87.0478 -18.1291 37.1386 34.6921 12.1004 12.1004 12.1004 -18.1291 38.1386 33.6921 -88.0333 -88.0333 -88.0333 -18.1291 38.1386 34.6921 38.7194 38.7194 38.7194 -19.1291 37.1386 33.6921 3.82737 3.82737 3.82737 -19.1291 37.1386 34.6921 -1.40986 -1.40986 -1.40986 -19.1291 38.1386 33.6921 -18.5625 -18.5625 -18.5625 -19.1291 38.1386 34.6921 23.6445 23.6445 23.6445 -18.1291 37.1386 35.6921 -42.4203 -42.4203 -42.4203 -18.1291 38.1386 35.6921 -42.0664 -42.0664 -42.0664 -18.1291 38.1386 36.6921 -107.708 -107.708 -107.708 -19.1291 37.1386 35.6921 3.60662 3.60662 3.60662 -19.1291 37.1386 36.6921 -6.07883 -6.07883 -6.07883 -19.1291 38.1386 35.6921 8.62134 8.62134 8.62134 -19.1291 38.1386 36.6921 -20.5909 -20.5909 -20.5909 -18.1291 39.1386 33.6921 -77.3994 -77.3994 -77.3994 -18.1291 39.1386 34.6921 -265.021 -265.021 -265.021 -18.1291 40.1386 33.6921 42.4344 42.4344 42.4344 -18.1291 40.1386 34.6921 -167.788 -167.788 -167.788 -19.1291 39.1386 33.6921 9.84758 9.84758 9.84758 -19.1291 40.1386 33.6921 -13.3512 -13.3512 -13.3512 -18.1291 39.1386 35.6921 101.685 101.685 101.685 -18.1291 39.1386 36.6921 54.6663 54.6663 54.6663 -18.1291 40.1386 36.6921 254.251 254.251 254.251 -19.1291 39.1386 35.6921 -25.3679 -25.3679 -25.3679 -19.1291 39.1386 36.6921 -49.3475 -49.3475 -49.3475 -19.1291 40.1386 36.6921 -86.2432 -86.2432 -86.2432 -16.1291 37.1386 37.6921 -32.783 -32.783 -32.783 -16.1291 38.1386 37.6921 -15.8739 -15.8739 -15.8739 -16.1291 38.1386 38.6921 -73.0717 -73.0717 -73.0717 -17.1291 37.1386 37.6921 134.471 134.471 134.471 -17.1291 37.1386 38.6921 120.334 120.334 120.334 -17.1291 38.1386 37.6921 -19.3916 -19.3916 -19.3916 -17.1291 38.1386 38.6921 -56.5749 -56.5749 -56.5749 -16.1291 37.1386 39.6921 -81.9967 -81.9967 -81.9967 -16.1291 37.1386 40.6921 11.974 11.974 11.974 -16.1291 38.1386 39.6921 56.1057 56.1057 56.1057 -16.1291 38.1386 40.6921 36.231 36.231 36.231 -17.1291 37.1386 39.6921 92.6839 92.6839 92.6839 -17.1291 37.1386 40.6921 15.5159 15.5159 15.5159 -17.1291 38.1386 39.6921 -6.30367 -6.30367 -6.30367 -17.1291 38.1386 40.6921 10.5851 10.5851 10.5851 -17.1291 39.1386 37.6921 -22.8174 -22.8174 -22.8174 -16.1291 39.1386 39.6921 7.05811 7.05811 7.05811 -16.1291 39.1386 40.6921 137.702 137.702 137.702 -16.1291 40.1386 39.6921 8.87397 8.87397 8.87397 -16.1291 40.1386 40.6921 -34.7893 -34.7893 -34.7893 -17.1291 39.1386 39.6921 2.27607 2.27607 2.27607 -17.1291 39.1386 40.6921 76.2415 76.2415 76.2415 -17.1291 40.1386 39.6921 -138.394 -138.394 -138.394 -17.1291 40.1386 40.6921 43.6903 43.6903 43.6903 -18.1291 37.1386 37.6921 84.2984 84.2984 84.2984 -18.1291 37.1386 38.6921 -29.3336 -29.3336 -29.3336 -18.1291 38.1386 37.6921 -77.4484 -77.4484 -77.4484 -18.1291 38.1386 38.6921 -18.2998 -18.2998 -18.2998 -19.1291 37.1386 37.6921 1.78907 1.78907 1.78907 -19.1291 37.1386 38.6921 -5.59785 -5.59785 -5.59785 -19.1291 38.1386 37.6921 21.6605 21.6605 21.6605 -18.1291 37.1386 39.6921 105.315 105.315 105.315 -18.1291 37.1386 40.6921 6.94977 6.94977 6.94977 -18.1291 38.1386 39.6921 15.704 15.704 15.704 -18.1291 38.1386 40.6921 -6.89269 -6.89269 -6.89269 -19.1291 37.1386 39.6921 32.2549 32.2549 32.2549 -19.1291 37.1386 40.6921 43.7736 43.7736 43.7736 -19.1291 38.1386 39.6921 -66.441 -66.441 -66.441 -19.1291 38.1386 40.6921 4.59723 4.59723 4.59723 -18.1291 39.1386 37.6921 26.5297 26.5297 26.5297 -18.1291 40.1386 37.6921 92.746 92.746 92.746 -19.1291 39.1386 37.6921 6.71649 6.71649 6.71649 -19.1291 40.1386 37.6921 2.40857 2.40857 2.40857 -19.1291 40.1386 38.6921 13.5369 13.5369 13.5369 -18.1291 39.1386 39.6921 -51.3737 -51.3737 -51.3737 -18.1291 39.1386 40.6921 -72.1227 -72.1227 -72.1227 -18.1291 40.1386 40.6921 5.32841 5.32841 5.32841 -19.1291 39.1386 39.6921 -27.8935 -27.8935 -27.8935 -19.1291 39.1386 40.6921 -70.3345 -70.3345 -70.3345 -19.1291 40.1386 40.6921 -116.995 -116.995 -116.995 -16.1291 41.1386 33.6921 1649.7 1649.7 1649.7 -16.1291 41.1386 34.6921 52.8655 52.8655 52.8655 -16.1291 42.1386 34.6921 -32.292 -32.292 -32.292 -17.1291 41.1386 33.6921 61.4284 61.4284 61.4284 -17.1291 41.1386 34.6921 38.5336 38.5336 38.5336 -17.1291 42.1386 33.6921 -579.209 -579.209 -579.209 -17.1291 42.1386 34.6921 100.478 100.478 100.478 -16.1291 41.1386 35.6921 -3.87188 -3.87188 -3.87188 -16.1291 42.1386 35.6921 62.2788 62.2788 62.2788 -16.1291 42.1386 36.6921 7.62027 7.62027 7.62027 -17.1291 41.1386 35.6921 33.842 33.842 33.842 -17.1291 42.1386 35.6921 -152.453 -152.453 -152.453 -16.1291 43.1386 33.6921 431.186 431.186 431.186 -16.1291 43.1386 34.6921 433.31 433.31 433.31 -16.1291 44.1386 33.6921 -875.633 -875.633 -875.633 -16.1291 44.1386 34.6921 -198.144 -198.144 -198.144 -17.1291 43.1386 33.6921 179.34 179.34 179.34 -17.1291 43.1386 34.6921 258.591 258.591 258.591 -17.1291 44.1386 33.6921 -1410.53 -1410.53 -1410.53 -16.1291 43.1386 35.6921 68.9908 68.9908 68.9908 -16.1291 43.1386 36.6921 -48.0328 -48.0328 -48.0328 -16.1291 44.1386 35.6921 53.1091 53.1091 53.1091 -16.1291 44.1386 36.6921 -44.0268 -44.0268 -44.0268 -17.1291 43.1386 35.6921 -9.11626 -9.11626 -9.11626 -17.1291 43.1386 36.6921 87.1131 87.1131 87.1131 -17.1291 44.1386 35.6921 -74.3972 -74.3972 -74.3972 -17.1291 44.1386 36.6921 -259.954 -259.954 -259.954 -18.1291 41.1386 33.6921 -47.6703 -47.6703 -47.6703 -18.1291 41.1386 34.6921 -207.338 -207.338 -207.338 -18.1291 42.1386 33.6921 -135.943 -135.943 -135.943 -18.1291 42.1386 34.6921 -180.702 -180.702 -180.702 -19.1291 41.1386 33.6921 -27.5164 -27.5164 -27.5164 -19.1291 41.1386 34.6921 32.7985 32.7985 32.7985 -19.1291 42.1386 33.6921 -138.114 -138.114 -138.114 -19.1291 42.1386 34.6921 17.6435 17.6435 17.6435 -18.1291 42.1386 36.6921 138.506 138.506 138.506 -19.1291 41.1386 36.6921 239.144 239.144 239.144 -19.1291 43.1386 33.6921 -1298.01 -1298.01 -1298.01 -19.1291 43.1386 34.6921 5.53632 5.53632 5.53632 -19.1291 44.1386 33.6921 -198.378 -198.378 -198.378 -19.1291 44.1386 34.6921 -210.173 -210.173 -210.173 -18.1291 43.1386 36.6921 106.68 106.68 106.68 -19.1291 44.1386 36.6921 185.349 185.349 185.349 -16.1291 41.1386 37.6921 -78.8887 -78.8887 -78.8887 -16.1291 41.1386 38.6921 -161.193 -161.193 -161.193 -16.1291 42.1386 37.6921 5.88482 5.88482 5.88482 -16.1291 42.1386 38.6921 15.3425 15.3425 15.3425 -17.1291 41.1386 37.6921 43.9813 43.9813 43.9813 -17.1291 41.1386 38.6921 -134.563 -134.563 -134.563 -17.1291 42.1386 37.6921 -120.197 -120.197 -120.197 -17.1291 42.1386 38.6921 -97.3075 -97.3075 -97.3075 -16.1291 41.1386 39.6921 257.193 257.193 257.193 -16.1291 41.1386 40.6921 60.4569 60.4569 60.4569 -16.1291 42.1386 39.6921 -104.395 -104.395 -104.395 -16.1291 42.1386 40.6921 -88.2915 -88.2915 -88.2915 -17.1291 41.1386 39.6921 127.206 127.206 127.206 -17.1291 41.1386 40.6921 74.7723 74.7723 74.7723 -17.1291 42.1386 39.6921 -104.669 -104.669 -104.669 -17.1291 42.1386 40.6921 9.91109 9.91109 9.91109 -16.1291 43.1386 37.6921 97.8917 97.8917 97.8917 -16.1291 44.1386 37.6921 -28.454 -28.454 -28.454 -17.1291 43.1386 37.6921 -37.0198 -37.0198 -37.0198 -17.1291 44.1386 37.6921 -50.6931 -50.6931 -50.6931 -16.1291 43.1386 39.6921 -76.0596 -76.0596 -76.0596 -17.1291 43.1386 39.6921 -810.568 -810.568 -810.568 -17.1291 43.1386 40.6921 144.199 144.199 144.199 -18.1291 41.1386 37.6921 52.2834 52.2834 52.2834 -18.1291 41.1386 38.6921 87.3592 87.3592 87.3592 -18.1291 42.1386 37.6921 61.1378 61.1378 61.1378 -18.1291 42.1386 38.6921 26.3808 26.3808 26.3808 -19.1291 41.1386 37.6921 -17.5177 -17.5177 -17.5177 -19.1291 41.1386 38.6921 -54.9164 -54.9164 -54.9164 -19.1291 42.1386 37.6921 -43.36 -43.36 -43.36 -19.1291 42.1386 38.6921 15.5454 15.5454 15.5454 -18.1291 41.1386 40.6921 78.2055 78.2055 78.2055 -18.1291 42.1386 39.6921 -328.079 -328.079 -328.079 -18.1291 42.1386 40.6921 -112.041 -112.041 -112.041 -19.1291 41.1386 40.6921 -70.6379 -70.6379 -70.6379 -19.1291 42.1386 39.6921 -40.4384 -40.4384 -40.4384 -19.1291 42.1386 40.6921 15.2349 15.2349 15.2349 -18.1291 43.1386 37.6921 -12.7445 -12.7445 -12.7445 -18.1291 43.1386 38.6921 165.328 165.328 165.328 -18.1291 44.1386 37.6921 -109.77 -109.77 -109.77 -18.1291 44.1386 38.6921 -422.243 -422.243 -422.243 -19.1291 43.1386 37.6921 29.4414 29.4414 29.4414 -19.1291 43.1386 38.6921 -221.324 -221.324 -221.324 -19.1291 44.1386 37.6921 -104.944 -104.944 -104.944 -19.1291 44.1386 38.6921 1290.63 1290.63 1290.63 -18.1291 43.1386 39.6921 -442.916 -442.916 -442.916 -18.1291 43.1386 40.6921 -128.978 -128.978 -128.978 -19.1291 43.1386 39.6921 169.668 169.668 169.668 -19.1291 43.1386 40.6921 -323.034 -323.034 -323.034 -19.1291 44.1386 39.6921 267.132 267.132 267.132 -19.1291 44.1386 40.6921 -225.937 -225.937 -225.937 -20.1291 37.1386 34.6921 -1.65175 -1.65175 -1.65175 -21.1291 37.1386 33.6921 -23.0729 -23.0729 -23.0729 -21.1291 38.1386 33.6921 -38.2492 -38.2492 -38.2492 -20.1291 37.1386 35.6921 -33.1736 -33.1736 -33.1736 -20.1291 37.1386 36.6921 -23.989 -23.989 -23.989 -20.1291 38.1386 35.6921 -68.2859 -68.2859 -68.2859 -20.1291 38.1386 36.6921 -5.03289 -5.03289 -5.03289 -21.1291 37.1386 36.6921 -34.2732 -34.2732 -34.2732 -20.1291 39.1386 33.6921 6.58366 6.58366 6.58366 -20.1291 39.1386 34.6921 10.9302 10.9302 10.9302 -20.1291 40.1386 33.6921 3.27547 3.27547 3.27547 -20.1291 40.1386 34.6921 -90.4175 -90.4175 -90.4175 -21.1291 39.1386 33.6921 8.04896 8.04896 8.04896 -21.1291 39.1386 34.6921 -17.25 -17.25 -17.25 -21.1291 40.1386 33.6921 51.7672 51.7672 51.7672 -21.1291 40.1386 34.6921 19.3251 19.3251 19.3251 -20.1291 39.1386 35.6921 25.746 25.746 25.746 -20.1291 39.1386 36.6921 123.695 123.695 123.695 -20.1291 40.1386 35.6921 -17.5879 -17.5879 -17.5879 -20.1291 40.1386 36.6921 8.18128 8.18128 8.18128 -21.1291 39.1386 35.6921 -1.68444 -1.68444 -1.68444 -21.1291 40.1386 35.6921 -27.2384 -27.2384 -27.2384 -21.1291 40.1386 36.6921 -22.6037 -22.6037 -22.6037 -22.1291 37.1386 33.6921 -165.305 -165.305 -165.305 -22.1291 38.1386 33.6921 -33.1047 -33.1047 -33.1047 -22.1291 38.1386 34.6921 -37.0249 -37.0249 -37.0249 -23.1291 37.1386 33.6921 2.85129 2.85129 2.85129 -23.1291 37.1386 34.6921 -0.110821 -0.110821 -0.110821 -23.1291 38.1386 33.6921 10.998 10.998 10.998 -23.1291 38.1386 34.6921 -6.91786 -6.91786 -6.91786 -22.1291 37.1386 36.6921 -153.535 -153.535 -153.535 -22.1291 38.1386 36.6921 44.8801 44.8801 44.8801 -23.1291 37.1386 35.6921 -0.908338 -0.908338 -0.908338 -23.1291 37.1386 36.6921 -128.588 -128.588 -128.588 -23.1291 38.1386 35.6921 -6.86517 -6.86517 -6.86517 -23.1291 38.1386 36.6921 -81.4487 -81.4487 -81.4487 -22.1291 39.1386 33.6921 33.5539 33.5539 33.5539 -22.1291 39.1386 34.6921 29.4917 29.4917 29.4917 -22.1291 40.1386 34.6921 22.3126 22.3126 22.3126 -23.1291 39.1386 33.6921 34.3184 34.3184 34.3184 -23.1291 39.1386 34.6921 39.9781 39.9781 39.9781 -23.1291 40.1386 33.6921 21.9324 21.9324 21.9324 -23.1291 40.1386 34.6921 76.7917 76.7917 76.7917 -22.1291 39.1386 35.6921 -4.14958 -4.14958 -4.14958 -22.1291 39.1386 36.6921 58.0801 58.0801 58.0801 -22.1291 40.1386 35.6921 -136.767 -136.767 -136.767 -22.1291 40.1386 36.6921 126.979 126.979 126.979 -23.1291 39.1386 35.6921 16.122 16.122 16.122 -23.1291 39.1386 36.6921 12.1653 12.1653 12.1653 -23.1291 40.1386 36.6921 144.181 144.181 144.181 -20.1291 37.1386 37.6921 -5.34812 -5.34812 -5.34812 -20.1291 37.1386 38.6921 -14.1834 -14.1834 -14.1834 -20.1291 38.1386 37.6921 18.5835 18.5835 18.5835 -21.1291 37.1386 37.6921 55.374 55.374 55.374 -21.1291 37.1386 38.6921 180.556 180.556 180.556 -21.1291 38.1386 37.6921 47.5843 47.5843 47.5843 -21.1291 38.1386 38.6921 -307.367 -307.367 -307.367 -20.1291 37.1386 39.6921 7.48214 7.48214 7.48214 -20.1291 37.1386 40.6921 9.02975 9.02975 9.02975 -20.1291 38.1386 39.6921 -12.7033 -12.7033 -12.7033 -20.1291 38.1386 40.6921 -21.1782 -21.1782 -21.1782 -21.1291 37.1386 39.6921 -7.90514 -7.90514 -7.90514 -21.1291 37.1386 40.6921 -16.517 -16.517 -16.517 -21.1291 38.1386 39.6921 -4.18048 -4.18048 -4.18048 -21.1291 38.1386 40.6921 -7.27221 -7.27221 -7.27221 -20.1291 39.1386 37.6921 33.8123 33.8123 33.8123 -20.1291 40.1386 37.6921 -33.1394 -33.1394 -33.1394 -20.1291 40.1386 38.6921 -47.3474 -47.3474 -47.3474 -21.1291 39.1386 37.6921 22.2999 22.2999 22.2999 -21.1291 39.1386 38.6921 69.3111 69.3111 69.3111 -21.1291 40.1386 37.6921 -53.6559 -53.6559 -53.6559 -21.1291 40.1386 38.6921 1.24895 1.24895 1.24895 -20.1291 39.1386 40.6921 -22.2877 -22.2877 -22.2877 -20.1291 40.1386 40.6921 -59.2239 -59.2239 -59.2239 -21.1291 39.1386 39.6921 15.6872 15.6872 15.6872 -21.1291 39.1386 40.6921 19.1672 19.1672 19.1672 -21.1291 40.1386 39.6921 12.9875 12.9875 12.9875 -21.1291 40.1386 40.6921 -10.065 -10.065 -10.065 -22.1291 37.1386 37.6921 158.041 158.041 158.041 -22.1291 37.1386 38.6921 13.7521 13.7521 13.7521 -22.1291 38.1386 37.6921 65.6435 65.6435 65.6435 -22.1291 38.1386 38.6921 -109.016 -109.016 -109.016 -23.1291 37.1386 37.6921 -25.7296 -25.7296 -25.7296 -23.1291 37.1386 38.6921 118.344 118.344 118.344 -23.1291 38.1386 37.6921 22.8838 22.8838 22.8838 -23.1291 38.1386 38.6921 -54.9238 -54.9238 -54.9238 -22.1291 37.1386 39.6921 -17.1604 -17.1604 -17.1604 -22.1291 37.1386 40.6921 -13.8094 -13.8094 -13.8094 -22.1291 38.1386 39.6921 1.81031 1.81031 1.81031 -22.1291 38.1386 40.6921 -7.30683 -7.30683 -7.30683 -23.1291 37.1386 39.6921 -13.9019 -13.9019 -13.9019 -23.1291 38.1386 39.6921 -8.05813 -8.05813 -8.05813 -23.1291 38.1386 40.6921 -44.9351 -44.9351 -44.9351 -22.1291 39.1386 37.6921 59.7878 59.7878 59.7878 -22.1291 39.1386 38.6921 67.5341 67.5341 67.5341 -22.1291 40.1386 37.6921 25.0386 25.0386 25.0386 -22.1291 40.1386 38.6921 8.61244 8.61244 8.61244 -23.1291 39.1386 37.6921 -10.4805 -10.4805 -10.4805 -23.1291 39.1386 38.6921 21.7073 21.7073 21.7073 -23.1291 40.1386 38.6921 14.3622 14.3622 14.3622 -22.1291 39.1386 39.6921 5.9348 5.9348 5.9348 -22.1291 39.1386 40.6921 20.3774 20.3774 20.3774 -22.1291 40.1386 39.6921 0.658145 0.658145 0.658145 -22.1291 40.1386 40.6921 -28.9828 -28.9828 -28.9828 -23.1291 39.1386 39.6921 7.01312 7.01312 7.01312 -23.1291 40.1386 39.6921 -25.8362 -25.8362 -25.8362 -20.1291 41.1386 33.6921 82.3149 82.3149 82.3149 -20.1291 41.1386 34.6921 -79.0064 -79.0064 -79.0064 -20.1291 42.1386 33.6921 -27.1527 -27.1527 -27.1527 -20.1291 42.1386 34.6921 170.726 170.726 170.726 -21.1291 41.1386 33.6921 59.2672 59.2672 59.2672 -21.1291 41.1386 34.6921 16.6595 16.6595 16.6595 -21.1291 42.1386 33.6921 350.68 350.68 350.68 -21.1291 42.1386 34.6921 59.2923 59.2923 59.2923 -20.1291 41.1386 35.6921 -65.6179 -65.6179 -65.6179 -20.1291 41.1386 36.6921 -57.6556 -57.6556 -57.6556 -20.1291 42.1386 35.6921 117.994 117.994 117.994 -21.1291 41.1386 35.6921 19.1657 19.1657 19.1657 -21.1291 41.1386 36.6921 -14.6073 -14.6073 -14.6073 -21.1291 42.1386 35.6921 5.95226 5.95226 5.95226 -20.1291 43.1386 33.6921 346.516 346.516 346.516 -20.1291 43.1386 34.6921 5.94383 5.94383 5.94383 -20.1291 44.1386 34.6921 -61.5878 -61.5878 -61.5878 -21.1291 43.1386 33.6921 215.928 215.928 215.928 -21.1291 43.1386 34.6921 53.0811 53.0811 53.0811 -21.1291 44.1386 34.6921 -6.92729 -6.92729 -6.92729 -20.1291 43.1386 35.6921 -25.9238 -25.9238 -25.9238 -20.1291 44.1386 35.6921 -44.9779 -44.9779 -44.9779 -20.1291 44.1386 36.6921 -49.7191 -49.7191 -49.7191 -21.1291 44.1386 35.6921 -133.913 -133.913 -133.913 -22.1291 41.1386 34.6921 89.3645 89.3645 89.3645 -22.1291 42.1386 33.6921 -84.4347 -84.4347 -84.4347 -22.1291 42.1386 34.6921 37.1441 37.1441 37.1441 -23.1291 41.1386 33.6921 146.599 146.599 146.599 -23.1291 41.1386 34.6921 145.517 145.517 145.517 -23.1291 42.1386 34.6921 218.131 218.131 218.131 -22.1291 41.1386 36.6921 -48.2173 -48.2173 -48.2173 -22.1291 42.1386 35.6921 60.3656 60.3656 60.3656 -22.1291 42.1386 36.6921 5.83795 5.83795 5.83795 -23.1291 41.1386 36.6921 -100.96 -100.96 -100.96 -23.1291 42.1386 35.6921 187.966 187.966 187.966 -23.1291 42.1386 36.6921 38.114 38.114 38.114 -22.1291 43.1386 33.6921 -7.10532 -7.10532 -7.10532 -22.1291 43.1386 34.6921 25.0644 25.0644 25.0644 -22.1291 44.1386 33.6921 13946.0 13946.0 13946.0 -22.1291 44.1386 34.6921 -30.4952 -30.4952 -30.4952 -23.1291 43.1386 34.6921 -492.703 -492.703 -492.703 -23.1291 44.1386 33.6921 5074.66 5074.66 5074.66 -23.1291 44.1386 34.6921 257.118 257.118 257.118 -22.1291 43.1386 35.6921 -4.05657 -4.05657 -4.05657 -22.1291 44.1386 35.6921 -10.9679 -10.9679 -10.9679 -22.1291 44.1386 36.6921 -114.524 -114.524 -114.524 -23.1291 43.1386 35.6921 -610.98 -610.98 -610.98 -23.1291 44.1386 35.6921 -34.6008 -34.6008 -34.6008 -23.1291 44.1386 36.6921 180.207 180.207 180.207 -20.1291 41.1386 37.6921 57.8972 57.8972 57.8972 -20.1291 41.1386 38.6921 -16.7087 -16.7087 -16.7087 -20.1291 42.1386 38.6921 -28.4064 -28.4064 -28.4064 -21.1291 41.1386 37.6921 -35.2116 -35.2116 -35.2116 -21.1291 41.1386 38.6921 -29.5478 -29.5478 -29.5478 -21.1291 42.1386 37.6921 -2.24576 -2.24576 -2.24576 -21.1291 42.1386 38.6921 -78.525 -78.525 -78.525 -20.1291 41.1386 39.6921 -23.9582 -23.9582 -23.9582 -20.1291 41.1386 40.6921 22.1401 22.1401 22.1401 -20.1291 42.1386 39.6921 80.8323 80.8323 80.8323 -20.1291 42.1386 40.6921 -350.039 -350.039 -350.039 -21.1291 41.1386 39.6921 -62.1174 -62.1174 -62.1174 -21.1291 41.1386 40.6921 0.995727 0.995727 0.995727 -21.1291 42.1386 39.6921 -47.1223 -47.1223 -47.1223 -21.1291 42.1386 40.6921 637.67 637.67 637.67 -20.1291 43.1386 37.6921 -99.4949 -99.4949 -99.4949 -20.1291 43.1386 38.6921 46.22 46.22 46.22 -20.1291 44.1386 37.6921 47.4562 47.4562 47.4562 -20.1291 44.1386 38.6921 81.8248 81.8248 81.8248 -21.1291 43.1386 37.6921 -56.9129 -56.9129 -56.9129 -21.1291 43.1386 38.6921 -155.929 -155.929 -155.929 -21.1291 44.1386 37.6921 361.393 361.393 361.393 -21.1291 44.1386 38.6921 136.298 136.298 136.298 -20.1291 43.1386 39.6921 -87.9784 -87.9784 -87.9784 -20.1291 44.1386 39.6921 -333.041 -333.041 -333.041 -20.1291 44.1386 40.6921 325.73 325.73 325.73 -21.1291 43.1386 39.6921 -111.326 -111.326 -111.326 -21.1291 43.1386 40.6921 310.066 310.066 310.066 -21.1291 44.1386 39.6921 -29.2695 -29.2695 -29.2695 -21.1291 44.1386 40.6921 65.6377 65.6377 65.6377 -22.1291 41.1386 37.6921 195.724 195.724 195.724 -22.1291 41.1386 38.6921 35.281 35.281 35.281 -23.1291 41.1386 37.6921 -0.295742 -0.295742 -0.295742 -23.1291 41.1386 38.6921 36.7344 36.7344 36.7344 -23.1291 42.1386 38.6921 37.0196 37.0196 37.0196 -22.1291 41.1386 39.6921 17.089 17.089 17.089 -22.1291 41.1386 40.6921 -44.7442 -44.7442 -44.7442 -22.1291 42.1386 39.6921 -167.836 -167.836 -167.836 -22.1291 42.1386 40.6921 -25.3272 -25.3272 -25.3272 -23.1291 41.1386 39.6921 -37.0253 -37.0253 -37.0253 -23.1291 41.1386 40.6921 -19.4056 -19.4056 -19.4056 -23.1291 42.1386 39.6921 98.292 98.292 98.292 -23.1291 42.1386 40.6921 -36.6688 -36.6688 -36.6688 -22.1291 44.1386 37.6921 174.776 174.776 174.776 -22.1291 44.1386 38.6921 56.7096 56.7096 56.7096 -23.1291 43.1386 38.6921 -79.9039 -79.9039 -79.9039 -23.1291 44.1386 37.6921 -6.38655 -6.38655 -6.38655 -23.1291 44.1386 38.6921 -64.0751 -64.0751 -64.0751 -22.1291 43.1386 39.6921 440.941 440.941 440.941 -22.1291 43.1386 40.6921 229.983 229.983 229.983 -22.1291 44.1386 39.6921 -348.95 -348.95 -348.95 -22.1291 44.1386 40.6921 -406.902 -406.902 -406.902 -23.1291 43.1386 39.6921 12.0664 12.0664 12.0664 -23.1291 43.1386 40.6921 -79.1448 -79.1448 -79.1448 -23.1291 44.1386 39.6921 230.786 230.786 230.786 -23.1291 44.1386 40.6921 -12.9475 -12.9475 -12.9475 -16.1291 45.1386 32.6921 290.309 290.309 290.309 -17.1291 45.1386 32.6921 190.627 190.627 190.627 -17.1291 46.1386 32.6921 -3524.7 -3524.7 -3524.7 -17.1291 47.1386 32.6921 -1447.01 -1447.01 -1447.01 -18.1291 45.1386 31.692100000000003 -350.062 -350.062 -350.062 -18.1291 45.1386 32.6921 2.15153 2.15153 2.15153 -18.1291 46.1386 31.692100000000003 -5468.67 -5468.67 -5468.67 -18.1291 46.1386 32.6921 -12404.2 -12404.2 -12404.2 -19.1291 45.1386 31.692100000000003 -529.21 -529.21 -529.21 -19.1291 45.1386 32.6921 -114.664 -114.664 -114.664 -19.1291 46.1386 31.692100000000003 4103.27 4103.27 4103.27 -18.1291 47.1386 31.692100000000003 3994.5 3994.5 3994.5 -18.1291 47.1386 32.6921 -6559.08 -6559.08 -6559.08 -18.1291 48.1386 32.6921 11826.7 11826.7 11826.7 -19.1291 47.1386 31.692100000000003 6035.73 6035.73 6035.73 -19.1291 47.1386 32.6921 -1668.35 -1668.35 -1668.35 -19.1291 48.1386 31.692100000000003 873.243 873.243 873.243 -19.1291 48.1386 32.6921 10320.8 10320.8 10320.8 -18.1291 49.1386 32.6921 364.13 364.13 364.13 -19.1291 49.1386 31.692100000000003 121.546 121.546 121.546 -19.1291 49.1386 32.6921 846.64 846.64 846.64 -20.1291 45.1386 31.692100000000003 -786.174 -786.174 -786.174 -20.1291 45.1386 32.6921 4238.51 4238.51 4238.51 -20.1291 46.1386 31.692100000000003 -854.496 -854.496 -854.496 -20.1291 46.1386 32.6921 34241.3 34241.3 34241.3 -21.1291 45.1386 31.692100000000003 -148.909 -148.909 -148.909 -21.1291 45.1386 32.6921 -2496.2 -2496.2 -2496.2 -21.1291 46.1386 31.692100000000003 -8850.43 -8850.43 -8850.43 -21.1291 46.1386 32.6921 4225.09 4225.09 4225.09 -20.1291 47.1386 31.692100000000003 -43.221 -43.221 -43.221 -20.1291 48.1386 31.692100000000003 201.899 201.899 201.899 -21.1291 47.1386 31.692100000000003 700.757 700.757 700.757 -21.1291 47.1386 32.6921 28142.8 28142.8 28142.8 -21.1291 48.1386 31.692100000000003 636.364 636.364 636.364 -21.1291 48.1386 32.6921 1972.44 1972.44 1972.44 -22.1291 45.1386 31.692100000000003 -9681.84 -9681.84 -9681.84 -22.1291 45.1386 32.6921 -16.6342 -16.6342 -16.6342 -22.1291 46.1386 31.692100000000003 2046.93 2046.93 2046.93 -23.1291 45.1386 31.692100000000003 -15957.6 -15957.6 -15957.6 -23.1291 45.1386 32.6921 -5833.48 -5833.48 -5833.48 -23.1291 46.1386 31.692100000000003 -12011.4 -12011.4 -12011.4 -23.1291 46.1386 32.6921 -5122.79 -5122.79 -5122.79 -22.1291 47.1386 31.692100000000003 -383.379 -383.379 -383.379 -22.1291 47.1386 32.6921 -14874.4 -14874.4 -14874.4 -22.1291 48.1386 32.6921 -195.969 -195.969 -195.969 -23.1291 47.1386 31.692100000000003 -328.632 -328.632 -328.632 -23.1291 47.1386 32.6921 799.708 799.708 799.708 -23.1291 48.1386 32.6921 -1010.94 -1010.94 -1010.94 -20.1291 49.1386 31.692100000000003 65.2034 65.2034 65.2034 -20.1291 49.1386 32.6921 359.139 359.139 359.139 -21.1291 49.1386 31.692100000000003 723.473 723.473 723.473 -21.1291 49.1386 32.6921 405.345 405.345 405.345 -22.1291 49.1386 32.6921 314.61 314.61 314.61 -16.1291 45.1386 33.6921 608.269 608.269 608.269 -16.1291 45.1386 34.6921 64.5645 64.5645 64.5645 -16.1291 46.1386 33.6921 76.5821 76.5821 76.5821 -16.1291 46.1386 34.6921 -321.731 -321.731 -321.731 -17.1291 45.1386 33.6921 583.026 583.026 583.026 -17.1291 46.1386 33.6921 -1075.1 -1075.1 -1075.1 -16.1291 45.1386 36.6921 -270.201 -270.201 -270.201 -16.1291 46.1386 36.6921 -1353.52 -1353.52 -1353.52 -17.1291 45.1386 36.6921 217.63 217.63 217.63 -16.1291 47.1386 33.6921 -636.362 -636.362 -636.362 -16.1291 47.1386 34.6921 169.379 169.379 169.379 -17.1291 47.1386 33.6921 -3629.63 -3629.63 -3629.63 -17.1291 47.1386 34.6921 -479.753 -479.753 -479.753 -17.1291 48.1386 33.6921 1733.05 1733.05 1733.05 -17.1291 48.1386 34.6921 34.9313 34.9313 34.9313 -16.1291 47.1386 35.6921 901.541 901.541 901.541 -16.1291 47.1386 36.6921 5018.88 5018.88 5018.88 -17.1291 47.1386 35.6921 30.5774 30.5774 30.5774 -17.1291 47.1386 36.6921 2002.47 2002.47 2002.47 -17.1291 48.1386 35.6921 -204.863 -204.863 -204.863 -18.1291 45.1386 33.6921 -206.048 -206.048 -206.048 -19.1291 45.1386 33.6921 117.023 117.023 117.023 -19.1291 45.1386 34.6921 -242.022 -242.022 -242.022 -19.1291 46.1386 34.6921 157.619 157.619 157.619 -18.1291 45.1386 35.6921 89.8825 89.8825 89.8825 -18.1291 45.1386 36.6921 26.7043 26.7043 26.7043 -18.1291 46.1386 35.6921 -35.8575 -35.8575 -35.8575 -18.1291 46.1386 36.6921 1939.11 1939.11 1939.11 -19.1291 45.1386 35.6921 -103.811 -103.811 -103.811 -19.1291 45.1386 36.6921 -20.9667 -20.9667 -20.9667 -19.1291 46.1386 35.6921 -105.629 -105.629 -105.629 -19.1291 46.1386 36.6921 -335.332 -335.332 -335.332 -18.1291 47.1386 33.6921 -10888.8 -10888.8 -10888.8 -18.1291 48.1386 33.6921 1550.64 1550.64 1550.64 -18.1291 48.1386 34.6921 56.9015 56.9015 56.9015 -19.1291 47.1386 34.6921 -58.3821 -58.3821 -58.3821 -19.1291 48.1386 33.6921 6279.51 6279.51 6279.51 -19.1291 48.1386 34.6921 67.1133 67.1133 67.1133 -18.1291 47.1386 35.6921 -217.488 -217.488 -217.488 -18.1291 47.1386 36.6921 4203.15 4203.15 4203.15 -18.1291 48.1386 35.6921 8.14545 8.14545 8.14545 -19.1291 47.1386 35.6921 -17.4879 -17.4879 -17.4879 -19.1291 47.1386 36.6921 1148.23 1148.23 1148.23 -19.1291 48.1386 35.6921 -14.1165 -14.1165 -14.1165 -19.1291 48.1386 36.6921 53959.9 53959.9 53959.9 -16.1291 45.1386 37.6921 -412.267 -412.267 -412.267 -16.1291 45.1386 38.6921 457.061 457.061 457.061 -16.1291 46.1386 37.6921 -6541.24 -6541.24 -6541.24 -16.1291 46.1386 38.6921 -11246.8 -11246.8 -11246.8 -17.1291 45.1386 37.6921 118.813 118.813 118.813 -17.1291 45.1386 38.6921 -598.395 -598.395 -598.395 -17.1291 46.1386 37.6921 -505.145 -505.145 -505.145 -17.1291 46.1386 38.6921 -6859.53 -6859.53 -6859.53 -16.1291 45.1386 39.6921 -2477.43 -2477.43 -2477.43 -16.1291 45.1386 40.6921 -1863.01 -1863.01 -1863.01 -16.1291 46.1386 39.6921 -3225.3 -3225.3 -3225.3 -16.1291 46.1386 40.6921 -1916.47 -1916.47 -1916.47 -17.1291 46.1386 39.6921 -60.3305 -60.3305 -60.3305 -17.1291 46.1386 40.6921 1071.33 1071.33 1071.33 -16.1291 47.1386 37.6921 7341.53 7341.53 7341.53 -17.1291 47.1386 37.6921 4977.57 4977.57 4977.57 -17.1291 47.1386 38.6921 7981.22 7981.22 7981.22 -17.1291 48.1386 37.6921 2852.7 2852.7 2852.7 -17.1291 48.1386 38.6921 511.715 511.715 511.715 -17.1291 47.1386 39.6921 -2535.96 -2535.96 -2535.96 -17.1291 47.1386 40.6921 -2927.49 -2927.49 -2927.49 -17.1291 48.1386 39.6921 616.667 616.667 616.667 -17.1291 48.1386 40.6921 -1643.85 -1643.85 -1643.85 -18.1291 46.1386 37.6921 -2191.5 -2191.5 -2191.5 -19.1291 46.1386 37.6921 -948.78 -948.78 -948.78 -19.1291 45.1386 39.6921 -356.366 -356.366 -356.366 -19.1291 45.1386 40.6921 316.892 316.892 316.892 -19.1291 46.1386 40.6921 9864.48 9864.48 9864.48 -18.1291 47.1386 37.6921 4656.53 4656.53 4656.53 -18.1291 47.1386 38.6921 -4305.82 -4305.82 -4305.82 -18.1291 48.1386 37.6921 -394167.0 -394167.0 -394167.0 -19.1291 47.1386 37.6921 36.5272 36.5272 36.5272 -19.1291 48.1386 37.6921 108788.0 108788.0 108788.0 -18.1291 47.1386 40.6921 -5018.89 -5018.89 -5018.89 -18.1291 48.1386 40.6921 -5275.22 -5275.22 -5275.22 -19.1291 47.1386 40.6921 1670.88 1670.88 1670.88 -19.1291 48.1386 40.6921 -9885.15 -9885.15 -9885.15 -18.1291 49.1386 33.6921 -78.1066 -78.1066 -78.1066 -19.1291 49.1386 33.6921 -248.44 -248.44 -248.44 -19.1291 49.1386 34.6921 26.6176 26.6176 26.6176 -17.1291 49.1386 37.6921 -2716.37 -2716.37 -2716.37 -17.1291 49.1386 38.6921 -3399.13 -3399.13 -3399.13 -17.1291 50.1386 38.6921 -2631.21 -2631.21 -2631.21 -17.1291 49.1386 39.6921 13120.2 13120.2 13120.2 -17.1291 49.1386 40.6921 5523.41 5523.41 5523.41 -17.1291 50.1386 39.6921 -1468.23 -1468.23 -1468.23 -18.1291 49.1386 37.6921 -85554.2 -85554.2 -85554.2 -18.1291 49.1386 38.6921 -374158.0 -374158.0 -374158.0 -18.1291 50.1386 38.6921 -166864.0 -166864.0 -166864.0 -19.1291 49.1386 37.6921 280552.0 280552.0 280552.0 -19.1291 49.1386 38.6921 82612.2 82612.2 82612.2 -19.1291 50.1386 38.6921 429891.0 429891.0 429891.0 -18.1291 49.1386 40.6921 7658.64 7658.64 7658.64 -18.1291 50.1386 39.6921 235.475 235.475 235.475 -18.1291 50.1386 40.6921 -5098.04 -5098.04 -5098.04 -19.1291 49.1386 39.6921 -1382.6 -1382.6 -1382.6 -19.1291 49.1386 40.6921 -10136.0 -10136.0 -10136.0 -19.1291 50.1386 39.6921 564.28 564.28 564.28 -19.1291 50.1386 40.6921 -355.773 -355.773 -355.773 -20.1291 45.1386 33.6921 1608.68 1608.68 1608.68 -20.1291 45.1386 34.6921 -7119.53 -7119.53 -7119.53 -20.1291 46.1386 33.6921 -3397.78 -3397.78 -3397.78 -20.1291 46.1386 34.6921 -14316.5 -14316.5 -14316.5 -21.1291 45.1386 33.6921 -4842.36 -4842.36 -4842.36 -21.1291 45.1386 34.6921 9868.26 9868.26 9868.26 -21.1291 46.1386 33.6921 5026.45 5026.45 5026.45 -21.1291 46.1386 34.6921 -9324.97 -9324.97 -9324.97 -20.1291 45.1386 35.6921 -95.5516 -95.5516 -95.5516 -20.1291 45.1386 36.6921 65.8204 65.8204 65.8204 -20.1291 46.1386 35.6921 -305.976 -305.976 -305.976 -20.1291 46.1386 36.6921 235.011 235.011 235.011 -21.1291 45.1386 35.6921 79.3923 79.3923 79.3923 -21.1291 45.1386 36.6921 57.6697 57.6697 57.6697 -21.1291 46.1386 35.6921 8.67644 8.67644 8.67644 -20.1291 47.1386 34.6921 8132.54 8132.54 8132.54 -20.1291 48.1386 34.6921 45.0007 45.0007 45.0007 -20.1291 47.1386 35.6921 233.232 233.232 233.232 -20.1291 47.1386 36.6921 531.097 531.097 531.097 -20.1291 48.1386 35.6921 -76.3933 -76.3933 -76.3933 -20.1291 48.1386 36.6921 -10236.4 -10236.4 -10236.4 -21.1291 47.1386 35.6921 78.7827 78.7827 78.7827 -21.1291 47.1386 36.6921 -393.511 -393.511 -393.511 -21.1291 48.1386 35.6921 -171.641 -171.641 -171.641 -21.1291 48.1386 36.6921 735.337 735.337 735.337 -22.1291 45.1386 33.6921 -10772.2 -10772.2 -10772.2 -22.1291 45.1386 34.6921 -22151.4 -22151.4 -22151.4 -22.1291 46.1386 34.6921 -3826.83 -3826.83 -3826.83 -23.1291 45.1386 33.6921 -6362.95 -6362.95 -6362.95 -23.1291 45.1386 34.6921 416.674 416.674 416.674 -23.1291 46.1386 34.6921 125.097 125.097 125.097 -22.1291 45.1386 35.6921 -69.0089 -69.0089 -69.0089 -22.1291 45.1386 36.6921 6.63885 6.63885 6.63885 -22.1291 46.1386 35.6921 85.9051 85.9051 85.9051 -22.1291 46.1386 36.6921 -11580.1 -11580.1 -11580.1 -23.1291 46.1386 35.6921 126.795 126.795 126.795 -23.1291 46.1386 36.6921 -2466.95 -2466.95 -2466.95 -22.1291 48.1386 33.6921 -283.425 -283.425 -283.425 -23.1291 47.1386 33.6921 320.114 320.114 320.114 -23.1291 48.1386 33.6921 -385.081 -385.081 -385.081 -23.1291 48.1386 34.6921 141.054 141.054 141.054 -22.1291 47.1386 35.6921 163.676 163.676 163.676 -22.1291 47.1386 36.6921 1949.5 1949.5 1949.5 -22.1291 48.1386 35.6921 -44.5179 -44.5179 -44.5179 -22.1291 48.1386 36.6921 7860.59 7860.59 7860.59 -23.1291 47.1386 36.6921 1158.77 1158.77 1158.77 -23.1291 48.1386 36.6921 6259.46 6259.46 6259.46 -20.1291 45.1386 37.6921 210.805 210.805 210.805 -20.1291 45.1386 38.6921 -168.302 -168.302 -168.302 -20.1291 46.1386 37.6921 521.93 521.93 521.93 -20.1291 46.1386 38.6921 -8363.8 -8363.8 -8363.8 -21.1291 45.1386 37.6921 107.678 107.678 107.678 -21.1291 45.1386 38.6921 -243.315 -243.315 -243.315 -21.1291 46.1386 37.6921 109.777 109.777 109.777 -20.1291 45.1386 39.6921 -749.984 -749.984 -749.984 -20.1291 45.1386 40.6921 -140.405 -140.405 -140.405 -20.1291 46.1386 39.6921 8462.57 8462.57 8462.57 -20.1291 46.1386 40.6921 517.367 517.367 517.367 -21.1291 45.1386 39.6921 -130.607 -130.607 -130.607 -21.1291 45.1386 40.6921 -328.622 -328.622 -328.622 -21.1291 46.1386 39.6921 -409.669 -409.669 -409.669 -21.1291 46.1386 40.6921 -725.521 -725.521 -725.521 -20.1291 47.1386 37.6921 1457.3 1457.3 1457.3 -20.1291 48.1386 37.6921 694398.0 694398.0 694398.0 -21.1291 47.1386 37.6921 587.355 587.355 587.355 -21.1291 48.1386 37.6921 199.735 199.735 199.735 -21.1291 48.1386 38.6921 294.936 294.936 294.936 -20.1291 47.1386 40.6921 5873.99 5873.99 5873.99 -20.1291 48.1386 40.6921 5609.43 5609.43 5609.43 -21.1291 47.1386 40.6921 1572.92 1572.92 1572.92 -21.1291 48.1386 40.6921 -187.241 -187.241 -187.241 -22.1291 45.1386 37.6921 -65.7658 -65.7658 -65.7658 -22.1291 45.1386 38.6921 -1.58806 -1.58806 -1.58806 -22.1291 46.1386 37.6921 -2687.39 -2687.39 -2687.39 -23.1291 45.1386 37.6921 138.794 138.794 138.794 -23.1291 45.1386 38.6921 168.779 168.779 168.779 -23.1291 46.1386 37.6921 -11935.2 -11935.2 -11935.2 -22.1291 45.1386 39.6921 -56.7621 -56.7621 -56.7621 -22.1291 45.1386 40.6921 1071.09 1071.09 1071.09 -22.1291 46.1386 40.6921 657.017 657.017 657.017 -23.1291 45.1386 39.6921 356.534 356.534 356.534 -23.1291 45.1386 40.6921 330.098 330.098 330.098 -23.1291 46.1386 40.6921 1274.51 1274.51 1274.51 -22.1291 47.1386 37.6921 -2586.74 -2586.74 -2586.74 -22.1291 48.1386 37.6921 2502.64 2502.64 2502.64 -22.1291 48.1386 38.6921 3434.39 3434.39 3434.39 -23.1291 47.1386 37.6921 -4786.19 -4786.19 -4786.19 -23.1291 47.1386 38.6921 -13406.2 -13406.2 -13406.2 -23.1291 48.1386 37.6921 9431.62 9431.62 9431.62 -23.1291 48.1386 38.6921 2753.32 2753.32 2753.32 -22.1291 47.1386 40.6921 892.542 892.542 892.542 -22.1291 48.1386 39.6921 -91.5718 -91.5718 -91.5718 -22.1291 48.1386 40.6921 -993.333 -993.333 -993.333 -23.1291 47.1386 40.6921 815.149 815.149 815.149 -23.1291 48.1386 39.6921 -1108.8 -1108.8 -1108.8 -23.1291 48.1386 40.6921 -799.564 -799.564 -799.564 -20.1291 49.1386 33.6921 -1356.35 -1356.35 -1356.35 -20.1291 49.1386 34.6921 382.405 382.405 382.405 -20.1291 50.1386 34.6921 34.2536 34.2536 34.2536 -21.1291 49.1386 33.6921 -1261.56 -1261.56 -1261.56 -21.1291 49.1386 34.6921 218.267 218.267 218.267 -21.1291 50.1386 34.6921 438.449 438.449 438.449 -20.1291 49.1386 35.6921 32.7868 32.7868 32.7868 -20.1291 49.1386 36.6921 -589246.0 -589246.0 -589246.0 -20.1291 50.1386 35.6921 -314.478 -314.478 -314.478 -21.1291 49.1386 35.6921 -53.471 -53.471 -53.471 -21.1291 49.1386 36.6921 812.618 812.618 812.618 -21.1291 50.1386 35.6921 -86.7256 -86.7256 -86.7256 -22.1291 49.1386 33.6921 353.642 353.642 353.642 -22.1291 49.1386 34.6921 456.211 456.211 456.211 -23.1291 49.1386 33.6921 153.854 153.854 153.854 -23.1291 49.1386 34.6921 39.0916 39.0916 39.0916 -22.1291 49.1386 35.6921 6.04401 6.04401 6.04401 -22.1291 49.1386 36.6921 483.086 483.086 483.086 -23.1291 49.1386 35.6921 -90.8686 -90.8686 -90.8686 -23.1291 49.1386 36.6921 -15.9859 -15.9859 -15.9859 -20.1291 49.1386 37.6921 -46498.4 -46498.4 -46498.4 -20.1291 49.1386 38.6921 24161.6 24161.6 24161.6 -21.1291 49.1386 38.6921 -1978.69 -1978.69 -1978.69 -20.1291 49.1386 39.6921 1376.9 1376.9 1376.9 -20.1291 49.1386 40.6921 3633.05 3633.05 3633.05 -20.1291 50.1386 39.6921 -327.269 -327.269 -327.269 -20.1291 50.1386 40.6921 1463.72 1463.72 1463.72 -21.1291 49.1386 39.6921 -709.42 -709.42 -709.42 -21.1291 49.1386 40.6921 -917.037 -917.037 -917.037 -22.1291 49.1386 37.6921 293.069 293.069 293.069 -22.1291 49.1386 38.6921 -647.305 -647.305 -647.305 -23.1291 49.1386 37.6921 -48.2363 -48.2363 -48.2363 -22.1291 49.1386 39.6921 845.68 845.68 845.68 -22.1291 49.1386 40.6921 -168.547 -168.547 -168.547 -10.129100000000001 37.1386 41.6921 -46.8593 -46.8593 -46.8593 -10.129100000000001 37.1386 42.6921 -1226.73 -1226.73 -1226.73 -11.129100000000001 37.1386 41.6921 -29.1749 -29.1749 -29.1749 -11.129100000000001 37.1386 42.6921 -387.844 -387.844 -387.844 -10.129100000000001 37.1386 43.6921 694.285 694.285 694.285 -11.129100000000001 37.1386 43.6921 -101.165 -101.165 -101.165 -11.129100000000001 37.1386 44.6921 111.485 111.485 111.485 -12.129100000000001 37.1386 41.6921 -56.7245 -56.7245 -56.7245 -12.129100000000001 37.1386 42.6921 -928.985 -928.985 -928.985 -13.129100000000001 37.1386 41.6921 -20.4891 -20.4891 -20.4891 -13.129100000000001 37.1386 42.6921 -24.6365 -24.6365 -24.6365 -12.129100000000001 37.1386 43.6921 -583.177 -583.177 -583.177 -12.129100000000001 37.1386 44.6921 981.792 981.792 981.792 -13.129100000000001 37.1386 43.6921 -107.42 -107.42 -107.42 -13.129100000000001 37.1386 44.6921 395.776 395.776 395.776 -13.129100000000001 38.1386 43.6921 65.2066 65.2066 65.2066 -13.129100000000001 38.1386 44.6921 823.983 823.983 823.983 -13.129100000000001 39.1386 41.6921 -57.0959 -57.0959 -57.0959 -13.129100000000001 39.1386 42.6921 -62.8063 -62.8063 -62.8063 -13.129100000000001 40.1386 41.6921 -44.9557 -44.9557 -44.9557 -13.129100000000001 40.1386 42.6921 111.714 111.714 111.714 -13.129100000000001 39.1386 43.6921 31.7773 31.7773 31.7773 -13.129100000000001 39.1386 44.6921 34.2633 34.2633 34.2633 -13.129100000000001 40.1386 43.6921 337.91 337.91 337.91 -14.129100000000001 37.1386 42.6921 -98.0374 -98.0374 -98.0374 -14.129100000000001 38.1386 42.6921 -75.2917 -75.2917 -75.2917 -15.129100000000001 37.1386 41.6921 -31.5016 -31.5016 -31.5016 -15.129100000000001 37.1386 42.6921 29.828 29.828 29.828 -15.129100000000001 38.1386 41.6921 -13.5769 -13.5769 -13.5769 -15.129100000000001 38.1386 42.6921 -11.0462 -11.0462 -11.0462 -14.129100000000001 37.1386 43.6921 -43.1684 -43.1684 -43.1684 -14.129100000000001 38.1386 43.6921 88.8601 88.8601 88.8601 -15.129100000000001 37.1386 43.6921 37.194 37.194 37.194 -15.129100000000001 38.1386 43.6921 68.5456 68.5456 68.5456 -14.129100000000001 39.1386 41.6921 -23.8803 -23.8803 -23.8803 -14.129100000000001 39.1386 42.6921 -19.3806 -19.3806 -19.3806 -14.129100000000001 40.1386 42.6921 -8.7992 -8.7992 -8.7992 -15.129100000000001 39.1386 41.6921 -55.1187 -55.1187 -55.1187 -15.129100000000001 39.1386 42.6921 -56.0755 -56.0755 -56.0755 -14.129100000000001 39.1386 43.6921 48.775 48.775 48.775 -14.129100000000001 39.1386 44.6921 9.87786 9.87786 9.87786 -14.129100000000001 40.1386 43.6921 18.9131 18.9131 18.9131 -14.129100000000001 40.1386 44.6921 -5.57851 -5.57851 -5.57851 -15.129100000000001 39.1386 43.6921 -6.20516 -6.20516 -6.20516 -15.129100000000001 39.1386 44.6921 -13.5791 -13.5791 -13.5791 -15.129100000000001 40.1386 43.6921 27.8472 27.8472 27.8472 -15.129100000000001 40.1386 44.6921 -1.94994 -1.94994 -1.94994 -12.129100000000001 37.1386 45.6921 3339.01 3339.01 3339.01 -12.129100000000001 37.1386 46.6921 62.5935 62.5935 62.5935 -12.129100000000001 38.1386 45.6921 305.307 305.307 305.307 -12.129100000000001 38.1386 46.6921 1583.45 1583.45 1583.45 -13.129100000000001 37.1386 45.6921 711.99 711.99 711.99 -13.129100000000001 37.1386 46.6921 -2695.21 -2695.21 -2695.21 -13.129100000000001 38.1386 45.6921 -672.66 -672.66 -672.66 -12.129100000000001 37.1386 47.6921 -1609.07 -1609.07 -1609.07 -12.129100000000001 38.1386 47.6921 -1110.51 -1110.51 -1110.51 -13.129100000000001 37.1386 47.6921 1066.42 1066.42 1066.42 -13.129100000000001 37.1386 48.6921 0.892883 0.892883 0.892883 -13.129100000000001 38.1386 47.6921 1317.64 1317.64 1317.64 -13.129100000000001 38.1386 48.6921 -30.4638 -30.4638 -30.4638 -12.129100000000001 39.1386 45.6921 -261.012 -261.012 -261.012 -12.129100000000001 39.1386 46.6921 156.436 156.436 156.436 -12.129100000000001 40.1386 45.6921 -240.292 -240.292 -240.292 -12.129100000000001 40.1386 46.6921 -157.877 -157.877 -157.877 -13.129100000000001 39.1386 45.6921 -295.192 -295.192 -295.192 -13.129100000000001 40.1386 45.6921 -318.663 -318.663 -318.663 -13.129100000000001 40.1386 46.6921 -163.752 -163.752 -163.752 -12.129100000000001 39.1386 47.6921 -835.458 -835.458 -835.458 -12.129100000000001 40.1386 47.6921 74.1968 74.1968 74.1968 -13.129100000000001 39.1386 47.6921 1392.09 1392.09 1392.09 -13.129100000000001 39.1386 48.6921 -133.77 -133.77 -133.77 -13.129100000000001 40.1386 47.6921 56.0605 56.0605 56.0605 -13.129100000000001 40.1386 48.6921 26.3143 26.3143 26.3143 -14.129100000000001 37.1386 45.6921 -290.916 -290.916 -290.916 -14.129100000000001 37.1386 46.6921 -457.478 -457.478 -457.478 -15.129100000000001 37.1386 45.6921 -39.7121 -39.7121 -39.7121 -14.129100000000001 37.1386 47.6921 275.253 275.253 275.253 -14.129100000000001 37.1386 48.6921 -227.182 -227.182 -227.182 -14.129100000000001 38.1386 47.6921 -310.571 -310.571 -310.571 -14.129100000000001 38.1386 48.6921 -12.9739 -12.9739 -12.9739 -15.129100000000001 37.1386 47.6921 22.7843 22.7843 22.7843 -15.129100000000001 37.1386 48.6921 -240.433 -240.433 -240.433 -15.129100000000001 38.1386 47.6921 14.6917 14.6917 14.6917 -14.129100000000001 39.1386 45.6921 -187.973 -187.973 -187.973 -14.129100000000001 40.1386 45.6921 -168.515 -168.515 -168.515 -14.129100000000001 40.1386 46.6921 14.873 14.873 14.873 -15.129100000000001 40.1386 45.6921 -47.247 -47.247 -47.247 -15.129100000000001 40.1386 46.6921 -69.839 -69.839 -69.839 -14.129100000000001 39.1386 47.6921 83.5001 83.5001 83.5001 -14.129100000000001 39.1386 48.6921 -102.969 -102.969 -102.969 -14.129100000000001 40.1386 47.6921 -40.3013 -40.3013 -40.3013 -14.129100000000001 40.1386 48.6921 -34.6137 -34.6137 -34.6137 -15.129100000000001 39.1386 47.6921 -39.8716 -39.8716 -39.8716 -15.129100000000001 39.1386 48.6921 32.6967 32.6967 32.6967 -15.129100000000001 40.1386 47.6921 3.05119 3.05119 3.05119 -15.129100000000001 40.1386 48.6921 85.3418 85.3418 85.3418 -12.129100000000001 41.1386 41.6921 -151.867 -151.867 -151.867 -12.129100000000001 41.1386 42.6921 -137.713 -137.713 -137.713 -12.129100000000001 42.1386 41.6921 243.532 243.532 243.532 -12.129100000000001 42.1386 42.6921 -13.0036 -13.0036 -13.0036 -13.129100000000001 41.1386 41.6921 -271.511 -271.511 -271.511 -13.129100000000001 41.1386 42.6921 -9.09509 -9.09509 -9.09509 -13.129100000000001 42.1386 41.6921 -344.205 -344.205 -344.205 -13.129100000000001 42.1386 42.6921 280.038 280.038 280.038 -13.129100000000001 41.1386 43.6921 374.236 374.236 374.236 -12.129100000000001 43.1386 41.6921 -17.6389 -17.6389 -17.6389 -13.129100000000001 43.1386 41.6921 -24.9526 -24.9526 -24.9526 -13.129100000000001 43.1386 42.6921 7.32594 7.32594 7.32594 -13.129100000000001 44.1386 41.6921 262.532 262.532 262.532 -13.129100000000001 44.1386 42.6921 848.704 848.704 848.704 -14.129100000000001 41.1386 42.6921 -39.1493 -39.1493 -39.1493 -14.129100000000001 42.1386 42.6921 -28.6138 -28.6138 -28.6138 -15.129100000000001 42.1386 42.6921 -191.147 -191.147 -191.147 -14.129100000000001 41.1386 43.6921 62.0148 62.0148 62.0148 -14.129100000000001 42.1386 43.6921 2.82706 2.82706 2.82706 -15.129100000000001 41.1386 43.6921 4.39647 4.39647 4.39647 -15.129100000000001 42.1386 43.6921 -9.09882 -9.09882 -9.09882 -14.129100000000001 43.1386 42.6921 -19.9101 -19.9101 -19.9101 -14.129100000000001 44.1386 41.6921 -902.662 -902.662 -902.662 -14.129100000000001 44.1386 42.6921 147.964 147.964 147.964 -15.129100000000001 43.1386 42.6921 -29.2747 -29.2747 -29.2747 -15.129100000000001 44.1386 41.6921 1058.03 1058.03 1058.03 -15.129100000000001 44.1386 42.6921 -709.615 -709.615 -709.615 -15.129100000000001 43.1386 43.6921 -11.3707 -11.3707 -11.3707 -15.129100000000001 43.1386 44.6921 24.5862 24.5862 24.5862 -15.129100000000001 44.1386 43.6921 -385.451 -385.451 -385.451 -15.129100000000001 44.1386 44.6921 82.4432 82.4432 82.4432 -15.129100000000001 41.1386 46.6921 5.45768 5.45768 5.45768 -15.129100000000001 42.1386 46.6921 -52.1827 -52.1827 -52.1827 -15.129100000000001 41.1386 47.6921 -34.3884 -34.3884 -34.3884 -15.129100000000001 41.1386 48.6921 -350.568 -350.568 -350.568 -15.129100000000001 42.1386 47.6921 -78.5862 -78.5862 -78.5862 -15.129100000000001 42.1386 48.6921 181.256 181.256 181.256 -15.129100000000001 43.1386 45.6921 16.3544 16.3544 16.3544 -15.129100000000001 43.1386 46.6921 -22.5673 -22.5673 -22.5673 -15.129100000000001 44.1386 45.6921 239.728 239.728 239.728 -15.129100000000001 44.1386 46.6921 -192.37 -192.37 -192.37 -15.129100000000001 43.1386 47.6921 -347.974 -347.974 -347.974 -15.129100000000001 43.1386 48.6921 208.388 208.388 208.388 -14.129100000000001 37.1386 49.6921 -185.899 -185.899 -185.899 -14.129100000000001 38.1386 49.6921 77.575 77.575 77.575 -14.129100000000001 38.1386 50.6921 -106.938 -106.938 -106.938 -15.129100000000001 37.1386 49.6921 104.445 104.445 104.445 -15.129100000000001 37.1386 50.6921 137.544 137.544 137.544 -15.129100000000001 38.1386 50.6921 13.8337 13.8337 13.8337 -14.129100000000001 39.1386 49.6921 -134.574 -134.574 -134.574 -15.129100000000001 39.1386 49.6921 174.455 174.455 174.455 -15.129100000000001 39.1386 50.6921 -29.7655 -29.7655 -29.7655 -15.129100000000001 40.1386 49.6921 143.127 143.127 143.127 -15.129100000000001 41.1386 49.6921 -1167.73 -1167.73 -1167.73 -15.129100000000001 42.1386 49.6921 -558.398 -558.398 -558.398 -14.129100000000001 45.1386 41.6921 -844.662 -844.662 -844.662 -15.129100000000001 45.1386 41.6921 -1679.85 -1679.85 -1679.85 -15.129100000000001 45.1386 42.6921 -340.567 -340.567 -340.567 -15.129100000000001 45.1386 44.6921 -44.3064 -44.3064 -44.3064 -15.129100000000001 45.1386 45.6921 264.231 264.231 264.231 -15.129100000000001 45.1386 46.6921 95.4811 95.4811 95.4811 -16.1291 37.1386 41.6921 17.5921 17.5921 17.5921 -16.1291 37.1386 42.6921 94.9273 94.9273 94.9273 -16.1291 38.1386 41.6921 -1.89443 -1.89443 -1.89443 -16.1291 38.1386 42.6921 9.47312 9.47312 9.47312 -17.1291 37.1386 42.6921 10.301 10.301 10.301 -17.1291 38.1386 41.6921 13.4783 13.4783 13.4783 -17.1291 38.1386 42.6921 13.1806 13.1806 13.1806 -16.1291 37.1386 43.6921 30.7204 30.7204 30.7204 -16.1291 37.1386 44.6921 -42.4824 -42.4824 -42.4824 -16.1291 38.1386 43.6921 11.7217 11.7217 11.7217 -16.1291 38.1386 44.6921 -31.7197 -31.7197 -31.7197 -17.1291 37.1386 43.6921 32.2669 32.2669 32.2669 -17.1291 37.1386 44.6921 -1.84348 -1.84348 -1.84348 -17.1291 38.1386 43.6921 37.3389 37.3389 37.3389 -17.1291 38.1386 44.6921 26.2096 26.2096 26.2096 -16.1291 39.1386 41.6921 92.213 92.213 92.213 -16.1291 39.1386 42.6921 2.57034 2.57034 2.57034 -16.1291 40.1386 41.6921 25.0033 25.0033 25.0033 -17.1291 39.1386 41.6921 60.8968 60.8968 60.8968 -17.1291 39.1386 42.6921 -11.8048 -11.8048 -11.8048 -17.1291 40.1386 41.6921 150.096 150.096 150.096 -17.1291 40.1386 42.6921 12.5458 12.5458 12.5458 -16.1291 39.1386 43.6921 -39.6907 -39.6907 -39.6907 -16.1291 39.1386 44.6921 1.18958 1.18958 1.18958 -16.1291 40.1386 43.6921 12.75 12.75 12.75 -16.1291 40.1386 44.6921 -10.9585 -10.9585 -10.9585 -17.1291 39.1386 43.6921 -9.1836 -9.1836 -9.1836 -17.1291 39.1386 44.6921 -36.6413 -36.6413 -36.6413 -17.1291 40.1386 43.6921 20.9095 20.9095 20.9095 -17.1291 40.1386 44.6921 -18.6194 -18.6194 -18.6194 -18.1291 37.1386 43.6921 17.9491 17.9491 17.9491 -18.1291 37.1386 44.6921 -1.65607 -1.65607 -1.65607 -18.1291 38.1386 44.6921 -0.483016 -0.483016 -0.483016 -19.1291 37.1386 44.6921 2.82432 2.82432 2.82432 -19.1291 38.1386 44.6921 3.14118 3.14118 3.14118 -18.1291 39.1386 41.6921 -17.4341 -17.4341 -17.4341 -18.1291 39.1386 42.6921 -1.69166 -1.69166 -1.69166 -18.1291 40.1386 41.6921 58.8388 58.8388 58.8388 -18.1291 40.1386 42.6921 -3.63163 -3.63163 -3.63163 -19.1291 39.1386 41.6921 -1.22913 -1.22913 -1.22913 -19.1291 39.1386 42.6921 -3.31651 -3.31651 -3.31651 -19.1291 40.1386 41.6921 9.61716 9.61716 9.61716 -19.1291 40.1386 42.6921 -4.96093 -4.96093 -4.96093 -18.1291 39.1386 43.6921 -0.83043 -0.83043 -0.83043 -18.1291 40.1386 43.6921 -3.27242 -3.27242 -3.27242 -16.1291 37.1386 45.6921 -32.139 -32.139 -32.139 -16.1291 38.1386 45.6921 10.0424 10.0424 10.0424 -17.1291 37.1386 45.6921 4.10412 4.10412 4.10412 -17.1291 37.1386 46.6921 -4.48881 -4.48881 -4.48881 -17.1291 38.1386 45.6921 34.6603 34.6603 34.6603 -17.1291 38.1386 46.6921 3.71558 3.71558 3.71558 -16.1291 37.1386 47.6921 13.2383 13.2383 13.2383 -16.1291 37.1386 48.6921 -11.0284 -11.0284 -11.0284 -17.1291 37.1386 47.6921 -4.27001 -4.27001 -4.27001 -17.1291 37.1386 48.6921 -18.8099 -18.8099 -18.8099 -17.1291 38.1386 47.6921 32.4722 32.4722 32.4722 -17.1291 38.1386 48.6921 1.46231 1.46231 1.46231 -16.1291 39.1386 45.6921 -5.6367 -5.6367 -5.6367 -16.1291 39.1386 46.6921 -16.1673 -16.1673 -16.1673 -16.1291 40.1386 45.6921 52.0469 52.0469 52.0469 -16.1291 40.1386 46.6921 24.6854 24.6854 24.6854 -17.1291 39.1386 45.6921 7.97154 7.97154 7.97154 -17.1291 39.1386 46.6921 -21.8973 -21.8973 -21.8973 -17.1291 40.1386 45.6921 -19.5399 -19.5399 -19.5399 -17.1291 40.1386 46.6921 4.71738 4.71738 4.71738 -16.1291 40.1386 47.6921 32.4594 32.4594 32.4594 -16.1291 40.1386 48.6921 -227.931 -227.931 -227.931 -17.1291 40.1386 47.6921 20.7847 20.7847 20.7847 -18.1291 37.1386 45.6921 -2.3458 -2.3458 -2.3458 -18.1291 37.1386 46.6921 -8.79541 -8.79541 -8.79541 -18.1291 38.1386 45.6921 -17.0489 -17.0489 -17.0489 -18.1291 38.1386 46.6921 -10.2974 -10.2974 -10.2974 -19.1291 37.1386 45.6921 1.82278 1.82278 1.82278 -19.1291 37.1386 46.6921 3.54014 3.54014 3.54014 -19.1291 38.1386 45.6921 40.3975 40.3975 40.3975 -19.1291 38.1386 46.6921 10.0253 10.0253 10.0253 -18.1291 37.1386 47.6921 2.07714 2.07714 2.07714 -18.1291 37.1386 48.6921 -40.0555 -40.0555 -40.0555 -18.1291 38.1386 47.6921 7.2481 7.2481 7.2481 -18.1291 38.1386 48.6921 6.86017 6.86017 6.86017 -19.1291 37.1386 47.6921 -3.3551 -3.3551 -3.3551 -19.1291 38.1386 47.6921 -4.06282 -4.06282 -4.06282 -18.1291 39.1386 46.6921 -31.5931 -31.5931 -31.5931 -18.1291 40.1386 46.6921 -15.5679 -15.5679 -15.5679 -19.1291 39.1386 45.6921 -1.66044 -1.66044 -1.66044 -19.1291 39.1386 46.6921 -0.709484 -0.709484 -0.709484 -19.1291 40.1386 46.6921 -21.7001 -21.7001 -21.7001 -18.1291 39.1386 47.6921 -14.8171 -14.8171 -14.8171 -18.1291 39.1386 48.6921 -14.002 -14.002 -14.002 -18.1291 40.1386 47.6921 17.0908 17.0908 17.0908 -19.1291 39.1386 47.6921 -4.43478 -4.43478 -4.43478 -19.1291 39.1386 48.6921 0.0178327 0.0178327 0.0178327 -19.1291 40.1386 47.6921 14.6609 14.6609 14.6609 -17.1291 41.1386 41.6921 64.8009 64.8009 64.8009 -17.1291 41.1386 42.6921 -1.27495 -1.27495 -1.27495 -16.1291 41.1386 43.6921 5.49422 5.49422 5.49422 -16.1291 42.1386 43.6921 -2.09322 -2.09322 -2.09322 -16.1291 42.1386 44.6921 11.8759 11.8759 11.8759 -17.1291 41.1386 43.6921 7.26752 7.26752 7.26752 -17.1291 41.1386 44.6921 -20.0087 -20.0087 -20.0087 -17.1291 42.1386 43.6921 53.5041 53.5041 53.5041 -17.1291 42.1386 44.6921 -2.60219 -2.60219 -2.60219 -16.1291 44.1386 42.6921 -7.93752 -7.93752 -7.93752 -17.1291 43.1386 42.6921 -20.9847 -20.9847 -20.9847 -17.1291 44.1386 42.6921 37.4478 37.4478 37.4478 -16.1291 43.1386 43.6921 4.32113 4.32113 4.32113 -16.1291 43.1386 44.6921 44.853 44.853 44.853 -16.1291 44.1386 43.6921 16.1639 16.1639 16.1639 -16.1291 44.1386 44.6921 27.3155 27.3155 27.3155 -17.1291 43.1386 43.6921 34.4475 34.4475 34.4475 -17.1291 43.1386 44.6921 -7.00126 -7.00126 -7.00126 -17.1291 44.1386 43.6921 4.47962 4.47962 4.47962 -17.1291 44.1386 44.6921 -23.3656 -23.3656 -23.3656 -18.1291 41.1386 41.6921 -28.8753 -28.8753 -28.8753 -18.1291 41.1386 42.6921 -19.2901 -19.2901 -19.2901 -18.1291 42.1386 41.6921 52.931 52.931 52.931 -18.1291 42.1386 42.6921 -16.7261 -16.7261 -16.7261 -19.1291 41.1386 41.6921 -56.3913 -56.3913 -56.3913 -19.1291 41.1386 42.6921 -7.06791 -7.06791 -7.06791 -19.1291 42.1386 41.6921 -91.0084 -91.0084 -91.0084 -19.1291 42.1386 42.6921 -46.266 -46.266 -46.266 -18.1291 41.1386 43.6921 1.74683 1.74683 1.74683 -18.1291 41.1386 44.6921 0.158557 0.158557 0.158557 -18.1291 42.1386 43.6921 -3.0001 -3.0001 -3.0001 -19.1291 41.1386 43.6921 -6.08607 -6.08607 -6.08607 -19.1291 42.1386 43.6921 -37.0471 -37.0471 -37.0471 -18.1291 43.1386 41.6921 -89.385 -89.385 -89.385 -18.1291 43.1386 42.6921 5.60153 5.60153 5.60153 -18.1291 44.1386 41.6921 384.247 384.247 384.247 -18.1291 44.1386 42.6921 123.496 123.496 123.496 -19.1291 43.1386 41.6921 -205.167 -205.167 -205.167 -19.1291 43.1386 42.6921 -135.908 -135.908 -135.908 -19.1291 44.1386 41.6921 176.888 176.888 176.888 -19.1291 44.1386 42.6921 148.093 148.093 148.093 -18.1291 43.1386 43.6921 -30.5378 -30.5378 -30.5378 -18.1291 44.1386 43.6921 -51.9538 -51.9538 -51.9538 -19.1291 43.1386 43.6921 -133.789 -133.789 -133.789 -19.1291 44.1386 43.6921 -30.2521 -30.2521 -30.2521 -16.1291 41.1386 46.6921 59.8971 59.8971 59.8971 -16.1291 42.1386 45.6921 -21.9983 -21.9983 -21.9983 -16.1291 42.1386 46.6921 -2.4004 -2.4004 -2.4004 -17.1291 41.1386 45.6921 -18.4435 -18.4435 -18.4435 -17.1291 41.1386 46.6921 -34.5424 -34.5424 -34.5424 -17.1291 42.1386 45.6921 -7.06037 -7.06037 -7.06037 -17.1291 42.1386 46.6921 -17.5359 -17.5359 -17.5359 -16.1291 41.1386 47.6921 -1.88834 -1.88834 -1.88834 -17.1291 41.1386 47.6921 -5.06169 -5.06169 -5.06169 -16.1291 43.1386 45.6921 12.6908 12.6908 12.6908 -16.1291 43.1386 46.6921 -150.499 -150.499 -150.499 -16.1291 44.1386 46.6921 95.0487 95.0487 95.0487 -16.1291 43.1386 47.6921 67.6115 67.6115 67.6115 -16.1291 43.1386 48.6921 374.164 374.164 374.164 -16.1291 44.1386 47.6921 -114.64 -114.64 -114.64 -17.1291 43.1386 47.6921 -4.20837 -4.20837 -4.20837 -17.1291 43.1386 48.6921 -26.7916 -26.7916 -26.7916 -17.1291 44.1386 47.6921 25.1071 25.1071 25.1071 -17.1291 44.1386 48.6921 148.877 148.877 148.877 -18.1291 41.1386 45.6921 -43.8952 -43.8952 -43.8952 -18.1291 41.1386 46.6921 -13.0826 -13.0826 -13.0826 -18.1291 42.1386 46.6921 -7.46651 -7.46651 -7.46651 -19.1291 41.1386 45.6921 7.38364 7.38364 7.38364 -19.1291 41.1386 46.6921 -5.29927 -5.29927 -5.29927 -19.1291 42.1386 46.6921 17.5262 17.5262 17.5262 -18.1291 41.1386 47.6921 3.92003 3.92003 3.92003 -18.1291 41.1386 48.6921 3.31918 3.31918 3.31918 -18.1291 42.1386 47.6921 -20.1211 -20.1211 -20.1211 -18.1291 42.1386 48.6921 -6.88716 -6.88716 -6.88716 -19.1291 41.1386 47.6921 38.3389 38.3389 38.3389 -19.1291 42.1386 47.6921 15.2193 15.2193 15.2193 -19.1291 42.1386 48.6921 18.2989 18.2989 18.2989 -18.1291 43.1386 46.6921 -5.06762 -5.06762 -5.06762 -18.1291 44.1386 46.6921 -8.89962 -8.89962 -8.89962 -19.1291 43.1386 46.6921 10.8196 10.8196 10.8196 -18.1291 43.1386 47.6921 0.834246 0.834246 0.834246 -18.1291 43.1386 48.6921 -229.552 -229.552 -229.552 -18.1291 44.1386 47.6921 28.766 28.766 28.766 -18.1291 44.1386 48.6921 382.682 382.682 382.682 -19.1291 43.1386 47.6921 -176.613 -176.613 -176.613 -19.1291 43.1386 48.6921 -163.572 -163.572 -163.572 -19.1291 44.1386 48.6921 215.666 215.666 215.666 -20.1291 37.1386 41.6921 7.50993 7.50993 7.50993 -20.1291 37.1386 42.6921 42.8326 42.8326 42.8326 -20.1291 38.1386 41.6921 11.6719 11.6719 11.6719 -20.1291 38.1386 42.6921 -50.4219 -50.4219 -50.4219 -21.1291 37.1386 41.6921 -20.641 -20.641 -20.641 -21.1291 37.1386 42.6921 -46.171 -46.171 -46.171 -21.1291 38.1386 41.6921 -17.1963 -17.1963 -17.1963 -21.1291 38.1386 42.6921 27.6984 27.6984 27.6984 -20.1291 38.1386 43.6921 -25.3681 -25.3681 -25.3681 -20.1291 38.1386 44.6921 -0.269312 -0.269312 -0.269312 -21.1291 37.1386 44.6921 58.8577 58.8577 58.8577 -21.1291 38.1386 43.6921 109.006 109.006 109.006 -21.1291 38.1386 44.6921 26.1982 26.1982 26.1982 -20.1291 39.1386 41.6921 1.99851 1.99851 1.99851 -20.1291 39.1386 42.6921 44.2261 44.2261 44.2261 -20.1291 40.1386 41.6921 11.4096 11.4096 11.4096 -20.1291 40.1386 42.6921 4.44952 4.44952 4.44952 -21.1291 39.1386 41.6921 -9.92085 -9.92085 -9.92085 -21.1291 39.1386 42.6921 -5.96887 -5.96887 -5.96887 -21.1291 40.1386 41.6921 -0.656841 -0.656841 -0.656841 -21.1291 40.1386 42.6921 32.874 32.874 32.874 -20.1291 39.1386 44.6921 -69.8239 -69.8239 -69.8239 -20.1291 40.1386 43.6921 -6.01182 -6.01182 -6.01182 -21.1291 39.1386 43.6921 53.8553 53.8553 53.8553 -21.1291 39.1386 44.6921 -68.6288 -68.6288 -68.6288 -21.1291 40.1386 43.6921 21.0431 21.0431 21.0431 -21.1291 40.1386 44.6921 0.167341 0.167341 0.167341 -22.1291 37.1386 42.6921 -33.9037 -33.9037 -33.9037 -22.1291 38.1386 41.6921 -7.87117 -7.87117 -7.87117 -22.1291 38.1386 42.6921 -14.8758 -14.8758 -14.8758 -23.1291 37.1386 42.6921 2.93128 2.93128 2.93128 -23.1291 38.1386 41.6921 -3.53756 -3.53756 -3.53756 -23.1291 38.1386 42.6921 4.03268 4.03268 4.03268 -22.1291 37.1386 43.6921 -16.5848 -16.5848 -16.5848 -22.1291 37.1386 44.6921 -11.1762 -11.1762 -11.1762 -22.1291 38.1386 43.6921 -28.543 -28.543 -28.543 -22.1291 38.1386 44.6921 22.0882 22.0882 22.0882 -23.1291 37.1386 43.6921 -1.86907 -1.86907 -1.86907 -23.1291 37.1386 44.6921 -105.385 -105.385 -105.385 -23.1291 38.1386 43.6921 -22.7951 -22.7951 -22.7951 -22.1291 39.1386 41.6921 23.5678 23.5678 23.5678 -22.1291 39.1386 42.6921 64.9706 64.9706 64.9706 -23.1291 39.1386 41.6921 39.54 39.54 39.54 -23.1291 39.1386 42.6921 15.7027 15.7027 15.7027 -22.1291 39.1386 43.6921 -18.2815 -18.2815 -18.2815 -22.1291 40.1386 43.6921 -10.0293 -10.0293 -10.0293 -22.1291 40.1386 44.6921 -14.3857 -14.3857 -14.3857 -23.1291 39.1386 43.6921 -38.084 -38.084 -38.084 -23.1291 39.1386 44.6921 -3.02673 -3.02673 -3.02673 -23.1291 40.1386 43.6921 -48.2112 -48.2112 -48.2112 -23.1291 40.1386 44.6921 10.5878 10.5878 10.5878 -20.1291 37.1386 45.6921 -12.2443 -12.2443 -12.2443 -20.1291 37.1386 46.6921 9.20655 9.20655 9.20655 -20.1291 38.1386 45.6921 13.4517 13.4517 13.4517 -20.1291 38.1386 46.6921 -0.545803 -0.545803 -0.545803 -21.1291 37.1386 45.6921 36.9814 36.9814 36.9814 -21.1291 37.1386 46.6921 4.77898 4.77898 4.77898 -21.1291 38.1386 45.6921 31.0301 31.0301 31.0301 -20.1291 37.1386 47.6921 20.7077 20.7077 20.7077 -20.1291 37.1386 48.6921 -20.1279 -20.1279 -20.1279 -20.1291 38.1386 47.6921 17.86 17.86 17.86 -20.1291 38.1386 48.6921 30.7538 30.7538 30.7538 -21.1291 37.1386 47.6921 -19.9361 -19.9361 -19.9361 -21.1291 37.1386 48.6921 -101.905 -101.905 -101.905 -21.1291 38.1386 47.6921 20.6193 20.6193 20.6193 -21.1291 38.1386 48.6921 -65.2062 -65.2062 -65.2062 -20.1291 39.1386 45.6921 13.2981 13.2981 13.2981 -20.1291 39.1386 46.6921 4.37424 4.37424 4.37424 -20.1291 40.1386 45.6921 49.5457 49.5457 49.5457 -20.1291 40.1386 46.6921 15.5656 15.5656 15.5656 -20.1291 39.1386 47.6921 6.00557 6.00557 6.00557 -20.1291 39.1386 48.6921 9.54334 9.54334 9.54334 -20.1291 40.1386 47.6921 -13.3302 -13.3302 -13.3302 -20.1291 40.1386 48.6921 -0.785891 -0.785891 -0.785891 -21.1291 39.1386 48.6921 -15.778 -15.778 -15.778 -21.1291 40.1386 47.6921 -65.0665 -65.0665 -65.0665 -21.1291 40.1386 48.6921 -9.88576 -9.88576 -9.88576 -22.1291 37.1386 45.6921 -58.2214 -58.2214 -58.2214 -23.1291 37.1386 45.6921 57.7938 57.7938 57.7938 -23.1291 37.1386 46.6921 201.809 201.809 201.809 -22.1291 37.1386 47.6921 -39.0903 -39.0903 -39.0903 -22.1291 37.1386 48.6921 12.7004 12.7004 12.7004 -22.1291 38.1386 47.6921 2.61934 2.61934 2.61934 -22.1291 38.1386 48.6921 -18.8892 -18.8892 -18.8892 -23.1291 37.1386 47.6921 96.2015 96.2015 96.2015 -23.1291 37.1386 48.6921 19.4948 19.4948 19.4948 -23.1291 38.1386 47.6921 77.8581 77.8581 77.8581 -23.1291 38.1386 48.6921 -51.0714 -51.0714 -51.0714 -22.1291 40.1386 46.6921 -96.1868 -96.1868 -96.1868 -23.1291 39.1386 46.6921 14.0087 14.0087 14.0087 -23.1291 40.1386 45.6921 -96.8976 -96.8976 -96.8976 -23.1291 40.1386 46.6921 -20.4454 -20.4454 -20.4454 -22.1291 39.1386 47.6921 -47.0757 -47.0757 -47.0757 -22.1291 39.1386 48.6921 -10.3577 -10.3577 -10.3577 -22.1291 40.1386 47.6921 -39.0506 -39.0506 -39.0506 -22.1291 40.1386 48.6921 -0.97511 -0.97511 -0.97511 -23.1291 39.1386 47.6921 155.478 155.478 155.478 -23.1291 39.1386 48.6921 -42.0529 -42.0529 -42.0529 -23.1291 40.1386 47.6921 74.3053 74.3053 74.3053 -23.1291 40.1386 48.6921 71.2931 71.2931 71.2931 -20.1291 41.1386 41.6921 1.75604 1.75604 1.75604 -20.1291 41.1386 42.6921 -4.55126 -4.55126 -4.55126 -20.1291 42.1386 41.6921 240.719 240.719 240.719 -20.1291 42.1386 42.6921 -244.975 -244.975 -244.975 -21.1291 41.1386 41.6921 -12.9345 -12.9345 -12.9345 -21.1291 41.1386 42.6921 -1.72081 -1.72081 -1.72081 -21.1291 42.1386 41.6921 206.997 206.997 206.997 -21.1291 42.1386 42.6921 -53.8552 -53.8552 -53.8552 -20.1291 41.1386 43.6921 10.8924 10.8924 10.8924 -20.1291 42.1386 43.6921 -79.9659 -79.9659 -79.9659 -21.1291 41.1386 43.6921 -0.167071 -0.167071 -0.167071 -21.1291 41.1386 44.6921 41.6774 41.6774 41.6774 -21.1291 42.1386 43.6921 -69.8889 -69.8889 -69.8889 -21.1291 42.1386 44.6921 0.570531 0.570531 0.570531 -20.1291 43.1386 42.6921 73.6323 73.6323 73.6323 -20.1291 44.1386 41.6921 -12.7469 -12.7469 -12.7469 -20.1291 44.1386 42.6921 174.044 174.044 174.044 -21.1291 43.1386 41.6921 -240.307 -240.307 -240.307 -21.1291 43.1386 42.6921 326.254 326.254 326.254 -21.1291 44.1386 41.6921 104.023 104.023 104.023 -21.1291 44.1386 42.6921 64.0085 64.0085 64.0085 -20.1291 43.1386 43.6921 -29.2394 -29.2394 -29.2394 -21.1291 43.1386 43.6921 40.4216 40.4216 40.4216 -21.1291 43.1386 44.6921 56.5882 56.5882 56.5882 -21.1291 44.1386 43.6921 -46.9934 -46.9934 -46.9934 -21.1291 44.1386 44.6921 113.517 113.517 113.517 -22.1291 41.1386 42.6921 76.9304 76.9304 76.9304 -22.1291 42.1386 41.6921 -147.92 -147.92 -147.92 -22.1291 42.1386 42.6921 124.47 124.47 124.47 -23.1291 42.1386 42.6921 91.1059 91.1059 91.1059 -22.1291 41.1386 43.6921 -45.889 -45.889 -45.889 -22.1291 41.1386 44.6921 16.4322 16.4322 16.4322 -22.1291 42.1386 43.6921 -186.435 -186.435 -186.435 -22.1291 42.1386 44.6921 -99.4654 -99.4654 -99.4654 -23.1291 41.1386 43.6921 -50.8906 -50.8906 -50.8906 -23.1291 41.1386 44.6921 -14.2228 -14.2228 -14.2228 -23.1291 42.1386 43.6921 -26.8411 -26.8411 -26.8411 -23.1291 42.1386 44.6921 139.166 139.166 139.166 -22.1291 43.1386 41.6921 -112.372 -112.372 -112.372 -22.1291 44.1386 41.6921 -739.613 -739.613 -739.613 -22.1291 44.1386 42.6921 -53.4685 -53.4685 -53.4685 -23.1291 43.1386 41.6921 -0.768486 -0.768486 -0.768486 -23.1291 43.1386 42.6921 126.158 126.158 126.158 -22.1291 43.1386 44.6921 19.1035 19.1035 19.1035 -22.1291 44.1386 43.6921 -282.735 -282.735 -282.735 -22.1291 44.1386 44.6921 -75.6789 -75.6789 -75.6789 -20.1291 41.1386 46.6921 -130.346 -130.346 -130.346 -20.1291 42.1386 45.6921 85.6715 85.6715 85.6715 -20.1291 42.1386 46.6921 0.199312 0.199312 0.199312 -21.1291 42.1386 45.6921 122.667 122.667 122.667 -21.1291 42.1386 46.6921 45.355 45.355 45.355 -20.1291 41.1386 47.6921 -37.0025 -37.0025 -37.0025 -20.1291 41.1386 48.6921 12.798 12.798 12.798 -20.1291 42.1386 47.6921 -37.4044 -37.4044 -37.4044 -20.1291 42.1386 48.6921 -157.308 -157.308 -157.308 -21.1291 41.1386 47.6921 -184.502 -184.502 -184.502 -21.1291 41.1386 48.6921 218.591 218.591 218.591 -21.1291 42.1386 47.6921 92.8903 92.8903 92.8903 -20.1291 43.1386 45.6921 40.5045 40.5045 40.5045 -20.1291 43.1386 46.6921 123.882 123.882 123.882 -20.1291 44.1386 45.6921 73.5375 73.5375 73.5375 -20.1291 44.1386 46.6921 22.5419 22.5419 22.5419 -21.1291 43.1386 45.6921 39.2346 39.2346 39.2346 -21.1291 43.1386 46.6921 14.435 14.435 14.435 -21.1291 44.1386 45.6921 -47.3773 -47.3773 -47.3773 -20.1291 43.1386 47.6921 -60.6952 -60.6952 -60.6952 -20.1291 43.1386 48.6921 -76.6634 -76.6634 -76.6634 -20.1291 44.1386 47.6921 53.7236 53.7236 53.7236 -20.1291 44.1386 48.6921 55.4172 55.4172 55.4172 -21.1291 44.1386 47.6921 -14.79 -14.79 -14.79 -22.1291 41.1386 45.6921 12.3915 12.3915 12.3915 -22.1291 41.1386 46.6921 40.4329 40.4329 40.4329 -22.1291 42.1386 45.6921 31.7828 31.7828 31.7828 -22.1291 42.1386 46.6921 -53.7753 -53.7753 -53.7753 -23.1291 41.1386 45.6921 -27.6181 -27.6181 -27.6181 -23.1291 41.1386 46.6921 81.7026 81.7026 81.7026 -22.1291 41.1386 47.6921 -256.948 -256.948 -256.948 -22.1291 41.1386 48.6921 -530.274 -530.274 -530.274 -22.1291 42.1386 47.6921 368.938 368.938 368.938 -23.1291 41.1386 48.6921 -292.647 -292.647 -292.647 -16.1291 37.1386 49.6921 -49.3589 -49.3589 -49.3589 -16.1291 37.1386 50.6921 1.51547 1.51547 1.51547 -16.1291 38.1386 50.6921 -24.9945 -24.9945 -24.9945 -17.1291 37.1386 49.6921 -26.1619 -26.1619 -26.1619 -17.1291 37.1386 50.6921 31.2085 31.2085 31.2085 -17.1291 38.1386 49.6921 43.9905 43.9905 43.9905 -17.1291 38.1386 50.6921 49.0959 49.0959 49.0959 -16.1291 39.1386 49.6921 -34.1146 -34.1146 -34.1146 -16.1291 39.1386 50.6921 -9.13669 -9.13669 -9.13669 -16.1291 40.1386 49.6921 -82.511 -82.511 -82.511 -16.1291 40.1386 50.6921 204.295 204.295 204.295 -17.1291 39.1386 49.6921 39.0595 39.0595 39.0595 -17.1291 39.1386 50.6921 12.0558 12.0558 12.0558 -17.1291 40.1386 50.6921 -0.770201 -0.770201 -0.770201 -18.1291 38.1386 49.6921 18.7355 18.7355 18.7355 -18.1291 39.1386 49.6921 -49.3105 -49.3105 -49.3105 -18.1291 39.1386 50.6921 -86.1974 -86.1974 -86.1974 -18.1291 40.1386 50.6921 -0.917731 -0.917731 -0.917731 -19.1291 39.1386 49.6921 14.2864 14.2864 14.2864 -19.1291 39.1386 50.6921 9.26352 9.26352 9.26352 -19.1291 40.1386 50.6921 51.6992 51.6992 51.6992 -16.1291 41.1386 49.6921 -139.827 -139.827 -139.827 -16.1291 41.1386 50.6921 1052.11 1052.11 1052.11 -16.1291 42.1386 49.6921 125.934 125.934 125.934 -16.1291 42.1386 50.6921 539.423 539.423 539.423 -17.1291 41.1386 50.6921 0.182839 0.182839 0.182839 -17.1291 42.1386 49.6921 -78.956 -78.956 -78.956 -17.1291 42.1386 50.6921 -53.4687 -53.4687 -53.4687 -16.1291 43.1386 49.6921 -114.63 -114.63 -114.63 -16.1291 43.1386 50.6921 -278.374 -278.374 -278.374 -17.1291 43.1386 49.6921 -211.681 -211.681 -211.681 -17.1291 43.1386 50.6921 -611.992 -611.992 -611.992 -18.1291 41.1386 49.6921 -5.92215 -5.92215 -5.92215 -18.1291 41.1386 50.6921 0.472891 0.472891 0.472891 -18.1291 42.1386 49.6921 -36.262 -36.262 -36.262 -18.1291 42.1386 50.6921 -9.32359 -9.32359 -9.32359 -19.1291 41.1386 50.6921 -13.3216 -13.3216 -13.3216 -19.1291 42.1386 49.6921 51.4293 51.4293 51.4293 -19.1291 42.1386 50.6921 -66.7374 -66.7374 -66.7374 -18.1291 43.1386 49.6921 -153.145 -153.145 -153.145 -18.1291 44.1386 49.6921 311.017 311.017 311.017 -19.1291 44.1386 49.6921 207.694 207.694 207.694 -21.1291 38.1386 49.6921 465.241 465.241 465.241 -20.1291 39.1386 49.6921 20.1028 20.1028 20.1028 -20.1291 39.1386 50.6921 -11.5544 -11.5544 -11.5544 -20.1291 40.1386 49.6921 15.6602 15.6602 15.6602 -20.1291 40.1386 50.6921 33.3569 33.3569 33.3569 -21.1291 39.1386 49.6921 5.22399 5.22399 5.22399 -21.1291 39.1386 50.6921 11.4223 11.4223 11.4223 -21.1291 40.1386 49.6921 -3.22565 -3.22565 -3.22565 -21.1291 40.1386 50.6921 -44.1512 -44.1512 -44.1512 -22.1291 37.1386 49.6921 -1108.11 -1108.11 -1108.11 -22.1291 38.1386 49.6921 -455.069 -455.069 -455.069 -22.1291 38.1386 50.6921 -474.544 -474.544 -474.544 -23.1291 37.1386 49.6921 6.10014 6.10014 6.10014 -23.1291 37.1386 50.6921 -171.439 -171.439 -171.439 -23.1291 38.1386 49.6921 94.775 94.775 94.775 -23.1291 38.1386 50.6921 -52.5064 -52.5064 -52.5064 -22.1291 39.1386 50.6921 -51.6977 -51.6977 -51.6977 -22.1291 40.1386 49.6921 -9.20421 -9.20421 -9.20421 -22.1291 40.1386 50.6921 -63.9701 -63.9701 -63.9701 -23.1291 39.1386 50.6921 128.949 128.949 128.949 -23.1291 40.1386 49.6921 43.8276 43.8276 43.8276 -23.1291 40.1386 50.6921 -39.8162 -39.8162 -39.8162 -20.1291 41.1386 49.6921 93.8286 93.8286 93.8286 -20.1291 41.1386 50.6921 -6.19651 -6.19651 -6.19651 -20.1291 42.1386 49.6921 167.895 167.895 167.895 -20.1291 42.1386 50.6921 -101.669 -101.669 -101.669 -21.1291 41.1386 49.6921 442.638 442.638 442.638 -20.1291 44.1386 49.6921 -128.08 -128.08 -128.08 -22.1291 41.1386 49.6921 927.049 927.049 927.049 -22.1291 41.1386 50.6921 -116.651 -116.651 -116.651 -23.1291 41.1386 49.6921 -140.074 -140.074 -140.074 -23.1291 41.1386 50.6921 -124.002 -124.002 -124.002 -16.1291 45.1386 41.6921 3040.31 3040.31 3040.31 -16.1291 45.1386 42.6921 -41.962 -41.962 -41.962 -16.1291 46.1386 41.6921 2558.56 2558.56 2558.56 -16.1291 46.1386 42.6921 806.311 806.311 806.311 -17.1291 45.1386 42.6921 -17.3928 -17.3928 -17.3928 -17.1291 46.1386 41.6921 220.062 220.062 220.062 -17.1291 46.1386 42.6921 -1491.61 -1491.61 -1491.61 -16.1291 45.1386 44.6921 -64.4389 -64.4389 -64.4389 -17.1291 45.1386 43.6921 -33.6723 -33.6723 -33.6723 -17.1291 45.1386 44.6921 -10.864 -10.864 -10.864 -17.1291 46.1386 43.6921 196.573 196.573 196.573 -17.1291 46.1386 44.6921 23.7751 23.7751 23.7751 -17.1291 47.1386 41.6921 4241.29 4241.29 4241.29 -17.1291 47.1386 42.6921 -998.074 -998.074 -998.074 -17.1291 48.1386 41.6921 2356.86 2356.86 2356.86 -17.1291 48.1386 42.6921 -1724.92 -1724.92 -1724.92 -17.1291 47.1386 43.6921 1015.23 1015.23 1015.23 -17.1291 47.1386 44.6921 45.8085 45.8085 45.8085 -17.1291 48.1386 43.6921 1368.14 1368.14 1368.14 -17.1291 48.1386 44.6921 4.75952 4.75952 4.75952 -18.1291 45.1386 41.6921 106.764 106.764 106.764 -18.1291 45.1386 42.6921 -7.35441 -7.35441 -7.35441 -18.1291 46.1386 41.6921 1320.65 1320.65 1320.65 -18.1291 46.1386 42.6921 1138.85 1138.85 1138.85 -19.1291 45.1386 41.6921 235.303 235.303 235.303 -19.1291 45.1386 42.6921 100.042 100.042 100.042 -19.1291 46.1386 41.6921 265.115 265.115 265.115 -19.1291 46.1386 42.6921 -149.748 -149.748 -149.748 -18.1291 45.1386 43.6921 -47.4233 -47.4233 -47.4233 -18.1291 46.1386 43.6921 -535.522 -535.522 -535.522 -18.1291 46.1386 44.6921 9.99 9.99 9.99 -19.1291 45.1386 43.6921 6.54506 6.54506 6.54506 -19.1291 45.1386 44.6921 49.9789 49.9789 49.9789 -19.1291 46.1386 43.6921 -34.9851 -34.9851 -34.9851 -19.1291 46.1386 44.6921 132.858 132.858 132.858 -18.1291 47.1386 41.6921 -620.226 -620.226 -620.226 -18.1291 48.1386 41.6921 -162.369 -162.369 -162.369 -19.1291 47.1386 41.6921 124.429 124.429 124.429 -19.1291 48.1386 41.6921 -3566.05 -3566.05 -3566.05 -18.1291 47.1386 43.6921 73.8593 73.8593 73.8593 -18.1291 47.1386 44.6921 24.859 24.859 24.859 -18.1291 48.1386 44.6921 -36.2454 -36.2454 -36.2454 -19.1291 47.1386 43.6921 -216.735 -216.735 -216.735 -19.1291 47.1386 44.6921 -39.6156 -39.6156 -39.6156 -19.1291 48.1386 43.6921 151.112 151.112 151.112 -19.1291 48.1386 44.6921 -98.6342 -98.6342 -98.6342 -16.1291 45.1386 45.6921 -40.2724 -40.2724 -40.2724 -16.1291 45.1386 46.6921 -92.226 -92.226 -92.226 -16.1291 46.1386 45.6921 -26.1258 -26.1258 -26.1258 -16.1291 46.1386 46.6921 -40.3253 -40.3253 -40.3253 -17.1291 45.1386 45.6921 9.04658 9.04658 9.04658 -17.1291 45.1386 46.6921 -47.5801 -47.5801 -47.5801 -17.1291 46.1386 45.6921 -26.6428 -26.6428 -26.6428 -16.1291 45.1386 47.6921 101.689 101.689 101.689 -16.1291 46.1386 47.6921 10.3116 10.3116 10.3116 -17.1291 45.1386 47.6921 28.9764 28.9764 28.9764 -17.1291 45.1386 48.6921 179.55 179.55 179.55 -17.1291 46.1386 47.6921 -13.897 -13.897 -13.897 -17.1291 46.1386 48.6921 10.8982 10.8982 10.8982 -16.1291 47.1386 45.6921 0.187626 0.187626 0.187626 -16.1291 47.1386 46.6921 -24.9381 -24.9381 -24.9381 -16.1291 48.1386 45.6921 12.0398 12.0398 12.0398 -16.1291 48.1386 46.6921 -4.18076 -4.18076 -4.18076 -17.1291 47.1386 45.6921 -54.8237 -54.8237 -54.8237 -17.1291 48.1386 45.6921 19.1948 19.1948 19.1948 -17.1291 48.1386 46.6921 -20.2168 -20.2168 -20.2168 -16.1291 47.1386 47.6921 52.7104 52.7104 52.7104 -16.1291 48.1386 47.6921 8.22363 8.22363 8.22363 -17.1291 47.1386 47.6921 14.9227 14.9227 14.9227 -17.1291 47.1386 48.6921 -51.5212 -51.5212 -51.5212 -17.1291 48.1386 47.6921 57.1483 57.1483 57.1483 -18.1291 46.1386 45.6921 13.6085 13.6085 13.6085 -19.1291 46.1386 45.6921 -36.5664 -36.5664 -36.5664 -18.1291 45.1386 48.6921 224.679 224.679 224.679 -18.1291 46.1386 48.6921 22.9455 22.9455 22.9455 -19.1291 45.1386 48.6921 234.599 234.599 234.599 -19.1291 46.1386 47.6921 -115.442 -115.442 -115.442 -19.1291 46.1386 48.6921 25.8807 25.8807 25.8807 -18.1291 47.1386 45.6921 -66.1876 -66.1876 -66.1876 -18.1291 48.1386 45.6921 -53.5359 -53.5359 -53.5359 -18.1291 48.1386 46.6921 4.72038 4.72038 4.72038 -19.1291 47.1386 45.6921 20.6097 20.6097 20.6097 -19.1291 47.1386 46.6921 -140.503 -140.503 -140.503 -19.1291 48.1386 45.6921 -41.5733 -41.5733 -41.5733 -19.1291 48.1386 46.6921 11.6412 11.6412 11.6412 -18.1291 47.1386 47.6921 38.7208 38.7208 38.7208 -18.1291 47.1386 48.6921 -89.9543 -89.9543 -89.9543 -18.1291 48.1386 47.6921 135.321 135.321 135.321 -19.1291 47.1386 47.6921 -118.359 -118.359 -118.359 -19.1291 48.1386 47.6921 23.5897 23.5897 23.5897 -17.1291 49.1386 41.6921 -2085.58 -2085.58 -2085.58 -17.1291 49.1386 42.6921 -219.378 -219.378 -219.378 -17.1291 50.1386 41.6921 -2422.66 -2422.66 -2422.66 -17.1291 50.1386 42.6921 -2425.15 -2425.15 -2425.15 -17.1291 49.1386 43.6921 -1541.29 -1541.29 -1541.29 -17.1291 49.1386 44.6921 24.4898 24.4898 24.4898 -17.1291 50.1386 43.6921 180.729 180.729 180.729 -18.1291 49.1386 41.6921 476.546 476.546 476.546 -18.1291 50.1386 41.6921 -6801.34 -6801.34 -6801.34 -18.1291 50.1386 42.6921 -754.855 -754.855 -754.855 -19.1291 49.1386 41.6921 -1120.71 -1120.71 -1120.71 -19.1291 50.1386 41.6921 2173.6 2173.6 2173.6 -19.1291 50.1386 42.6921 -1832.24 -1832.24 -1832.24 -18.1291 49.1386 43.6921 1775.0 1775.0 1775.0 -18.1291 49.1386 44.6921 -33.6107 -33.6107 -33.6107 -18.1291 50.1386 43.6921 74.0953 74.0953 74.0953 -18.1291 50.1386 44.6921 -228.028 -228.028 -228.028 -19.1291 50.1386 44.6921 -2.26948 -2.26948 -2.26948 -18.1291 51.1386 41.6921 -10425.2 -10425.2 -10425.2 -18.1291 51.1386 42.6921 -1308.55 -1308.55 -1308.55 -18.1291 52.1386 42.6921 1159.84 1159.84 1159.84 -19.1291 51.1386 41.6921 5373.86 5373.86 5373.86 -19.1291 51.1386 42.6921 2251.03 2251.03 2251.03 -19.1291 52.1386 41.6921 1595.71 1595.71 1595.71 -19.1291 52.1386 42.6921 1023.03 1023.03 1023.03 -18.1291 51.1386 43.6921 -723.478 -723.478 -723.478 -18.1291 51.1386 44.6921 -37.1996 -37.1996 -37.1996 -18.1291 52.1386 43.6921 -911.466 -911.466 -911.466 -18.1291 52.1386 44.6921 54.7168 54.7168 54.7168 -19.1291 51.1386 44.6921 -81.2588 -81.2588 -81.2588 -19.1291 52.1386 43.6921 -615.568 -615.568 -615.568 -19.1291 52.1386 44.6921 0.443931 0.443931 0.443931 -18.1291 49.1386 45.6921 51.2696 51.2696 51.2696 -18.1291 50.1386 45.6921 25.6005 25.6005 25.6005 -19.1291 49.1386 45.6921 38.8163 38.8163 38.8163 -19.1291 49.1386 46.6921 96.5908 96.5908 96.5908 -19.1291 50.1386 45.6921 84.8354 84.8354 84.8354 -19.1291 50.1386 46.6921 -7.38533 -7.38533 -7.38533 -19.1291 51.1386 45.6921 -2.30069 -2.30069 -2.30069 -19.1291 52.1386 45.6921 44.6815 44.6815 44.6815 -20.1291 45.1386 41.6921 526.891 526.891 526.891 -20.1291 46.1386 41.6921 163.912 163.912 163.912 -21.1291 45.1386 41.6921 -27.0592 -27.0592 -27.0592 -21.1291 46.1386 41.6921 -72.4003 -72.4003 -72.4003 -20.1291 45.1386 43.6921 -44.6437 -44.6437 -44.6437 -20.1291 45.1386 44.6921 45.3111 45.3111 45.3111 -20.1291 46.1386 43.6921 55.6443 55.6443 55.6443 -20.1291 46.1386 44.6921 80.5523 80.5523 80.5523 -21.1291 45.1386 43.6921 13.8147 13.8147 13.8147 -21.1291 45.1386 44.6921 -32.0126 -32.0126 -32.0126 -21.1291 46.1386 43.6921 278.587 278.587 278.587 -20.1291 47.1386 41.6921 310.919 310.919 310.919 -20.1291 47.1386 42.6921 1480.86 1480.86 1480.86 -20.1291 48.1386 41.6921 -2259.58 -2259.58 -2259.58 -20.1291 48.1386 42.6921 -1194.26 -1194.26 -1194.26 -21.1291 47.1386 41.6921 -2054.3 -2054.3 -2054.3 -21.1291 47.1386 42.6921 -1150.42 -1150.42 -1150.42 -21.1291 48.1386 41.6921 539.114 539.114 539.114 -21.1291 48.1386 42.6921 -2169.13 -2169.13 -2169.13 -20.1291 47.1386 43.6921 534.815 534.815 534.815 -20.1291 47.1386 44.6921 -59.3378 -59.3378 -59.3378 -20.1291 48.1386 43.6921 -632.279 -632.279 -632.279 -21.1291 47.1386 43.6921 587.342 587.342 587.342 -21.1291 47.1386 44.6921 -16.1893 -16.1893 -16.1893 -21.1291 48.1386 43.6921 291.245 291.245 291.245 -21.1291 48.1386 44.6921 -19.3913 -19.3913 -19.3913 -22.1291 45.1386 41.6921 -1077.04 -1077.04 -1077.04 -22.1291 45.1386 42.6921 115.462 115.462 115.462 -22.1291 46.1386 41.6921 -123.998 -123.998 -123.998 -22.1291 46.1386 42.6921 -609.464 -609.464 -609.464 -23.1291 46.1386 41.6921 859.305 859.305 859.305 -22.1291 45.1386 43.6921 -36.2012 -36.2012 -36.2012 -22.1291 46.1386 43.6921 -298.646 -298.646 -298.646 -22.1291 47.1386 41.6921 1978.22 1978.22 1978.22 -22.1291 47.1386 42.6921 125.953 125.953 125.953 -23.1291 47.1386 41.6921 1657.23 1657.23 1657.23 -23.1291 48.1386 41.6921 -50.3415 -50.3415 -50.3415 -22.1291 48.1386 44.6921 249.48 249.48 249.48 -20.1291 45.1386 45.6921 55.6045 55.6045 55.6045 -20.1291 45.1386 46.6921 -226.217 -226.217 -226.217 -20.1291 46.1386 45.6921 68.175 68.175 68.175 -20.1291 46.1386 46.6921 -248.212 -248.212 -248.212 -21.1291 45.1386 45.6921 22.6371 22.6371 22.6371 -20.1291 45.1386 47.6921 -86.1098 -86.1098 -86.1098 -20.1291 45.1386 48.6921 -48.3227 -48.3227 -48.3227 -20.1291 46.1386 47.6921 -58.82 -58.82 -58.82 -20.1291 46.1386 48.6921 23.478 23.478 23.478 -21.1291 45.1386 47.6921 2.14576 2.14576 2.14576 -20.1291 47.1386 45.6921 33.9956 33.9956 33.9956 -20.1291 47.1386 46.6921 170.783 170.783 170.783 -20.1291 48.1386 45.6921 -387.23 -387.23 -387.23 -20.1291 48.1386 46.6921 -99.7035 -99.7035 -99.7035 -21.1291 47.1386 45.6921 -190.133 -190.133 -190.133 -21.1291 48.1386 45.6921 32.8845 32.8845 32.8845 -21.1291 48.1386 46.6921 86.9394 86.9394 86.9394 -22.1291 48.1386 45.6921 -84.1221 -84.1221 -84.1221 -20.1291 49.1386 41.6921 -299.977 -299.977 -299.977 -20.1291 50.1386 41.6921 -2905.34 -2905.34 -2905.34 -20.1291 50.1386 42.6921 -2778.36 -2778.36 -2778.36 -21.1291 49.1386 41.6921 -1177.41 -1177.41 -1177.41 -21.1291 49.1386 42.6921 285.577 285.577 285.577 -21.1291 50.1386 41.6921 1666.06 1666.06 1666.06 -21.1291 50.1386 42.6921 2611.18 2611.18 2611.18 -20.1291 50.1386 44.6921 29.2085 29.2085 29.2085 -21.1291 49.1386 43.6921 562.289 562.289 562.289 -21.1291 49.1386 44.6921 150.425 150.425 150.425 -21.1291 50.1386 43.6921 1705.94 1705.94 1705.94 -21.1291 50.1386 44.6921 76.0165 76.0165 76.0165 -20.1291 51.1386 41.6921 -3679.16 -3679.16 -3679.16 -20.1291 51.1386 42.6921 5901.53 5901.53 5901.53 -20.1291 52.1386 41.6921 494.251 494.251 494.251 -20.1291 52.1386 42.6921 -261.61 -261.61 -261.61 -21.1291 51.1386 41.6921 -2369.5 -2369.5 -2369.5 -21.1291 51.1386 42.6921 -1878.39 -1878.39 -1878.39 -21.1291 52.1386 42.6921 -850.455 -850.455 -850.455 -20.1291 51.1386 44.6921 64.838 64.838 64.838 -20.1291 52.1386 43.6921 -368.86 -368.86 -368.86 -20.1291 52.1386 44.6921 9.65484 9.65484 9.65484 -21.1291 51.1386 43.6921 -1339.47 -1339.47 -1339.47 -21.1291 51.1386 44.6921 15.0108 15.0108 15.0108 -21.1291 52.1386 43.6921 -478.164 -478.164 -478.164 -21.1291 52.1386 44.6921 -14.0364 -14.0364 -14.0364 -22.1291 49.1386 44.6921 16.2209 16.2209 16.2209 -22.1291 50.1386 44.6921 -386.521 -386.521 -386.521 -20.1291 49.1386 46.6921 -106.269 -106.269 -106.269 -20.1291 50.1386 45.6921 -71.8655 -71.8655 -71.8655 -20.1291 50.1386 46.6921 54.1903 54.1903 54.1903 -21.1291 49.1386 45.6921 145.768 145.768 145.768 -21.1291 49.1386 46.6921 62.2287 62.2287 62.2287 -21.1291 50.1386 45.6921 19.5068 19.5068 19.5068 -21.1291 50.1386 46.6921 -46.6167 -46.6167 -46.6167 -20.1291 51.1386 45.6921 -35.685 -35.685 -35.685 -20.1291 52.1386 45.6921 47.6983 47.6983 47.6983 -22.1291 49.1386 45.6921 383.292 383.292 383.292 -18.1291 45.1386 49.6921 311.742 311.742 311.742 -19.1291 45.1386 49.6921 -92.5965 -92.5965 -92.5965 -20.1291 45.1386 49.6921 -78.2489 -78.2489 -78.2489 -27.1291 24.138599999999997 28.692100000000003 -204.662 -204.662 -204.662 -27.1291 22.138599999999997 31.692100000000003 7.64056 7.64056 7.64056 -27.1291 22.138599999999997 32.6921 -106.482 -106.482 -106.482 -26.1291 24.138599999999997 29.692100000000003 -60.6878 -60.6878 -60.6878 -26.1291 24.138599999999997 30.692100000000003 214.907 214.907 214.907 -27.1291 23.138599999999997 29.692100000000003 -81.7099 -81.7099 -81.7099 -27.1291 23.138599999999997 30.692100000000003 202.726 202.726 202.726 -27.1291 24.138599999999997 29.692100000000003 -180.795 -180.795 -180.795 -27.1291 24.138599999999997 30.692100000000003 -138.682 -138.682 -138.682 -26.1291 23.138599999999997 31.692100000000003 1.24022 1.24022 1.24022 -26.1291 23.138599999999997 32.6921 -2.6539 -2.6539 -2.6539 -26.1291 24.138599999999997 31.692100000000003 161.105 161.105 161.105 -26.1291 24.138599999999997 32.6921 35.4383 35.4383 35.4383 -27.1291 23.138599999999997 31.692100000000003 193.65 193.65 193.65 -27.1291 23.138599999999997 32.6921 -67.5374 -67.5374 -67.5374 -27.1291 24.138599999999997 31.692100000000003 -3.93626 -3.93626 -3.93626 -26.1291 25.138599999999997 28.692100000000003 -332.575 -332.575 -332.575 -26.1291 26.138599999999997 28.692100000000003 -259.928 -259.928 -259.928 -27.1291 25.138599999999997 28.692100000000003 453.853 453.853 453.853 -27.1291 26.138599999999997 28.692100000000003 -136.966 -136.966 -136.966 -26.1291 27.138599999999997 28.692100000000003 206.318 206.318 206.318 -27.1291 27.138599999999997 28.692100000000003 85.0815 85.0815 85.0815 -25.1291 25.138599999999997 30.692100000000003 2766.28 2766.28 2766.28 -25.1291 26.138599999999997 30.692100000000003 265.468 265.468 265.468 -25.1291 25.138599999999997 31.692100000000003 239.221 239.221 239.221 -25.1291 26.138599999999997 31.692100000000003 200.342 200.342 200.342 -25.1291 26.138599999999997 32.6921 -351.227 -351.227 -351.227 -25.1291 27.138599999999997 30.692100000000003 -2733.39 -2733.39 -2733.39 -25.1291 28.138599999999997 29.692100000000003 20.0934 20.0934 20.0934 -25.1291 28.138599999999997 30.692100000000003 179.18 179.18 179.18 -24.1291 27.138599999999997 32.6921 -110.79 -110.79 -110.79 -24.1291 28.138599999999997 31.692100000000003 245.788 245.788 245.788 -24.1291 28.138599999999997 32.6921 44.8932 44.8932 44.8932 -25.1291 27.138599999999997 31.692100000000003 144.662 144.662 144.662 -25.1291 27.138599999999997 32.6921 -140.521 -140.521 -140.521 -25.1291 28.138599999999997 31.692100000000003 804.176 804.176 804.176 -25.1291 28.138599999999997 32.6921 -3831.13 -3831.13 -3831.13 -26.1291 25.138599999999997 29.692100000000003 87.8613 87.8613 87.8613 -26.1291 25.138599999999997 30.692100000000003 -43.0879 -43.0879 -43.0879 -26.1291 26.138599999999997 29.692100000000003 -138.84 -138.84 -138.84 -26.1291 26.138599999999997 30.692100000000003 -9.61773 -9.61773 -9.61773 -27.1291 25.138599999999997 29.692100000000003 -229.168 -229.168 -229.168 -26.1291 25.138599999999997 31.692100000000003 108.501 108.501 108.501 -26.1291 25.138599999999997 32.6921 -98.8072 -98.8072 -98.8072 -26.1291 26.138599999999997 31.692100000000003 -352.413 -352.413 -352.413 -26.1291 26.138599999999997 32.6921 -331.879 -331.879 -331.879 -26.1291 27.138599999999997 29.692100000000003 -63.1536 -63.1536 -63.1536 -26.1291 27.138599999999997 30.692100000000003 -74.3181 -74.3181 -74.3181 -26.1291 28.138599999999997 29.692100000000003 -1.83543 -1.83543 -1.83543 -26.1291 28.138599999999997 30.692100000000003 -24.0919 -24.0919 -24.0919 -27.1291 27.138599999999997 29.692100000000003 52.0346 52.0346 52.0346 -27.1291 27.138599999999997 30.692100000000003 -80.8942 -80.8942 -80.8942 -27.1291 28.138599999999997 30.692100000000003 -2245.02 -2245.02 -2245.02 -26.1291 27.138599999999997 31.692100000000003 -5.73276 -5.73276 -5.73276 -26.1291 28.138599999999997 31.692100000000003 4349.52 4349.52 4349.52 -27.1291 28.138599999999997 31.692100000000003 4957.67 4957.67 4957.67 -27.1291 28.138599999999997 32.6921 -6315.44 -6315.44 -6315.44 -28.1291 24.138599999999997 28.692100000000003 127.936 127.936 127.936 -29.1291 24.138599999999997 28.692100000000003 -28.6801 -28.6801 -28.6801 -28.1291 22.138599999999997 31.692100000000003 -91.4306 -91.4306 -91.4306 -28.1291 22.138599999999997 32.6921 72.9792 72.9792 72.9792 -28.1291 23.138599999999997 29.692100000000003 142.888 142.888 142.888 -28.1291 23.138599999999997 30.692100000000003 518.035 518.035 518.035 -28.1291 24.138599999999997 29.692100000000003 185.63 185.63 185.63 -28.1291 24.138599999999997 30.692100000000003 -296.7 -296.7 -296.7 -29.1291 24.138599999999997 29.692100000000003 138.454 138.454 138.454 -29.1291 24.138599999999997 30.692100000000003 -194.837 -194.837 -194.837 -28.1291 23.138599999999997 31.692100000000003 -50.2291 -50.2291 -50.2291 -28.1291 23.138599999999997 32.6921 41.1593 41.1593 41.1593 -28.1291 24.138599999999997 31.692100000000003 -213.839 -213.839 -213.839 -28.1291 24.138599999999997 32.6921 -386.722 -386.722 -386.722 -29.1291 23.138599999999997 31.692100000000003 82.2689 82.2689 82.2689 -29.1291 23.138599999999997 32.6921 425.792 425.792 425.792 -29.1291 24.138599999999997 31.692100000000003 75.9417 75.9417 75.9417 -29.1291 24.138599999999997 32.6921 349.607 349.607 349.607 -28.1291 25.138599999999997 28.692100000000003 141.765 141.765 141.765 -28.1291 26.138599999999997 28.692100000000003 1476.1 1476.1 1476.1 -29.1291 25.138599999999997 28.692100000000003 -86.2816 -86.2816 -86.2816 -28.1291 27.138599999999997 28.692100000000003 -1869.94 -1869.94 -1869.94 -28.1291 25.138599999999997 29.692100000000003 110.047 110.047 110.047 -28.1291 25.138599999999997 30.692100000000003 -141.806 -141.806 -141.806 -28.1291 26.138599999999997 29.692100000000003 -1119.58 -1119.58 -1119.58 -28.1291 26.138599999999997 30.692100000000003 280.228 280.228 280.228 -29.1291 25.138599999999997 29.692100000000003 -107.599 -107.599 -107.599 -29.1291 25.138599999999997 30.692100000000003 -300.141 -300.141 -300.141 -29.1291 26.138599999999997 29.692100000000003 369.517 369.517 369.517 -29.1291 26.138599999999997 30.692100000000003 133.946 133.946 133.946 -28.1291 25.138599999999997 31.692100000000003 596.429 596.429 596.429 -28.1291 25.138599999999997 32.6921 32.0494 32.0494 32.0494 -28.1291 26.138599999999997 31.692100000000003 331.446 331.446 331.446 -28.1291 26.138599999999997 32.6921 228.029 228.029 228.029 -29.1291 25.138599999999997 31.692100000000003 327.522 327.522 327.522 -29.1291 25.138599999999997 32.6921 138.468 138.468 138.468 -29.1291 26.138599999999997 31.692100000000003 -26.2201 -26.2201 -26.2201 -29.1291 26.138599999999997 32.6921 394.809 394.809 394.809 -28.1291 27.138599999999997 29.692100000000003 -1058.52 -1058.52 -1058.52 -28.1291 27.138599999999997 30.692100000000003 670.145 670.145 670.145 -28.1291 28.138599999999997 30.692100000000003 8982.16 8982.16 8982.16 -28.1291 27.138599999999997 31.692100000000003 2.134 2.134 2.134 -28.1291 27.138599999999997 32.6921 -160.688 -160.688 -160.688 -28.1291 28.138599999999997 31.692100000000003 -6195.34 -6195.34 -6195.34 -28.1291 28.138599999999997 32.6921 -9977.33 -9977.33 -9977.33 -26.1291 23.138599999999997 33.6921 43209.9 43209.9 43209.9 -26.1291 24.138599999999997 33.6921 468857.0 468857.0 468857.0 -26.1291 24.138599999999997 34.6921 287187.0 287187.0 287187.0 -27.1291 23.138599999999997 33.6921 -376627.0 -376627.0 -376627.0 -27.1291 24.138599999999997 33.6921 -340488.0 -340488.0 -340488.0 -27.1291 24.138599999999997 34.6921 -82704.0 -82704.0 -82704.0 -25.1291 26.138599999999997 33.6921 -99.7897 -99.7897 -99.7897 -25.1291 26.138599999999997 34.6921 -90.7195 -90.7195 -90.7195 -24.1291 27.138599999999997 33.6921 228.744 228.744 228.744 -24.1291 28.138599999999997 33.6921 -89.1617 -89.1617 -89.1617 -24.1291 28.138599999999997 34.6921 340.827 340.827 340.827 -25.1291 27.138599999999997 33.6921 426.876 426.876 426.876 -25.1291 27.138599999999997 34.6921 544.275 544.275 544.275 -25.1291 28.138599999999997 33.6921 1258.25 1258.25 1258.25 -25.1291 28.138599999999997 34.6921 2277.47 2277.47 2277.47 -25.1291 28.138599999999997 35.6921 624.017 624.017 624.017 -26.1291 25.138599999999997 33.6921 -130.998 -130.998 -130.998 -26.1291 25.138599999999997 34.6921 -78.814 -78.814 -78.814 -26.1291 26.138599999999997 33.6921 -232.377 -232.377 -232.377 -26.1291 26.138599999999997 34.6921 -214.524 -214.524 -214.524 -27.1291 25.138599999999997 33.6921 -203.095 -203.095 -203.095 -27.1291 25.138599999999997 34.6921 -99.4421 -99.4421 -99.4421 -27.1291 26.138599999999997 33.6921 -199.322 -199.322 -199.322 -27.1291 26.138599999999997 34.6921 456.952 456.952 456.952 -26.1291 27.138599999999997 34.6921 -1887.24 -1887.24 -1887.24 -26.1291 28.138599999999997 34.6921 10295.7 10295.7 10295.7 -27.1291 27.138599999999997 34.6921 3029.88 3029.88 3029.88 -27.1291 28.138599999999997 34.6921 1831.26 1831.26 1831.26 -26.1291 28.138599999999997 35.6921 -3293.59 -3293.59 -3293.59 -27.1291 28.138599999999997 35.6921 4890.97 4890.97 4890.97 -28.1291 23.138599999999997 33.6921 148.134 148.134 148.134 -28.1291 24.138599999999997 33.6921 66.6674 66.6674 66.6674 -28.1291 24.138599999999997 34.6921 -232.764 -232.764 -232.764 -29.1291 24.138599999999997 33.6921 366.946 366.946 366.946 -28.1291 25.138599999999997 33.6921 -332.844 -332.844 -332.844 -28.1291 25.138599999999997 34.6921 -114.187 -114.187 -114.187 -28.1291 26.138599999999997 33.6921 -258.965 -258.965 -258.965 -28.1291 26.138599999999997 34.6921 -155.178 -155.178 -155.178 -29.1291 25.138599999999997 33.6921 -354.642 -354.642 -354.642 -28.1291 27.138599999999997 33.6921 -621.667 -621.667 -621.667 -28.1291 27.138599999999997 34.6921 -622.279 -622.279 -622.279 -28.1291 28.138599999999997 33.6921 2428.02 2428.02 2428.02 -28.1291 28.138599999999997 34.6921 -785.229 -785.229 -785.229 -25.1291 29.138599999999997 28.692100000000003 -6525.27 -6525.27 -6525.27 -25.1291 30.138599999999997 28.692100000000003 2289.27 2289.27 2289.27 -25.1291 31.138599999999997 28.692100000000003 3565.34 3565.34 3565.34 -26.1291 29.138599999999997 28.692100000000003 -687.894 -687.894 -687.894 -26.1291 30.138599999999997 28.692100000000003 -6708.98 -6708.98 -6708.98 -27.1291 29.138599999999997 28.692100000000003 -225.892 -225.892 -225.892 -27.1291 30.138599999999997 28.692100000000003 -7080.79 -7080.79 -7080.79 -26.1291 31.138599999999997 28.692100000000003 -4864.26 -4864.26 -4864.26 -24.1291 29.138599999999997 29.692100000000003 2314.55 2314.55 2314.55 -24.1291 29.138599999999997 30.692100000000003 4204.84 4204.84 4204.84 -24.1291 30.138599999999997 29.692100000000003 -2775.7 -2775.7 -2775.7 -24.1291 30.138599999999997 30.692100000000003 1576.99 1576.99 1576.99 -25.1291 29.138599999999997 29.692100000000003 -3120.61 -3120.61 -3120.61 -25.1291 29.138599999999997 30.692100000000003 5842.07 5842.07 5842.07 -25.1291 30.138599999999997 29.692100000000003 2104.9 2104.9 2104.9 -24.1291 29.138599999999997 31.692100000000003 333.225 333.225 333.225 -24.1291 30.138599999999997 31.692100000000003 1185.49 1185.49 1185.49 -25.1291 29.138599999999997 31.692100000000003 105.421 105.421 105.421 -24.1291 31.138599999999997 29.692100000000003 -3412.37 -3412.37 -3412.37 -24.1291 31.138599999999997 30.692100000000003 -3077.4 -3077.4 -3077.4 -24.1291 32.1386 30.692100000000003 -184.041 -184.041 -184.041 -25.1291 31.138599999999997 29.692100000000003 840.982 840.982 840.982 -25.1291 31.138599999999997 30.692100000000003 -3018.79 -3018.79 -3018.79 -25.1291 32.1386 30.692100000000003 -1277.6 -1277.6 -1277.6 -24.1291 32.1386 31.692100000000003 245.2 245.2 245.2 -24.1291 32.1386 32.6921 386.905 386.905 386.905 -25.1291 32.1386 31.692100000000003 -307.498 -307.498 -307.498 -25.1291 32.1386 32.6921 1008.13 1008.13 1008.13 -26.1291 29.138599999999997 29.692100000000003 -701.451 -701.451 -701.451 -26.1291 29.138599999999997 30.692100000000003 -0.37339 -0.37339 -0.37339 -26.1291 30.138599999999997 29.692100000000003 5934.98 5934.98 5934.98 -27.1291 29.138599999999997 29.692100000000003 311.809 311.809 311.809 -27.1291 29.138599999999997 30.692100000000003 1463.73 1463.73 1463.73 -27.1291 30.138599999999997 29.692100000000003 8618.21 8618.21 8618.21 -27.1291 30.138599999999997 30.692100000000003 0.217224 0.217224 0.217224 -26.1291 29.138599999999997 31.692100000000003 -3069.88 -3069.88 -3069.88 -26.1291 30.138599999999997 32.6921 -3033.23 -3033.23 -3033.23 -27.1291 29.138599999999997 31.692100000000003 3438.92 3438.92 3438.92 -27.1291 29.138599999999997 32.6921 -874.479 -874.479 -874.479 -27.1291 30.138599999999997 31.692100000000003 3220.3 3220.3 3220.3 -27.1291 30.138599999999997 32.6921 -4150.2 -4150.2 -4150.2 -26.1291 31.138599999999997 29.692100000000003 1249.56 1249.56 1249.56 -26.1291 32.1386 29.692100000000003 -9607.98 -9607.98 -9607.98 -26.1291 32.1386 30.692100000000003 -9149.24 -9149.24 -9149.24 -27.1291 31.138599999999997 29.692100000000003 -211.055 -211.055 -211.055 -27.1291 31.138599999999997 30.692100000000003 16038.7 16038.7 16038.7 -27.1291 32.1386 30.692100000000003 548.168 548.168 548.168 -26.1291 31.138599999999997 32.6921 1560.36 1560.36 1560.36 -26.1291 32.1386 31.692100000000003 5240.85 5240.85 5240.85 -26.1291 32.1386 32.6921 3338.18 3338.18 3338.18 -27.1291 31.138599999999997 31.692100000000003 -15477.0 -15477.0 -15477.0 -27.1291 31.138599999999997 32.6921 -1847.85 -1847.85 -1847.85 -27.1291 32.1386 31.692100000000003 5001.06 5001.06 5001.06 -27.1291 32.1386 32.6921 -304.467 -304.467 -304.467 -24.1291 36.1386 27.692100000000003 -285.037 -285.037 -285.037 -24.1291 36.1386 28.692100000000003 262.905 262.905 262.905 -24.1291 33.1386 31.692100000000003 -32.5425 -32.5425 -32.5425 -24.1291 33.1386 32.6921 147.512 147.512 147.512 -24.1291 34.1386 32.6921 4.83007 4.83007 4.83007 -25.1291 33.1386 32.6921 445.855 445.855 445.855 -24.1291 35.1386 29.692100000000003 -23.1761 -23.1761 -23.1761 -24.1291 36.1386 29.692100000000003 118.6 118.6 118.6 -24.1291 36.1386 30.692100000000003 8.50878 8.50878 8.50878 -25.1291 36.1386 30.692100000000003 -8.46118 -8.46118 -8.46118 -24.1291 36.1386 31.692100000000003 -18.7645 -18.7645 -18.7645 -24.1291 36.1386 32.6921 -24.9003 -24.9003 -24.9003 -25.1291 36.1386 31.692100000000003 0.924621 0.924621 0.924621 -25.1291 36.1386 32.6921 10.4508 10.4508 10.4508 -26.1291 33.1386 32.6921 -244.938 -244.938 -244.938 -26.1291 34.1386 32.6921 -238.13 -238.13 -238.13 -27.1291 33.1386 32.6921 -3702.99 -3702.99 -3702.99 -27.1291 34.1386 32.6921 1401.61 1401.61 1401.61 -26.1291 35.1386 31.692100000000003 -754.402 -754.402 -754.402 -26.1291 35.1386 32.6921 4785.72 4785.72 4785.72 -26.1291 36.1386 31.692100000000003 30.8679 30.8679 30.8679 -26.1291 36.1386 32.6921 -38.6598 -38.6598 -38.6598 -27.1291 35.1386 31.692100000000003 2188.52 2188.52 2188.52 -27.1291 35.1386 32.6921 -3196.61 -3196.61 -3196.61 -27.1291 36.1386 31.692100000000003 34.6702 34.6702 34.6702 -28.1291 30.138599999999997 30.692100000000003 -2343.21 -2343.21 -2343.21 -28.1291 29.138599999999997 32.6921 4317.91 4317.91 4317.91 -28.1291 30.138599999999997 31.692100000000003 7468.32 7468.32 7468.32 -28.1291 31.138599999999997 31.692100000000003 6608.19 6608.19 6608.19 -28.1291 32.1386 32.6921 -1371.38 -1371.38 -1371.38 -28.1291 33.1386 32.6921 784.162 784.162 784.162 -28.1291 34.1386 32.6921 2679.0 2679.0 2679.0 -29.1291 34.1386 32.6921 -6320.69 -6320.69 -6320.69 -28.1291 35.1386 31.692100000000003 8274.79 8274.79 8274.79 -28.1291 35.1386 32.6921 4243.94 4243.94 4243.94 -28.1291 36.1386 31.692100000000003 17.2581 17.2581 17.2581 -29.1291 35.1386 32.6921 1867.7 1867.7 1867.7 -29.1291 36.1386 31.692100000000003 6.78345 6.78345 6.78345 -29.1291 36.1386 32.6921 -18.9207 -18.9207 -18.9207 -30.1291 36.1386 32.6921 -23.571 -23.571 -23.571 -24.1291 29.138599999999997 33.6921 -67.1291 -67.1291 -67.1291 -24.1291 29.138599999999997 34.6921 291.806 291.806 291.806 -24.1291 30.138599999999997 33.6921 -167.606 -167.606 -167.606 -24.1291 30.138599999999997 34.6921 -20.209 -20.209 -20.209 -25.1291 29.138599999999997 34.6921 -2019.59 -2019.59 -2019.59 -25.1291 30.138599999999997 33.6921 -2969.19 -2969.19 -2969.19 -25.1291 30.138599999999997 34.6921 -658.65 -658.65 -658.65 -24.1291 30.138599999999997 36.6921 533.276 533.276 533.276 -25.1291 29.138599999999997 35.6921 2389.13 2389.13 2389.13 -25.1291 30.138599999999997 35.6921 102.937 102.937 102.937 -25.1291 30.138599999999997 36.6921 2749.35 2749.35 2749.35 -24.1291 31.138599999999997 33.6921 256.44 256.44 256.44 -24.1291 31.138599999999997 34.6921 -120.839 -120.839 -120.839 -24.1291 32.1386 33.6921 46.2678 46.2678 46.2678 -24.1291 32.1386 34.6921 -100.042 -100.042 -100.042 -25.1291 31.138599999999997 33.6921 -152.457 -152.457 -152.457 -25.1291 31.138599999999997 34.6921 523.32 523.32 523.32 -25.1291 32.1386 33.6921 -936.879 -936.879 -936.879 -25.1291 32.1386 34.6921 272.321 272.321 272.321 -24.1291 31.138599999999997 35.6921 147.096 147.096 147.096 -24.1291 31.138599999999997 36.6921 459.557 459.557 459.557 -24.1291 32.1386 35.6921 -1105.09 -1105.09 -1105.09 -25.1291 31.138599999999997 35.6921 -31.0645 -31.0645 -31.0645 -25.1291 31.138599999999997 36.6921 1233.23 1233.23 1233.23 -25.1291 32.1386 35.6921 -1090.64 -1090.64 -1090.64 -26.1291 29.138599999999997 34.6921 26.0486 26.0486 26.0486 -26.1291 30.138599999999997 33.6921 -3162.78 -3162.78 -3162.78 -26.1291 30.138599999999997 34.6921 -6948.07 -6948.07 -6948.07 -27.1291 29.138599999999997 34.6921 -4249.64 -4249.64 -4249.64 -27.1291 30.138599999999997 33.6921 -9182.91 -9182.91 -9182.91 -27.1291 30.138599999999997 34.6921 -3168.54 -3168.54 -3168.54 -26.1291 29.138599999999997 35.6921 5509.25 5509.25 5509.25 -26.1291 30.138599999999997 35.6921 819.836 819.836 819.836 -26.1291 30.138599999999997 36.6921 1718.01 1718.01 1718.01 -27.1291 29.138599999999997 35.6921 1829.66 1829.66 1829.66 -27.1291 30.138599999999997 35.6921 -430.545 -430.545 -430.545 -27.1291 30.138599999999997 36.6921 -1507.14 -1507.14 -1507.14 -26.1291 31.138599999999997 33.6921 383.693 383.693 383.693 -26.1291 31.138599999999997 34.6921 61.6781 61.6781 61.6781 -26.1291 32.1386 33.6921 -814.701 -814.701 -814.701 -26.1291 32.1386 34.6921 -496.801 -496.801 -496.801 -27.1291 31.138599999999997 33.6921 -322.83 -322.83 -322.83 -27.1291 31.138599999999997 34.6921 1146.98 1146.98 1146.98 -27.1291 32.1386 33.6921 767.14 767.14 767.14 -27.1291 32.1386 34.6921 -1081.47 -1081.47 -1081.47 -26.1291 31.138599999999997 35.6921 613.813 613.813 613.813 -26.1291 32.1386 35.6921 413.361 413.361 413.361 -27.1291 31.138599999999997 35.6921 968.127 968.127 968.127 -27.1291 31.138599999999997 36.6921 -3.87598 -3.87598 -3.87598 -27.1291 32.1386 35.6921 1123.42 1123.42 1123.42 -27.1291 32.1386 36.6921 -868.933 -868.933 -868.933 -24.1291 30.138599999999997 37.6921 -284.329 -284.329 -284.329 -24.1291 30.138599999999997 38.6921 -278.85 -278.85 -278.85 -25.1291 30.138599999999997 37.6921 1170.84 1170.84 1170.84 -24.1291 31.138599999999997 38.6921 -411.11 -411.11 -411.11 -24.1291 32.1386 38.6921 -95.9725 -95.9725 -95.9725 -25.1291 31.138599999999997 37.6921 2251.32 2251.32 2251.32 -25.1291 31.138599999999997 38.6921 -1492.66 -1492.66 -1492.66 -25.1291 32.1386 38.6921 68.2282 68.2282 68.2282 -24.1291 31.138599999999997 39.6921 -29.4381 -29.4381 -29.4381 -24.1291 31.138599999999997 40.6921 -180.675 -180.675 -180.675 -24.1291 32.1386 39.6921 -517.955 -517.955 -517.955 -24.1291 32.1386 40.6921 -338.178 -338.178 -338.178 -26.1291 30.138599999999997 37.6921 -2003.45 -2003.45 -2003.45 -26.1291 30.138599999999997 38.6921 -166.448 -166.448 -166.448 -27.1291 30.138599999999997 37.6921 158.459 158.459 158.459 -27.1291 30.138599999999997 38.6921 -573.051 -573.051 -573.051 -26.1291 31.138599999999997 38.6921 835.293 835.293 835.293 -26.1291 32.1386 38.6921 -259.191 -259.191 -259.191 -27.1291 31.138599999999997 37.6921 -1153.59 -1153.59 -1153.59 -27.1291 31.138599999999997 38.6921 -693.928 -693.928 -693.928 -27.1291 32.1386 37.6921 229.849 229.849 229.849 -27.1291 32.1386 38.6921 385.68 385.68 385.68 -24.1291 33.1386 33.6921 217.107 217.107 217.107 -24.1291 33.1386 34.6921 97.3234 97.3234 97.3234 -24.1291 34.1386 33.6921 -67.8506 -67.8506 -67.8506 -24.1291 34.1386 34.6921 -41.2612 -41.2612 -41.2612 -25.1291 33.1386 33.6921 1547.35 1547.35 1547.35 -25.1291 33.1386 34.6921 864.184 864.184 864.184 -25.1291 34.1386 34.6921 1103.59 1103.59 1103.59 -24.1291 33.1386 35.6921 -598.025 -598.025 -598.025 -24.1291 35.1386 34.6921 32.4868 32.4868 32.4868 -24.1291 36.1386 33.6921 -11.0442 -11.0442 -11.0442 -24.1291 36.1386 34.6921 2.7092 2.7092 2.7092 -25.1291 35.1386 34.6921 -173.624 -173.624 -173.624 -25.1291 36.1386 33.6921 -2.34684 -2.34684 -2.34684 -25.1291 36.1386 34.6921 -5.94834 -5.94834 -5.94834 -24.1291 36.1386 35.6921 7.10234 7.10234 7.10234 -25.1291 35.1386 35.6921 -264.698 -264.698 -264.698 -25.1291 36.1386 35.6921 12.3187 12.3187 12.3187 -26.1291 33.1386 33.6921 -1320.24 -1320.24 -1320.24 -26.1291 33.1386 34.6921 1148.73 1148.73 1148.73 -26.1291 34.1386 33.6921 -1655.77 -1655.77 -1655.77 -26.1291 34.1386 34.6921 1117.91 1117.91 1117.91 -27.1291 34.1386 33.6921 1430.18 1430.18 1430.18 -27.1291 33.1386 35.6921 316.871 316.871 316.871 -27.1291 33.1386 36.6921 -666.4 -666.4 -666.4 -27.1291 34.1386 36.6921 -637.909 -637.909 -637.909 -26.1291 35.1386 33.6921 -2305.38 -2305.38 -2305.38 -26.1291 35.1386 34.6921 -296.982 -296.982 -296.982 -26.1291 36.1386 33.6921 -38.5163 -38.5163 -38.5163 -26.1291 36.1386 34.6921 -0.160862 -0.160862 -0.160862 -27.1291 35.1386 33.6921 611.9 611.9 611.9 -27.1291 35.1386 34.6921 -3339.19 -3339.19 -3339.19 -27.1291 36.1386 34.6921 132.512 132.512 132.512 -26.1291 35.1386 35.6921 -73.4462 -73.4462 -73.4462 -26.1291 35.1386 36.6921 -302.924 -302.924 -302.924 -26.1291 36.1386 35.6921 -72.2712 -72.2712 -72.2712 -26.1291 36.1386 36.6921 64.6683 64.6683 64.6683 -27.1291 35.1386 35.6921 -71.5679 -71.5679 -71.5679 -27.1291 36.1386 35.6921 38.6984 38.6984 38.6984 -27.1291 36.1386 36.6921 -12.9186 -12.9186 -12.9186 -24.1291 33.1386 37.6921 283.974 283.974 283.974 -24.1291 33.1386 38.6921 -187.029 -187.029 -187.029 -24.1291 34.1386 37.6921 -82.4036 -82.4036 -82.4036 -24.1291 34.1386 38.6921 -107.206 -107.206 -107.206 -25.1291 33.1386 38.6921 336.582 336.582 336.582 -25.1291 34.1386 37.6921 479.281 479.281 479.281 -25.1291 34.1386 38.6921 710.147 710.147 710.147 -24.1291 33.1386 39.6921 -62.879 -62.879 -62.879 -24.1291 33.1386 40.6921 23.8602 23.8602 23.8602 -24.1291 34.1386 39.6921 -57.1358 -57.1358 -57.1358 -25.1291 33.1386 39.6921 -361.791 -361.791 -361.791 -25.1291 33.1386 40.6921 -7830.71 -7830.71 -7830.71 -25.1291 34.1386 39.6921 -5804.31 -5804.31 -5804.31 -25.1291 34.1386 40.6921 -5521.73 -5521.73 -5521.73 -24.1291 35.1386 37.6921 -116.395 -116.395 -116.395 -24.1291 35.1386 38.6921 1.9373 1.9373 1.9373 -24.1291 36.1386 37.6921 19.3599 19.3599 19.3599 -24.1291 36.1386 38.6921 -63.8638 -63.8638 -63.8638 -25.1291 35.1386 37.6921 666.955 666.955 666.955 -25.1291 35.1386 38.6921 673.414 673.414 673.414 -25.1291 36.1386 37.6921 -105.486 -105.486 -105.486 -25.1291 36.1386 38.6921 -94.2252 -94.2252 -94.2252 -24.1291 35.1386 39.6921 -37.0898 -37.0898 -37.0898 -25.1291 35.1386 39.6921 3709.66 3709.66 3709.66 -25.1291 35.1386 40.6921 -3530.07 -3530.07 -3530.07 -26.1291 33.1386 37.6921 -313.366 -313.366 -313.366 -26.1291 33.1386 38.6921 -1162.82 -1162.82 -1162.82 -26.1291 34.1386 37.6921 -396.483 -396.483 -396.483 -26.1291 34.1386 38.6921 -263.237 -263.237 -263.237 -27.1291 33.1386 37.6921 -969.564 -969.564 -969.564 -27.1291 33.1386 38.6921 -159.233 -159.233 -159.233 -27.1291 34.1386 37.6921 -82.6766 -82.6766 -82.6766 -27.1291 34.1386 38.6921 1254.2 1254.2 1254.2 -26.1291 34.1386 39.6921 9257.24 9257.24 9257.24 -26.1291 34.1386 40.6921 -2609.32 -2609.32 -2609.32 -26.1291 35.1386 37.6921 -119.186 -119.186 -119.186 -26.1291 35.1386 38.6921 264.76 264.76 264.76 -26.1291 36.1386 37.6921 -20.0455 -20.0455 -20.0455 -26.1291 36.1386 38.6921 -87.3831 -87.3831 -87.3831 -27.1291 35.1386 37.6921 -487.837 -487.837 -487.837 -27.1291 35.1386 38.6921 -439.414 -439.414 -439.414 -26.1291 35.1386 39.6921 4243.92 4243.92 4243.92 -26.1291 35.1386 40.6921 9033.56 9033.56 9033.56 -26.1291 36.1386 39.6921 -41.1782 -41.1782 -41.1782 -26.1291 36.1386 40.6921 34.8696 34.8696 34.8696 -27.1291 35.1386 39.6921 -1147.26 -1147.26 -1147.26 -27.1291 36.1386 39.6921 -15.1856 -15.1856 -15.1856 -27.1291 36.1386 40.6921 20.1815 20.1815 20.1815 -28.1291 29.138599999999997 33.6921 -341.381 -341.381 -341.381 -28.1291 29.138599999999997 34.6921 -46.4854 -46.4854 -46.4854 -28.1291 30.138599999999997 33.6921 4684.85 4684.85 4684.85 -28.1291 30.138599999999997 36.6921 -3379.46 -3379.46 -3379.46 -28.1291 31.138599999999997 33.6921 399.814 399.814 399.814 -28.1291 31.138599999999997 34.6921 3797.93 3797.93 3797.93 -28.1291 32.1386 33.6921 5624.86 5624.86 5624.86 -28.1291 32.1386 34.6921 1956.04 1956.04 1956.04 -29.1291 32.1386 34.6921 988.797 988.797 988.797 -28.1291 31.138599999999997 35.6921 1918.83 1918.83 1918.83 -28.1291 31.138599999999997 36.6921 -2892.18 -2892.18 -2892.18 -28.1291 32.1386 35.6921 1041.55 1041.55 1041.55 -28.1291 32.1386 36.6921 -3246.96 -3246.96 -3246.96 -29.1291 32.1386 35.6921 -379.387 -379.387 -379.387 -29.1291 32.1386 36.6921 -1353.46 -1353.46 -1353.46 -30.1291 32.1386 35.6921 -58.6957 -58.6957 -58.6957 -30.1291 32.1386 36.6921 -25219.5 -25219.5 -25219.5 -28.1291 30.138599999999997 37.6921 837.303 837.303 837.303 -28.1291 31.138599999999997 37.6921 711.548 711.548 711.548 -28.1291 31.138599999999997 38.6921 2705.07 2705.07 2705.07 -28.1291 32.1386 37.6921 252.189 252.189 252.189 -28.1291 32.1386 38.6921 1496.15 1496.15 1496.15 -28.1291 33.1386 33.6921 4208.85 4208.85 4208.85 -28.1291 34.1386 33.6921 -2119.07 -2119.07 -2119.07 -29.1291 33.1386 33.6921 -1317.3 -1317.3 -1317.3 -29.1291 33.1386 34.6921 -4495.33 -4495.33 -4495.33 -29.1291 34.1386 33.6921 -1817.58 -1817.58 -1817.58 -28.1291 33.1386 35.6921 81.0002 81.0002 81.0002 -28.1291 33.1386 36.6921 -643.505 -643.505 -643.505 -28.1291 34.1386 36.6921 -334.248 -334.248 -334.248 -29.1291 33.1386 35.6921 -229.705 -229.705 -229.705 -29.1291 33.1386 36.6921 -684.032 -684.032 -684.032 -28.1291 35.1386 33.6921 370.952 370.952 370.952 -29.1291 35.1386 33.6921 -568.577 -568.577 -568.577 -28.1291 35.1386 35.6921 -109.582 -109.582 -109.582 -28.1291 35.1386 36.6921 -88.5296 -88.5296 -88.5296 -28.1291 36.1386 35.6921 -83.3597 -83.3597 -83.3597 -28.1291 36.1386 36.6921 -42.5033 -42.5033 -42.5033 -29.1291 35.1386 36.6921 -638.747 -638.747 -638.747 -29.1291 36.1386 36.6921 -59.311 -59.311 -59.311 -30.1291 33.1386 33.6921 -1161.89 -1161.89 -1161.89 -30.1291 33.1386 34.6921 -2611.65 -2611.65 -2611.65 -30.1291 34.1386 33.6921 -2826.86 -2826.86 -2826.86 -30.1291 34.1386 34.6921 -1072.1 -1072.1 -1072.1 -31.1291 33.1386 34.6921 -475.13 -475.13 -475.13 -31.1291 34.1386 34.6921 -787.723 -787.723 -787.723 -30.1291 33.1386 35.6921 104.908 104.908 104.908 -30.1291 33.1386 36.6921 -14785.4 -14785.4 -14785.4 -31.1291 33.1386 35.6921 48.4683 48.4683 48.4683 -31.1291 33.1386 36.6921 -21561.1 -21561.1 -21561.1 -31.1291 34.1386 35.6921 78.8796 78.8796 78.8796 -31.1291 34.1386 36.6921 459.46 459.46 459.46 -30.1291 35.1386 33.6921 -1004.15 -1004.15 -1004.15 -30.1291 35.1386 34.6921 -489.697 -489.697 -489.697 -30.1291 36.1386 33.6921 5.49085 5.49085 5.49085 -30.1291 36.1386 34.6921 -82.9121 -82.9121 -82.9121 -31.1291 35.1386 34.6921 -5.63544 -5.63544 -5.63544 -31.1291 36.1386 33.6921 -11.4859 -11.4859 -11.4859 -31.1291 36.1386 34.6921 12.4909 12.4909 12.4909 -30.1291 36.1386 36.6921 19.6372 19.6372 19.6372 -31.1291 35.1386 36.6921 -168.805 -168.805 -168.805 -31.1291 36.1386 35.6921 26.5649 26.5649 26.5649 -31.1291 36.1386 36.6921 -101.264 -101.264 -101.264 -28.1291 33.1386 37.6921 -116.898 -116.898 -116.898 -28.1291 34.1386 37.6921 404.139 404.139 404.139 -28.1291 34.1386 38.6921 -434.402 -434.402 -434.402 -29.1291 33.1386 37.6921 -1354.4 -1354.4 -1354.4 -29.1291 34.1386 37.6921 -433.99 -433.99 -433.99 -28.1291 35.1386 37.6921 471.726 471.726 471.726 -28.1291 35.1386 38.6921 31.9449 31.9449 31.9449 -28.1291 36.1386 37.6921 -60.6841 -60.6841 -60.6841 -28.1291 36.1386 38.6921 56.0382 56.0382 56.0382 -29.1291 35.1386 37.6921 669.822 669.822 669.822 -29.1291 35.1386 38.6921 -516.968 -516.968 -516.968 -29.1291 36.1386 37.6921 166.161 166.161 166.161 -29.1291 36.1386 38.6921 -123.232 -123.232 -123.232 -28.1291 35.1386 39.6921 239.787 239.787 239.787 -28.1291 36.1386 39.6921 58.6726 58.6726 58.6726 -28.1291 36.1386 40.6921 708.115 708.115 708.115 -30.1291 33.1386 37.6921 26202.1 26202.1 26202.1 -30.1291 34.1386 37.6921 24916.2 24916.2 24916.2 -31.1291 34.1386 37.6921 22917.8 22917.8 22917.8 -30.1291 35.1386 37.6921 332.696 332.696 332.696 -30.1291 36.1386 37.6921 245.536 245.536 245.536 -31.1291 35.1386 37.6921 344.881 344.881 344.881 -31.1291 36.1386 37.6921 268.154 268.154 268.154 -32.1291 34.1386 34.6921 -445.498 -445.498 -445.498 -32.1291 34.1386 35.6921 35.7856 35.7856 35.7856 -32.1291 34.1386 36.6921 -14559.7 -14559.7 -14559.7 -32.1291 35.1386 34.6921 99.2274 99.2274 99.2274 -32.1291 36.1386 34.6921 -29.2536 -29.2536 -29.2536 -32.1291 35.1386 35.6921 -91.9008 -91.9008 -91.9008 -32.1291 35.1386 36.6921 -421.055 -421.055 -421.055 -32.1291 36.1386 35.6921 49.9525 49.9525 49.9525 -32.1291 36.1386 36.6921 -185.042 -185.042 -185.042 -32.1291 35.1386 37.6921 469.873 469.873 469.873 -32.1291 36.1386 37.6921 -359.317 -359.317 -359.317 -24.1291 28.138599999999997 44.6921 135.769 135.769 135.769 -25.1291 28.138599999999997 44.6921 -345.347 -345.347 -345.347 -24.1291 28.138599999999997 45.6921 -78.7379 -78.7379 -78.7379 -24.1291 28.138599999999997 46.6921 -69.0739 -69.0739 -69.0739 -25.1291 28.138599999999997 45.6921 -224.81 -224.81 -224.81 -24.1291 28.138599999999997 47.6921 83.4406 83.4406 83.4406 -24.1291 29.138599999999997 43.6921 -34.2127 -34.2127 -34.2127 -24.1291 29.138599999999997 44.6921 -27.3734 -27.3734 -27.3734 -24.1291 30.138599999999997 43.6921 145.899 145.899 145.899 -24.1291 30.138599999999997 44.6921 111.605 111.605 111.605 -25.1291 29.138599999999997 44.6921 -67.0929 -67.0929 -67.0929 -25.1291 30.138599999999997 44.6921 60.7618 60.7618 60.7618 -24.1291 31.138599999999997 41.6921 277.117 277.117 277.117 -24.1291 31.138599999999997 42.6921 58.1839 58.1839 58.1839 -24.1291 32.1386 41.6921 290.646 290.646 290.646 -24.1291 32.1386 42.6921 -176.328 -176.328 -176.328 -24.1291 31.138599999999997 43.6921 39.3245 39.3245 39.3245 -24.1291 31.138599999999997 44.6921 242.699 242.699 242.699 -24.1291 32.1386 44.6921 70.1664 70.1664 70.1664 -25.1291 31.138599999999997 44.6921 171.233 171.233 171.233 -26.1291 29.138599999999997 44.6921 130.765 130.765 130.765 -26.1291 30.138599999999997 44.6921 -10.0573 -10.0573 -10.0573 -24.1291 29.138599999999997 45.6921 -144.216 -144.216 -144.216 -24.1291 29.138599999999997 46.6921 110.033 110.033 110.033 -25.1291 29.138599999999997 45.6921 -141.261 -141.261 -141.261 -25.1291 29.138599999999997 46.6921 100.661 100.661 100.661 -25.1291 30.138599999999997 45.6921 -297.805 -297.805 -297.805 -25.1291 30.138599999999997 46.6921 284.253 284.253 284.253 -24.1291 29.138599999999997 47.6921 95.7119 95.7119 95.7119 -24.1291 29.138599999999997 48.6921 38.9157 38.9157 38.9157 -24.1291 30.138599999999997 47.6921 140.415 140.415 140.415 -24.1291 30.138599999999997 48.6921 -199.598 -199.598 -199.598 -25.1291 29.138599999999997 47.6921 -303.715 -303.715 -303.715 -25.1291 30.138599999999997 47.6921 -426.865 -426.865 -426.865 -25.1291 30.138599999999997 48.6921 -35.3105 -35.3105 -35.3105 -24.1291 31.138599999999997 45.6921 -9.83951 -9.83951 -9.83951 -24.1291 32.1386 45.6921 212.348 212.348 212.348 -24.1291 32.1386 46.6921 -96.4489 -96.4489 -96.4489 -25.1291 31.138599999999997 45.6921 34.6256 34.6256 34.6256 -25.1291 31.138599999999997 46.6921 259.317 259.317 259.317 -25.1291 32.1386 45.6921 224.274 224.274 224.274 -25.1291 32.1386 46.6921 179.603 179.603 179.603 -25.1291 31.138599999999997 47.6921 -239.461 -239.461 -239.461 -25.1291 31.138599999999997 48.6921 39.6422 39.6422 39.6422 -25.1291 32.1386 47.6921 -35.212 -35.212 -35.212 -25.1291 32.1386 48.6921 -15.0952 -15.0952 -15.0952 -26.1291 29.138599999999997 45.6921 -812.013 -812.013 -812.013 -26.1291 30.138599999999997 45.6921 772.296 772.296 772.296 -26.1291 31.138599999999997 48.6921 50.7705 50.7705 50.7705 -26.1291 32.1386 48.6921 -11.6209 -11.6209 -11.6209 -24.1291 33.1386 41.6921 282.067 282.067 282.067 -24.1291 33.1386 42.6921 -359.441 -359.441 -359.441 -24.1291 34.1386 42.6921 -159.384 -159.384 -159.384 -25.1291 33.1386 41.6921 3811.48 3811.48 3811.48 -25.1291 33.1386 42.6921 -304.725 -304.725 -304.725 -25.1291 34.1386 41.6921 -5092.59 -5092.59 -5092.59 -25.1291 34.1386 42.6921 -845.327 -845.327 -845.327 -24.1291 33.1386 44.6921 -200.376 -200.376 -200.376 -24.1291 34.1386 43.6921 194.228 194.228 194.228 -24.1291 34.1386 44.6921 -176.145 -176.145 -176.145 -25.1291 33.1386 44.6921 45.9033 45.9033 45.9033 -25.1291 34.1386 43.6921 578.194 578.194 578.194 -25.1291 34.1386 44.6921 191.736 191.736 191.736 -24.1291 35.1386 41.6921 46.1154 46.1154 46.1154 -24.1291 35.1386 42.6921 -62.4867 -62.4867 -62.4867 -24.1291 36.1386 41.6921 75.6183 75.6183 75.6183 -25.1291 35.1386 41.6921 -4042.05 -4042.05 -4042.05 -25.1291 35.1386 42.6921 195.533 195.533 195.533 -25.1291 36.1386 41.6921 60.72 60.72 60.72 -25.1291 36.1386 42.6921 -19.7949 -19.7949 -19.7949 -24.1291 35.1386 43.6921 -53.4268 -53.4268 -53.4268 -24.1291 35.1386 44.6921 -54.5918 -54.5918 -54.5918 -24.1291 36.1386 43.6921 12.332 12.332 12.332 -24.1291 36.1386 44.6921 21.3398 21.3398 21.3398 -25.1291 35.1386 43.6921 -279.008 -279.008 -279.008 -25.1291 35.1386 44.6921 -29.4739 -29.4739 -29.4739 -25.1291 36.1386 43.6921 -3.9502 -3.9502 -3.9502 -25.1291 36.1386 44.6921 118.931 118.931 118.931 -26.1291 34.1386 41.6921 28.5096 28.5096 28.5096 -26.1291 35.1386 41.6921 6219.27 6219.27 6219.27 -26.1291 36.1386 41.6921 -26.4912 -26.4912 -26.4912 -26.1291 36.1386 42.6921 -17.6547 -17.6547 -17.6547 -27.1291 36.1386 41.6921 -53.8549 -53.8549 -53.8549 -27.1291 36.1386 42.6921 -170.433 -170.433 -170.433 -26.1291 36.1386 43.6921 90.2731 90.2731 90.2731 -27.1291 36.1386 43.6921 79.4623 79.4623 79.4623 -24.1291 33.1386 45.6921 147.009 147.009 147.009 -24.1291 33.1386 46.6921 99.1705 99.1705 99.1705 -24.1291 34.1386 46.6921 -30.9165 -30.9165 -30.9165 -25.1291 33.1386 45.6921 78.6265 78.6265 78.6265 -25.1291 33.1386 46.6921 68.3182 68.3182 68.3182 -25.1291 34.1386 45.6921 75.3732 75.3732 75.3732 -25.1291 34.1386 46.6921 92.0614 92.0614 92.0614 -24.1291 33.1386 47.6921 117.214 117.214 117.214 -24.1291 33.1386 48.6921 40.7372 40.7372 40.7372 -24.1291 34.1386 48.6921 -182.491 -182.491 -182.491 -25.1291 33.1386 47.6921 -169.138 -169.138 -169.138 -25.1291 33.1386 48.6921 -137.768 -137.768 -137.768 -25.1291 34.1386 48.6921 46.0702 46.0702 46.0702 -24.1291 35.1386 46.6921 -28.8302 -28.8302 -28.8302 -24.1291 36.1386 45.6921 210.963 210.963 210.963 -24.1291 36.1386 46.6921 258.038 258.038 258.038 -25.1291 35.1386 45.6921 1.46737 1.46737 1.46737 -25.1291 35.1386 46.6921 23.4726 23.4726 23.4726 -25.1291 36.1386 45.6921 143.249 143.249 143.249 -25.1291 36.1386 46.6921 41.8579 41.8579 41.8579 -24.1291 35.1386 47.6921 -10.2309 -10.2309 -10.2309 -24.1291 35.1386 48.6921 -47.2769 -47.2769 -47.2769 -24.1291 36.1386 47.6921 127.532 127.532 127.532 -24.1291 36.1386 48.6921 -107.606 -107.606 -107.606 -25.1291 35.1386 48.6921 289.451 289.451 289.451 -25.1291 36.1386 48.6921 39.0964 39.0964 39.0964 -26.1291 33.1386 48.6921 -25.9519 -25.9519 -25.9519 -26.1291 34.1386 48.6921 55.9242 55.9242 55.9242 -28.1291 36.1386 41.6921 144.828 144.828 144.828 -28.1291 36.1386 42.6921 126.037 126.037 126.037 -29.1291 36.1386 41.6921 -1149.91 -1149.91 -1149.91 -29.1291 36.1386 42.6921 -171.579 -171.579 -171.579 -28.1291 36.1386 43.6921 11.9971 11.9971 11.9971 -24.1291 30.138599999999997 49.6921 53.5395 53.5395 53.5395 -24.1291 30.138599999999997 50.6921 136.951 136.951 136.951 -25.1291 30.138599999999997 49.6921 32.7807 32.7807 32.7807 -24.1291 31.138599999999997 49.6921 152.78 152.78 152.78 -24.1291 31.138599999999997 50.6921 86.1086 86.1086 86.1086 -25.1291 31.138599999999997 49.6921 1.68456 1.68456 1.68456 -25.1291 31.138599999999997 50.6921 31.2466 31.2466 31.2466 -25.1291 32.1386 50.6921 29.061 29.061 29.061 -24.1291 31.138599999999997 51.6921 348.636 348.636 348.636 -24.1291 32.1386 51.6921 -129.974 -129.974 -129.974 -24.1291 32.1386 52.6921 261.564 261.564 261.564 -25.1291 31.138599999999997 51.6921 -213.396 -213.396 -213.396 -25.1291 31.138599999999997 52.6921 197.026 197.026 197.026 -25.1291 32.1386 51.6921 899.367 899.367 899.367 -25.1291 32.1386 52.6921 99.8373 99.8373 99.8373 -26.1291 31.138599999999997 49.6921 22.8307 22.8307 22.8307 -26.1291 32.1386 49.6921 34.1642 34.1642 34.1642 -26.1291 32.1386 50.6921 23.8464 23.8464 23.8464 -27.1291 32.1386 50.6921 29.1723 29.1723 29.1723 -26.1291 31.138599999999997 51.6921 -186.837 -186.837 -186.837 -26.1291 31.138599999999997 52.6921 -330.312 -330.312 -330.312 -26.1291 32.1386 51.6921 -598.636 -598.636 -598.636 -26.1291 32.1386 52.6921 -479.145 -479.145 -479.145 -27.1291 31.138599999999997 51.6921 14.9003 14.9003 14.9003 -27.1291 31.138599999999997 52.6921 22.4034 22.4034 22.4034 -27.1291 32.1386 51.6921 -56.0105 -56.0105 -56.0105 -27.1291 32.1386 52.6921 89.8047 89.8047 89.8047 -25.1291 32.1386 53.6921 130.368 130.368 130.368 -26.1291 32.1386 53.6921 -32.0927 -32.0927 -32.0927 -27.1291 32.1386 53.6921 105.412 105.412 105.412 -24.1291 34.1386 49.6921 -109.151 -109.151 -109.151 -24.1291 34.1386 50.6921 -92.4259 -92.4259 -92.4259 -25.1291 34.1386 49.6921 -81.8991 -81.8991 -81.8991 -25.1291 34.1386 50.6921 17.2494 17.2494 17.2494 -24.1291 33.1386 52.6921 20.4602 20.4602 20.4602 -24.1291 34.1386 51.6921 15.8828 15.8828 15.8828 -24.1291 34.1386 52.6921 -54.7462 -54.7462 -54.7462 -25.1291 33.1386 52.6921 -13.6319 -13.6319 -13.6319 -25.1291 34.1386 52.6921 -245.676 -245.676 -245.676 -24.1291 35.1386 49.6921 196.39 196.39 196.39 -24.1291 35.1386 50.6921 165.026 165.026 165.026 -24.1291 36.1386 50.6921 -36.4224 -36.4224 -36.4224 -25.1291 35.1386 49.6921 -59.4053 -59.4053 -59.4053 -25.1291 35.1386 50.6921 -53.5953 -53.5953 -53.5953 -25.1291 36.1386 49.6921 112.969 112.969 112.969 -25.1291 36.1386 50.6921 18.5608 18.5608 18.5608 -24.1291 35.1386 51.6921 421.192 421.192 421.192 -24.1291 35.1386 52.6921 -359.413 -359.413 -359.413 -24.1291 36.1386 51.6921 293.082 293.082 293.082 -25.1291 35.1386 51.6921 -187.534 -187.534 -187.534 -25.1291 35.1386 52.6921 -103.27 -103.27 -103.27 -26.1291 33.1386 49.6921 50.3659 50.3659 50.3659 -26.1291 33.1386 50.6921 12.2544 12.2544 12.2544 -26.1291 34.1386 49.6921 21.7247 21.7247 21.7247 -26.1291 34.1386 50.6921 -140.832 -140.832 -140.832 -27.1291 33.1386 50.6921 -12.1603 -12.1603 -12.1603 -27.1291 34.1386 50.6921 -109.615 -109.615 -109.615 -26.1291 34.1386 52.6921 6.26168 6.26168 6.26168 -27.1291 33.1386 51.6921 42.2397 42.2397 42.2397 -27.1291 33.1386 52.6921 68.7672 68.7672 68.7672 -27.1291 34.1386 51.6921 191.975 191.975 191.975 -27.1291 34.1386 52.6921 175.245 175.245 175.245 -26.1291 35.1386 50.6921 -39.4896 -39.4896 -39.4896 -26.1291 35.1386 51.6921 223.081 223.081 223.081 -26.1291 35.1386 52.6921 -17.515 -17.515 -17.515 -27.1291 35.1386 51.6921 -149.502 -149.502 -149.502 -27.1291 35.1386 52.6921 -361.641 -361.641 -361.641 -25.1291 33.1386 53.6921 12.6055 12.6055 12.6055 -25.1291 34.1386 53.6921 31.5191 31.5191 31.5191 -26.1291 33.1386 53.6921 -24.5376 -24.5376 -24.5376 -26.1291 34.1386 53.6921 -45.0773 -45.0773 -45.0773 -27.1291 33.1386 53.6921 -83.2409 -83.2409 -83.2409 -27.1291 34.1386 53.6921 115.006 115.006 115.006 -28.1291 32.1386 51.6921 -95.5286 -95.5286 -95.5286 -28.1291 32.1386 52.6921 -76.3091 -76.3091 -76.3091 -28.1291 33.1386 51.6921 -105.242 -105.242 -105.242 -28.1291 33.1386 52.6921 -172.958 -172.958 -172.958 -28.1291 34.1386 51.6921 -65.5197 -65.5197 -65.5197 -28.1291 34.1386 52.6921 -65.0803 -65.0803 -65.0803 -24.1291 38.1386 26.692100000000003 -134.687 -134.687 -134.687 -24.1291 37.1386 27.692100000000003 -39.1494 -39.1494 -39.1494 -24.1291 37.1386 28.692100000000003 91.9193 91.9193 91.9193 -24.1291 38.1386 27.692100000000003 -387.946 -387.946 -387.946 -25.1291 37.1386 28.692100000000003 90.6043 90.6043 90.6043 -25.1291 38.1386 27.692100000000003 -503.452 -503.452 -503.452 -25.1291 38.1386 28.692100000000003 -279.352 -279.352 -279.352 -24.1291 39.1386 26.692100000000003 146.123 146.123 146.123 -24.1291 40.1386 26.692100000000003 -235.147 -235.147 -235.147 -24.1291 39.1386 27.692100000000003 207.114 207.114 207.114 -24.1291 39.1386 28.692100000000003 273.052 273.052 273.052 -24.1291 40.1386 27.692100000000003 103.351 103.351 103.351 -24.1291 40.1386 28.692100000000003 225.182 225.182 225.182 -25.1291 39.1386 28.692100000000003 258.912 258.912 258.912 -24.1291 37.1386 29.692100000000003 136.989 136.989 136.989 -24.1291 37.1386 30.692100000000003 16.5278 16.5278 16.5278 -24.1291 38.1386 29.692100000000003 -326.171 -326.171 -326.171 -24.1291 38.1386 30.692100000000003 -8.02802 -8.02802 -8.02802 -25.1291 37.1386 29.692100000000003 1.29148 1.29148 1.29148 -25.1291 37.1386 30.692100000000003 12.2089 12.2089 12.2089 -25.1291 38.1386 29.692100000000003 -148.783 -148.783 -148.783 -25.1291 38.1386 30.692100000000003 28.1145 28.1145 28.1145 -24.1291 38.1386 32.6921 9.50978 9.50978 9.50978 -25.1291 37.1386 31.692100000000003 16.1328 16.1328 16.1328 -25.1291 37.1386 32.6921 -4.65225 -4.65225 -4.65225 -25.1291 38.1386 31.692100000000003 5.39191 5.39191 5.39191 -25.1291 38.1386 32.6921 -14.9445 -14.9445 -14.9445 -24.1291 39.1386 29.692100000000003 29.9483 29.9483 29.9483 -24.1291 39.1386 30.692100000000003 -1.53975 -1.53975 -1.53975 -24.1291 40.1386 29.692100000000003 0.40123 0.40123 0.40123 -24.1291 40.1386 30.692100000000003 24.1515 24.1515 24.1515 -25.1291 39.1386 29.692100000000003 -57.8566 -57.8566 -57.8566 -25.1291 39.1386 30.692100000000003 11.8645 11.8645 11.8645 -25.1291 40.1386 29.692100000000003 23.9225 23.9225 23.9225 -25.1291 40.1386 30.692100000000003 57.0701 57.0701 57.0701 -24.1291 39.1386 31.692100000000003 -11.3821 -11.3821 -11.3821 -24.1291 39.1386 32.6921 3.12948 3.12948 3.12948 -24.1291 40.1386 31.692100000000003 17.1081 17.1081 17.1081 -24.1291 40.1386 32.6921 -12.0337 -12.0337 -12.0337 -25.1291 39.1386 31.692100000000003 -10.305 -10.305 -10.305 -25.1291 39.1386 32.6921 -17.1643 -17.1643 -17.1643 -25.1291 40.1386 31.692100000000003 52.0573 52.0573 52.0573 -25.1291 40.1386 32.6921 27.0519 27.0519 27.0519 -26.1291 37.1386 30.692100000000003 49.5958 49.5958 49.5958 -26.1291 38.1386 30.692100000000003 -116.737 -116.737 -116.737 -27.1291 38.1386 30.692100000000003 280.618 280.618 280.618 -26.1291 37.1386 31.692100000000003 -76.3382 -76.3382 -76.3382 -26.1291 37.1386 32.6921 -25.9581 -25.9581 -25.9581 -26.1291 38.1386 31.692100000000003 -207.771 -207.771 -207.771 -26.1291 38.1386 32.6921 -84.6298 -84.6298 -84.6298 -27.1291 37.1386 31.692100000000003 157.187 157.187 157.187 -27.1291 37.1386 32.6921 88.2401 88.2401 88.2401 -27.1291 38.1386 31.692100000000003 -104.011 -104.011 -104.011 -27.1291 38.1386 32.6921 -47.5165 -47.5165 -47.5165 -26.1291 39.1386 30.692100000000003 21.4931 21.4931 21.4931 -26.1291 40.1386 29.692100000000003 -64.0299 -64.0299 -64.0299 -26.1291 40.1386 30.692100000000003 21.2611 21.2611 21.2611 -27.1291 39.1386 30.692100000000003 201.842 201.842 201.842 -27.1291 40.1386 29.692100000000003 30.9219 30.9219 30.9219 -27.1291 40.1386 30.692100000000003 -528.361 -528.361 -528.361 -26.1291 39.1386 31.692100000000003 142.519 142.519 142.519 -26.1291 39.1386 32.6921 -1.5782 -1.5782 -1.5782 -26.1291 40.1386 31.692100000000003 93.527 93.527 93.527 -26.1291 40.1386 32.6921 -166.166 -166.166 -166.166 -27.1291 39.1386 31.692100000000003 114.884 114.884 114.884 -27.1291 39.1386 32.6921 72.7896 72.7896 72.7896 -27.1291 40.1386 31.692100000000003 -384.279 -384.279 -384.279 -27.1291 40.1386 32.6921 -222.561 -222.561 -222.561 -24.1291 41.1386 26.692100000000003 21.7034 21.7034 21.7034 -24.1291 41.1386 27.692100000000003 -13.1641 -13.1641 -13.1641 -24.1291 41.1386 28.692100000000003 -151.305 -151.305 -151.305 -24.1291 42.1386 27.692100000000003 143.671 143.671 143.671 -24.1291 42.1386 28.692100000000003 55.5062 55.5062 55.5062 -25.1291 41.1386 28.692100000000003 -179.193 -179.193 -179.193 -25.1291 42.1386 28.692100000000003 38.9311 38.9311 38.9311 -24.1291 43.1386 27.692100000000003 -204.865 -204.865 -204.865 -24.1291 43.1386 28.692100000000003 -169.877 -169.877 -169.877 -24.1291 44.1386 28.692100000000003 216.063 216.063 216.063 -25.1291 43.1386 28.692100000000003 -175.039 -175.039 -175.039 -25.1291 44.1386 28.692100000000003 -144.261 -144.261 -144.261 -26.1291 41.1386 28.692100000000003 -37.8748 -37.8748 -37.8748 -26.1291 42.1386 28.692100000000003 -112.702 -112.702 -112.702 -27.1291 41.1386 28.692100000000003 89.7949 89.7949 89.7949 -27.1291 42.1386 28.692100000000003 -321.278 -321.278 -321.278 -24.1291 41.1386 29.692100000000003 20.8256 20.8256 20.8256 -24.1291 41.1386 30.692100000000003 44.9445 44.9445 44.9445 -24.1291 42.1386 29.692100000000003 229.322 229.322 229.322 -24.1291 42.1386 30.692100000000003 -40.6527 -40.6527 -40.6527 -25.1291 41.1386 29.692100000000003 -75.9858 -75.9858 -75.9858 -25.1291 41.1386 30.692100000000003 61.7148 61.7148 61.7148 -25.1291 42.1386 29.692100000000003 12.4557 12.4557 12.4557 -25.1291 41.1386 32.6921 176.706 176.706 176.706 -25.1291 42.1386 32.6921 -699.952 -699.952 -699.952 -24.1291 44.1386 29.692100000000003 -198.26 -198.26 -198.26 -24.1291 44.1386 30.692100000000003 -481.807 -481.807 -481.807 -25.1291 43.1386 29.692100000000003 -178.083 -178.083 -178.083 -25.1291 44.1386 29.692100000000003 192.314 192.314 192.314 -25.1291 44.1386 30.692100000000003 -168.104 -168.104 -168.104 -24.1291 43.1386 31.692100000000003 295.807 295.807 295.807 -24.1291 43.1386 32.6921 358.623 358.623 358.623 -24.1291 44.1386 31.692100000000003 220.733 220.733 220.733 -24.1291 44.1386 32.6921 -139.652 -139.652 -139.652 -25.1291 43.1386 32.6921 270.01 270.01 270.01 -25.1291 44.1386 31.692100000000003 -280.657 -280.657 -280.657 -25.1291 44.1386 32.6921 36.0598 36.0598 36.0598 -26.1291 41.1386 29.692100000000003 0.0163364 0.0163364 0.0163364 -26.1291 42.1386 29.692100000000003 25.0146 25.0146 25.0146 -27.1291 41.1386 29.692100000000003 43.7416 43.7416 43.7416 -27.1291 42.1386 29.692100000000003 -346.281 -346.281 -346.281 -26.1291 41.1386 32.6921 -200.752 -200.752 -200.752 -26.1291 42.1386 32.6921 -681.599 -681.599 -681.599 -27.1291 41.1386 32.6921 -470.868 -470.868 -470.868 -27.1291 42.1386 31.692100000000003 -398.517 -398.517 -398.517 -27.1291 42.1386 32.6921 -70.0097 -70.0097 -70.0097 -26.1291 43.1386 29.692100000000003 49.9959 49.9959 49.9959 -26.1291 43.1386 30.692100000000003 29.0362 29.0362 29.0362 -26.1291 44.1386 29.692100000000003 225.463 225.463 225.463 -26.1291 44.1386 30.692100000000003 161.23 161.23 161.23 -27.1291 43.1386 29.692100000000003 -637.395 -637.395 -637.395 -27.1291 43.1386 30.692100000000003 370.051 370.051 370.051 -26.1291 43.1386 31.692100000000003 1336.69 1336.69 1336.69 -26.1291 43.1386 32.6921 643.642 643.642 643.642 -26.1291 44.1386 31.692100000000003 86.0018 86.0018 86.0018 -26.1291 44.1386 32.6921 679.763 679.763 679.763 -27.1291 43.1386 31.692100000000003 441.737 441.737 441.737 -29.1291 40.1386 28.692100000000003 -4.2703 -4.2703 -4.2703 -30.1291 40.1386 28.692100000000003 2361.69 2361.69 2361.69 -31.1291 40.1386 28.692100000000003 -124.518 -124.518 -124.518 -28.1291 37.1386 30.692100000000003 -21.3372 -21.3372 -21.3372 -28.1291 38.1386 30.692100000000003 -18.0753 -18.0753 -18.0753 -29.1291 37.1386 30.692100000000003 0.506442 0.506442 0.506442 -29.1291 38.1386 30.692100000000003 38.6196 38.6196 38.6196 -28.1291 37.1386 31.692100000000003 -42.0918 -42.0918 -42.0918 -28.1291 38.1386 31.692100000000003 -231.331 -231.331 -231.331 -29.1291 37.1386 31.692100000000003 -0.376956 -0.376956 -0.376956 -29.1291 37.1386 32.6921 26.2218 26.2218 26.2218 -29.1291 38.1386 31.692100000000003 20.7068 20.7068 20.7068 -28.1291 39.1386 30.692100000000003 134.312 134.312 134.312 -28.1291 40.1386 29.692100000000003 417.453 417.453 417.453 -28.1291 40.1386 30.692100000000003 -180.749 -180.749 -180.749 -29.1291 39.1386 30.692100000000003 32.5022 32.5022 32.5022 -29.1291 40.1386 29.692100000000003 -132.75 -132.75 -132.75 -29.1291 40.1386 30.692100000000003 92.4794 92.4794 92.4794 -28.1291 40.1386 31.692100000000003 136.899 136.899 136.899 -28.1291 40.1386 32.6921 -272.187 -272.187 -272.187 -29.1291 39.1386 31.692100000000003 65.485 65.485 65.485 -29.1291 40.1386 31.692100000000003 23.82 23.82 23.82 -29.1291 40.1386 32.6921 -713.435 -713.435 -713.435 -30.1291 38.1386 30.692100000000003 -111.611 -111.611 -111.611 -30.1291 37.1386 31.692100000000003 -7.97169 -7.97169 -7.97169 -30.1291 37.1386 32.6921 14.426 14.426 14.426 -30.1291 38.1386 31.692100000000003 18.5294 18.5294 18.5294 -30.1291 38.1386 32.6921 -33.418 -33.418 -33.418 -30.1291 39.1386 29.692100000000003 -48.0678 -48.0678 -48.0678 -30.1291 39.1386 30.692100000000003 -35.3074 -35.3074 -35.3074 -30.1291 40.1386 29.692100000000003 1596.94 1596.94 1596.94 -30.1291 40.1386 30.692100000000003 457.983 457.983 457.983 -31.1291 39.1386 29.692100000000003 128.478 128.478 128.478 -31.1291 39.1386 30.692100000000003 61.8229 61.8229 61.8229 -31.1291 40.1386 29.692100000000003 -330.706 -330.706 -330.706 -30.1291 39.1386 31.692100000000003 21.381 21.381 21.381 -30.1291 39.1386 32.6921 34.9834 34.9834 34.9834 -30.1291 40.1386 31.692100000000003 59.7096 59.7096 59.7096 -30.1291 40.1386 32.6921 336.674 336.674 336.674 -31.1291 39.1386 31.692100000000003 -35.848 -35.848 -35.848 -31.1291 39.1386 32.6921 5.41989 5.41989 5.41989 -31.1291 40.1386 31.692100000000003 -90.6934 -90.6934 -90.6934 -31.1291 40.1386 32.6921 -1055.86 -1055.86 -1055.86 -29.1291 41.1386 28.692100000000003 -409.178 -409.178 -409.178 -29.1291 42.1386 28.692100000000003 850.937 850.937 850.937 -30.1291 41.1386 28.692100000000003 1390.95 1390.95 1390.95 -30.1291 42.1386 28.692100000000003 3312.35 3312.35 3312.35 -31.1291 41.1386 28.692100000000003 -947.181 -947.181 -947.181 -31.1291 42.1386 28.692100000000003 1513.32 1513.32 1513.32 -28.1291 41.1386 29.692100000000003 548.2 548.2 548.2 -28.1291 41.1386 30.692100000000003 -15655.1 -15655.1 -15655.1 -28.1291 42.1386 29.692100000000003 -282.413 -282.413 -282.413 -28.1291 42.1386 30.692100000000003 -14200.3 -14200.3 -14200.3 -29.1291 41.1386 29.692100000000003 500.663 500.663 500.663 -29.1291 41.1386 30.692100000000003 17432.1 17432.1 17432.1 -29.1291 42.1386 29.692100000000003 332.704 332.704 332.704 -29.1291 42.1386 30.692100000000003 -14537.4 -14537.4 -14537.4 -28.1291 41.1386 31.692100000000003 7005.14 7005.14 7005.14 -28.1291 41.1386 32.6921 4817.91 4817.91 4817.91 -28.1291 42.1386 31.692100000000003 -6597.84 -6597.84 -6597.84 -28.1291 42.1386 32.6921 2793.3 2793.3 2793.3 -29.1291 41.1386 31.692100000000003 18942.3 18942.3 18942.3 -29.1291 42.1386 31.692100000000003 35501.5 35501.5 35501.5 -28.1291 43.1386 29.692100000000003 -557.013 -557.013 -557.013 -28.1291 43.1386 30.692100000000003 -18709.3 -18709.3 -18709.3 -28.1291 43.1386 31.692100000000003 -8413.91 -8413.91 -8413.91 -30.1291 42.1386 29.692100000000003 -470.829 -470.829 -470.829 -30.1291 42.1386 30.692100000000003 2470.18 2470.18 2470.18 -31.1291 41.1386 29.692100000000003 -2918.02 -2918.02 -2918.02 -31.1291 42.1386 29.692100000000003 -2942.92 -2942.92 -2942.92 -30.1291 41.1386 31.692100000000003 -5814.07 -5814.07 -5814.07 -30.1291 42.1386 31.692100000000003 -6279.22 -6279.22 -6279.22 -31.1291 41.1386 31.692100000000003 -2350.78 -2350.78 -2350.78 -31.1291 41.1386 32.6921 986.598 986.598 986.598 -31.1291 42.1386 31.692100000000003 -974.577 -974.577 -974.577 -31.1291 42.1386 32.6921 370.44 370.44 370.44 -30.1291 43.1386 29.692100000000003 1562.62 1562.62 1562.62 -30.1291 43.1386 30.692100000000003 969.308 969.308 969.308 -30.1291 44.1386 29.692100000000003 -2304.42 -2304.42 -2304.42 -30.1291 44.1386 30.692100000000003 4168.72 4168.72 4168.72 -31.1291 43.1386 29.692100000000003 313.69 313.69 313.69 -31.1291 44.1386 29.692100000000003 -4430.23 -4430.23 -4430.23 -31.1291 44.1386 30.692100000000003 3021.72 3021.72 3021.72 -30.1291 43.1386 31.692100000000003 15796.3 15796.3 15796.3 -30.1291 44.1386 31.692100000000003 5794.72 5794.72 5794.72 -31.1291 43.1386 31.692100000000003 -867.049 -867.049 -867.049 -31.1291 43.1386 32.6921 -2618.88 -2618.88 -2618.88 -31.1291 44.1386 31.692100000000003 273.241 273.241 273.241 -24.1291 37.1386 33.6921 -3.37417 -3.37417 -3.37417 -24.1291 37.1386 34.6921 0.352195 0.352195 0.352195 -24.1291 38.1386 33.6921 -9.03021 -9.03021 -9.03021 -24.1291 38.1386 34.6921 -18.3278 -18.3278 -18.3278 -25.1291 37.1386 33.6921 -5.38926 -5.38926 -5.38926 -25.1291 37.1386 34.6921 0.844854 0.844854 0.844854 -25.1291 38.1386 33.6921 -13.9624 -13.9624 -13.9624 -25.1291 38.1386 34.6921 28.0294 28.0294 28.0294 -24.1291 37.1386 35.6921 15.3247 15.3247 15.3247 -24.1291 37.1386 36.6921 -25.2559 -25.2559 -25.2559 -24.1291 38.1386 35.6921 -14.8301 -14.8301 -14.8301 -24.1291 38.1386 36.6921 -16.4447 -16.4447 -16.4447 -25.1291 37.1386 35.6921 -27.2574 -27.2574 -27.2574 -25.1291 37.1386 36.6921 -15.7802 -15.7802 -15.7802 -25.1291 38.1386 35.6921 -52.0846 -52.0846 -52.0846 -25.1291 38.1386 36.6921 -51.2774 -51.2774 -51.2774 -24.1291 39.1386 34.6921 -10.828 -10.828 -10.828 -24.1291 40.1386 33.6921 8.19132 8.19132 8.19132 -24.1291 40.1386 34.6921 -98.4802 -98.4802 -98.4802 -25.1291 39.1386 33.6921 -31.6995 -31.6995 -31.6995 -25.1291 39.1386 34.6921 10.4631 10.4631 10.4631 -25.1291 40.1386 33.6921 39.5344 39.5344 39.5344 -25.1291 40.1386 34.6921 -12.4583 -12.4583 -12.4583 -24.1291 39.1386 35.6921 64.2726 64.2726 64.2726 -24.1291 39.1386 36.6921 -6.78621 -6.78621 -6.78621 -24.1291 40.1386 35.6921 -243.211 -243.211 -243.211 -24.1291 40.1386 36.6921 -44.2674 -44.2674 -44.2674 -26.1291 37.1386 33.6921 -37.1172 -37.1172 -37.1172 -26.1291 37.1386 34.6921 -62.8122 -62.8122 -62.8122 -26.1291 38.1386 33.6921 -117.094 -117.094 -117.094 -26.1291 38.1386 34.6921 -14.9496 -14.9496 -14.9496 -27.1291 37.1386 34.6921 109.381 109.381 109.381 -26.1291 37.1386 35.6921 -83.217 -83.217 -83.217 -26.1291 37.1386 36.6921 20.7608 20.7608 20.7608 -26.1291 38.1386 36.6921 -49.6975 -49.6975 -49.6975 -27.1291 37.1386 35.6921 107.962 107.962 107.962 -27.1291 37.1386 36.6921 -47.3507 -47.3507 -47.3507 -27.1291 38.1386 36.6921 -57.2333 -57.2333 -57.2333 -26.1291 39.1386 33.6921 -9.52375 -9.52375 -9.52375 -26.1291 40.1386 33.6921 -153.362 -153.362 -153.362 -26.1291 40.1386 34.6921 -51.1148 -51.1148 -51.1148 -27.1291 40.1386 33.6921 -367.622 -367.622 -367.622 -27.1291 40.1386 34.6921 -17.7921 -17.7921 -17.7921 -26.1291 40.1386 35.6921 -18.1885 -18.1885 -18.1885 -26.1291 40.1386 36.6921 -13.3346 -13.3346 -13.3346 -27.1291 39.1386 36.6921 -76.8455 -76.8455 -76.8455 -27.1291 40.1386 35.6921 16.2053 16.2053 16.2053 -27.1291 40.1386 36.6921 -29.0519 -29.0519 -29.0519 -24.1291 37.1386 37.6921 -37.6119 -37.6119 -37.6119 -24.1291 37.1386 38.6921 63.0404 63.0404 63.0404 -24.1291 38.1386 37.6921 -27.3231 -27.3231 -27.3231 -24.1291 38.1386 38.6921 0.464113 0.464113 0.464113 -25.1291 37.1386 37.6921 15.0777 15.0777 15.0777 -25.1291 37.1386 38.6921 111.838 111.838 111.838 -25.1291 38.1386 37.6921 49.044 49.044 49.044 -25.1291 38.1386 38.6921 13.7471 13.7471 13.7471 -24.1291 37.1386 39.6921 127.053 127.053 127.053 -24.1291 38.1386 39.6921 8.52594 8.52594 8.52594 -24.1291 39.1386 37.6921 44.9155 44.9155 44.9155 -24.1291 39.1386 38.6921 2.77143 2.77143 2.77143 -25.1291 39.1386 38.6921 -31.5098 -31.5098 -31.5098 -25.1291 40.1386 38.6921 -32.6826 -32.6826 -32.6826 -24.1291 39.1386 39.6921 -30.2029 -30.2029 -30.2029 -24.1291 40.1386 39.6921 -14.2809 -14.2809 -14.2809 -24.1291 40.1386 40.6921 -88.8323 -88.8323 -88.8323 -25.1291 39.1386 39.6921 55.0948 55.0948 55.0948 -25.1291 39.1386 40.6921 69.2904 69.2904 69.2904 -25.1291 40.1386 39.6921 7.98417 7.98417 7.98417 -25.1291 40.1386 40.6921 36.3631 36.3631 36.3631 -26.1291 37.1386 37.6921 -57.745 -57.745 -57.745 -26.1291 37.1386 38.6921 17.499 17.499 17.499 -26.1291 38.1386 37.6921 26.9081 26.9081 26.9081 -26.1291 38.1386 38.6921 14.6975 14.6975 14.6975 -27.1291 37.1386 37.6921 -10.8895 -10.8895 -10.8895 -27.1291 37.1386 38.6921 31.568 31.568 31.568 -27.1291 38.1386 37.6921 -7.49878 -7.49878 -7.49878 -27.1291 38.1386 38.6921 -24.8743 -24.8743 -24.8743 -26.1291 37.1386 39.6921 42.4526 42.4526 42.4526 -26.1291 38.1386 39.6921 111.204 111.204 111.204 -27.1291 37.1386 39.6921 -40.7326 -40.7326 -40.7326 -27.1291 38.1386 39.6921 -124.409 -124.409 -124.409 -27.1291 38.1386 40.6921 -328.863 -328.863 -328.863 -26.1291 39.1386 37.6921 -117.044 -117.044 -117.044 -26.1291 39.1386 38.6921 45.6573 45.6573 45.6573 -26.1291 40.1386 37.6921 -43.2288 -43.2288 -43.2288 -26.1291 40.1386 38.6921 8.67814 8.67814 8.67814 -27.1291 39.1386 37.6921 -75.5877 -75.5877 -75.5877 -27.1291 39.1386 38.6921 42.9012 42.9012 42.9012 -27.1291 40.1386 37.6921 -44.3725 -44.3725 -44.3725 -27.1291 40.1386 38.6921 0.470558 0.470558 0.470558 -26.1291 39.1386 39.6921 85.5592 85.5592 85.5592 -26.1291 39.1386 40.6921 89.7191 89.7191 89.7191 -26.1291 40.1386 39.6921 -129.549 -129.549 -129.549 -26.1291 40.1386 40.6921 30.1536 30.1536 30.1536 -27.1291 39.1386 39.6921 162.508 162.508 162.508 -27.1291 39.1386 40.6921 -160.991 -160.991 -160.991 -27.1291 40.1386 39.6921 -67.2052 -67.2052 -67.2052 -27.1291 40.1386 40.6921 -74.5728 -74.5728 -74.5728 -24.1291 41.1386 33.6921 53.6985 53.6985 53.6985 -24.1291 41.1386 34.6921 -82.0983 -82.0983 -82.0983 -24.1291 42.1386 33.6921 287.98 287.98 287.98 -24.1291 42.1386 34.6921 84.8132 84.8132 84.8132 -25.1291 41.1386 33.6921 89.0185 89.0185 89.0185 -25.1291 41.1386 34.6921 -58.2398 -58.2398 -58.2398 -25.1291 42.1386 33.6921 100.809 100.809 100.809 -25.1291 42.1386 34.6921 -98.2843 -98.2843 -98.2843 -24.1291 41.1386 35.6921 -712.361 -712.361 -712.361 -24.1291 41.1386 36.6921 -76.1122 -76.1122 -76.1122 -24.1291 42.1386 35.6921 346.862 346.862 346.862 -24.1291 42.1386 36.6921 -20.6186 -20.6186 -20.6186 -25.1291 41.1386 35.6921 -91.5813 -91.5813 -91.5813 -25.1291 41.1386 36.6921 21.625 21.625 21.625 -25.1291 42.1386 36.6921 33.9744 33.9744 33.9744 -24.1291 43.1386 33.6921 -1449.4 -1449.4 -1449.4 -24.1291 43.1386 34.6921 -537.461 -537.461 -537.461 -24.1291 44.1386 33.6921 323.971 323.971 323.971 -24.1291 44.1386 34.6921 310.283 310.283 310.283 -25.1291 43.1386 33.6921 -1325.56 -1325.56 -1325.56 -25.1291 43.1386 34.6921 -402.132 -402.132 -402.132 -25.1291 44.1386 33.6921 -5.49772 -5.49772 -5.49772 -24.1291 43.1386 35.6921 -198.11 -198.11 -198.11 -24.1291 43.1386 36.6921 -61.1489 -61.1489 -61.1489 -24.1291 44.1386 35.6921 -167.018 -167.018 -167.018 -24.1291 44.1386 36.6921 -87.7014 -87.7014 -87.7014 -25.1291 43.1386 36.6921 12.4247 12.4247 12.4247 -25.1291 44.1386 36.6921 -30.0313 -30.0313 -30.0313 -26.1291 41.1386 34.6921 73.1333 73.1333 73.1333 -26.1291 41.1386 35.6921 79.3096 79.3096 79.3096 -26.1291 41.1386 36.6921 -18.4518 -18.4518 -18.4518 -27.1291 41.1386 35.6921 421.414 421.414 421.414 -24.1291 41.1386 38.6921 82.5961 82.5961 82.5961 -24.1291 42.1386 38.6921 -0.00169969 -0.00169969 -0.00169969 -25.1291 41.1386 37.6921 14.931 14.931 14.931 -25.1291 41.1386 38.6921 35.5158 35.5158 35.5158 -25.1291 42.1386 37.6921 -29.5363 -29.5363 -29.5363 -25.1291 42.1386 38.6921 -1.66039 -1.66039 -1.66039 -24.1291 41.1386 39.6921 30.0412 30.0412 30.0412 -24.1291 41.1386 40.6921 -160.014 -160.014 -160.014 -24.1291 42.1386 39.6921 25.7327 25.7327 25.7327 -24.1291 42.1386 40.6921 66.6026 66.6026 66.6026 -25.1291 41.1386 39.6921 -26.6539 -26.6539 -26.6539 -25.1291 41.1386 40.6921 -46.6076 -46.6076 -46.6076 -25.1291 42.1386 40.6921 14.258 14.258 14.258 -24.1291 43.1386 38.6921 -38.056 -38.056 -38.056 -24.1291 44.1386 37.6921 -103.099 -103.099 -103.099 -24.1291 44.1386 38.6921 -234.179 -234.179 -234.179 -25.1291 43.1386 37.6921 -29.5237 -29.5237 -29.5237 -25.1291 43.1386 38.6921 -21.1925 -21.1925 -21.1925 -25.1291 44.1386 37.6921 17.4893 17.4893 17.4893 -25.1291 44.1386 38.6921 -84.2848 -84.2848 -84.2848 -24.1291 43.1386 39.6921 -111.007 -111.007 -111.007 -24.1291 43.1386 40.6921 -22.8787 -22.8787 -22.8787 -24.1291 44.1386 39.6921 -77.1978 -77.1978 -77.1978 -24.1291 44.1386 40.6921 562.708 562.708 562.708 -25.1291 43.1386 40.6921 -5.26277 -5.26277 -5.26277 -25.1291 44.1386 39.6921 -90.0586 -90.0586 -90.0586 -25.1291 44.1386 40.6921 -170.548 -170.548 -170.548 -26.1291 41.1386 37.6921 44.9379 44.9379 44.9379 -26.1291 41.1386 38.6921 -34.8495 -34.8495 -34.8495 -26.1291 44.1386 38.6921 32.3271 32.3271 32.3271 -27.1291 44.1386 38.6921 -42.7395 -42.7395 -42.7395 -26.1291 44.1386 39.6921 59.3676 59.3676 59.3676 -26.1291 44.1386 40.6921 -13.3613 -13.3613 -13.3613 -27.1291 44.1386 39.6921 35.0392 35.0392 35.0392 -27.1291 44.1386 40.6921 -3.16877 -3.16877 -3.16877 -28.1291 37.1386 34.6921 23.167 23.167 23.167 -29.1291 38.1386 34.6921 27.5473 27.5473 27.5473 -28.1291 37.1386 35.6921 29.0579 29.0579 29.0579 -28.1291 37.1386 36.6921 -9.96332 -9.96332 -9.96332 -28.1291 38.1386 35.6921 75.0609 75.0609 75.0609 -28.1291 38.1386 36.6921 -46.6385 -46.6385 -46.6385 -29.1291 37.1386 36.6921 -43.71 -43.71 -43.71 -29.1291 38.1386 35.6921 -29.2199 -29.2199 -29.2199 -29.1291 38.1386 36.6921 -11.9479 -11.9479 -11.9479 -28.1291 39.1386 34.6921 -46.0696 -46.0696 -46.0696 -28.1291 40.1386 33.6921 -154.445 -154.445 -154.445 -28.1291 40.1386 34.6921 17.6365 17.6365 17.6365 -29.1291 39.1386 33.6921 -139.114 -139.114 -139.114 -29.1291 39.1386 34.6921 -69.8868 -69.8868 -69.8868 -29.1291 40.1386 33.6921 -347.052 -347.052 -347.052 -29.1291 40.1386 34.6921 -99.2516 -99.2516 -99.2516 -28.1291 39.1386 35.6921 -8.59537 -8.59537 -8.59537 -28.1291 39.1386 36.6921 -129.471 -129.471 -129.471 -28.1291 40.1386 35.6921 -38.9836 -38.9836 -38.9836 -28.1291 40.1386 36.6921 59.4639 59.4639 59.4639 -29.1291 39.1386 35.6921 -32.2382 -32.2382 -32.2382 -29.1291 39.1386 36.6921 15.5791 15.5791 15.5791 -29.1291 40.1386 36.6921 45.0007 45.0007 45.0007 -30.1291 37.1386 33.6921 31.9624 31.9624 31.9624 -30.1291 37.1386 34.6921 7.46965 7.46965 7.46965 -30.1291 38.1386 33.6921 -23.2087 -23.2087 -23.2087 -30.1291 38.1386 34.6921 7.21987 7.21987 7.21987 -31.1291 37.1386 33.6921 -4.21943 -4.21943 -4.21943 -31.1291 37.1386 34.6921 -12.6977 -12.6977 -12.6977 -31.1291 38.1386 34.6921 -1.0662 -1.0662 -1.0662 -30.1291 37.1386 36.6921 16.1832 16.1832 16.1832 -30.1291 38.1386 35.6921 32.4582 32.4582 32.4582 -30.1291 38.1386 36.6921 17.7204 17.7204 17.7204 -31.1291 37.1386 35.6921 46.3982 46.3982 46.3982 -31.1291 37.1386 36.6921 -88.2555 -88.2555 -88.2555 -31.1291 38.1386 35.6921 -21.1757 -21.1757 -21.1757 -31.1291 38.1386 36.6921 -73.4066 -73.4066 -73.4066 -30.1291 39.1386 33.6921 -31.446 -31.446 -31.446 -30.1291 39.1386 34.6921 -53.4848 -53.4848 -53.4848 -30.1291 40.1386 34.6921 -308.22 -308.22 -308.22 -31.1291 39.1386 33.6921 23.0961 23.0961 23.0961 -31.1291 39.1386 34.6921 -0.917817 -0.917817 -0.917817 -31.1291 40.1386 33.6921 775.097 775.097 775.097 -31.1291 40.1386 34.6921 103.37 103.37 103.37 -30.1291 39.1386 36.6921 13.5731 13.5731 13.5731 -30.1291 40.1386 35.6921 19.7927 19.7927 19.7927 -30.1291 40.1386 36.6921 13.252 13.252 13.252 -31.1291 39.1386 35.6921 -16.879 -16.879 -16.879 -31.1291 39.1386 36.6921 -21.2866 -21.2866 -21.2866 -31.1291 40.1386 35.6921 -180.156 -180.156 -180.156 -31.1291 40.1386 36.6921 3.28602 3.28602 3.28602 -28.1291 37.1386 37.6921 31.7656 31.7656 31.7656 -28.1291 37.1386 38.6921 23.4002 23.4002 23.4002 -28.1291 38.1386 37.6921 11.5498 11.5498 11.5498 -29.1291 37.1386 37.6921 24.1354 24.1354 24.1354 -29.1291 37.1386 38.6921 -116.372 -116.372 -116.372 -29.1291 38.1386 37.6921 33.2427 33.2427 33.2427 -29.1291 38.1386 38.6921 -28.043 -28.043 -28.043 -28.1291 37.1386 39.6921 -17.2002 -17.2002 -17.2002 -28.1291 37.1386 40.6921 147.905 147.905 147.905 -28.1291 38.1386 39.6921 113.712 113.712 113.712 -28.1291 38.1386 40.6921 678.01 678.01 678.01 -29.1291 37.1386 39.6921 -53.0201 -53.0201 -53.0201 -29.1291 37.1386 40.6921 2096.28 2096.28 2096.28 -29.1291 38.1386 39.6921 46.0028 46.0028 46.0028 -29.1291 38.1386 40.6921 -6.96943 -6.96943 -6.96943 -28.1291 39.1386 37.6921 -4.26106 -4.26106 -4.26106 -28.1291 39.1386 38.6921 -71.452 -71.452 -71.452 -28.1291 40.1386 38.6921 -71.481 -71.481 -71.481 -29.1291 39.1386 37.6921 18.6699 18.6699 18.6699 -29.1291 39.1386 38.6921 84.8961 84.8961 84.8961 -29.1291 40.1386 37.6921 -22.3087 -22.3087 -22.3087 -29.1291 40.1386 38.6921 -265.02 -265.02 -265.02 -28.1291 39.1386 39.6921 -0.412164 -0.412164 -0.412164 -28.1291 39.1386 40.6921 -102.676 -102.676 -102.676 -28.1291 40.1386 39.6921 -87.7827 -87.7827 -87.7827 -29.1291 39.1386 39.6921 -400.835 -400.835 -400.835 -29.1291 39.1386 40.6921 -372.911 -372.911 -372.911 -29.1291 40.1386 39.6921 99.7025 99.7025 99.7025 -30.1291 37.1386 37.6921 51.0284 51.0284 51.0284 -30.1291 37.1386 38.6921 -263.159 -263.159 -263.159 -30.1291 38.1386 37.6921 34.4972 34.4972 34.4972 -30.1291 38.1386 38.6921 18.7649 18.7649 18.7649 -31.1291 37.1386 37.6921 -28.4379 -28.4379 -28.4379 -31.1291 37.1386 38.6921 -1.55812 -1.55812 -1.55812 -31.1291 38.1386 37.6921 38.7026 38.7026 38.7026 -31.1291 38.1386 38.6921 -14.4097 -14.4097 -14.4097 -30.1291 37.1386 39.6921 5.18734 5.18734 5.18734 -30.1291 38.1386 39.6921 -174.256 -174.256 -174.256 -31.1291 38.1386 39.6921 78.6689 78.6689 78.6689 -30.1291 39.1386 37.6921 24.3522 24.3522 24.3522 -30.1291 39.1386 38.6921 -35.9305 -35.9305 -35.9305 -30.1291 40.1386 37.6921 -28.9979 -28.9979 -28.9979 -30.1291 40.1386 38.6921 -77.4015 -77.4015 -77.4015 -31.1291 39.1386 38.6921 223.295 223.295 223.295 -31.1291 40.1386 37.6921 -74.5132 -74.5132 -74.5132 -31.1291 40.1386 38.6921 -67.0304 -67.0304 -67.0304 -30.1291 39.1386 39.6921 -204.186 -204.186 -204.186 -31.1291 39.1386 39.6921 100.394 100.394 100.394 -30.1291 41.1386 34.6921 404.558 404.558 404.558 -31.1291 41.1386 33.6921 656.546 656.546 656.546 -31.1291 41.1386 34.6921 85.2753 85.2753 85.2753 -31.1291 42.1386 33.6921 -317.345 -317.345 -317.345 -31.1291 42.1386 34.6921 -638.483 -638.483 -638.483 -30.1291 41.1386 35.6921 106.607 106.607 106.607 -30.1291 41.1386 36.6921 -14.7891 -14.7891 -14.7891 -31.1291 41.1386 35.6921 -488.399 -488.399 -488.399 -31.1291 41.1386 36.6921 -13.3153 -13.3153 -13.3153 -31.1291 42.1386 35.6921 20.6653 20.6653 20.6653 -30.1291 41.1386 37.6921 -6.73004 -6.73004 -6.73004 -30.1291 41.1386 38.6921 29.4605 29.4605 29.4605 -31.1291 41.1386 37.6921 -11.7299 -11.7299 -11.7299 -31.1291 41.1386 38.6921 -64.9054 -64.9054 -64.9054 -24.1291 45.1386 29.692100000000003 766.743 766.743 766.743 -24.1291 45.1386 30.692100000000003 179.842 179.842 179.842 -25.1291 45.1386 29.692100000000003 1113.22 1113.22 1113.22 -25.1291 45.1386 30.692100000000003 488.347 488.347 488.347 -24.1291 45.1386 32.6921 -244.166 -244.166 -244.166 -24.1291 46.1386 32.6921 -268.543 -268.543 -268.543 -24.1291 47.1386 32.6921 580.725 580.725 580.725 -24.1291 45.1386 33.6921 -117.757 -117.757 -117.757 -24.1291 45.1386 34.6921 400.525 400.525 400.525 -24.1291 46.1386 33.6921 -97.4057 -97.4057 -97.4057 -24.1291 46.1386 34.6921 -63.9965 -63.9965 -63.9965 -25.1291 46.1386 34.6921 -16.0729 -16.0729 -16.0729 -24.1291 46.1386 35.6921 277.61 277.61 277.61 -24.1291 46.1386 36.6921 6376.27 6376.27 6376.27 -25.1291 46.1386 35.6921 232.65 232.65 232.65 -25.1291 46.1386 36.6921 242.705 242.705 242.705 -24.1291 47.1386 33.6921 147.278 147.278 147.278 -24.1291 47.1386 34.6921 53.5587 53.5587 53.5587 -24.1291 48.1386 33.6921 3.66797 3.66797 3.66797 -24.1291 48.1386 34.6921 470.026 470.026 470.026 -25.1291 47.1386 34.6921 52.8237 52.8237 52.8237 -25.1291 48.1386 34.6921 -85.903 -85.903 -85.903 -24.1291 47.1386 36.6921 5480.61 5480.61 5480.61 -24.1291 48.1386 35.6921 44.0654 44.0654 44.0654 -24.1291 48.1386 36.6921 -3910.01 -3910.01 -3910.01 -25.1291 47.1386 35.6921 122.821 122.821 122.821 -25.1291 47.1386 36.6921 145.52 145.52 145.52 -25.1291 48.1386 35.6921 -139.57 -139.57 -139.57 -24.1291 45.1386 37.6921 -103.732 -103.732 -103.732 -24.1291 46.1386 37.6921 6247.5 6247.5 6247.5 -25.1291 45.1386 37.6921 415.098 415.098 415.098 -25.1291 45.1386 38.6921 -293.788 -293.788 -293.788 -25.1291 46.1386 37.6921 316.093 316.093 316.093 -25.1291 46.1386 38.6921 -494.295 -494.295 -494.295 -24.1291 45.1386 40.6921 94.1738 94.1738 94.1738 -24.1291 46.1386 40.6921 832.954 832.954 832.954 -25.1291 45.1386 40.6921 -15.1675 -15.1675 -15.1675 -24.1291 47.1386 37.6921 -1365.81 -1365.81 -1365.81 -24.1291 47.1386 38.6921 -6427.97 -6427.97 -6427.97 -24.1291 48.1386 38.6921 7420.38 7420.38 7420.38 -25.1291 47.1386 37.6921 -141.774 -141.774 -141.774 -25.1291 47.1386 38.6921 -91.2281 -91.2281 -91.2281 -25.1291 48.1386 38.6921 -427.043 -427.043 -427.043 -24.1291 47.1386 39.6921 647.546 647.546 647.546 -24.1291 47.1386 40.6921 629.13 629.13 629.13 -24.1291 48.1386 39.6921 -542.095 -542.095 -542.095 -24.1291 48.1386 40.6921 672.27 672.27 672.27 -25.1291 47.1386 39.6921 25.0921 25.0921 25.0921 -25.1291 47.1386 40.6921 178.507 178.507 178.507 -25.1291 48.1386 39.6921 206.528 206.528 206.528 -25.1291 48.1386 40.6921 253.384 253.384 253.384 -26.1291 45.1386 38.6921 -155.318 -155.318 -155.318 -26.1291 46.1386 38.6921 -635.724 -635.724 -635.724 -27.1291 45.1386 38.6921 -29.9223 -29.9223 -29.9223 -27.1291 46.1386 38.6921 -70.8283 -70.8283 -70.8283 -26.1291 45.1386 40.6921 -145.18 -145.18 -145.18 -26.1291 46.1386 40.6921 92.5455 92.5455 92.5455 -27.1291 45.1386 39.6921 24.1715 24.1715 24.1715 -27.1291 45.1386 40.6921 6.84605 6.84605 6.84605 -27.1291 46.1386 39.6921 -170.068 -170.068 -170.068 -27.1291 46.1386 40.6921 -8.65591 -8.65591 -8.65591 -26.1291 47.1386 38.6921 -23.8828 -23.8828 -23.8828 -26.1291 48.1386 38.6921 -435.494 -435.494 -435.494 -27.1291 47.1386 38.6921 52.8293 52.8293 52.8293 -26.1291 47.1386 40.6921 224.947 224.947 224.947 -26.1291 48.1386 39.6921 -241.135 -241.135 -241.135 -26.1291 48.1386 40.6921 364.994 364.994 364.994 -27.1291 47.1386 39.6921 -44.4728 -44.4728 -44.4728 -27.1291 47.1386 40.6921 -64.12 -64.12 -64.12 -27.1291 48.1386 39.6921 134.414 134.414 134.414 -24.1291 49.1386 34.6921 216.795 216.795 216.795 -24.1291 49.1386 35.6921 94.9774 94.9774 94.9774 -24.1291 49.1386 36.6921 -30.0655 -30.0655 -30.0655 -32.1291 40.1386 28.692100000000003 44.3661 44.3661 44.3661 -32.1291 39.1386 29.692100000000003 56.1011 56.1011 56.1011 -32.1291 39.1386 30.692100000000003 91.3889 91.3889 91.3889 -32.1291 40.1386 29.692100000000003 -2430.42 -2430.42 -2430.42 -33.1291 39.1386 29.692100000000003 -0.593079 -0.593079 -0.593079 -33.1291 39.1386 30.692100000000003 -25.459 -25.459 -25.459 -33.1291 40.1386 29.692100000000003 -801.292 -801.292 -801.292 -33.1291 40.1386 30.692100000000003 -3321.34 -3321.34 -3321.34 -32.1291 39.1386 31.692100000000003 -66.5028 -66.5028 -66.5028 -32.1291 39.1386 32.6921 -9.17839 -9.17839 -9.17839 -32.1291 40.1386 31.692100000000003 725.846 725.846 725.846 -32.1291 40.1386 32.6921 2964.55 2964.55 2964.55 -33.1291 39.1386 31.692100000000003 -130.487 -130.487 -130.487 -33.1291 39.1386 32.6921 -2.63606 -2.63606 -2.63606 -33.1291 40.1386 31.692100000000003 1203.42 1203.42 1203.42 -33.1291 40.1386 32.6921 734.598 734.598 734.598 -34.1291 40.1386 29.692100000000003 593.175 593.175 593.175 -34.1291 40.1386 30.692100000000003 3455.31 3455.31 3455.31 -35.1291 40.1386 30.692100000000003 30.5412 30.5412 30.5412 -34.1291 39.1386 31.692100000000003 -109.746 -109.746 -109.746 -34.1291 39.1386 32.6921 -7.86055 -7.86055 -7.86055 -34.1291 40.1386 31.692100000000003 -1519.07 -1519.07 -1519.07 -34.1291 40.1386 32.6921 -3810.29 -3810.29 -3810.29 -35.1291 40.1386 31.692100000000003 34.5063 34.5063 34.5063 -35.1291 40.1386 32.6921 65.9411 65.9411 65.9411 -32.1291 41.1386 28.692100000000003 -2131.3 -2131.3 -2131.3 -32.1291 42.1386 28.692100000000003 -2647.07 -2647.07 -2647.07 -33.1291 41.1386 28.692100000000003 2789.92 2789.92 2789.92 -33.1291 42.1386 28.692100000000003 -1040.62 -1040.62 -1040.62 -32.1291 43.1386 28.692100000000003 326.938 326.938 326.938 -32.1291 41.1386 29.692100000000003 2168.09 2168.09 2168.09 -32.1291 42.1386 29.692100000000003 783.761 783.761 783.761 -33.1291 41.1386 29.692100000000003 -187.991 -187.991 -187.991 -33.1291 42.1386 29.692100000000003 521.38 521.38 521.38 -32.1291 42.1386 31.692100000000003 -788.749 -788.749 -788.749 -32.1291 42.1386 32.6921 -1900.3 -1900.3 -1900.3 -33.1291 42.1386 32.6921 1655.28 1655.28 1655.28 -32.1291 43.1386 29.692100000000003 -1205.08 -1205.08 -1205.08 -32.1291 44.1386 29.692100000000003 -2754.84 -2754.84 -2754.84 -32.1291 44.1386 30.692100000000003 -3807.94 -3807.94 -3807.94 -33.1291 43.1386 29.692100000000003 -290.858 -290.858 -290.858 -33.1291 43.1386 30.692100000000003 70.7222 70.7222 70.7222 -33.1291 44.1386 29.692100000000003 -525.058 -525.058 -525.058 -33.1291 44.1386 30.692100000000003 -1058.7 -1058.7 -1058.7 -32.1291 43.1386 31.692100000000003 -2159.48 -2159.48 -2159.48 -32.1291 43.1386 32.6921 -2832.44 -2832.44 -2832.44 -32.1291 44.1386 31.692100000000003 294.82 294.82 294.82 -33.1291 43.1386 31.692100000000003 277.093 277.093 277.093 -33.1291 43.1386 32.6921 1004.53 1004.53 1004.53 -33.1291 44.1386 31.692100000000003 -468.749 -468.749 -468.749 -34.1291 41.1386 29.692100000000003 525.658 525.658 525.658 -34.1291 41.1386 30.692100000000003 3712.69 3712.69 3712.69 -34.1291 42.1386 29.692100000000003 -1459.27 -1459.27 -1459.27 -34.1291 42.1386 30.692100000000003 1116.14 1116.14 1116.14 -35.1291 41.1386 30.692100000000003 562.98 562.98 562.98 -35.1291 42.1386 30.692100000000003 -619.106 -619.106 -619.106 -34.1291 41.1386 32.6921 -4310.04 -4310.04 -4310.04 -34.1291 42.1386 31.692100000000003 2665.03 2665.03 2665.03 -34.1291 42.1386 32.6921 -1875.0 -1875.0 -1875.0 -35.1291 41.1386 31.692100000000003 908.863 908.863 908.863 -35.1291 41.1386 32.6921 28.1589 28.1589 28.1589 -35.1291 42.1386 31.692100000000003 147.928 147.928 147.928 -35.1291 42.1386 32.6921 -5.10192 -5.10192 -5.10192 -34.1291 43.1386 29.692100000000003 23.2427 23.2427 23.2427 -34.1291 43.1386 30.692100000000003 -419.809 -419.809 -419.809 -34.1291 43.1386 31.692100000000003 1004.63 1004.63 1004.63 -34.1291 43.1386 32.6921 209.366 209.366 209.366 -32.1291 38.1386 34.6921 -11.3449 -11.3449 -11.3449 -33.1291 38.1386 33.6921 115.795 115.795 115.795 -33.1291 38.1386 34.6921 14.8134 14.8134 14.8134 -32.1291 37.1386 35.6921 -21.5344 -21.5344 -21.5344 -32.1291 37.1386 36.6921 48.0748 48.0748 48.0748 -32.1291 38.1386 35.6921 12.7736 12.7736 12.7736 -32.1291 38.1386 36.6921 21.9231 21.9231 21.9231 -33.1291 37.1386 35.6921 -25.9211 -25.9211 -25.9211 -33.1291 37.1386 36.6921 -30.0655 -30.0655 -30.0655 -33.1291 38.1386 35.6921 29.8697 29.8697 29.8697 -32.1291 39.1386 33.6921 -6.08649 -6.08649 -6.08649 -32.1291 39.1386 34.6921 -47.2905 -47.2905 -47.2905 -33.1291 39.1386 33.6921 79.2036 79.2036 79.2036 -33.1291 39.1386 34.6921 -36.176 -36.176 -36.176 -33.1291 40.1386 35.6921 -144.253 -144.253 -144.253 -33.1291 40.1386 36.6921 34.7463 34.7463 34.7463 -34.1291 37.1386 34.6921 22.2156 22.2156 22.2156 -34.1291 38.1386 34.6921 -9.60355 -9.60355 -9.60355 -35.1291 38.1386 34.6921 104.192 104.192 104.192 -34.1291 37.1386 35.6921 13.008 13.008 13.008 -34.1291 37.1386 36.6921 -61.7448 -61.7448 -61.7448 -34.1291 38.1386 35.6921 17.2329 17.2329 17.2329 -35.1291 37.1386 35.6921 20.4521 20.4521 20.4521 -35.1291 37.1386 36.6921 -29.8806 -29.8806 -29.8806 -35.1291 38.1386 35.6921 54.148 54.148 54.148 -35.1291 38.1386 36.6921 5.96677 5.96677 5.96677 -34.1291 39.1386 33.6921 40.7188 40.7188 40.7188 -34.1291 39.1386 34.6921 34.3445 34.3445 34.3445 -34.1291 40.1386 33.6921 -22.4035 -22.4035 -22.4035 -34.1291 40.1386 34.6921 23.9235 23.9235 23.9235 -35.1291 39.1386 33.6921 28.473 28.473 28.473 -35.1291 39.1386 34.6921 30.6997 30.6997 30.6997 -35.1291 40.1386 33.6921 -41.311 -41.311 -41.311 -35.1291 40.1386 34.6921 3.10618 3.10618 3.10618 -34.1291 39.1386 35.6921 68.3286 68.3286 68.3286 -34.1291 40.1386 35.6921 44.9934 44.9934 44.9934 -34.1291 40.1386 36.6921 0.275782 0.275782 0.275782 -35.1291 39.1386 35.6921 37.5571 37.5571 37.5571 -35.1291 39.1386 36.6921 -70.4937 -70.4937 -70.4937 -35.1291 40.1386 35.6921 44.9381 44.9381 44.9381 -35.1291 40.1386 36.6921 -103.005 -103.005 -103.005 -32.1291 37.1386 37.6921 -271.028 -271.028 -271.028 -32.1291 37.1386 38.6921 -174.234 -174.234 -174.234 -32.1291 38.1386 37.6921 -19.7805 -19.7805 -19.7805 -32.1291 38.1386 38.6921 -394.101 -394.101 -394.101 -33.1291 37.1386 37.6921 15.8828 15.8828 15.8828 -33.1291 37.1386 38.6921 202.618 202.618 202.618 -33.1291 38.1386 37.6921 -51.9718 -51.9718 -51.9718 -33.1291 38.1386 38.6921 43.9435 43.9435 43.9435 -32.1291 38.1386 39.6921 -336.078 -336.078 -336.078 -32.1291 39.1386 38.6921 6.77439 6.77439 6.77439 -32.1291 40.1386 37.6921 -69.2352 -69.2352 -69.2352 -32.1291 40.1386 38.6921 -58.8976 -58.8976 -58.8976 -33.1291 39.1386 37.6921 37.5763 37.5763 37.5763 -33.1291 39.1386 38.6921 38.7997 38.7997 38.7997 -33.1291 40.1386 37.6921 -56.2129 -56.2129 -56.2129 -33.1291 40.1386 38.6921 32.5239 32.5239 32.5239 -32.1291 39.1386 39.6921 153.545 153.545 153.545 -34.1291 37.1386 37.6921 355.762 355.762 355.762 -34.1291 37.1386 38.6921 286.359 286.359 286.359 -34.1291 38.1386 37.6921 293.206 293.206 293.206 -34.1291 38.1386 38.6921 79.1358 79.1358 79.1358 -35.1291 37.1386 37.6921 8.94158 8.94158 8.94158 -35.1291 38.1386 37.6921 -4.86821 -4.86821 -4.86821 -34.1291 39.1386 37.6921 58.0706 58.0706 58.0706 -34.1291 39.1386 38.6921 -3.16133 -3.16133 -3.16133 -34.1291 40.1386 37.6921 -62.2347 -62.2347 -62.2347 -35.1291 39.1386 37.6921 -23.7169 -23.7169 -23.7169 -32.1291 41.1386 34.6921 -398.746 -398.746 -398.746 -32.1291 42.1386 33.6921 -251.806 -251.806 -251.806 -32.1291 42.1386 34.6921 -197.386 -197.386 -197.386 -33.1291 42.1386 33.6921 315.581 315.581 315.581 -33.1291 42.1386 34.6921 -182.911 -182.911 -182.911 -32.1291 41.1386 35.6921 -83.2796 -83.2796 -83.2796 -32.1291 41.1386 36.6921 14.3608 14.3608 14.3608 -32.1291 42.1386 35.6921 -465.519 -465.519 -465.519 -33.1291 41.1386 35.6921 5.62367 5.62367 5.62367 -33.1291 41.1386 36.6921 -4.00439 -4.00439 -4.00439 -33.1291 42.1386 35.6921 228.399 228.399 228.399 -32.1291 43.1386 33.6921 -1282.28 -1282.28 -1282.28 -33.1291 43.1386 33.6921 -1419.75 -1419.75 -1419.75 -34.1291 41.1386 33.6921 -292.454 -292.454 -292.454 -34.1291 41.1386 34.6921 -73.4321 -73.4321 -73.4321 -34.1291 42.1386 33.6921 188.404 188.404 188.404 -34.1291 42.1386 34.6921 191.39 191.39 191.39 -35.1291 41.1386 33.6921 -27.8006 -27.8006 -27.8006 -35.1291 41.1386 34.6921 48.9273 48.9273 48.9273 -34.1291 41.1386 35.6921 29.4433 29.4433 29.4433 -32.1291 41.1386 37.6921 -36.3843 -36.3843 -36.3843 -33.1291 41.1386 37.6921 -11.1755 -11.1755 -11.1755 -24.1291 37.1386 42.6921 17.2196 17.2196 17.2196 -24.1291 38.1386 42.6921 23.628 23.628 23.628 -25.1291 37.1386 42.6921 14.924 14.924 14.924 -25.1291 38.1386 42.6921 27.9577 27.9577 27.9577 -24.1291 37.1386 43.6921 34.2883 34.2883 34.2883 -24.1291 37.1386 44.6921 11.2463 11.2463 11.2463 -24.1291 38.1386 43.6921 14.0178 14.0178 14.0178 -24.1291 38.1386 44.6921 -115.948 -115.948 -115.948 -25.1291 37.1386 43.6921 -9.34556 -9.34556 -9.34556 -25.1291 38.1386 43.6921 -0.973704 -0.973704 -0.973704 -24.1291 39.1386 42.6921 15.8111 15.8111 15.8111 -25.1291 39.1386 41.6921 5.46682 5.46682 5.46682 -25.1291 39.1386 42.6921 12.8131 12.8131 12.8131 -25.1291 40.1386 41.6921 -12.6184 -12.6184 -12.6184 -25.1291 40.1386 42.6921 -1.10623 -1.10623 -1.10623 -24.1291 39.1386 43.6921 -29.0767 -29.0767 -29.0767 -24.1291 39.1386 44.6921 -37.4683 -37.4683 -37.4683 -24.1291 40.1386 43.6921 22.6039 22.6039 22.6039 -24.1291 40.1386 44.6921 -15.7841 -15.7841 -15.7841 -25.1291 39.1386 43.6921 46.7407 46.7407 46.7407 -25.1291 40.1386 43.6921 13.1691 13.1691 13.1691 -25.1291 40.1386 44.6921 25.4636 25.4636 25.4636 -26.1291 37.1386 42.6921 -112.241 -112.241 -112.241 -26.1291 38.1386 42.6921 -64.5512 -64.5512 -64.5512 -26.1291 37.1386 43.6921 -31.3267 -31.3267 -31.3267 -26.1291 38.1386 43.6921 -38.5485 -38.5485 -38.5485 -27.1291 37.1386 43.6921 -53.1812 -53.1812 -53.1812 -27.1291 38.1386 43.6921 18.0234 18.0234 18.0234 -26.1291 39.1386 41.6921 12.9588 12.9588 12.9588 -26.1291 39.1386 42.6921 -40.9417 -40.9417 -40.9417 -26.1291 40.1386 41.6921 -169.089 -169.089 -169.089 -27.1291 39.1386 41.6921 54.9392 54.9392 54.9392 -27.1291 39.1386 42.6921 421.968 421.968 421.968 -27.1291 40.1386 41.6921 -98.7996 -98.7996 -98.7996 -26.1291 39.1386 43.6921 -0.314137 -0.314137 -0.314137 -27.1291 39.1386 43.6921 42.439 42.439 42.439 -24.1291 37.1386 45.6921 -49.5256 -49.5256 -49.5256 -24.1291 37.1386 46.6921 -70.1899 -70.1899 -70.1899 -24.1291 38.1386 45.6921 -106.509 -106.509 -106.509 -24.1291 38.1386 46.6921 221.444 221.444 221.444 -25.1291 38.1386 45.6921 -198.583 -198.583 -198.583 -24.1291 37.1386 47.6921 108.737 108.737 108.737 -24.1291 37.1386 48.6921 77.5367 77.5367 77.5367 -24.1291 38.1386 47.6921 130.722 130.722 130.722 -24.1291 38.1386 48.6921 -262.721 -262.721 -262.721 -25.1291 37.1386 48.6921 59.5517 59.5517 59.5517 -25.1291 38.1386 48.6921 29.9984 29.9984 29.9984 -24.1291 39.1386 45.6921 -289.911 -289.911 -289.911 -24.1291 39.1386 46.6921 135.024 135.024 135.024 -24.1291 40.1386 45.6921 -111.468 -111.468 -111.468 -24.1291 40.1386 46.6921 -144.221 -144.221 -144.221 -24.1291 39.1386 48.6921 -230.44 -230.44 -230.44 -24.1291 40.1386 48.6921 415.859 415.859 415.859 -24.1291 42.1386 41.6921 82.0463 82.0463 82.0463 -24.1291 42.1386 42.6921 143.917 143.917 143.917 -25.1291 41.1386 41.6921 205.28 205.28 205.28 -25.1291 41.1386 42.6921 -5.53117 -5.53117 -5.53117 -25.1291 42.1386 41.6921 -35.0701 -35.0701 -35.0701 -25.1291 42.1386 42.6921 0.78626 0.78626 0.78626 -24.1291 41.1386 43.6921 -44.9557 -44.9557 -44.9557 -24.1291 41.1386 44.6921 26.504 26.504 26.504 -24.1291 42.1386 43.6921 53.6336 53.6336 53.6336 -24.1291 42.1386 44.6921 59.1662 59.1662 59.1662 -25.1291 41.1386 43.6921 -35.6439 -35.6439 -35.6439 -25.1291 41.1386 44.6921 8.90929 8.90929 8.90929 -25.1291 42.1386 43.6921 -43.8005 -43.8005 -43.8005 -24.1291 43.1386 41.6921 -221.064 -221.064 -221.064 -24.1291 43.1386 42.6921 -133.907 -133.907 -133.907 -25.1291 43.1386 41.6921 -5.85861 -5.85861 -5.85861 -28.1291 37.1386 41.6921 -301.143 -301.143 -301.143 -28.1291 37.1386 42.6921 -185.014 -185.014 -185.014 -28.1291 38.1386 41.6921 491.178 491.178 491.178 -28.1291 38.1386 42.6921 -180.542 -180.542 -180.542 -29.1291 37.1386 41.6921 -440.123 -440.123 -440.123 -29.1291 37.1386 42.6921 -1357.85 -1357.85 -1357.85 -29.1291 38.1386 41.6921 277.086 277.086 277.086 -29.1291 38.1386 42.6921 121.817 121.817 121.817 -28.1291 37.1386 43.6921 31.5016 31.5016 31.5016 -28.1291 38.1386 43.6921 47.7493 47.7493 47.7493 -29.1291 37.1386 43.6921 66.292 66.292 66.292 -29.1291 38.1386 43.6921 1.55659 1.55659 1.55659 -28.1291 39.1386 41.6921 452.956 452.956 452.956 -28.1291 39.1386 42.6921 28.2691 28.2691 28.2691 -29.1291 39.1386 42.6921 93.982 93.982 93.982 -28.1291 39.1386 43.6921 -179.818 -179.818 -179.818 -24.1291 37.1386 50.6921 67.3857 67.3857 67.3857 -24.1291 38.1386 49.6921 36.2145 36.2145 36.2145 -24.1291 38.1386 50.6921 -201.326 -201.326 -201.326 -25.1291 37.1386 49.6921 101.494 101.494 101.494 -25.1291 37.1386 50.6921 190.195 190.195 190.195 -25.1291 38.1386 49.6921 -193.187 -193.187 -193.187 -25.1291 38.1386 50.6921 -118.783 -118.783 -118.783 -24.1291 37.1386 51.6921 13.3545 13.3545 13.3545 -24.1291 39.1386 49.6921 -661.595 -661.595 -661.595 -24.1291 39.1386 50.6921 452.616 452.616 452.616 -24.1291 40.1386 49.6921 -257.273 -257.273 -257.273 -24.1291 40.1386 50.6921 7.71944 7.71944 7.71944 -24.1291 45.1386 41.6921 -954.37 -954.37 -954.37 -24.1291 46.1386 41.6921 507.312 507.312 507.312 -25.1291 45.1386 41.6921 -292.488 -292.488 -292.488 -25.1291 46.1386 41.6921 -701.532 -701.532 -701.532 -24.1291 47.1386 41.6921 -161.733 -161.733 -161.733 -25.1291 47.1386 41.6921 -97.5299 -97.5299 -97.5299 -26.1291 45.1386 41.6921 -432.051 -432.051 -432.051 -26.1291 46.1386 41.6921 -71.4656 -71.4656 -71.4656 -26.1291 47.1386 41.6921 -329.037 -329.037 -329.037 diff --git a/tensorflow/script/ocnn_lrp_results/4djv.ply b/tensorflow/script/ocnn_lrp_results/4djv.ply deleted file mode 100644 index eaca264..0000000 --- a/tensorflow/script/ocnn_lrp_results/4djv.ply +++ /dev/null @@ -1,8668 +0,0 @@ -ply -format ascii 1.0 -element vertex 8656 -property float x -property float y -property float z -property float nx -property float ny -property float nz -element face 0 -property list uchar int vertex_indices -end_header -8.0628 5.9633 17.0968 108.611 108.611 108.611 -8.0628 4.9633 18.0968 -872.009 -872.009 -872.009 -8.0628 4.9633 19.0968 -736.321 -736.321 -736.321 -8.0628 5.9633 18.0968 77.8559 77.8559 77.8559 -8.0628 5.9633 19.0968 257.449 257.449 257.449 -8.0628 5.9633 20.0968 -655.903 -655.903 -655.903 -8.0628 6.9633 17.0968 38.3083 38.3083 38.3083 -8.0628 6.9633 18.0968 -69.7541 -69.7541 -69.7541 -8.0628 6.9633 19.0968 -119.131 -119.131 -119.131 -8.0628 7.9633 18.0968 -17.1653 -17.1653 -17.1653 -8.0628 7.9633 19.0968 27.4325 27.4325 27.4325 -8.0628 6.9633 20.0968 -275.162 -275.162 -275.162 -8.0628 9.9633 20.0968 3.78985 3.78985 3.78985 -8.0628 9.9633 21.0968 -0.416413 -0.416413 -0.416413 -17.0628 7.9633 5.096800000000002 -17.4587 -17.4587 -17.4587 -18.0628 6.9633 5.096800000000002 6.42031 6.42031 6.42031 -18.0628 7.9633 5.096800000000002 -172.467 -172.467 -172.467 -17.0628 8.9633 5.096800000000002 25.1228 25.1228 25.1228 -18.0628 8.9633 5.096800000000002 -320.46 -320.46 -320.46 -19.0628 6.9633 5.096800000000002 -48.3838 -48.3838 -48.3838 -19.0628 7.9633 5.096800000000002 -124.479 -124.479 -124.479 -19.0628 8.9633 5.096800000000002 218.237 218.237 218.237 -15.0628 1.9633000000000003 17.0968 171.775 171.775 171.775 -16.0628 0.9633000000000003 17.0968 -12.2054 -12.2054 -12.2054 -16.0628 1.9633000000000003 17.0968 -77.4076 -77.4076 -77.4076 -14.0628 -0.03669999999999973 20.0968 69.9464 69.9464 69.9464 -14.0628 -0.03669999999999973 21.0968 309.966 309.966 309.966 -14.0628 1.9633000000000003 18.0968 382.147 382.147 382.147 -14.0628 1.9633000000000003 19.0968 213.466 213.466 213.466 -13.0628 0.9633000000000003 20.0968 14.5134 14.5134 14.5134 -13.0628 0.9633000000000003 21.0968 -5.3907 -5.3907 -5.3907 -13.0628 1.9633000000000003 20.0968 -287.495 -287.495 -287.495 -13.0628 1.9633000000000003 21.0968 -9.62649 -9.62649 -9.62649 -14.0628 0.9633000000000003 20.0968 -82.9671 -82.9671 -82.9671 -14.0628 0.9633000000000003 21.0968 -42.2623 -42.2623 -42.2623 -14.0628 1.9633000000000003 20.0968 -194.617 -194.617 -194.617 -14.0628 1.9633000000000003 21.0968 -54.8055 -54.8055 -54.8055 -15.0628 -0.03669999999999973 20.0968 -41.3423 -41.3423 -41.3423 -15.0628 -0.03669999999999973 21.0968 16.9437 16.9437 16.9437 -15.0628 1.9633000000000003 18.0968 224.063 224.063 224.063 -15.0628 1.9633000000000003 19.0968 93.5606 93.5606 93.5606 -16.0628 0.9633000000000003 18.0968 32.9642 32.9642 32.9642 -16.0628 0.9633000000000003 19.0968 -13.669 -13.669 -13.669 -16.0628 1.9633000000000003 18.0968 77.1741 77.1741 77.1741 -16.0628 1.9633000000000003 19.0968 118.722 118.722 118.722 -15.0628 0.9633000000000003 20.0968 -148.239 -148.239 -148.239 -15.0628 0.9633000000000003 21.0968 -59.3338 -59.3338 -59.3338 -15.0628 1.9633000000000003 20.0968 -222.992 -222.992 -222.992 -16.0628 0.9633000000000003 20.0968 -19.4053 -19.4053 -19.4053 -16.0628 0.9633000000000003 21.0968 -62.1941 -62.1941 -62.1941 -16.0628 1.9633000000000003 20.0968 -40.8151 -40.8151 -40.8151 -16.0628 1.9633000000000003 21.0968 -53.8964 -53.8964 -53.8964 -16.0628 5.9633 7.096800000000002 -3.70379 -3.70379 -3.70379 -15.0628 5.9633 8.096800000000002 157.736 157.736 157.736 -15.0628 5.9633 9.096800000000002 -47.3907 -47.3907 -47.3907 -16.0628 4.9633 8.096800000000002 6.55301 6.55301 6.55301 -16.0628 4.9633 9.096800000000002 4.27476 4.27476 4.27476 -16.0628 5.9633 8.096800000000002 -166.236 -166.236 -166.236 -16.0628 5.9633 9.096800000000002 -75.4006 -75.4006 -75.4006 -16.0628 3.9633000000000003 13.096800000000002 16.0488 16.0488 16.0488 -15.0628 5.9633 10.096800000000002 47.7279 47.7279 47.7279 -16.0628 4.9633 10.096800000000002 14.7342 14.7342 14.7342 -16.0628 5.9633 10.096800000000002 -77.0747 -77.0747 -77.0747 -16.0628 4.9633 13.096800000000002 -17.975 -17.975 -17.975 -15.0628 7.9633 7.096800000000002 -13.9539 -13.9539 -13.9539 -16.0628 6.9633 7.096800000000002 5.14717 5.14717 5.14717 -16.0628 7.9633 6.096800000000002 -13.3175 -13.3175 -13.3175 -16.0628 7.9633 7.096800000000002 -19.0814 -19.0814 -19.0814 -15.0628 6.9633 8.096800000000002 3.30368 3.30368 3.30368 -15.0628 6.9633 9.096800000000002 -1.74734 -1.74734 -1.74734 -15.0628 7.9633 8.096800000000002 -9.81529 -9.81529 -9.81529 -15.0628 7.9633 9.096800000000002 -2.86033 -2.86033 -2.86033 -16.0628 6.9633 8.096800000000002 15.7101 15.7101 15.7101 -16.0628 6.9633 9.096800000000002 5.88402 5.88402 5.88402 -16.0628 7.9633 8.096800000000002 3.41849 3.41849 3.41849 -16.0628 7.9633 9.096800000000002 -0.719295 -0.719295 -0.719295 -15.0628 8.9633 7.096800000000002 -22.8703 -22.8703 -22.8703 -16.0628 8.9633 6.096800000000002 55.4137 55.4137 55.4137 -16.0628 8.9633 7.096800000000002 18.5855 18.5855 18.5855 -16.0628 9.9633 6.096800000000002 29.7397 29.7397 29.7397 -16.0628 9.9633 7.096800000000002 -40.6568 -40.6568 -40.6568 -15.0628 8.9633 8.096800000000002 2.00097 2.00097 2.00097 -15.0628 8.9633 9.096800000000002 -0.572569 -0.572569 -0.572569 -16.0628 8.9633 8.096800000000002 6.16538 6.16538 6.16538 -16.0628 8.9633 9.096800000000002 -0.436707 -0.436707 -0.436707 -16.0628 9.9633 8.096800000000002 -6.06134 -6.06134 -6.06134 -16.0628 9.9633 9.096800000000002 5.57755 5.57755 5.57755 -13.0628 6.9633 13.096800000000002 5.66897 5.66897 5.66897 -13.0628 7.9633 12.096800000000002 -0.886595 -0.886595 -0.886595 -13.0628 7.9633 13.096800000000002 -26.5066 -26.5066 -26.5066 -14.0628 6.9633 12.096800000000002 2.58252 2.58252 2.58252 -14.0628 6.9633 13.096800000000002 -14.3945 -14.3945 -14.3945 -14.0628 7.9633 12.096800000000002 -77.1194 -77.1194 -77.1194 -13.0628 8.9633 12.096800000000002 -11.1405 -11.1405 -11.1405 -13.0628 8.9633 13.096800000000002 -3.98816 -3.98816 -3.98816 -14.0628 8.9633 12.096800000000002 -14.8675 -14.8675 -14.8675 -14.0628 8.9633 13.096800000000002 2.53691 2.53691 2.53691 -14.0628 9.9633 12.096800000000002 -5.00253 -5.00253 -5.00253 -14.0628 9.9633 13.096800000000002 2.85294 2.85294 2.85294 -15.0628 6.9633 10.096800000000002 20.6075 20.6075 20.6075 -16.0628 6.9633 10.096800000000002 -9.59952 -9.59952 -9.59952 -16.0628 6.9633 11.096800000000002 -97.0035 -97.0035 -97.0035 -16.0628 7.9633 10.096800000000002 -21.9127 -21.9127 -21.9127 -16.0628 7.9633 11.096800000000002 -23.9506 -23.9506 -23.9506 -15.0628 6.9633 12.096800000000002 108.329 108.329 108.329 -15.0628 6.9633 13.096800000000002 3.94557 3.94557 3.94557 -15.0628 7.9633 12.096800000000002 49.2971 49.2971 49.2971 -16.0628 6.9633 12.096800000000002 156.763 156.763 156.763 -16.0628 6.9633 13.096800000000002 -6.344 -6.344 -6.344 -16.0628 7.9633 12.096800000000002 89.6631 89.6631 89.6631 -16.0628 7.9633 13.096800000000002 20.2768 20.2768 20.2768 -16.0628 8.9633 10.096800000000002 -6.97452 -6.97452 -6.97452 -15.0628 8.9633 12.096800000000002 0.967694 0.967694 0.967694 -15.0628 9.9633 12.096800000000002 -4.95198 -4.95198 -4.95198 -15.0628 9.9633 13.096800000000002 -2.52924 -2.52924 -2.52924 -16.0628 8.9633 12.096800000000002 -10.5299 -10.5299 -10.5299 -16.0628 9.9633 12.096800000000002 -0.547126 -0.547126 -0.547126 -16.0628 9.9633 13.096800000000002 3.6799 3.6799 3.6799 -9.0628 3.9633000000000003 17.0968 40.3895 40.3895 40.3895 -10.0628 3.9633000000000003 17.0968 136.378 136.378 136.378 -9.0628 4.9633 17.0968 119.727 119.727 119.727 -9.0628 5.9633 17.0968 75.1904 75.1904 75.1904 -10.0628 4.9633 16.0968 -12.3452 -12.3452 -12.3452 -10.0628 4.9633 17.0968 -57.7538 -57.7538 -57.7538 -10.0628 5.9633 16.0968 -23.0614 -23.0614 -23.0614 -10.0628 5.9633 17.0968 19.0016 19.0016 19.0016 -11.0628 3.9633000000000003 17.0968 -103.035 -103.035 -103.035 -12.0628 2.9633000000000003 16.0968 117.251 117.251 117.251 -12.0628 2.9633000000000003 17.0968 -209.025 -209.025 -209.025 -12.0628 3.9633000000000003 16.0968 7.71192 7.71192 7.71192 -12.0628 3.9633000000000003 17.0968 -174.359 -174.359 -174.359 -11.0628 4.9633 16.0968 -2.05272 -2.05272 -2.05272 -11.0628 4.9633 17.0968 88.3191 88.3191 88.3191 -11.0628 5.9633 16.0968 55.7682 55.7682 55.7682 -11.0628 5.9633 17.0968 -21.8208 -21.8208 -21.8208 -12.0628 4.9633 16.0968 -42.7852 -42.7852 -42.7852 -12.0628 4.9633 17.0968 -6.17289 -6.17289 -6.17289 -12.0628 5.9633 16.0968 27.2094 27.2094 27.2094 -12.0628 5.9633 17.0968 -26.8089 -26.8089 -26.8089 -9.0628 3.9633000000000003 18.0968 177.763 177.763 177.763 -9.0628 3.9633000000000003 19.0968 -124.74 -124.74 -124.74 -10.0628 3.9633000000000003 18.0968 357.416 357.416 357.416 -10.0628 3.9633000000000003 19.0968 -205.787 -205.787 -205.787 -9.0628 4.9633 18.0968 1008.88 1008.88 1008.88 -9.0628 4.9633 19.0968 1308.51 1308.51 1308.51 -9.0628 5.9633 18.0968 -665.18 -665.18 -665.18 -10.0628 4.9633 19.0968 118.879 118.879 118.879 -9.0628 4.9633 20.0968 823.182 823.182 823.182 -9.0628 5.9633 20.0968 -466.932 -466.932 -466.932 -9.0628 5.9633 21.0968 -896.891 -896.891 -896.891 -10.0628 4.9633 20.0968 -266.898 -266.898 -266.898 -10.0628 4.9633 21.0968 -1865.31 -1865.31 -1865.31 -10.0628 5.9633 20.0968 181.34 181.34 181.34 -10.0628 5.9633 21.0968 691.136 691.136 691.136 -11.0628 3.9633000000000003 18.0968 -86.6811 -86.6811 -86.6811 -11.0628 3.9633000000000003 19.0968 12.4394 12.4394 12.4394 -12.0628 2.9633000000000003 18.0968 -100.294 -100.294 -100.294 -12.0628 2.9633000000000003 19.0968 -143.008 -143.008 -143.008 -12.0628 3.9633000000000003 18.0968 44.5815 44.5815 44.5815 -12.0628 3.9633000000000003 19.0968 -175.583 -175.583 -175.583 -12.0628 3.9633000000000003 20.0968 -69.8102 -69.8102 -69.8102 -11.0628 4.9633 19.0968 22.2323 22.2323 22.2323 -11.0628 5.9633 18.0968 116.177 116.177 116.177 -11.0628 5.9633 19.0968 -110.589 -110.589 -110.589 -12.0628 4.9633 19.0968 -98.283 -98.283 -98.283 -12.0628 5.9633 18.0968 87.3867 87.3867 87.3867 -12.0628 5.9633 19.0968 34.6508 34.6508 34.6508 -11.0628 4.9633 20.0968 70.0399 70.0399 70.0399 -11.0628 4.9633 21.0968 -698.618 -698.618 -698.618 -12.0628 4.9633 20.0968 -55.2287 -55.2287 -55.2287 -12.0628 4.9633 21.0968 801.227 801.227 801.227 -12.0628 5.9633 21.0968 207.78 207.78 207.78 -9.0628 6.9633 17.0968 44.0193 44.0193 44.0193 -9.0628 7.9633 17.0968 16.2594 16.2594 16.2594 -10.0628 6.9633 17.0968 -7.10268 -7.10268 -7.10268 -10.0628 7.9633 17.0968 -82.0215 -82.0215 -82.0215 -11.0628 6.9633 17.0968 -153.319 -153.319 -153.319 -11.0628 9.9633 17.0968 -8.60625 -8.60625 -8.60625 -12.0628 8.9633 16.0968 5.28267 5.28267 5.28267 -12.0628 8.9633 17.0968 -34.6374 -34.6374 -34.6374 -12.0628 9.9633 16.0968 0.449352 0.449352 0.449352 -12.0628 9.9633 17.0968 -2.9679 -2.9679 -2.9679 -9.0628 6.9633 18.0968 152.411 152.411 152.411 -9.0628 6.9633 19.0968 25.3445 25.3445 25.3445 -9.0628 7.9633 18.0968 8.36263 8.36263 8.36263 -9.0628 7.9633 19.0968 9.67124 9.67124 9.67124 -10.0628 7.9633 18.0968 25.2276 25.2276 25.2276 -10.0628 7.9633 19.0968 -21.1269 -21.1269 -21.1269 -9.0628 6.9633 20.0968 -71.2236 -71.2236 -71.2236 -9.0628 6.9633 21.0968 595.38 595.38 595.38 -9.0628 7.9633 20.0968 25.0968 25.0968 25.0968 -9.0628 7.9633 21.0968 14.9527 14.9527 14.9527 -10.0628 6.9633 21.0968 926.591 926.591 926.591 -10.0628 7.9633 21.0968 3.59375 3.59375 3.59375 -9.0628 8.9633 19.0968 -31.8646 -31.8646 -31.8646 -9.0628 9.9633 19.0968 13.9464 13.9464 13.9464 -10.0628 8.9633 18.0968 -13.5293 -13.5293 -13.5293 -10.0628 8.9633 19.0968 -9.33223 -9.33223 -9.33223 -10.0628 9.9633 18.0968 7.82098 7.82098 7.82098 -10.0628 9.9633 19.0968 5.08466 5.08466 5.08466 -9.0628 8.9633 20.0968 8.3508 8.3508 8.3508 -9.0628 8.9633 21.0968 2.81168 2.81168 2.81168 -9.0628 9.9633 20.0968 0.639585 0.639585 0.639585 -9.0628 9.9633 21.0968 -6.58595 -6.58595 -6.58595 -10.0628 8.9633 20.0968 -6.39788 -6.39788 -6.39788 -10.0628 8.9633 21.0968 0.149891 0.149891 0.149891 -10.0628 9.9633 20.0968 -5.07395 -5.07395 -5.07395 -11.0628 6.9633 18.0968 33.836 33.836 33.836 -11.0628 6.9633 19.0968 -77.8415 -77.8415 -77.8415 -11.0628 7.9633 18.0968 0.940321 0.940321 0.940321 -12.0628 6.9633 18.0968 70.4743 70.4743 70.4743 -12.0628 6.9633 19.0968 212.959 212.959 212.959 -12.0628 7.9633 18.0968 -92.3346 -92.3346 -92.3346 -12.0628 7.9633 19.0968 -72.9391 -72.9391 -72.9391 -11.0628 6.9633 21.0968 1215.08 1215.08 1215.08 -11.0628 7.9633 21.0968 -0.229133 -0.229133 -0.229133 -12.0628 6.9633 20.0968 -79.7959 -79.7959 -79.7959 -12.0628 6.9633 21.0968 -900.459 -900.459 -900.459 -12.0628 7.9633 21.0968 1.22078 1.22078 1.22078 -11.0628 8.9633 18.0968 0.209506 0.209506 0.209506 -11.0628 9.9633 18.0968 0.208422 0.208422 0.208422 -11.0628 9.9633 19.0968 2.3582 2.3582 2.3582 -12.0628 8.9633 18.0968 -37.9795 -37.9795 -37.9795 -12.0628 8.9633 19.0968 -59.4089 -59.4089 -59.4089 -12.0628 9.9633 18.0968 -0.530718 -0.530718 -0.530718 -12.0628 9.9633 19.0968 3.46639 3.46639 3.46639 -11.0628 9.9633 20.0968 -9.32566 -9.32566 -9.32566 -12.0628 9.9633 20.0968 6.44515 6.44515 6.44515 -13.0628 2.9633000000000003 16.0968 8.05987 8.05987 8.05987 -13.0628 2.9633000000000003 17.0968 -142.191 -142.191 -142.191 -13.0628 3.9633000000000003 16.0968 -8.00295 -8.00295 -8.00295 -14.0628 2.9633000000000003 16.0968 -26.0478 -26.0478 -26.0478 -14.0628 2.9633000000000003 17.0968 -117.895 -117.895 -117.895 -14.0628 3.9633000000000003 16.0968 -10.2609 -10.2609 -10.2609 -14.0628 3.9633000000000003 17.0968 20.4492 20.4492 20.4492 -13.0628 5.9633 14.096800000000002 -1.82938 -1.82938 -1.82938 -13.0628 5.9633 15.096800000000002 -62.9513 -62.9513 -62.9513 -14.0628 5.9633 14.096800000000002 -27.6916 -27.6916 -27.6916 -14.0628 5.9633 15.096800000000002 -7.01521 -7.01521 -7.01521 -13.0628 4.9633 16.0968 17.2682 17.2682 17.2682 -13.0628 5.9633 16.0968 39.6825 39.6825 39.6825 -13.0628 5.9633 17.0968 38.7701 38.7701 38.7701 -14.0628 4.9633 16.0968 14.6135 14.6135 14.6135 -14.0628 4.9633 17.0968 -13.6297 -13.6297 -13.6297 -14.0628 5.9633 16.0968 -7.72961 -7.72961 -7.72961 -14.0628 5.9633 17.0968 38.3677 38.3677 38.3677 -16.0628 3.9633000000000003 14.096800000000002 133.476 133.476 133.476 -15.0628 2.9633000000000003 17.0968 -213.406 -213.406 -213.406 -15.0628 3.9633000000000003 16.0968 63.2074 63.2074 63.2074 -15.0628 3.9633000000000003 17.0968 -5.44568 -5.44568 -5.44568 -16.0628 2.9633000000000003 17.0968 -68.2015 -68.2015 -68.2015 -16.0628 3.9633000000000003 17.0968 -48.6267 -48.6267 -48.6267 -15.0628 5.9633 14.096800000000002 -7.03391 -7.03391 -7.03391 -15.0628 5.9633 15.096800000000002 -4.75609 -4.75609 -4.75609 -16.0628 4.9633 14.096800000000002 9.72783 9.72783 9.72783 -16.0628 4.9633 15.096800000000002 -44.218 -44.218 -44.218 -16.0628 5.9633 14.096800000000002 -7.50851 -7.50851 -7.50851 -16.0628 5.9633 15.096800000000002 5.72606 5.72606 5.72606 -15.0628 4.9633 16.0968 -10.4966 -10.4966 -10.4966 -15.0628 4.9633 17.0968 -22.6787 -22.6787 -22.6787 -15.0628 5.9633 16.0968 0.0567734 0.0567734 0.0567734 -15.0628 5.9633 17.0968 -49.703 -49.703 -49.703 -16.0628 4.9633 16.0968 -56.1901 -56.1901 -56.1901 -16.0628 4.9633 17.0968 -53.7436 -53.7436 -53.7436 -16.0628 5.9633 16.0968 11.987 11.987 11.987 -16.0628 5.9633 17.0968 -31.668 -31.668 -31.668 -13.0628 2.9633000000000003 18.0968 215.883 215.883 215.883 -13.0628 2.9633000000000003 19.0968 -71.2539 -71.2539 -71.2539 -13.0628 3.9633000000000003 19.0968 -73.6391 -73.6391 -73.6391 -14.0628 2.9633000000000003 18.0968 366.92 366.92 366.92 -14.0628 2.9633000000000003 19.0968 154.548 154.548 154.548 -14.0628 3.9633000000000003 19.0968 267.068 267.068 267.068 -13.0628 2.9633000000000003 21.0968 29.4397 29.4397 29.4397 -13.0628 3.9633000000000003 20.0968 15.8928 15.8928 15.8928 -13.0628 3.9633000000000003 21.0968 113.653 113.653 113.653 -14.0628 2.9633000000000003 20.0968 26.0237 26.0237 26.0237 -14.0628 2.9633000000000003 21.0968 -150.033 -150.033 -150.033 -14.0628 3.9633000000000003 20.0968 -195.665 -195.665 -195.665 -14.0628 3.9633000000000003 21.0968 39.4137 39.4137 39.4137 -13.0628 5.9633 18.0968 91.7047 91.7047 91.7047 -13.0628 5.9633 19.0968 -4.59233 -4.59233 -4.59233 -14.0628 5.9633 18.0968 -5.22213 -5.22213 -5.22213 -14.0628 5.9633 19.0968 -65.2363 -65.2363 -65.2363 -13.0628 4.9633 20.0968 -64.5838 -64.5838 -64.5838 -13.0628 4.9633 21.0968 -15.8374 -15.8374 -15.8374 -13.0628 5.9633 21.0968 -50.2692 -50.2692 -50.2692 -14.0628 4.9633 20.0968 111.932 111.932 111.932 -14.0628 4.9633 21.0968 -13.7921 -13.7921 -13.7921 -14.0628 5.9633 20.0968 -3.21545 -3.21545 -3.21545 -14.0628 5.9633 21.0968 -11.9162 -11.9162 -11.9162 -15.0628 2.9633000000000003 18.0968 -33.7915 -33.7915 -33.7915 -15.0628 3.9633000000000003 20.0968 -306.356 -306.356 -306.356 -15.0628 3.9633000000000003 21.0968 -10.1183 -10.1183 -10.1183 -15.0628 5.9633 18.0968 -8.77755 -8.77755 -8.77755 -15.0628 5.9633 19.0968 43.3093 43.3093 43.3093 -16.0628 4.9633 18.0968 -90.9377 -90.9377 -90.9377 -16.0628 4.9633 19.0968 311.473 311.473 311.473 -16.0628 5.9633 18.0968 14.8035 14.8035 14.8035 -16.0628 5.9633 19.0968 3.79539 3.79539 3.79539 -15.0628 4.9633 20.0968 187.001 187.001 187.001 -15.0628 4.9633 21.0968 61.3036 61.3036 61.3036 -15.0628 5.9633 20.0968 -86.6463 -86.6463 -86.6463 -15.0628 5.9633 21.0968 -8.60793 -8.60793 -8.60793 -16.0628 4.9633 20.0968 190.237 190.237 190.237 -16.0628 4.9633 21.0968 120.242 120.242 120.242 -16.0628 5.9633 20.0968 113.624 113.624 113.624 -16.0628 5.9633 21.0968 123.295 123.295 123.295 -13.0628 6.9633 14.096800000000002 2.18776 2.18776 2.18776 -13.0628 6.9633 15.096800000000002 0.0635636 0.0635636 0.0635636 -13.0628 7.9633 14.096800000000002 -9.32 -9.32 -9.32 -13.0628 7.9633 15.096800000000002 4.34929 4.34929 4.34929 -14.0628 6.9633 14.096800000000002 -27.0388 -27.0388 -27.0388 -13.0628 6.9633 16.0968 -2.98358 -2.98358 -2.98358 -13.0628 7.9633 16.0968 4.56351 4.56351 4.56351 -14.0628 6.9633 16.0968 2.27075 2.27075 2.27075 -14.0628 6.9633 17.0968 -77.987 -77.987 -77.987 -14.0628 7.9633 16.0968 7.9586 7.9586 7.9586 -14.0628 7.9633 17.0968 14.2687 14.2687 14.2687 -13.0628 8.9633 14.096800000000002 3.73045 3.73045 3.73045 -13.0628 8.9633 15.096800000000002 -3.97334 -3.97334 -3.97334 -13.0628 9.9633 15.096800000000002 0.322158 0.322158 0.322158 -14.0628 8.9633 14.096800000000002 1.58703 1.58703 1.58703 -14.0628 8.9633 15.096800000000002 1.67519 1.67519 1.67519 -14.0628 9.9633 14.096800000000002 9.63024 9.63024 9.63024 -14.0628 9.9633 15.096800000000002 8.08798 8.08798 8.08798 -13.0628 8.9633 16.0968 2.92826 2.92826 2.92826 -13.0628 8.9633 17.0968 -1.80706 -1.80706 -1.80706 -13.0628 9.9633 16.0968 3.90126 3.90126 3.90126 -14.0628 8.9633 16.0968 10.335 10.335 10.335 -14.0628 8.9633 17.0968 -0.465198 -0.465198 -0.465198 -14.0628 9.9633 16.0968 -4.38167 -4.38167 -4.38167 -14.0628 9.9633 17.0968 -6.04898 -6.04898 -6.04898 -15.0628 6.9633 14.096800000000002 1.00008 1.00008 1.00008 -16.0628 6.9633 14.096800000000002 6.00145 6.00145 6.00145 -16.0628 6.9633 15.096800000000002 -0.165776 -0.165776 -0.165776 -16.0628 7.9633 14.096800000000002 -0.553526 -0.553526 -0.553526 -16.0628 7.9633 15.096800000000002 5.43956 5.43956 5.43956 -15.0628 6.9633 16.0968 0.303856 0.303856 0.303856 -15.0628 6.9633 17.0968 141.778 141.778 141.778 -15.0628 7.9633 17.0968 1105.35 1105.35 1105.35 -16.0628 6.9633 16.0968 6.38774 6.38774 6.38774 -16.0628 6.9633 17.0968 805.821 805.821 805.821 -16.0628 7.9633 17.0968 1230.45 1230.45 1230.45 -15.0628 8.9633 15.096800000000002 0.909702 0.909702 0.909702 -15.0628 9.9633 14.096800000000002 -2.14406 -2.14406 -2.14406 -15.0628 9.9633 15.096800000000002 -5.22684 -5.22684 -5.22684 -15.0628 8.9633 17.0968 -272.762 -272.762 -272.762 -15.0628 9.9633 16.0968 7.30862 7.30862 7.30862 -15.0628 9.9633 17.0968 7.06151 7.06151 7.06151 -16.0628 8.9633 17.0968 -651.877 -651.877 -651.877 -16.0628 9.9633 17.0968 6.30414 6.30414 6.30414 -13.0628 6.9633 18.0968 -77.5914 -77.5914 -77.5914 -13.0628 6.9633 19.0968 -145.951 -145.951 -145.951 -13.0628 7.9633 18.0968 133.723 133.723 133.723 -13.0628 7.9633 19.0968 -233.441 -233.441 -233.441 -14.0628 6.9633 18.0968 -281.22 -281.22 -281.22 -14.0628 6.9633 19.0968 117.075 117.075 117.075 -13.0628 6.9633 20.0968 23.0401 23.0401 23.0401 -13.0628 6.9633 21.0968 -48.6154 -48.6154 -48.6154 -13.0628 7.9633 20.0968 73.1293 73.1293 73.1293 -13.0628 7.9633 21.0968 56.7117 56.7117 56.7117 -14.0628 6.9633 20.0968 158.537 158.537 158.537 -14.0628 6.9633 21.0968 -68.0265 -68.0265 -68.0265 -14.0628 7.9633 21.0968 49.7115 49.7115 49.7115 -13.0628 8.9633 18.0968 -8.66333 -8.66333 -8.66333 -13.0628 8.9633 19.0968 -133.904 -133.904 -133.904 -13.0628 9.9633 18.0968 -2.03434 -2.03434 -2.03434 -13.0628 9.9633 19.0968 3.45024 3.45024 3.45024 -14.0628 8.9633 18.0968 143.959 143.959 143.959 -14.0628 9.9633 18.0968 1.86805 1.86805 1.86805 -14.0628 9.9633 19.0968 -2.953 -2.953 -2.953 -13.0628 8.9633 20.0968 16.1865 16.1865 16.1865 -13.0628 8.9633 21.0968 7.46697 7.46697 7.46697 -13.0628 9.9633 20.0968 1.2304 1.2304 1.2304 -13.0628 9.9633 21.0968 2.45631 2.45631 2.45631 -14.0628 8.9633 20.0968 28.15 28.15 28.15 -14.0628 8.9633 21.0968 5.35666 5.35666 5.35666 -14.0628 9.9633 20.0968 1.73379 1.73379 1.73379 -14.0628 9.9633 21.0968 -3.30671 -3.30671 -3.30671 -15.0628 6.9633 18.0968 -397.024 -397.024 -397.024 -15.0628 6.9633 19.0968 927.14 927.14 927.14 -15.0628 7.9633 18.0968 -151.809 -151.809 -151.809 -15.0628 7.9633 19.0968 -188.372 -188.372 -188.372 -16.0628 6.9633 18.0968 -65.4359 -65.4359 -65.4359 -16.0628 6.9633 19.0968 -269.558 -269.558 -269.558 -16.0628 7.9633 18.0968 -714.032 -714.032 -714.032 -15.0628 6.9633 20.0968 -86.8924 -86.8924 -86.8924 -15.0628 6.9633 21.0968 -11.2481 -11.2481 -11.2481 -15.0628 7.9633 20.0968 101.474 101.474 101.474 -15.0628 7.9633 21.0968 45.3776 45.3776 45.3776 -16.0628 6.9633 20.0968 -44.5249 -44.5249 -44.5249 -16.0628 6.9633 21.0968 -290.502 -290.502 -290.502 -16.0628 7.9633 20.0968 73.1872 73.1872 73.1872 -16.0628 7.9633 21.0968 19.4546 19.4546 19.4546 -15.0628 8.9633 18.0968 45.3323 45.3323 45.3323 -15.0628 8.9633 19.0968 -43.255 -43.255 -43.255 -15.0628 9.9633 18.0968 -0.558937 -0.558937 -0.558937 -15.0628 9.9633 19.0968 0.338425 0.338425 0.338425 -16.0628 8.9633 18.0968 -194.403 -194.403 -194.403 -16.0628 8.9633 19.0968 -503.084 -503.084 -503.084 -16.0628 9.9633 18.0968 0.794233 0.794233 0.794233 -16.0628 9.9633 19.0968 -0.520117 -0.520117 -0.520117 -15.0628 8.9633 20.0968 39.5885 39.5885 39.5885 -15.0628 9.9633 20.0968 2.05283 2.05283 2.05283 -15.0628 9.9633 21.0968 -0.581477 -0.581477 -0.581477 -16.0628 8.9633 20.0968 42.5008 42.5008 42.5008 -16.0628 9.9633 20.0968 0.283833 0.283833 0.283833 -16.0628 9.9633 21.0968 2.38607 2.38607 2.38607 -19.0628 -2.0366999999999997 17.0968 -13.5408 -13.5408 -13.5408 -20.0628 -3.0366999999999997 17.0968 -29.271 -29.271 -29.271 -20.0628 -2.0366999999999997 17.0968 12.5491 12.5491 12.5491 -19.0628 -3.0366999999999997 18.0968 7.66763 7.66763 7.66763 -19.0628 -3.0366999999999997 19.0968 15.3173 15.3173 15.3173 -19.0628 -2.0366999999999997 18.0968 -3.05073 -3.05073 -3.05073 -19.0628 -2.0366999999999997 19.0968 0.142335 0.142335 0.142335 -20.0628 -3.0366999999999997 18.0968 5.90202 5.90202 5.90202 -20.0628 -3.0366999999999997 19.0968 11.8226 11.8226 11.8226 -19.0628 -2.0366999999999997 20.0968 -20.2782 -20.2782 -20.2782 -20.0628 -3.0366999999999997 20.0968 -10.0662 -10.0662 -10.0662 -20.0628 -2.0366999999999997 20.0968 1.97806 1.97806 1.97806 -17.0628 1.9633000000000003 14.096800000000002 -30.0806 -30.0806 -30.0806 -17.0628 1.9633000000000003 15.096800000000002 -63.5111 -63.5111 -63.5111 -18.0628 1.9633000000000003 14.096800000000002 1.62292 1.62292 1.62292 -18.0628 1.9633000000000003 15.096800000000002 21.5663 21.5663 21.5663 -17.0628 0.9633000000000003 17.0968 167.103 167.103 167.103 -17.0628 1.9633000000000003 16.0968 -53.5952 -53.5952 -53.5952 -17.0628 1.9633000000000003 17.0968 36.344 36.344 36.344 -18.0628 0.9633000000000003 17.0968 34.3142 34.3142 34.3142 -18.0628 1.9633000000000003 16.0968 86.726 86.726 86.726 -18.0628 1.9633000000000003 17.0968 42.1307 42.1307 42.1307 -19.0628 -1.0366999999999997 17.0968 -12.1665 -12.1665 -12.1665 -20.0628 -1.0366999999999997 17.0968 18.7037 18.7037 18.7037 -19.0628 1.9633000000000003 14.096800000000002 41.1797 41.1797 41.1797 -19.0628 1.9633000000000003 15.096800000000002 -58.1761 -58.1761 -58.1761 -20.0628 1.9633000000000003 14.096800000000002 -4.33492 -4.33492 -4.33492 -20.0628 1.9633000000000003 15.096800000000002 -3.80163 -3.80163 -3.80163 -19.0628 1.9633000000000003 16.0968 -29.7217 -29.7217 -29.7217 -19.0628 1.9633000000000003 17.0968 -36.8992 -36.8992 -36.8992 -20.0628 0.9633000000000003 16.0968 6.26369 6.26369 6.26369 -20.0628 0.9633000000000003 17.0968 -5.54459 -5.54459 -5.54459 -20.0628 1.9633000000000003 16.0968 -6.2462 -6.2462 -6.2462 -20.0628 1.9633000000000003 17.0968 6.57459 6.57459 6.57459 -17.0628 -1.0366999999999997 21.0968 -56.1539 -56.1539 -56.1539 -17.0628 -0.03669999999999973 21.0968 55.9478 55.9478 55.9478 -18.0628 -1.0366999999999997 21.0968 54.1373 54.1373 54.1373 -18.0628 -0.03669999999999973 20.0968 2.89406 2.89406 2.89406 -18.0628 -0.03669999999999973 21.0968 -40.9264 -40.9264 -40.9264 -17.0628 0.9633000000000003 18.0968 -11.6107 -11.6107 -11.6107 -17.0628 0.9633000000000003 19.0968 -67.5546 -67.5546 -67.5546 -17.0628 1.9633000000000003 19.0968 -76.4629 -76.4629 -76.4629 -18.0628 0.9633000000000003 18.0968 -59.9422 -59.9422 -59.9422 -18.0628 0.9633000000000003 19.0968 8.90393 8.90393 8.90393 -18.0628 1.9633000000000003 18.0968 -55.8134 -55.8134 -55.8134 -18.0628 1.9633000000000003 19.0968 -4.52447 -4.52447 -4.52447 -17.0628 0.9633000000000003 21.0968 9172.71 9172.71 9172.71 -17.0628 1.9633000000000003 20.0968 -91.1332 -91.1332 -91.1332 -17.0628 1.9633000000000003 21.0968 9288.46 9288.46 9288.46 -18.0628 0.9633000000000003 20.0968 53.1058 53.1058 53.1058 -18.0628 0.9633000000000003 21.0968 5794.27 5794.27 5794.27 -18.0628 1.9633000000000003 20.0968 -37.8078 -37.8078 -37.8078 -18.0628 1.9633000000000003 21.0968 5003.51 5003.51 5003.51 -19.0628 -1.0366999999999997 18.0968 -0.485541 -0.485541 -0.485541 -19.0628 -1.0366999999999997 19.0968 11.3589 11.3589 11.3589 -20.0628 -1.0366999999999997 18.0968 -6.53626 -6.53626 -6.53626 -20.0628 -1.0366999999999997 19.0968 -19.7488 -19.7488 -19.7488 -20.0628 -0.03669999999999973 18.0968 3.31917 3.31917 3.31917 -20.0628 -0.03669999999999973 19.0968 -0.0509925 -0.0509925 -0.0509925 -19.0628 -1.0366999999999997 20.0968 3.32645 3.32645 3.32645 -19.0628 -1.0366999999999997 21.0968 11.7515 11.7515 11.7515 -19.0628 -0.03669999999999973 20.0968 74.1413 74.1413 74.1413 -19.0628 -0.03669999999999973 21.0968 -77.0475 -77.0475 -77.0475 -20.0628 -1.0366999999999997 20.0968 22.2139 22.2139 22.2139 -20.0628 -0.03669999999999973 20.0968 5.55122 5.55122 5.55122 -20.0628 -0.03669999999999973 21.0968 6.786 6.786 6.786 -19.0628 0.9633000000000003 18.0968 3.64328 3.64328 3.64328 -19.0628 0.9633000000000003 19.0968 45.3046 45.3046 45.3046 -19.0628 1.9633000000000003 18.0968 84.6063 84.6063 84.6063 -19.0628 1.9633000000000003 19.0968 -37.3753 -37.3753 -37.3753 -20.0628 0.9633000000000003 18.0968 -1.04081 -1.04081 -1.04081 -20.0628 0.9633000000000003 19.0968 8.35624 8.35624 8.35624 -20.0628 1.9633000000000003 18.0968 13.7525 13.7525 13.7525 -20.0628 1.9633000000000003 19.0968 21.6208 21.6208 21.6208 -19.0628 0.9633000000000003 20.0968 49.8974 49.8974 49.8974 -19.0628 0.9633000000000003 21.0968 -10830.4 -10830.4 -10830.4 -19.0628 1.9633000000000003 20.0968 42.8525 42.8525 42.8525 -20.0628 0.9633000000000003 20.0968 -32.1968 -32.1968 -32.1968 -20.0628 0.9633000000000003 21.0968 -27.9832 -27.9832 -27.9832 -21.0628 -3.0366999999999997 17.0968 -0.707438 -0.707438 -0.707438 -21.0628 -2.0366999999999997 17.0968 4.98379 4.98379 4.98379 -22.0628 -3.0366999999999997 17.0968 -0.263874 -0.263874 -0.263874 -22.0628 -2.0366999999999997 17.0968 -26.9716 -26.9716 -26.9716 -21.0628 -4.0367 18.0968 -5.63033 -5.63033 -5.63033 -21.0628 -4.0367 19.0968 -8.59472 -8.59472 -8.59472 -22.0628 -4.0367 18.0968 7.57912 7.57912 7.57912 -22.0628 -4.0367 19.0968 1.37327 1.37327 1.37327 -21.0628 -4.0367 20.0968 0.515371 0.515371 0.515371 -22.0628 -4.0367 20.0968 -0.358456 -0.358456 -0.358456 -22.0628 -4.0367 21.0968 10.2308 10.2308 10.2308 -21.0628 -3.0366999999999997 18.0968 -15.6052 -15.6052 -15.6052 -21.0628 -3.0366999999999997 19.0968 -13.2014 -13.2014 -13.2014 -22.0628 -3.0366999999999997 18.0968 -1.86313 -1.86313 -1.86313 -22.0628 -3.0366999999999997 19.0968 -0.51336 -0.51336 -0.51336 -22.0628 -2.0366999999999997 18.0968 8.71498 8.71498 8.71498 -21.0628 -3.0366999999999997 20.0968 2.2581 2.2581 2.2581 -21.0628 -3.0366999999999997 21.0968 9.11986 9.11986 9.11986 -21.0628 -2.0366999999999997 20.0968 -0.46988 -0.46988 -0.46988 -21.0628 -2.0366999999999997 21.0968 -7.34484 -7.34484 -7.34484 -22.0628 -3.0366999999999997 20.0968 -3.37374 -3.37374 -3.37374 -22.0628 -3.0366999999999997 21.0968 14.3778 14.3778 14.3778 -22.0628 -2.0366999999999997 21.0968 30.523 30.523 30.523 -23.0628 -4.0367 18.0968 9.51326 9.51326 9.51326 -23.0628 -4.0367 19.0968 2.15948 2.15948 2.15948 -24.0628 -4.0367 18.0968 0.492028 0.492028 0.492028 -24.0628 -4.0367 19.0968 2.68212 2.68212 2.68212 -23.0628 -4.0367 20.0968 0.812253 0.812253 0.812253 -23.0628 -4.0367 21.0968 -30.3274 -30.3274 -30.3274 -24.0628 -4.0367 20.0968 0.9771 0.9771 0.9771 -24.0628 -4.0367 21.0968 -10.55 -10.55 -10.55 -23.0628 -3.0366999999999997 18.0968 11.347 11.347 11.347 -23.0628 -2.0366999999999997 18.0968 13782.5 13782.5 13782.5 -24.0628 -3.0366999999999997 18.0968 -2.8359 -2.8359 -2.8359 -24.0628 -3.0366999999999997 19.0968 12.3358 12.3358 12.3358 -24.0628 -2.0366999999999997 18.0968 -25526.8 -25526.8 -25526.8 -24.0628 -2.0366999999999997 19.0968 3.7072 3.7072 3.7072 -23.0628 -3.0366999999999997 21.0968 -39.1566 -39.1566 -39.1566 -23.0628 -2.0366999999999997 21.0968 343.663 343.663 343.663 -24.0628 -3.0366999999999997 20.0968 12.5002 12.5002 12.5002 -24.0628 -3.0366999999999997 21.0968 11.2488 11.2488 11.2488 -24.0628 -2.0366999999999997 20.0968 -198.53 -198.53 -198.53 -24.0628 -2.0366999999999997 21.0968 302.094 302.094 302.094 -21.0628 -1.0366999999999997 17.0968 -4.04028 -4.04028 -4.04028 -21.0628 -0.03669999999999973 17.0968 20.1941 20.1941 20.1941 -22.0628 -1.0366999999999997 17.0968 -18.0444 -18.0444 -18.0444 -22.0628 -0.03669999999999973 17.0968 37.7031 37.7031 37.7031 -21.0628 1.9633000000000003 15.096800000000002 -18.234 -18.234 -18.234 -22.0628 1.9633000000000003 15.096800000000002 15.7895 15.7895 15.7895 -21.0628 0.9633000000000003 16.0968 -3.61732 -3.61732 -3.61732 -21.0628 0.9633000000000003 17.0968 25.464 25.464 25.464 -21.0628 1.9633000000000003 16.0968 19.0837 19.0837 19.0837 -22.0628 0.9633000000000003 16.0968 1.0651 1.0651 1.0651 -22.0628 0.9633000000000003 17.0968 -10.3506 -10.3506 -10.3506 -22.0628 1.9633000000000003 16.0968 -62.025 -62.025 -62.025 -23.0628 -1.0366999999999997 17.0968 11726.8 11726.8 11726.8 -23.0628 -0.03669999999999973 17.0968 -4274.86 -4274.86 -4274.86 -24.0628 -1.0366999999999997 17.0968 7287.18 7287.18 7287.18 -24.0628 -0.03669999999999973 17.0968 -44333.1 -44333.1 -44333.1 -23.0628 0.9633000000000003 16.0968 69.4644 69.4644 69.4644 -23.0628 0.9633000000000003 17.0968 32.5835 32.5835 32.5835 -23.0628 1.9633000000000003 16.0968 -9.94947 -9.94947 -9.94947 -23.0628 1.9633000000000003 17.0968 19.432 19.432 19.432 -24.0628 0.9633000000000003 17.0968 -21.8281 -21.8281 -21.8281 -24.0628 1.9633000000000003 17.0968 22.3373 22.3373 22.3373 -21.0628 -1.0366999999999997 18.0968 -20.9129 -20.9129 -20.9129 -21.0628 -0.03669999999999973 18.0968 11.7356 11.7356 11.7356 -21.0628 -0.03669999999999973 19.0968 25.6343 25.6343 25.6343 -22.0628 -1.0366999999999997 18.0968 -16.8255 -16.8255 -16.8255 -22.0628 -0.03669999999999973 18.0968 9.36821 9.36821 9.36821 -21.0628 -1.0366999999999997 20.0968 -0.66199 -0.66199 -0.66199 -21.0628 -1.0366999999999997 21.0968 33.2194 33.2194 33.2194 -21.0628 -0.03669999999999973 20.0968 -45.5956 -45.5956 -45.5956 -21.0628 -0.03669999999999973 21.0968 12.5871 12.5871 12.5871 -22.0628 -1.0366999999999997 21.0968 48.7037 48.7037 48.7037 -22.0628 -0.03669999999999973 20.0968 63.4036 63.4036 63.4036 -22.0628 -0.03669999999999973 21.0968 -23.5576 -23.5576 -23.5576 -21.0628 0.9633000000000003 18.0968 -7.50217 -7.50217 -7.50217 -21.0628 1.9633000000000003 18.0968 -25.621 -25.621 -25.621 -21.0628 1.9633000000000003 19.0968 27.9555 27.9555 27.9555 -21.0628 0.9633000000000003 21.0968 91.2438 91.2438 91.2438 -23.0628 -1.0366999999999997 18.0968 16317.8 16317.8 16317.8 -24.0628 -1.0366999999999997 18.0968 41480.9 41480.9 41480.9 -24.0628 -1.0366999999999997 19.0968 -35.2155 -35.2155 -35.2155 -24.0628 -0.03669999999999973 18.0968 -16677.2 -16677.2 -16677.2 -24.0628 -0.03669999999999973 19.0968 -38.8631 -38.8631 -38.8631 -23.0628 -1.0366999999999997 20.0968 -336.146 -336.146 -336.146 -23.0628 -1.0366999999999997 21.0968 535.689 535.689 535.689 -23.0628 -0.03669999999999973 20.0968 -29.6078 -29.6078 -29.6078 -23.0628 -0.03669999999999973 21.0968 413.266 413.266 413.266 -24.0628 -1.0366999999999997 20.0968 -93.3874 -93.3874 -93.3874 -24.0628 -1.0366999999999997 21.0968 1111.34 1111.34 1111.34 -24.0628 -0.03669999999999973 20.0968 -68.5413 -68.5413 -68.5413 -23.0628 0.9633000000000003 18.0968 33.1808 33.1808 33.1808 -23.0628 0.9633000000000003 19.0968 -37.1531 -37.1531 -37.1531 -23.0628 1.9633000000000003 19.0968 17.5702 17.5702 17.5702 -24.0628 0.9633000000000003 18.0968 14.7726 14.7726 14.7726 -24.0628 0.9633000000000003 19.0968 13.2376 13.2376 13.2376 -24.0628 1.9633000000000003 18.0968 -4.195 -4.195 -4.195 -24.0628 1.9633000000000003 19.0968 14.7225 14.7225 14.7225 -23.0628 0.9633000000000003 20.0968 -73.0302 -73.0302 -73.0302 -23.0628 0.9633000000000003 21.0968 56.6311 56.6311 56.6311 -23.0628 1.9633000000000003 20.0968 5.36707 5.36707 5.36707 -23.0628 1.9633000000000003 21.0968 83.1933 83.1933 83.1933 -24.0628 0.9633000000000003 20.0968 99.6107 99.6107 99.6107 -24.0628 0.9633000000000003 21.0968 4.44037 4.44037 4.44037 -24.0628 1.9633000000000003 20.0968 30.3181 30.3181 30.3181 -24.0628 1.9633000000000003 21.0968 -153.161 -153.161 -153.161 -17.0628 5.9633 7.096800000000002 -99.2483 -99.2483 -99.2483 -18.0628 5.9633 7.096800000000002 2.03712 2.03712 2.03712 -17.0628 4.9633 8.096800000000002 1.72055 1.72055 1.72055 -17.0628 4.9633 9.096800000000002 45.7385 45.7385 45.7385 -17.0628 5.9633 8.096800000000002 110.115 110.115 110.115 -18.0628 4.9633 8.096800000000002 3.90173 3.90173 3.90173 -18.0628 4.9633 9.096800000000002 8.75019 8.75019 8.75019 -18.0628 5.9633 8.096800000000002 3.24798 3.24798 3.24798 -19.0628 4.9633 8.096800000000002 -27.4561 -27.4561 -27.4561 -19.0628 4.9633 9.096800000000002 5.56572 5.56572 5.56572 -19.0628 5.9633 8.096800000000002 19.6555 19.6555 19.6555 -19.0628 5.9633 9.096800000000002 16.5659 16.5659 16.5659 -17.0628 2.9633000000000003 13.096800000000002 -55.9216 -55.9216 -55.9216 -17.0628 3.9633000000000003 12.096800000000002 -50.5077 -50.5077 -50.5077 -17.0628 3.9633000000000003 13.096800000000002 41.0595 41.0595 41.0595 -18.0628 2.9633000000000003 12.096800000000002 7.40956 7.40956 7.40956 -18.0628 2.9633000000000003 13.096800000000002 -33.0656 -33.0656 -33.0656 -18.0628 3.9633000000000003 12.096800000000002 -6.20518 -6.20518 -6.20518 -17.0628 4.9633 10.096800000000002 10.63 10.63 10.63 -17.0628 5.9633 10.096800000000002 -18.2894 -18.2894 -18.2894 -17.0628 5.9633 11.096800000000002 -90.4519 -90.4519 -90.4519 -18.0628 4.9633 10.096800000000002 -1.2488 -1.2488 -1.2488 -18.0628 5.9633 10.096800000000002 11.0335 11.0335 11.0335 -18.0628 5.9633 11.096800000000002 -33.782 -33.782 -33.782 -17.0628 4.9633 12.096800000000002 -31.3742 -31.3742 -31.3742 -17.0628 4.9633 13.096800000000002 -17.9722 -17.9722 -17.9722 -17.0628 5.9633 12.096800000000002 97.0595 97.0595 97.0595 -17.0628 5.9633 13.096800000000002 19.4482 19.4482 19.4482 -18.0628 4.9633 12.096800000000002 -28.2909 -28.2909 -28.2909 -18.0628 4.9633 13.096800000000002 3.69424 3.69424 3.69424 -18.0628 5.9633 12.096800000000002 97.6742 97.6742 97.6742 -18.0628 5.9633 13.096800000000002 17.4964 17.4964 17.4964 -19.0628 3.9633000000000003 11.096800000000002 7.90553 7.90553 7.90553 -20.0628 3.9633000000000003 11.096800000000002 11.0606 11.0606 11.0606 -19.0628 2.9633000000000003 12.096800000000002 1.64195 1.64195 1.64195 -19.0628 2.9633000000000003 13.096800000000002 -33.5126 -33.5126 -33.5126 -19.0628 3.9633000000000003 12.096800000000002 -2.4239 -2.4239 -2.4239 -20.0628 2.9633000000000003 12.096800000000002 -1.60595 -1.60595 -1.60595 -20.0628 2.9633000000000003 13.096800000000002 -4.96974 -4.96974 -4.96974 -20.0628 3.9633000000000003 12.096800000000002 -4.02107 -4.02107 -4.02107 -19.0628 4.9633 10.096800000000002 -23.1355 -23.1355 -23.1355 -19.0628 4.9633 11.096800000000002 12.1476 12.1476 12.1476 -19.0628 5.9633 10.096800000000002 -36.1186 -36.1186 -36.1186 -19.0628 5.9633 11.096800000000002 8.43687 8.43687 8.43687 -20.0628 4.9633 11.096800000000002 -1.4556 -1.4556 -1.4556 -20.0628 5.9633 11.096800000000002 -4.4114 -4.4114 -4.4114 -19.0628 4.9633 12.096800000000002 3.32411 3.32411 3.32411 -19.0628 5.9633 12.096800000000002 -0.124778 -0.124778 -0.124778 -19.0628 5.9633 13.096800000000002 0.984656 0.984656 0.984656 -20.0628 4.9633 12.096800000000002 8.02028 8.02028 8.02028 -20.0628 5.9633 12.096800000000002 -2.56568 -2.56568 -2.56568 -20.0628 5.9633 13.096800000000002 3.31321 3.31321 3.31321 -17.0628 6.9633 6.096800000000002 6.44028 6.44028 6.44028 -17.0628 6.9633 7.096800000000002 10.3479 10.3479 10.3479 -17.0628 7.9633 6.096800000000002 -19.7246 -19.7246 -19.7246 -18.0628 6.9633 6.096800000000002 21.2935 21.2935 21.2935 -18.0628 6.9633 7.096800000000002 -20.6107 -20.6107 -20.6107 -18.0628 6.9633 8.096800000000002 0.574849 0.574849 0.574849 -18.0628 6.9633 9.096800000000002 -20.6913 -20.6913 -20.6913 -18.0628 7.9633 8.096800000000002 -7.89502 -7.89502 -7.89502 -17.0628 8.9633 6.096800000000002 -1.73305 -1.73305 -1.73305 -17.0628 9.9633 6.096800000000002 -1.26351 -1.26351 -1.26351 -17.0628 9.9633 7.096800000000002 11.6012 11.6012 11.6012 -18.0628 8.9633 6.096800000000002 -15.0658 -15.0658 -15.0658 -18.0628 9.9633 6.096800000000002 241.871 241.871 241.871 -18.0628 9.9633 7.096800000000002 -103.731 -103.731 -103.731 -17.0628 9.9633 8.096800000000002 1.7201 1.7201 1.7201 -17.0628 9.9633 9.096800000000002 -5.3341 -5.3341 -5.3341 -18.0628 9.9633 8.096800000000002 4.28268 4.28268 4.28268 -19.0628 6.9633 6.096800000000002 -11.3932 -11.3932 -11.3932 -19.0628 6.9633 7.096800000000002 -22.6372 -22.6372 -22.6372 -19.0628 7.9633 6.096800000000002 344.792 344.792 344.792 -19.0628 7.9633 7.096800000000002 -174.658 -174.658 -174.658 -20.0628 7.9633 6.096800000000002 -55.2896 -55.2896 -55.2896 -20.0628 7.9633 7.096800000000002 -320.769 -320.769 -320.769 -19.0628 6.9633 8.096800000000002 -60.5152 -60.5152 -60.5152 -19.0628 6.9633 9.096800000000002 7.22476 7.22476 7.22476 -19.0628 7.9633 8.096800000000002 -52.6972 -52.6972 -52.6972 -19.0628 7.9633 9.096800000000002 -190.588 -190.588 -190.588 -20.0628 6.9633 9.096800000000002 411.222 411.222 411.222 -20.0628 7.9633 9.096800000000002 310.314 310.314 310.314 -19.0628 8.9633 6.096800000000002 164.985 164.985 164.985 -19.0628 8.9633 7.096800000000002 -164.96 -164.96 -164.96 -19.0628 9.9633 6.096800000000002 -32.0147 -32.0147 -32.0147 -19.0628 9.9633 7.096800000000002 92.3851 92.3851 92.3851 -20.0628 8.9633 6.096800000000002 211.49 211.49 211.49 -20.0628 8.9633 7.096800000000002 -145.384 -145.384 -145.384 -19.0628 8.9633 8.096800000000002 25.1379 25.1379 25.1379 -19.0628 8.9633 9.096800000000002 22.4266 22.4266 22.4266 -19.0628 9.9633 8.096800000000002 100.115 100.115 100.115 -20.0628 8.9633 8.096800000000002 -1486.11 -1486.11 -1486.11 -20.0628 8.9633 9.096800000000002 -561.16 -561.16 -561.16 -20.0628 9.9633 8.096800000000002 0.570122 0.570122 0.570122 -20.0628 9.9633 9.096800000000002 7.29603 7.29603 7.29603 -17.0628 6.9633 10.096800000000002 -140.147 -140.147 -140.147 -17.0628 6.9633 11.096800000000002 -88.0719 -88.0719 -88.0719 -17.0628 7.9633 10.096800000000002 -115.828 -115.828 -115.828 -17.0628 7.9633 11.096800000000002 -28.1397 -28.1397 -28.1397 -18.0628 6.9633 10.096800000000002 -84.5458 -84.5458 -84.5458 -17.0628 6.9633 12.096800000000002 103.486 103.486 103.486 -17.0628 6.9633 13.096800000000002 5.41249 5.41249 5.41249 -17.0628 7.9633 12.096800000000002 72.8365 72.8365 72.8365 -17.0628 7.9633 13.096800000000002 16.7796 16.7796 16.7796 -18.0628 6.9633 12.096800000000002 120.948 120.948 120.948 -18.0628 6.9633 13.096800000000002 7.54675 7.54675 7.54675 -18.0628 7.9633 13.096800000000002 22.6916 22.6916 22.6916 -17.0628 8.9633 10.096800000000002 2.92596 2.92596 2.92596 -17.0628 8.9633 11.096800000000002 0.28697 0.28697 0.28697 -17.0628 9.9633 10.096800000000002 -5.58731 -5.58731 -5.58731 -17.0628 9.9633 11.096800000000002 0.155566 0.155566 0.155566 -18.0628 8.9633 11.096800000000002 1.65103 1.65103 1.65103 -18.0628 9.9633 11.096800000000002 -0.290451 -0.290451 -0.290451 -17.0628 8.9633 12.096800000000002 -7.7969 -7.7969 -7.7969 -17.0628 8.9633 13.096800000000002 -7.38821 -7.38821 -7.38821 -17.0628 9.9633 12.096800000000002 0.546068 0.546068 0.546068 -17.0628 9.9633 13.096800000000002 3.08505 3.08505 3.08505 -18.0628 8.9633 12.096800000000002 3.36111 3.36111 3.36111 -18.0628 8.9633 13.096800000000002 3.87812 3.87812 3.87812 -18.0628 9.9633 12.096800000000002 0.356107 0.356107 0.356107 -18.0628 9.9633 13.096800000000002 -4.21364 -4.21364 -4.21364 -19.0628 6.9633 10.096800000000002 -61.9434 -61.9434 -61.9434 -19.0628 6.9633 11.096800000000002 -2.38627 -2.38627 -2.38627 -20.0628 6.9633 10.096800000000002 888.619 888.619 888.619 -20.0628 6.9633 11.096800000000002 -4.18714 -4.18714 -4.18714 -20.0628 7.9633 10.096800000000002 1124.51 1124.51 1124.51 -20.0628 7.9633 11.096800000000002 1.78746 1.78746 1.78746 -19.0628 6.9633 12.096800000000002 -0.53876 -0.53876 -0.53876 -19.0628 6.9633 13.096800000000002 6.00882 6.00882 6.00882 -19.0628 7.9633 13.096800000000002 5.50591 5.50591 5.50591 -20.0628 6.9633 12.096800000000002 -6.59809 -6.59809 -6.59809 -20.0628 6.9633 13.096800000000002 -14.5568 -14.5568 -14.5568 -20.0628 7.9633 13.096800000000002 8.64106 8.64106 8.64106 -19.0628 8.9633 11.096800000000002 -0.178156 -0.178156 -0.178156 -19.0628 9.9633 11.096800000000002 2.82584 2.82584 2.82584 -20.0628 8.9633 10.096800000000002 -695.188 -695.188 -695.188 -20.0628 8.9633 11.096800000000002 0.211984 0.211984 0.211984 -20.0628 9.9633 10.096800000000002 45.4261 45.4261 45.4261 -20.0628 9.9633 11.096800000000002 0.609251 0.609251 0.609251 -19.0628 8.9633 12.096800000000002 1.02837 1.02837 1.02837 -19.0628 8.9633 13.096800000000002 -5.06536 -5.06536 -5.06536 -19.0628 9.9633 12.096800000000002 2.17295 2.17295 2.17295 -19.0628 9.9633 13.096800000000002 -6.57298 -6.57298 -6.57298 -20.0628 8.9633 12.096800000000002 5.50496 5.50496 5.50496 -20.0628 8.9633 13.096800000000002 9.48302 9.48302 9.48302 -20.0628 9.9633 12.096800000000002 1.48773 1.48773 1.48773 -20.0628 9.9633 13.096800000000002 -7.04324 -7.04324 -7.04324 -21.0628 2.9633000000000003 12.096800000000002 2.18694 2.18694 2.18694 -21.0628 2.9633000000000003 13.096800000000002 0.230174 0.230174 0.230174 -21.0628 3.9633000000000003 12.096800000000002 2.43676 2.43676 2.43676 -21.0628 3.9633000000000003 13.096800000000002 7.38862 7.38862 7.38862 -22.0628 2.9633000000000003 12.096800000000002 -1.91983 -1.91983 -1.91983 -22.0628 2.9633000000000003 13.096800000000002 1.24674 1.24674 1.24674 -22.0628 3.9633000000000003 12.096800000000002 3.0609 3.0609 3.0609 -22.0628 3.9633000000000003 13.096800000000002 6.33839 6.33839 6.33839 -21.0628 4.9633 12.096800000000002 2.47225 2.47225 2.47225 -21.0628 4.9633 13.096800000000002 31.6218 31.6218 31.6218 -21.0628 5.9633 12.096800000000002 -7.35864 -7.35864 -7.35864 -21.0628 5.9633 13.096800000000002 3.52413 3.52413 3.52413 -22.0628 4.9633 12.096800000000002 -8.66779 -8.66779 -8.66779 -22.0628 4.9633 13.096800000000002 0.931067 0.931067 0.931067 -22.0628 5.9633 12.096800000000002 -18.5373 -18.5373 -18.5373 -22.0628 5.9633 13.096800000000002 -22.2774 -22.2774 -22.2774 -23.0628 3.9633000000000003 11.096800000000002 -0.868626 -0.868626 -0.868626 -24.0628 2.9633000000000003 11.096800000000002 0.506677 0.506677 0.506677 -24.0628 3.9633000000000003 11.096800000000002 -2.36987 -2.36987 -2.36987 -23.0628 2.9633000000000003 12.096800000000002 0.598972 0.598972 0.598972 -23.0628 2.9633000000000003 13.096800000000002 -3.27265 -3.27265 -3.27265 -23.0628 3.9633000000000003 12.096800000000002 2.64909 2.64909 2.64909 -24.0628 2.9633000000000003 12.096800000000002 -4.76052 -4.76052 -4.76052 -24.0628 2.9633000000000003 13.096800000000002 -2.5608 -2.5608 -2.5608 -23.0628 4.9633 11.096800000000002 -5.35846 -5.35846 -5.35846 -24.0628 4.9633 11.096800000000002 -4.22202 -4.22202 -4.22202 -24.0628 5.9633 11.096800000000002 -8.0842 -8.0842 -8.0842 -23.0628 4.9633 12.096800000000002 1.26175 1.26175 1.26175 -23.0628 5.9633 12.096800000000002 -0.390198 -0.390198 -0.390198 -23.0628 5.9633 13.096800000000002 -15.5156 -15.5156 -15.5156 -24.0628 4.9633 12.096800000000002 -0.422561 -0.422561 -0.422561 -24.0628 5.9633 12.096800000000002 -0.35256 -0.35256 -0.35256 -24.0628 5.9633 13.096800000000002 -2.05922 -2.05922 -2.05922 -21.0628 7.9633 9.096800000000002 526.941 526.941 526.941 -22.0628 7.9633 9.096800000000002 -728.774 -728.774 -728.774 -21.0628 8.9633 9.096800000000002 -3232.39 -3232.39 -3232.39 -21.0628 9.9633 9.096800000000002 12.4293 12.4293 12.4293 -22.0628 8.9633 8.096800000000002 192.984 192.984 192.984 -22.0628 8.9633 9.096800000000002 -2208.79 -2208.79 -2208.79 -22.0628 9.9633 8.096800000000002 89.726 89.726 89.726 -22.0628 9.9633 9.096800000000002 38.2431 38.2431 38.2431 -23.0628 6.9633 9.096800000000002 -166.233 -166.233 -166.233 -23.0628 7.9633 9.096800000000002 220.663 220.663 220.663 -24.0628 7.9633 9.096800000000002 -147.916 -147.916 -147.916 -23.0628 8.9633 8.096800000000002 230.142 230.142 230.142 -23.0628 8.9633 9.096800000000002 46.771 46.771 46.771 -23.0628 9.9633 8.096800000000002 5.49047 5.49047 5.49047 -24.0628 8.9633 8.096800000000002 -93.3675 -93.3675 -93.3675 -24.0628 8.9633 9.096800000000002 51.0434 51.0434 51.0434 -24.0628 9.9633 8.096800000000002 -44.7176 -44.7176 -44.7176 -24.0628 9.9633 9.096800000000002 -105.71 -105.71 -105.71 -21.0628 6.9633 11.096800000000002 -0.503882 -0.503882 -0.503882 -21.0628 7.9633 10.096800000000002 3350.79 3350.79 3350.79 -21.0628 7.9633 11.096800000000002 0.938421 0.938421 0.938421 -22.0628 6.9633 10.096800000000002 2623.93 2623.93 2623.93 -22.0628 6.9633 11.096800000000002 0.757507 0.757507 0.757507 -22.0628 7.9633 10.096800000000002 807.97 807.97 807.97 -22.0628 7.9633 11.096800000000002 -2.34938 -2.34938 -2.34938 -21.0628 6.9633 12.096800000000002 -3.37334 -3.37334 -3.37334 -21.0628 6.9633 13.096800000000002 -36.8695 -36.8695 -36.8695 -21.0628 7.9633 12.096800000000002 26.057 26.057 26.057 -21.0628 7.9633 13.096800000000002 12.2552 12.2552 12.2552 -22.0628 7.9633 12.096800000000002 27.2222 27.2222 27.2222 -22.0628 7.9633 13.096800000000002 8.96216 8.96216 8.96216 -21.0628 8.9633 10.096800000000002 -749.011 -749.011 -749.011 -21.0628 8.9633 11.096800000000002 2.39623 2.39623 2.39623 -21.0628 9.9633 10.096800000000002 56.0989 56.0989 56.0989 -21.0628 9.9633 11.096800000000002 1.91181 1.91181 1.91181 -22.0628 8.9633 11.096800000000002 -6.93001 -6.93001 -6.93001 -22.0628 9.9633 11.096800000000002 0.566986 0.566986 0.566986 -21.0628 8.9633 12.096800000000002 8.20423 8.20423 8.20423 -21.0628 8.9633 13.096800000000002 4.01473 4.01473 4.01473 -21.0628 9.9633 12.096800000000002 -3.14547 -3.14547 -3.14547 -21.0628 9.9633 13.096800000000002 0.265432 0.265432 0.265432 -22.0628 8.9633 12.096800000000002 -1.12818 -1.12818 -1.12818 -22.0628 8.9633 13.096800000000002 -1.08701 -1.08701 -1.08701 -22.0628 9.9633 12.096800000000002 3.87499 3.87499 3.87499 -23.0628 6.9633 10.096800000000002 -104.154 -104.154 -104.154 -23.0628 6.9633 11.096800000000002 6.6388 6.6388 6.6388 -23.0628 7.9633 10.096800000000002 -68.3418 -68.3418 -68.3418 -23.0628 7.9633 11.096800000000002 -3.05988 -3.05988 -3.05988 -24.0628 6.9633 10.096800000000002 -20.9019 -20.9019 -20.9019 -24.0628 6.9633 11.096800000000002 0.955317 0.955317 0.955317 -24.0628 7.9633 10.096800000000002 20.525 20.525 20.525 -23.0628 6.9633 12.096800000000002 2.19211 2.19211 2.19211 -23.0628 7.9633 12.096800000000002 -0.0816462 -0.0816462 -0.0816462 -23.0628 7.9633 13.096800000000002 -1.20354 -1.20354 -1.20354 -24.0628 6.9633 12.096800000000002 -1.34913 -1.34913 -1.34913 -24.0628 7.9633 12.096800000000002 -1.34023 -1.34023 -1.34023 -24.0628 7.9633 13.096800000000002 0.026114 0.026114 0.026114 -23.0628 9.9633 11.096800000000002 -4.0343 -4.0343 -4.0343 -24.0628 8.9633 10.096800000000002 -22.5723 -22.5723 -22.5723 -24.0628 9.9633 10.096800000000002 1.14354 1.14354 1.14354 -23.0628 8.9633 12.096800000000002 -5.49229 -5.49229 -5.49229 -23.0628 8.9633 13.096800000000002 0.99451 0.99451 0.99451 -23.0628 9.9633 12.096800000000002 -2.75796 -2.75796 -2.75796 -23.0628 9.9633 13.096800000000002 -1.23965 -1.23965 -1.23965 -24.0628 8.9633 12.096800000000002 -1.14835 -1.14835 -1.14835 -24.0628 8.9633 13.096800000000002 -1.25604 -1.25604 -1.25604 -24.0628 9.9633 12.096800000000002 -2.49645 -2.49645 -2.49645 -24.0628 9.9633 13.096800000000002 -1.37143 -1.37143 -1.37143 -17.0628 2.9633000000000003 14.096800000000002 25.5607 25.5607 25.5607 -17.0628 2.9633000000000003 15.096800000000002 -41.0952 -41.0952 -41.0952 -17.0628 3.9633000000000003 14.096800000000002 26.5487 26.5487 26.5487 -17.0628 3.9633000000000003 15.096800000000002 -21.927 -21.927 -21.927 -18.0628 2.9633000000000003 14.096800000000002 -14.2421 -14.2421 -14.2421 -17.0628 2.9633000000000003 16.0968 -62.0772 -62.0772 -62.0772 -17.0628 2.9633000000000003 17.0968 -38.5833 -38.5833 -38.5833 -17.0628 3.9633000000000003 16.0968 -6.18513 -6.18513 -6.18513 -17.0628 3.9633000000000003 17.0968 57.9088 57.9088 57.9088 -18.0628 2.9633000000000003 16.0968 49.7226 49.7226 49.7226 -18.0628 2.9633000000000003 17.0968 -12.0048 -12.0048 -12.0048 -18.0628 3.9633000000000003 16.0968 -56.2696 -56.2696 -56.2696 -18.0628 3.9633000000000003 17.0968 6.82173 6.82173 6.82173 -17.0628 4.9633 14.096800000000002 -12.8681 -12.8681 -12.8681 -17.0628 4.9633 15.096800000000002 -22.2586 -22.2586 -22.2586 -17.0628 5.9633 14.096800000000002 91.6918 91.6918 91.6918 -17.0628 5.9633 15.096800000000002 31.1904 31.1904 31.1904 -17.0628 4.9633 16.0968 -51.1526 -51.1526 -51.1526 -17.0628 4.9633 17.0968 1.96367 1.96367 1.96367 -17.0628 5.9633 16.0968 33.7639 33.7639 33.7639 -18.0628 4.9633 16.0968 12.3212 12.3212 12.3212 -18.0628 5.9633 16.0968 63.7227 63.7227 63.7227 -19.0628 2.9633000000000003 14.096800000000002 -21.5789 -21.5789 -21.5789 -19.0628 3.9633000000000003 15.096800000000002 22.9382 22.9382 22.9382 -20.0628 2.9633000000000003 14.096800000000002 -24.1292 -24.1292 -24.1292 -20.0628 2.9633000000000003 15.096800000000002 6.69712 6.69712 6.69712 -20.0628 3.9633000000000003 15.096800000000002 16.0991 16.0991 16.0991 -19.0628 2.9633000000000003 16.0968 -27.0737 -27.0737 -27.0737 -19.0628 2.9633000000000003 17.0968 22.0567 22.0567 22.0567 -19.0628 3.9633000000000003 16.0968 -7.00684 -7.00684 -7.00684 -19.0628 3.9633000000000003 17.0968 10.9793 10.9793 10.9793 -20.0628 2.9633000000000003 17.0968 6.71335 6.71335 6.71335 -20.0628 3.9633000000000003 16.0968 -15.4184 -15.4184 -15.4184 -20.0628 3.9633000000000003 17.0968 8.11444 8.11444 8.11444 -19.0628 4.9633 15.096800000000002 23.2406 23.2406 23.2406 -19.0628 5.9633 14.096800000000002 8.28816 8.28816 8.28816 -19.0628 5.9633 15.096800000000002 10.5245 10.5245 10.5245 -20.0628 4.9633 14.096800000000002 4.2235 4.2235 4.2235 -20.0628 4.9633 15.096800000000002 15.551 15.551 15.551 -20.0628 5.9633 14.096800000000002 10.8532 10.8532 10.8532 -20.0628 5.9633 15.096800000000002 -1.58489 -1.58489 -1.58489 -19.0628 4.9633 16.0968 -9.60872 -9.60872 -9.60872 -19.0628 4.9633 17.0968 17.6986 17.6986 17.6986 -19.0628 5.9633 16.0968 3.83013 3.83013 3.83013 -19.0628 5.9633 17.0968 7.11944 7.11944 7.11944 -20.0628 4.9633 16.0968 8.44715 8.44715 8.44715 -20.0628 4.9633 17.0968 12.533 12.533 12.533 -20.0628 5.9633 16.0968 4.23818 4.23818 4.23818 -20.0628 5.9633 17.0968 7.83365 7.83365 7.83365 -17.0628 3.9633000000000003 18.0968 -29.7825 -29.7825 -29.7825 -17.0628 3.9633000000000003 19.0968 -46.5977 -46.5977 -46.5977 -18.0628 3.9633000000000003 18.0968 -21.0687 -21.0687 -21.0687 -18.0628 3.9633000000000003 19.0968 -13.6589 -13.6589 -13.6589 -17.0628 2.9633000000000003 20.0968 4.458 4.458 4.458 -17.0628 2.9633000000000003 21.0968 8573.9 8573.9 8573.9 -17.0628 3.9633000000000003 20.0968 13.1165 13.1165 13.1165 -17.0628 3.9633000000000003 21.0968 26.3415 26.3415 26.3415 -18.0628 2.9633000000000003 20.0968 -3.5985 -3.5985 -3.5985 -18.0628 2.9633000000000003 21.0968 11747.3 11747.3 11747.3 -18.0628 3.9633000000000003 20.0968 15.4195 15.4195 15.4195 -18.0628 3.9633000000000003 21.0968 1.17805 1.17805 1.17805 -17.0628 4.9633 18.0968 -44.3433 -44.3433 -44.3433 -17.0628 4.9633 19.0968 56.9764 56.9764 56.9764 -17.0628 5.9633 18.0968 -9.42633 -9.42633 -9.42633 -17.0628 5.9633 19.0968 -50.3355 -50.3355 -50.3355 -18.0628 4.9633 18.0968 13.9626 13.9626 13.9626 -18.0628 4.9633 19.0968 45.6587 45.6587 45.6587 -18.0628 5.9633 18.0968 29.1318 29.1318 29.1318 -17.0628 4.9633 20.0968 -314.966 -314.966 -314.966 -17.0628 4.9633 21.0968 -44.1054 -44.1054 -44.1054 -17.0628 5.9633 20.0968 57.5546 57.5546 57.5546 -17.0628 5.9633 21.0968 64.0758 64.0758 64.0758 -18.0628 4.9633 20.0968 23.1322 23.1322 23.1322 -18.0628 4.9633 21.0968 107.935 107.935 107.935 -18.0628 5.9633 21.0968 42.5628 42.5628 42.5628 -19.0628 2.9633000000000003 18.0968 -25.3988 -25.3988 -25.3988 -19.0628 2.9633000000000003 19.0968 -15.4657 -15.4657 -15.4657 -19.0628 3.9633000000000003 18.0968 3.80687 3.80687 3.80687 -19.0628 3.9633000000000003 19.0968 -1.82368 -1.82368 -1.82368 -20.0628 2.9633000000000003 18.0968 10.9155 10.9155 10.9155 -20.0628 2.9633000000000003 19.0968 22.4001 22.4001 22.4001 -20.0628 3.9633000000000003 18.0968 7.78002 7.78002 7.78002 -20.0628 3.9633000000000003 19.0968 -1.2869 -1.2869 -1.2869 -19.0628 2.9633000000000003 20.0968 -2.23335 -2.23335 -2.23335 -19.0628 3.9633000000000003 20.0968 3.25013 3.25013 3.25013 -19.0628 3.9633000000000003 21.0968 -22.9115 -22.9115 -22.9115 -20.0628 2.9633000000000003 20.0968 34.7918 34.7918 34.7918 -20.0628 3.9633000000000003 20.0968 3.54047 3.54047 3.54047 -20.0628 3.9633000000000003 21.0968 -171.621 -171.621 -171.621 -19.0628 4.9633 18.0968 4.42121 4.42121 4.42121 -19.0628 4.9633 19.0968 3.10217 3.10217 3.10217 -19.0628 5.9633 18.0968 1.49477 1.49477 1.49477 -19.0628 5.9633 19.0968 5.02416 5.02416 5.02416 -20.0628 4.9633 18.0968 2.17655 2.17655 2.17655 -20.0628 4.9633 19.0968 7.43172 7.43172 7.43172 -20.0628 5.9633 18.0968 -0.540825 -0.540825 -0.540825 -20.0628 5.9633 19.0968 -1.40631 -1.40631 -1.40631 -19.0628 4.9633 20.0968 8.46413 8.46413 8.46413 -19.0628 4.9633 21.0968 -12.3898 -12.3898 -12.3898 -19.0628 5.9633 20.0968 5.44864 5.44864 5.44864 -20.0628 4.9633 20.0968 4.78112 4.78112 4.78112 -20.0628 4.9633 21.0968 -9.45818 -9.45818 -9.45818 -20.0628 5.9633 20.0968 1.35288 1.35288 1.35288 -20.0628 5.9633 21.0968 1.68517 1.68517 1.68517 -17.0628 6.9633 14.096800000000002 -7.7415 -7.7415 -7.7415 -17.0628 6.9633 15.096800000000002 -12.7 -12.7 -12.7 -17.0628 7.9633 14.096800000000002 1.35216 1.35216 1.35216 -17.0628 7.9633 15.096800000000002 -4.78171 -4.78171 -4.78171 -18.0628 6.9633 14.096800000000002 3.73431 3.73431 3.73431 -18.0628 6.9633 15.096800000000002 -5.68096 -5.68096 -5.68096 -18.0628 7.9633 14.096800000000002 11.494 11.494 11.494 -18.0628 7.9633 15.096800000000002 -8.84272 -8.84272 -8.84272 -17.0628 6.9633 16.0968 -0.305975 -0.305975 -0.305975 -17.0628 6.9633 17.0968 375.288 375.288 375.288 -17.0628 7.9633 16.0968 0.324237 0.324237 0.324237 -17.0628 7.9633 17.0968 373.869 373.869 373.869 -18.0628 6.9633 16.0968 7.11004 7.11004 7.11004 -18.0628 7.9633 16.0968 -8.34879 -8.34879 -8.34879 -18.0628 7.9633 17.0968 2.64242 2.64242 2.64242 -17.0628 8.9633 14.096800000000002 3.85085 3.85085 3.85085 -17.0628 8.9633 15.096800000000002 -1.86571 -1.86571 -1.86571 -18.0628 8.9633 14.096800000000002 4.94246 4.94246 4.94246 -18.0628 8.9633 15.096800000000002 -7.71935 -7.71935 -7.71935 -18.0628 9.9633 14.096800000000002 -0.81862 -0.81862 -0.81862 -18.0628 9.9633 15.096800000000002 -0.713624 -0.713624 -0.713624 -18.0628 8.9633 16.0968 -2.30297 -2.30297 -2.30297 -18.0628 8.9633 17.0968 0.494258 0.494258 0.494258 -18.0628 9.9633 17.0968 1.13936 1.13936 1.13936 -19.0628 6.9633 14.096800000000002 -0.491769 -0.491769 -0.491769 -19.0628 6.9633 15.096800000000002 -13.0815 -13.0815 -13.0815 -19.0628 7.9633 14.096800000000002 2.40321 2.40321 2.40321 -20.0628 6.9633 14.096800000000002 -31.7843 -31.7843 -31.7843 -20.0628 7.9633 14.096800000000002 -6.57755 -6.57755 -6.57755 -20.0628 7.9633 15.096800000000002 -0.581633 -0.581633 -0.581633 -19.0628 6.9633 16.0968 -2.17102 -2.17102 -2.17102 -19.0628 6.9633 17.0968 -0.950065 -0.950065 -0.950065 -19.0628 7.9633 17.0968 -0.484458 -0.484458 -0.484458 -20.0628 6.9633 16.0968 -5.25725 -5.25725 -5.25725 -20.0628 6.9633 17.0968 0.230773 0.230773 0.230773 -20.0628 7.9633 16.0968 -1.24229 -1.24229 -1.24229 -20.0628 7.9633 17.0968 -2.3043 -2.3043 -2.3043 -19.0628 8.9633 14.096800000000002 3.49478 3.49478 3.49478 -19.0628 9.9633 14.096800000000002 -3.56246 -3.56246 -3.56246 -19.0628 9.9633 15.096800000000002 -1.95264 -1.95264 -1.95264 -20.0628 8.9633 14.096800000000002 -3.07576 -3.07576 -3.07576 -20.0628 8.9633 15.096800000000002 -1.25099 -1.25099 -1.25099 -20.0628 9.9633 14.096800000000002 -1.06365 -1.06365 -1.06365 -20.0628 9.9633 15.096800000000002 -0.150016 -0.150016 -0.150016 -19.0628 8.9633 16.0968 1.64504 1.64504 1.64504 -19.0628 9.9633 16.0968 0.177466 0.177466 0.177466 -19.0628 9.9633 17.0968 2.0988 2.0988 2.0988 -20.0628 8.9633 16.0968 1.60704 1.60704 1.60704 -20.0628 8.9633 17.0968 -0.423519 -0.423519 -0.423519 -20.0628 9.9633 16.0968 1.60132 1.60132 1.60132 -20.0628 9.9633 17.0968 -0.334078 -0.334078 -0.334078 -17.0628 6.9633 18.0968 -878.224 -878.224 -878.224 -17.0628 6.9633 19.0968 -635.793 -635.793 -635.793 -17.0628 7.9633 18.0968 119.449 119.449 119.449 -17.0628 7.9633 19.0968 -410.919 -410.919 -410.919 -18.0628 6.9633 18.0968 10.752 10.752 10.752 -18.0628 6.9633 19.0968 0.983563 0.983563 0.983563 -18.0628 7.9633 18.0968 1.49359 1.49359 1.49359 -18.0628 7.9633 19.0968 -3.80918 -3.80918 -3.80918 -17.0628 6.9633 20.0968 248.771 248.771 248.771 -17.0628 6.9633 21.0968 -174.964 -174.964 -174.964 -17.0628 7.9633 20.0968 4.3809 4.3809 4.3809 -17.0628 7.9633 21.0968 4.9721 4.9721 4.9721 -18.0628 6.9633 20.0968 0.638955 0.638955 0.638955 -18.0628 6.9633 21.0968 20.9309 20.9309 20.9309 -18.0628 7.9633 20.0968 0.70815 0.70815 0.70815 -18.0628 7.9633 21.0968 -0.6485 -0.6485 -0.6485 -17.0628 8.9633 18.0968 94.5743 94.5743 94.5743 -17.0628 8.9633 19.0968 292.287 292.287 292.287 -17.0628 9.9633 18.0968 -1.20141 -1.20141 -1.20141 -17.0628 9.9633 19.0968 -9.30119 -9.30119 -9.30119 -18.0628 8.9633 18.0968 1.46171 1.46171 1.46171 -18.0628 8.9633 19.0968 -1.05348 -1.05348 -1.05348 -18.0628 9.9633 18.0968 3.29294 3.29294 3.29294 -18.0628 9.9633 19.0968 -7.15212 -7.15212 -7.15212 -17.0628 8.9633 20.0968 2.55879 2.55879 2.55879 -17.0628 8.9633 21.0968 -3.01019 -3.01019 -3.01019 -17.0628 9.9633 20.0968 3.57451 3.57451 3.57451 -17.0628 9.9633 21.0968 2.16718 2.16718 2.16718 -18.0628 8.9633 20.0968 -1.43959 -1.43959 -1.43959 -18.0628 8.9633 21.0968 -2.12295 -2.12295 -2.12295 -18.0628 9.9633 21.0968 1.48376 1.48376 1.48376 -19.0628 6.9633 18.0968 -1.67651 -1.67651 -1.67651 -19.0628 6.9633 19.0968 1.78411 1.78411 1.78411 -19.0628 7.9633 18.0968 -5.57101 -5.57101 -5.57101 -19.0628 7.9633 19.0968 2.87349 2.87349 2.87349 -20.0628 7.9633 18.0968 -4.18512 -4.18512 -4.18512 -20.0628 7.9633 19.0968 -0.298917 -0.298917 -0.298917 -19.0628 6.9633 20.0968 -1.3517 -1.3517 -1.3517 -19.0628 6.9633 21.0968 -3.32265 -3.32265 -3.32265 -19.0628 7.9633 20.0968 -4.41355 -4.41355 -4.41355 -19.0628 7.9633 21.0968 -5.75085 -5.75085 -5.75085 -20.0628 6.9633 20.0968 4.23902 4.23902 4.23902 -20.0628 6.9633 21.0968 -1.86302 -1.86302 -1.86302 -20.0628 7.9633 20.0968 -62.6607 -62.6607 -62.6607 -20.0628 7.9633 21.0968 -19.7838 -19.7838 -19.7838 -19.0628 8.9633 18.0968 2.62167 2.62167 2.62167 -19.0628 8.9633 19.0968 -0.095359 -0.095359 -0.095359 -19.0628 9.9633 18.0968 -0.259367 -0.259367 -0.259367 -19.0628 9.9633 19.0968 -5.35456 -5.35456 -5.35456 -20.0628 8.9633 18.0968 0.0726016 0.0726016 0.0726016 -20.0628 8.9633 19.0968 -0.0874673 -0.0874673 -0.0874673 -20.0628 9.9633 18.0968 1.42574 1.42574 1.42574 -20.0628 9.9633 19.0968 -6.34084 -6.34084 -6.34084 -21.0628 2.9633000000000003 14.096800000000002 16.6768 16.6768 16.6768 -21.0628 2.9633000000000003 15.096800000000002 -0.897711 -0.897711 -0.897711 -21.0628 3.9633000000000003 15.096800000000002 -7.38509 -7.38509 -7.38509 -22.0628 2.9633000000000003 14.096800000000002 0.363874 0.363874 0.363874 -22.0628 2.9633000000000003 15.096800000000002 -0.505235 -0.505235 -0.505235 -22.0628 3.9633000000000003 14.096800000000002 2.72471 2.72471 2.72471 -21.0628 3.9633000000000003 16.0968 -11.7604 -11.7604 -11.7604 -21.0628 3.9633000000000003 17.0968 -5.82341 -5.82341 -5.82341 -22.0628 2.9633000000000003 16.0968 4.18202 4.18202 4.18202 -21.0628 4.9633 14.096800000000002 4.19504 4.19504 4.19504 -21.0628 4.9633 15.096800000000002 19.8143 19.8143 19.8143 -21.0628 5.9633 14.096800000000002 10.5638 10.5638 10.5638 -21.0628 5.9633 15.096800000000002 19.6853 19.6853 19.6853 -22.0628 4.9633 14.096800000000002 18.2198 18.2198 18.2198 -22.0628 4.9633 15.096800000000002 25.0185 25.0185 25.0185 -22.0628 5.9633 14.096800000000002 -18.46 -18.46 -18.46 -22.0628 5.9633 15.096800000000002 14.2962 14.2962 14.2962 -21.0628 4.9633 16.0968 -14.3775 -14.3775 -14.3775 -21.0628 5.9633 16.0968 35.6167 35.6167 35.6167 -22.0628 4.9633 16.0968 3.73237 3.73237 3.73237 -22.0628 5.9633 16.0968 17.8126 17.8126 17.8126 -23.0628 2.9633000000000003 14.096800000000002 2.83924 2.83924 2.83924 -23.0628 2.9633000000000003 15.096800000000002 4.71455 4.71455 4.71455 -24.0628 2.9633000000000003 14.096800000000002 2.53085 2.53085 2.53085 -24.0628 2.9633000000000003 15.096800000000002 1.32589 1.32589 1.32589 -23.0628 2.9633000000000003 16.0968 3.44367 3.44367 3.44367 -24.0628 2.9633000000000003 16.0968 1.18604 1.18604 1.18604 -24.0628 2.9633000000000003 17.0968 10.3908 10.3908 10.3908 -24.0628 3.9633000000000003 16.0968 -8.94569 -8.94569 -8.94569 -24.0628 3.9633000000000003 17.0968 -24.0509 -24.0509 -24.0509 -23.0628 4.9633 14.096800000000002 6.94724 6.94724 6.94724 -23.0628 5.9633 14.096800000000002 -62.0958 -62.0958 -62.0958 -23.0628 5.9633 15.096800000000002 -24.487 -24.487 -24.487 -24.0628 5.9633 14.096800000000002 -2.89848 -2.89848 -2.89848 -24.0628 5.9633 15.096800000000002 -16.1737 -16.1737 -16.1737 -23.0628 5.9633 16.0968 -6.9066 -6.9066 -6.9066 -24.0628 4.9633 16.0968 8.25424 8.25424 8.25424 -24.0628 4.9633 17.0968 10.1708 10.1708 10.1708 -24.0628 5.9633 16.0968 15.5431 15.5431 15.5431 -24.0628 5.9633 17.0968 10.5708 10.5708 10.5708 -21.0628 2.9633000000000003 18.0968 28.6573 28.6573 28.6573 -21.0628 2.9633000000000003 19.0968 47.4272 47.4272 47.4272 -21.0628 3.9633000000000003 18.0968 -49.147 -49.147 -49.147 -21.0628 3.9633000000000003 19.0968 -44.2641 -44.2641 -44.2641 -22.0628 2.9633000000000003 19.0968 83.5221 83.5221 83.5221 -22.0628 3.9633000000000003 18.0968 0.789554 0.789554 0.789554 -22.0628 3.9633000000000003 19.0968 31.3767 31.3767 31.3767 -21.0628 2.9633000000000003 20.0968 74.0063 74.0063 74.0063 -21.0628 2.9633000000000003 21.0968 16.2448 16.2448 16.2448 -21.0628 3.9633000000000003 21.0968 -205.559 -205.559 -205.559 -22.0628 2.9633000000000003 20.0968 44.8251 44.8251 44.8251 -22.0628 2.9633000000000003 21.0968 -308.479 -308.479 -308.479 -22.0628 3.9633000000000003 21.0968 -13.9385 -13.9385 -13.9385 -21.0628 4.9633 19.0968 1.00053 1.00053 1.00053 -21.0628 5.9633 19.0968 -4.37917 -4.37917 -4.37917 -22.0628 4.9633 18.0968 -37.7087 -37.7087 -37.7087 -22.0628 4.9633 19.0968 -37.2682 -37.2682 -37.2682 -22.0628 5.9633 19.0968 -0.181255 -0.181255 -0.181255 -21.0628 4.9633 21.0968 -14.6208 -14.6208 -14.6208 -21.0628 5.9633 20.0968 5.11166 5.11166 5.11166 -21.0628 5.9633 21.0968 4.86179 4.86179 4.86179 -22.0628 4.9633 21.0968 -2.34756 -2.34756 -2.34756 -22.0628 5.9633 20.0968 -2.04545 -2.04545 -2.04545 -22.0628 5.9633 21.0968 0.800061 0.800061 0.800061 -23.0628 2.9633000000000003 19.0968 10.0109 10.0109 10.0109 -23.0628 3.9633000000000003 18.0968 -78.0188 -78.0188 -78.0188 -23.0628 3.9633000000000003 19.0968 -3.06267 -3.06267 -3.06267 -24.0628 2.9633000000000003 18.0968 0.437444 0.437444 0.437444 -24.0628 2.9633000000000003 19.0968 55.7548 55.7548 55.7548 -24.0628 3.9633000000000003 18.0968 -17.6003 -17.6003 -17.6003 -24.0628 3.9633000000000003 19.0968 4.45582 4.45582 4.45582 -23.0628 2.9633000000000003 20.0968 19.2653 19.2653 19.2653 -23.0628 2.9633000000000003 21.0968 -0.1138 -0.1138 -0.1138 -23.0628 3.9633000000000003 20.0968 22.6007 22.6007 22.6007 -23.0628 3.9633000000000003 21.0968 6.03913 6.03913 6.03913 -24.0628 2.9633000000000003 20.0968 51.7687 51.7687 51.7687 -24.0628 2.9633000000000003 21.0968 -27.6664 -27.6664 -27.6664 -24.0628 3.9633000000000003 20.0968 35.9998 35.9998 35.9998 -24.0628 3.9633000000000003 21.0968 -26.9598 -26.9598 -26.9598 -23.0628 4.9633 18.0968 60.9829 60.9829 60.9829 -23.0628 4.9633 19.0968 -9.31014 -9.31014 -9.31014 -23.0628 5.9633 18.0968 1.87505 1.87505 1.87505 -23.0628 5.9633 19.0968 3.6073 3.6073 3.6073 -24.0628 4.9633 18.0968 -1.53763 -1.53763 -1.53763 -24.0628 4.9633 19.0968 -28.1934 -28.1934 -28.1934 -24.0628 5.9633 18.0968 1.30835 1.30835 1.30835 -24.0628 5.9633 19.0968 6.1688 6.1688 6.1688 -23.0628 4.9633 20.0968 -48.8266 -48.8266 -48.8266 -23.0628 4.9633 21.0968 -22.882 -22.882 -22.882 -23.0628 5.9633 21.0968 -0.728398 -0.728398 -0.728398 -24.0628 4.9633 20.0968 -25.2217 -25.2217 -25.2217 -24.0628 4.9633 21.0968 -11.6026 -11.6026 -11.6026 -24.0628 5.9633 20.0968 8.44963 8.44963 8.44963 -24.0628 5.9633 21.0968 -2.08748 -2.08748 -2.08748 -21.0628 7.9633 14.096800000000002 -2.08561 -2.08561 -2.08561 -21.0628 7.9633 15.096800000000002 -2.95495 -2.95495 -2.95495 -22.0628 6.9633 15.096800000000002 -3.17994 -3.17994 -3.17994 -22.0628 7.9633 14.096800000000002 -2.98654 -2.98654 -2.98654 -22.0628 7.9633 15.096800000000002 -1.34873 -1.34873 -1.34873 -21.0628 6.9633 16.0968 -5.00512 -5.00512 -5.00512 -21.0628 6.9633 17.0968 1.99703 1.99703 1.99703 -21.0628 7.9633 16.0968 -0.654452 -0.654452 -0.654452 -21.0628 7.9633 17.0968 -3.80113 -3.80113 -3.80113 -22.0628 6.9633 16.0968 15.0182 15.0182 15.0182 -22.0628 6.9633 17.0968 -5.30217 -5.30217 -5.30217 -22.0628 7.9633 16.0968 -1.90443 -1.90443 -1.90443 -22.0628 7.9633 17.0968 4.14465 4.14465 4.14465 -21.0628 8.9633 14.096800000000002 5.24363 5.24363 5.24363 -21.0628 8.9633 17.0968 0.100401 0.100401 0.100401 -21.0628 9.9633 17.0968 17.2724 17.2724 17.2724 -22.0628 8.9633 16.0968 0.0931253 0.0931253 0.0931253 -22.0628 8.9633 17.0968 -5.83084 -5.83084 -5.83084 -22.0628 9.9633 17.0968 6.89836 6.89836 6.89836 -23.0628 6.9633 15.096800000000002 -20.4089 -20.4089 -20.4089 -23.0628 7.9633 14.096800000000002 -3.67603 -3.67603 -3.67603 -23.0628 7.9633 15.096800000000002 -1.09106 -1.09106 -1.09106 -24.0628 6.9633 14.096800000000002 3.46885 3.46885 3.46885 -24.0628 6.9633 15.096800000000002 -6.24659 -6.24659 -6.24659 -24.0628 7.9633 14.096800000000002 -3.4347 -3.4347 -3.4347 -24.0628 7.9633 15.096800000000002 -3.33532 -3.33532 -3.33532 -23.0628 6.9633 16.0968 0.509975 0.509975 0.509975 -23.0628 7.9633 16.0968 2.17538 2.17538 2.17538 -23.0628 7.9633 17.0968 14.8481 14.8481 14.8481 -24.0628 6.9633 16.0968 7.08583 7.08583 7.08583 -24.0628 7.9633 16.0968 1.33349 1.33349 1.33349 -24.0628 7.9633 17.0968 8.99399 8.99399 8.99399 -23.0628 8.9633 14.096800000000002 0.0385203 0.0385203 0.0385203 -23.0628 8.9633 15.096800000000002 1.5026 1.5026 1.5026 -23.0628 9.9633 14.096800000000002 1.11908 1.11908 1.11908 -23.0628 9.9633 15.096800000000002 -2.26168 -2.26168 -2.26168 -24.0628 8.9633 14.096800000000002 -1.6376 -1.6376 -1.6376 -24.0628 8.9633 15.096800000000002 4.09721 4.09721 4.09721 -24.0628 9.9633 14.096800000000002 0.606642 0.606642 0.606642 -24.0628 9.9633 15.096800000000002 -3.13575 -3.13575 -3.13575 -23.0628 8.9633 16.0968 8.81526 8.81526 8.81526 -23.0628 9.9633 16.0968 -4.82214 -4.82214 -4.82214 -23.0628 9.9633 17.0968 5.74702 5.74702 5.74702 -24.0628 8.9633 17.0968 10.4506 10.4506 10.4506 -24.0628 9.9633 16.0968 -1.03507 -1.03507 -1.03507 -24.0628 9.9633 17.0968 0.548351 0.548351 0.548351 -21.0628 7.9633 18.0968 -1.86829 -1.86829 -1.86829 -21.0628 7.9633 19.0968 0.965864 0.965864 0.965864 -22.0628 6.9633 18.0968 1.44254 1.44254 1.44254 -22.0628 6.9633 19.0968 9.90275 9.90275 9.90275 -22.0628 7.9633 18.0968 4.01272 4.01272 4.01272 -22.0628 7.9633 19.0968 5.63976 5.63976 5.63976 -21.0628 6.9633 20.0968 2.23105 2.23105 2.23105 -21.0628 6.9633 21.0968 1.73879 1.73879 1.73879 -21.0628 7.9633 20.0968 57.7279 57.7279 57.7279 -21.0628 7.9633 21.0968 4.12447 4.12447 4.12447 -22.0628 6.9633 20.0968 -0.805663 -0.805663 -0.805663 -22.0628 6.9633 21.0968 2.37869 2.37869 2.37869 -22.0628 7.9633 20.0968 -6.26783 -6.26783 -6.26783 -22.0628 7.9633 21.0968 82.2583 82.2583 82.2583 -21.0628 8.9633 18.0968 -0.920562 -0.920562 -0.920562 -21.0628 8.9633 19.0968 -0.206214 -0.206214 -0.206214 -21.0628 9.9633 18.0968 13.8706 13.8706 13.8706 -21.0628 9.9633 19.0968 -7.50948 -7.50948 -7.50948 -22.0628 8.9633 19.0968 -7.40332 -7.40332 -7.40332 -22.0628 9.9633 18.0968 5.62032 5.62032 5.62032 -22.0628 9.9633 19.0968 10.6504 10.6504 10.6504 -21.0628 8.9633 20.0968 -17.594 -17.594 -17.594 -22.0628 8.9633 20.0968 -56.8197 -56.8197 -56.8197 -22.0628 8.9633 21.0968 -37.1678 -37.1678 -37.1678 -22.0628 9.9633 20.0968 46.3093 46.3093 46.3093 -23.0628 6.9633 18.0968 3.75531 3.75531 3.75531 -23.0628 6.9633 19.0968 -6.68962 -6.68962 -6.68962 -23.0628 7.9633 18.0968 1.49031 1.49031 1.49031 -24.0628 6.9633 18.0968 -12.0318 -12.0318 -12.0318 -24.0628 6.9633 19.0968 -7.69708 -7.69708 -7.69708 -24.0628 7.9633 18.0968 10.9091 10.9091 10.9091 -24.0628 7.9633 19.0968 -14.0722 -14.0722 -14.0722 -23.0628 6.9633 20.0968 -2.28778 -2.28778 -2.28778 -23.0628 6.9633 21.0968 1.5369 1.5369 1.5369 -23.0628 7.9633 21.0968 76.1285 76.1285 76.1285 -24.0628 6.9633 20.0968 6.19334 6.19334 6.19334 -24.0628 6.9633 21.0968 4.08311 4.08311 4.08311 -24.0628 7.9633 20.0968 2.92102 2.92102 2.92102 -24.0628 7.9633 21.0968 -18.0825 -18.0825 -18.0825 -23.0628 8.9633 18.0968 -5.85697 -5.85697 -5.85697 -23.0628 8.9633 19.0968 -17.4372 -17.4372 -17.4372 -23.0628 9.9633 18.0968 7.60929 7.60929 7.60929 -24.0628 8.9633 18.0968 -5.63626 -5.63626 -5.63626 -24.0628 8.9633 19.0968 1.66802 1.66802 1.66802 -24.0628 9.9633 18.0968 3.20307 3.20307 3.20307 -24.0628 9.9633 19.0968 34.0257 34.0257 34.0257 -23.0628 8.9633 20.0968 -0.890211 -0.890211 -0.890211 -23.0628 8.9633 21.0968 -73.6324 -73.6324 -73.6324 -23.0628 9.9633 20.0968 11.3505 11.3505 11.3505 -24.0628 8.9633 20.0968 -4.98041 -4.98041 -4.98041 -24.0628 8.9633 21.0968 -168.281 -168.281 -168.281 -14.0628 -0.03669999999999973 22.0968 -303.396 -303.396 -303.396 -14.0628 -0.03669999999999973 25.0968 90.4052 90.4052 90.4052 -13.0628 0.9633000000000003 22.0968 40.8984 40.8984 40.8984 -13.0628 1.9633000000000003 22.0968 -80.1252 -80.1252 -80.1252 -13.0628 1.9633000000000003 23.0968 101.964 101.964 101.964 -14.0628 0.9633000000000003 22.0968 -82.1079 -82.1079 -82.1079 -14.0628 0.9633000000000003 23.0968 195.408 195.408 195.408 -14.0628 1.9633000000000003 22.0968 -103.605 -103.605 -103.605 -14.0628 1.9633000000000003 23.0968 -42.3433 -42.3433 -42.3433 -13.0628 1.9633000000000003 24.0968 -116.638 -116.638 -116.638 -13.0628 1.9633000000000003 25.0968 -13.0061 -13.0061 -13.0061 -14.0628 0.9633000000000003 24.0968 191.323 191.323 191.323 -14.0628 0.9633000000000003 25.0968 31.1154 31.1154 31.1154 -14.0628 1.9633000000000003 24.0968 274.457 274.457 274.457 -14.0628 1.9633000000000003 25.0968 3.04006 3.04006 3.04006 -15.0628 -0.03669999999999973 22.0968 13.6241 13.6241 13.6241 -15.0628 -1.0366999999999997 24.0968 -21.4714 -21.4714 -21.4714 -15.0628 -1.0366999999999997 25.0968 4.12197 4.12197 4.12197 -15.0628 -0.03669999999999973 24.0968 16.1887 16.1887 16.1887 -15.0628 -0.03669999999999973 25.0968 2.4395 2.4395 2.4395 -16.0628 -1.0366999999999997 24.0968 -21.8247 -21.8247 -21.8247 -16.0628 -1.0366999999999997 25.0968 -6.37188 -6.37188 -6.37188 -16.0628 -0.03669999999999973 24.0968 -32.0546 -32.0546 -32.0546 -15.0628 0.9633000000000003 22.0968 22.726 22.726 22.726 -15.0628 0.9633000000000003 23.0968 93.3869 93.3869 93.3869 -15.0628 1.9633000000000003 23.0968 73.6643 73.6643 73.6643 -16.0628 0.9633000000000003 22.0968 -36.119 -36.119 -36.119 -16.0628 1.9633000000000003 22.0968 -92.3894 -92.3894 -92.3894 -16.0628 1.9633000000000003 23.0968 33.0139 33.0139 33.0139 -15.0628 0.9633000000000003 24.0968 -53.0842 -53.0842 -53.0842 -15.0628 0.9633000000000003 25.0968 11.981 11.981 11.981 -15.0628 1.9633000000000003 24.0968 81.7579 81.7579 81.7579 -15.0628 1.9633000000000003 25.0968 1.3577 1.3577 1.3577 -16.0628 0.9633000000000003 24.0968 11.1828 11.1828 11.1828 -16.0628 0.9633000000000003 25.0968 0.510752 0.510752 0.510752 -16.0628 1.9633000000000003 24.0968 48.998 48.998 48.998 -16.0628 1.9633000000000003 25.0968 -1.58734 -1.58734 -1.58734 -14.0628 -0.03669999999999973 26.0968 56.1646 56.1646 56.1646 -14.0628 0.9633000000000003 26.0968 69.2143 69.2143 69.2143 -14.0628 0.9633000000000003 27.0968 -2.4444 -2.4444 -2.4444 -14.0628 1.9633000000000003 26.0968 -58.0344 -58.0344 -58.0344 -14.0628 1.9633000000000003 27.0968 -8.40116 -8.40116 -8.40116 -15.0628 -1.0366999999999997 26.0968 1.20818 1.20818 1.20818 -15.0628 -1.0366999999999997 27.0968 -0.597834 -0.597834 -0.597834 -15.0628 -0.03669999999999973 26.0968 10.3343 10.3343 10.3343 -15.0628 -0.03669999999999973 27.0968 0.610162 0.610162 0.610162 -16.0628 -1.0366999999999997 26.0968 5.21554 5.21554 5.21554 -16.0628 -1.0366999999999997 27.0968 -19.7861 -19.7861 -19.7861 -16.0628 -0.03669999999999973 27.0968 -12.8491 -12.8491 -12.8491 -15.0628 -0.03669999999999973 28.0968 2.46891 2.46891 2.46891 -16.0628 -0.03669999999999973 28.0968 5.73615 5.73615 5.73615 -15.0628 0.9633000000000003 26.0968 -9.8998 -9.8998 -9.8998 -15.0628 0.9633000000000003 27.0968 -1.50842 -1.50842 -1.50842 -15.0628 1.9633000000000003 26.0968 2.37546 2.37546 2.37546 -15.0628 1.9633000000000003 27.0968 -24.2553 -24.2553 -24.2553 -16.0628 1.9633000000000003 26.0968 8.04713 8.04713 8.04713 -16.0628 1.9633000000000003 27.0968 -2.50797 -2.50797 -2.50797 -15.0628 0.9633000000000003 28.0968 -5.3325 -5.3325 -5.3325 -15.0628 1.9633000000000003 28.0968 10.5628 10.5628 10.5628 -16.0628 0.9633000000000003 28.0968 -3.59266 -3.59266 -3.59266 -16.0628 1.9633000000000003 28.0968 9.11916 9.11916 9.11916 -16.0628 1.9633000000000003 32.0968 -15.5631 -15.5631 -15.5631 -16.0628 1.9633000000000003 33.0968 -0.203853 -0.203853 -0.203853 -16.0628 1.9633000000000003 34.0968 -0.514741 -0.514741 -0.514741 -10.0628 3.9633000000000003 25.0968 -6.0592 -6.0592 -6.0592 -10.0628 4.9633 22.0968 -519.993 -519.993 -519.993 -10.0628 5.9633 22.0968 -201.78 -201.78 -201.78 -10.0628 4.9633 24.0968 411.82 411.82 411.82 -10.0628 4.9633 25.0968 -3.1628 -3.1628 -3.1628 -10.0628 5.9633 24.0968 269.535 269.535 269.535 -10.0628 5.9633 25.0968 -5.07631 -5.07631 -5.07631 -11.0628 3.9633000000000003 24.0968 -83.4583 -83.4583 -83.4583 -11.0628 3.9633000000000003 25.0968 -29.9825 -29.9825 -29.9825 -12.0628 3.9633000000000003 24.0968 257.788 257.788 257.788 -12.0628 3.9633000000000003 25.0968 55.8939 55.8939 55.8939 -11.0628 4.9633 22.0968 -814.453 -814.453 -814.453 -11.0628 4.9633 23.0968 878.512 878.512 878.512 -11.0628 5.9633 22.0968 -719.679 -719.679 -719.679 -11.0628 5.9633 23.0968 -1030.03 -1030.03 -1030.03 -12.0628 4.9633 22.0968 -1018.52 -1018.52 -1018.52 -12.0628 4.9633 23.0968 -1119.42 -1119.42 -1119.42 -12.0628 5.9633 22.0968 540.694 540.694 540.694 -12.0628 5.9633 23.0968 -1240.52 -1240.52 -1240.52 -11.0628 4.9633 24.0968 29.4627 29.4627 29.4627 -11.0628 4.9633 25.0968 11.5335 11.5335 11.5335 -11.0628 5.9633 24.0968 333.089 333.089 333.089 -12.0628 4.9633 24.0968 254.281 254.281 254.281 -12.0628 4.9633 25.0968 -1.57239 -1.57239 -1.57239 -10.0628 3.9633000000000003 26.0968 11.969 11.969 11.969 -10.0628 3.9633000000000003 27.0968 -9.73973 -9.73973 -9.73973 -10.0628 3.9633000000000003 28.0968 9.52754 9.52754 9.52754 -10.0628 4.9633 26.0968 11.319 11.319 11.319 -10.0628 4.9633 27.0968 -11.5239 -11.5239 -11.5239 -10.0628 5.9633 26.0968 44.564 44.564 44.564 -10.0628 5.9633 27.0968 -20.4405 -20.4405 -20.4405 -10.0628 4.9633 28.0968 -21.3764 -21.3764 -21.3764 -10.0628 5.9633 28.0968 1.02468 1.02468 1.02468 -11.0628 2.9633000000000003 26.0968 3.11252 3.11252 3.11252 -11.0628 2.9633000000000003 27.0968 -22.3747 -22.3747 -22.3747 -11.0628 3.9633000000000003 26.0968 -6.43452 -6.43452 -6.43452 -11.0628 3.9633000000000003 27.0968 -4.57056 -4.57056 -4.57056 -12.0628 2.9633000000000003 26.0968 -10.9315 -10.9315 -10.9315 -12.0628 2.9633000000000003 27.0968 -2.5001 -2.5001 -2.5001 -12.0628 3.9633000000000003 26.0968 -4.89344 -4.89344 -4.89344 -12.0628 3.9633000000000003 27.0968 -10.4947 -10.4947 -10.4947 -11.0628 2.9633000000000003 28.0968 13.3296 13.3296 13.3296 -11.0628 3.9633000000000003 28.0968 14.2657 14.2657 14.2657 -12.0628 2.9633000000000003 28.0968 2.73607 2.73607 2.73607 -12.0628 3.9633000000000003 28.0968 -1.44963 -1.44963 -1.44963 -11.0628 5.9633 27.0968 8.95749 8.95749 8.95749 -12.0628 4.9633 26.0968 2.50676 2.50676 2.50676 -11.0628 4.9633 28.0968 10.2941 10.2941 10.2941 -11.0628 5.9633 28.0968 13.0774 13.0774 13.0774 -11.0628 5.9633 29.0968 3.04448 3.04448 3.04448 -12.0628 4.9633 28.0968 6.06931 6.06931 6.06931 -12.0628 5.9633 28.0968 -2.96487 -2.96487 -2.96487 -12.0628 5.9633 29.0968 13.4384 13.4384 13.4384 -10.0628 6.9633 22.0968 820.181 820.181 820.181 -10.0628 7.9633 22.0968 -4.38061 -4.38061 -4.38061 -10.0628 6.9633 24.0968 -5.6209 -5.6209 -5.6209 -10.0628 6.9633 25.0968 -27.5259 -27.5259 -27.5259 -9.0628 8.9633 22.0968 -6.41689 -6.41689 -6.41689 -9.0628 9.9633 22.0968 8.19461 8.19461 8.19461 -10.0628 8.9633 22.0968 0.998389 0.998389 0.998389 -10.0628 8.9633 23.0968 -19.569 -19.569 -19.569 -10.0628 9.9633 22.0968 -2.12734 -2.12734 -2.12734 -10.0628 9.9633 23.0968 1.69098 1.69098 1.69098 -11.0628 6.9633 22.0968 1764.58 1764.58 1764.58 -11.0628 6.9633 23.0968 38.6134 38.6134 38.6134 -11.0628 7.9633 22.0968 -4.68906 -4.68906 -4.68906 -11.0628 7.9633 23.0968 -2.59831 -2.59831 -2.59831 -12.0628 6.9633 22.0968 719.245 719.245 719.245 -12.0628 6.9633 23.0968 538.052 538.052 538.052 -12.0628 7.9633 22.0968 7.90186 7.90186 7.90186 -12.0628 7.9633 23.0968 23.0683 23.0683 23.0683 -11.0628 6.9633 24.0968 -17.6794 -17.6794 -17.6794 -11.0628 6.9633 25.0968 -46.896 -46.896 -46.896 -11.0628 7.9633 24.0968 12.2622 12.2622 12.2622 -11.0628 7.9633 25.0968 22.5639 22.5639 22.5639 -12.0628 7.9633 24.0968 2.94538 2.94538 2.94538 -12.0628 7.9633 25.0968 81.859 81.859 81.859 -11.0628 8.9633 23.0968 8.4869 8.4869 8.4869 -11.0628 9.9633 23.0968 -6.3229 -6.3229 -6.3229 -12.0628 8.9633 22.0968 -2.24469 -2.24469 -2.24469 -12.0628 8.9633 23.0968 -11.1978 -11.1978 -11.1978 -12.0628 9.9633 22.0968 0.395012 0.395012 0.395012 -12.0628 9.9633 23.0968 15.7547 15.7547 15.7547 -11.0628 9.9633 24.0968 -20.6549 -20.6549 -20.6549 -11.0628 9.9633 25.0968 101.228 101.228 101.228 -12.0628 8.9633 24.0968 1.30483 1.30483 1.30483 -12.0628 8.9633 25.0968 -40.3331 -40.3331 -40.3331 -12.0628 9.9633 24.0968 2.13019 2.13019 2.13019 -12.0628 9.9633 25.0968 -28.6518 -28.6518 -28.6518 -10.0628 6.9633 26.0968 -40.8971 -40.8971 -40.8971 -10.0628 6.9633 27.0968 -26.5357 -26.5357 -26.5357 -11.0628 6.9633 26.0968 -41.4977 -41.4977 -41.4977 -11.0628 6.9633 27.0968 26.9043 26.9043 26.9043 -11.0628 7.9633 26.0968 27.095 27.095 27.095 -11.0628 7.9633 27.0968 -43.3468 -43.3468 -43.3468 -12.0628 7.9633 26.0968 32.7336 32.7336 32.7336 -12.0628 7.9633 27.0968 -2.6035 -2.6035 -2.6035 -11.0628 6.9633 28.0968 0.629444 0.629444 0.629444 -11.0628 6.9633 29.0968 -0.379614 -0.379614 -0.379614 -11.0628 7.9633 28.0968 13.5842 13.5842 13.5842 -11.0628 7.9633 29.0968 -8.1039 -8.1039 -8.1039 -12.0628 6.9633 29.0968 16.4285 16.4285 16.4285 -12.0628 7.9633 29.0968 -14.1953 -14.1953 -14.1953 -12.0628 8.9633 27.0968 26.0532 26.0532 26.0532 -12.0628 9.9633 26.0968 -81.6535 -81.6535 -81.6535 -11.0628 8.9633 28.0968 20.322 20.322 20.322 -11.0628 8.9633 29.0968 10.054 10.054 10.054 -12.0628 8.9633 28.0968 12.005 12.005 12.005 -12.0628 8.9633 29.0968 -19.8211 -19.8211 -19.8211 -13.0628 2.9633000000000003 22.0968 118.716 118.716 118.716 -13.0628 2.9633000000000003 23.0968 -44.579 -44.579 -44.579 -13.0628 3.9633000000000003 23.0968 -91.5331 -91.5331 -91.5331 -14.0628 2.9633000000000003 22.0968 -34.1686 -34.1686 -34.1686 -14.0628 2.9633000000000003 23.0968 -56.0925 -56.0925 -56.0925 -14.0628 3.9633000000000003 22.0968 -42.8182 -42.8182 -42.8182 -14.0628 3.9633000000000003 23.0968 -92.3493 -92.3493 -92.3493 -13.0628 2.9633000000000003 24.0968 -337.746 -337.746 -337.746 -13.0628 2.9633000000000003 25.0968 10.1135 10.1135 10.1135 -13.0628 3.9633000000000003 24.0968 171.623 171.623 171.623 -13.0628 3.9633000000000003 25.0968 89.2229 89.2229 89.2229 -14.0628 2.9633000000000003 25.0968 13.0921 13.0921 13.0921 -14.0628 3.9633000000000003 24.0968 -4.27691 -4.27691 -4.27691 -14.0628 3.9633000000000003 25.0968 38.2675 38.2675 38.2675 -13.0628 4.9633 23.0968 -224.384 -224.384 -224.384 -13.0628 5.9633 22.0968 88.1646 88.1646 88.1646 -13.0628 5.9633 23.0968 -172.599 -172.599 -172.599 -14.0628 4.9633 22.0968 -7.80646 -7.80646 -7.80646 -14.0628 4.9633 23.0968 -9.83354 -9.83354 -9.83354 -14.0628 5.9633 22.0968 -20.822 -20.822 -20.822 -14.0628 5.9633 23.0968 -14.2115 -14.2115 -14.2115 -13.0628 4.9633 24.0968 5.74316 5.74316 5.74316 -13.0628 4.9633 25.0968 -37.977 -37.977 -37.977 -13.0628 5.9633 24.0968 -109.559 -109.559 -109.559 -13.0628 5.9633 25.0968 3.14346 3.14346 3.14346 -14.0628 4.9633 24.0968 8.44775 8.44775 8.44775 -14.0628 4.9633 25.0968 -0.544695 -0.544695 -0.544695 -14.0628 5.9633 24.0968 -5.11173 -5.11173 -5.11173 -14.0628 5.9633 25.0968 2.78785 2.78785 2.78785 -15.0628 3.9633000000000003 22.0968 -58.8631 -58.8631 -58.8631 -15.0628 3.9633000000000003 23.0968 -201.134 -201.134 -201.134 -16.0628 3.9633000000000003 22.0968 -46.7823 -46.7823 -46.7823 -16.0628 2.9633000000000003 24.0968 30.8163 30.8163 30.8163 -16.0628 2.9633000000000003 25.0968 17.1188 17.1188 17.1188 -16.0628 3.9633000000000003 25.0968 413.643 413.643 413.643 -15.0628 4.9633 22.0968 145.719 145.719 145.719 -15.0628 4.9633 23.0968 -86.2551 -86.2551 -86.2551 -15.0628 5.9633 23.0968 -174.559 -174.559 -174.559 -16.0628 4.9633 22.0968 -181.541 -181.541 -181.541 -16.0628 5.9633 22.0968 31.1617 31.1617 31.1617 -16.0628 5.9633 23.0968 88.4325 88.4325 88.4325 -15.0628 4.9633 24.0968 -286.525 -286.525 -286.525 -15.0628 4.9633 25.0968 -485.472 -485.472 -485.472 -15.0628 5.9633 24.0968 -458.83 -458.83 -458.83 -15.0628 5.9633 25.0968 -673.103 -673.103 -673.103 -16.0628 4.9633 24.0968 604.067 604.067 604.067 -16.0628 4.9633 25.0968 -36.5038 -36.5038 -36.5038 -16.0628 5.9633 24.0968 70.602 70.602 70.602 -16.0628 5.9633 25.0968 -93.0159 -93.0159 -93.0159 -13.0628 2.9633000000000003 26.0968 -3.00513 -3.00513 -3.00513 -13.0628 2.9633000000000003 27.0968 3.48002 3.48002 3.48002 -13.0628 3.9633000000000003 26.0968 17.2588 17.2588 17.2588 -13.0628 3.9633000000000003 27.0968 17.392 17.392 17.392 -14.0628 2.9633000000000003 26.0968 5.51293 5.51293 5.51293 -14.0628 2.9633000000000003 27.0968 14.2317 14.2317 14.2317 -14.0628 3.9633000000000003 26.0968 16.878 16.878 16.878 -14.0628 3.9633000000000003 27.0968 -12.3186 -12.3186 -12.3186 -13.0628 3.9633000000000003 28.0968 7.16869 7.16869 7.16869 -14.0628 3.9633000000000003 28.0968 -7.8366 -7.8366 -7.8366 -13.0628 4.9633 26.0968 1.41791 1.41791 1.41791 -13.0628 4.9633 27.0968 5.91592 5.91592 5.91592 -14.0628 4.9633 26.0968 9.47399 9.47399 9.47399 -13.0628 4.9633 28.0968 -1.15047 -1.15047 -1.15047 -13.0628 5.9633 28.0968 -0.480101 -0.480101 -0.480101 -13.0628 5.9633 29.0968 -4.16609 -4.16609 -4.16609 -14.0628 4.9633 28.0968 -1.80315 -1.80315 -1.80315 -14.0628 5.9633 28.0968 -2.79464 -2.79464 -2.79464 -14.0628 5.9633 29.0968 -515.463 -515.463 -515.463 -15.0628 2.9633000000000003 26.0968 4.03015 4.03015 4.03015 -15.0628 2.9633000000000003 27.0968 -1.21724 -1.21724 -1.21724 -15.0628 3.9633000000000003 26.0968 85.9864 85.9864 85.9864 -15.0628 3.9633000000000003 27.0968 59.8819 59.8819 59.8819 -16.0628 2.9633000000000003 26.0968 -5.05667 -5.05667 -5.05667 -16.0628 2.9633000000000003 27.0968 28.3798 28.3798 28.3798 -16.0628 3.9633000000000003 26.0968 251.794 251.794 251.794 -16.0628 3.9633000000000003 27.0968 -77.1822 -77.1822 -77.1822 -15.0628 3.9633000000000003 28.0968 -2.53047 -2.53047 -2.53047 -16.0628 2.9633000000000003 28.0968 288.288 288.288 288.288 -16.0628 2.9633000000000003 29.0968 -399.015 -399.015 -399.015 -16.0628 3.9633000000000003 28.0968 709.309 709.309 709.309 -16.0628 3.9633000000000003 29.0968 -299.829 -299.829 -299.829 -15.0628 4.9633 26.0968 138.56 138.56 138.56 -15.0628 4.9633 27.0968 203.582 203.582 203.582 -15.0628 5.9633 26.0968 131.785 131.785 131.785 -16.0628 4.9633 26.0968 234.406 234.406 234.406 -16.0628 4.9633 27.0968 -98.247 -98.247 -98.247 -16.0628 5.9633 26.0968 212.667 212.667 212.667 -15.0628 4.9633 28.0968 3.8384 3.8384 3.8384 -15.0628 4.9633 29.0968 -5.08779 -5.08779 -5.08779 -15.0628 5.9633 28.0968 8.02436 8.02436 8.02436 -15.0628 5.9633 29.0968 -1125.62 -1125.62 -1125.62 -16.0628 4.9633 28.0968 555.423 555.423 555.423 -16.0628 4.9633 29.0968 418.746 418.746 418.746 -16.0628 5.9633 28.0968 -5.54303 -5.54303 -5.54303 -16.0628 5.9633 29.0968 -640.673 -640.673 -640.673 -13.0628 6.9633 22.0968 -11.6708 -11.6708 -11.6708 -13.0628 6.9633 23.0968 5.58053 5.58053 5.58053 -13.0628 7.9633 22.0968 5.3961 5.3961 5.3961 -13.0628 7.9633 23.0968 -16.3687 -16.3687 -16.3687 -14.0628 6.9633 22.0968 -115.203 -115.203 -115.203 -14.0628 6.9633 23.0968 -10.9003 -10.9003 -10.9003 -14.0628 7.9633 22.0968 -43.1912 -43.1912 -43.1912 -14.0628 7.9633 23.0968 -5.62739 -5.62739 -5.62739 -13.0628 6.9633 25.0968 0.741383 0.741383 0.741383 -13.0628 7.9633 24.0968 -1.14332 -1.14332 -1.14332 -13.0628 7.9633 25.0968 0.663952 0.663952 0.663952 -14.0628 6.9633 24.0968 -3.29966 -3.29966 -3.29966 -14.0628 6.9633 25.0968 5.58241 5.58241 5.58241 -14.0628 7.9633 24.0968 -6.02993 -6.02993 -6.02993 -14.0628 7.9633 25.0968 -2.0308 -2.0308 -2.0308 -13.0628 8.9633 22.0968 -0.26283 -0.26283 -0.26283 -13.0628 9.9633 22.0968 -2.33001 -2.33001 -2.33001 -13.0628 9.9633 23.0968 1.21076 1.21076 1.21076 -14.0628 8.9633 22.0968 25.9233 25.9233 25.9233 -14.0628 8.9633 23.0968 -0.37176 -0.37176 -0.37176 -14.0628 9.9633 22.0968 -2.00427 -2.00427 -2.00427 -14.0628 9.9633 23.0968 2.53189 2.53189 2.53189 -13.0628 8.9633 24.0968 5.55028 5.55028 5.55028 -13.0628 8.9633 25.0968 -14.5852 -14.5852 -14.5852 -13.0628 9.9633 24.0968 2.98268 2.98268 2.98268 -13.0628 9.9633 25.0968 18.7048 18.7048 18.7048 -14.0628 9.9633 24.0968 1.3638 1.3638 1.3638 -14.0628 9.9633 25.0968 -0.127324 -0.127324 -0.127324 -15.0628 6.9633 23.0968 4.95113 4.95113 4.95113 -15.0628 7.9633 22.0968 -15.8674 -15.8674 -15.8674 -15.0628 7.9633 23.0968 3.2995 3.2995 3.2995 -16.0628 6.9633 22.0968 -170.218 -170.218 -170.218 -16.0628 6.9633 23.0968 18.8277 18.8277 18.8277 -16.0628 7.9633 22.0968 7.60267 7.60267 7.60267 -16.0628 7.9633 23.0968 2.37297 2.37297 2.37297 -15.0628 6.9633 24.0968 15.0834 15.0834 15.0834 -15.0628 6.9633 25.0968 -1.10856 -1.10856 -1.10856 -16.0628 6.9633 25.0968 -9.38723 -9.38723 -9.38723 -15.0628 8.9633 22.0968 -55.5358 -55.5358 -55.5358 -15.0628 8.9633 23.0968 38.6769 38.6769 38.6769 -15.0628 9.9633 22.0968 -20.1319 -20.1319 -20.1319 -15.0628 9.9633 23.0968 13.1483 13.1483 13.1483 -16.0628 9.9633 22.0968 -54.928 -54.928 -54.928 -16.0628 9.9633 23.0968 -46.592 -46.592 -46.592 -15.0628 9.9633 24.0968 73.1198 73.1198 73.1198 -13.0628 7.9633 26.0968 -11.7553 -11.7553 -11.7553 -13.0628 7.9633 27.0968 3.16825 3.16825 3.16825 -14.0628 6.9633 26.0968 6.70846 6.70846 6.70846 -14.0628 7.9633 26.0968 4.05122 4.05122 4.05122 -14.0628 7.9633 27.0968 17.0491 17.0491 17.0491 -13.0628 6.9633 29.0968 -16.0155 -16.0155 -16.0155 -13.0628 7.9633 29.0968 29.3836 29.3836 29.3836 -14.0628 6.9633 28.0968 12.0725 12.0725 12.0725 -14.0628 6.9633 29.0968 947.546 947.546 947.546 -14.0628 7.9633 28.0968 13.272 13.272 13.272 -14.0628 7.9633 29.0968 417.434 417.434 417.434 -13.0628 8.9633 26.0968 56.4022 56.4022 56.4022 -13.0628 8.9633 27.0968 95.3914 95.3914 95.3914 -13.0628 9.9633 26.0968 17.5069 17.5069 17.5069 -14.0628 8.9633 27.0968 3.9904 3.9904 3.9904 -14.0628 9.9633 26.0968 3.37893 3.37893 3.37893 -14.0628 9.9633 27.0968 0.126925 0.126925 0.126925 -13.0628 8.9633 28.0968 4.73315 4.73315 4.73315 -13.0628 8.9633 29.0968 6.28431 6.28431 6.28431 -14.0628 8.9633 28.0968 -14.7784 -14.7784 -14.7784 -14.0628 8.9633 29.0968 -6.49846 -6.49846 -6.49846 -14.0628 9.9633 28.0968 -11.2779 -11.2779 -11.2779 -14.0628 9.9633 29.0968 -2.79964 -2.79964 -2.79964 -15.0628 6.9633 26.0968 -1.83831 -1.83831 -1.83831 -15.0628 7.9633 26.0968 4.93182 4.93182 4.93182 -15.0628 7.9633 27.0968 -14.4586 -14.4586 -14.4586 -16.0628 6.9633 26.0968 -5.09389 -5.09389 -5.09389 -16.0628 7.9633 26.0968 5.09679 5.09679 5.09679 -16.0628 7.9633 27.0968 3.56222 3.56222 3.56222 -15.0628 6.9633 28.0968 -13.761 -13.761 -13.761 -15.0628 6.9633 29.0968 2650.64 2650.64 2650.64 -15.0628 7.9633 28.0968 15.0733 15.0733 15.0733 -15.0628 7.9633 29.0968 1265.24 1265.24 1265.24 -16.0628 6.9633 28.0968 -22.4458 -22.4458 -22.4458 -16.0628 6.9633 29.0968 2606.6 2606.6 2606.6 -16.0628 7.9633 28.0968 6.93549 6.93549 6.93549 -16.0628 7.9633 29.0968 43.5948 43.5948 43.5948 -15.0628 8.9633 27.0968 6.46848 6.46848 6.46848 -15.0628 9.9633 27.0968 -0.852217 -0.852217 -0.852217 -16.0628 8.9633 27.0968 -8.14956 -8.14956 -8.14956 -16.0628 9.9633 26.0968 -13.8045 -13.8045 -13.8045 -16.0628 9.9633 27.0968 9.86575 9.86575 9.86575 -15.0628 8.9633 28.0968 3.279 3.279 3.279 -15.0628 8.9633 29.0968 25.7306 25.7306 25.7306 -15.0628 9.9633 28.0968 -12.9299 -12.9299 -12.9299 -16.0628 8.9633 28.0968 13.3389 13.3389 13.3389 -12.0628 5.9633 30.0968 10.6374 10.6374 10.6374 -12.0628 6.9633 30.0968 -21.4085 -21.4085 -21.4085 -12.0628 7.9633 30.0968 -9.31569 -9.31569 -9.31569 -14.0628 3.9633000000000003 30.0968 11.0653 11.0653 11.0653 -14.0628 3.9633000000000003 31.0968 5.61658 5.61658 5.61658 -14.0628 3.9633000000000003 32.0968 177.571 177.571 177.571 -13.0628 5.9633 30.0968 13.0994 13.0994 13.0994 -14.0628 4.9633 30.0968 -9.81959 -9.81959 -9.81959 -14.0628 4.9633 31.0968 -51.8989 -51.8989 -51.8989 -14.0628 5.9633 30.0968 -736.015 -736.015 -736.015 -14.0628 5.9633 31.0968 -2120.02 -2120.02 -2120.02 -14.0628 4.9633 32.0968 -64.8451 -64.8451 -64.8451 -14.0628 4.9633 33.0968 -48.0212 -48.0212 -48.0212 -14.0628 5.9633 32.0968 -82.962 -82.962 -82.962 -14.0628 5.9633 33.0968 -45.0143 -45.0143 -45.0143 -15.0628 2.9633000000000003 31.0968 6.55323 6.55323 6.55323 -15.0628 3.9633000000000003 30.0968 7.0966 7.0966 7.0966 -15.0628 3.9633000000000003 31.0968 13.2287 13.2287 13.2287 -16.0628 2.9633000000000003 31.0968 -3.68723 -3.68723 -3.68723 -16.0628 3.9633000000000003 30.0968 115.422 115.422 115.422 -16.0628 3.9633000000000003 31.0968 1.8525 1.8525 1.8525 -15.0628 2.9633000000000003 32.0968 -0.149934 -0.149934 -0.149934 -15.0628 2.9633000000000003 33.0968 9.63574 9.63574 9.63574 -15.0628 3.9633000000000003 32.0968 89.7725 89.7725 89.7725 -15.0628 3.9633000000000003 33.0968 114.409 114.409 114.409 -16.0628 2.9633000000000003 32.0968 -90.2129 -90.2129 -90.2129 -16.0628 2.9633000000000003 33.0968 73.1523 73.1523 73.1523 -16.0628 3.9633000000000003 33.0968 7.25907 7.25907 7.25907 -15.0628 4.9633 30.0968 2.4201 2.4201 2.4201 -15.0628 5.9633 30.0968 -1426.16 -1426.16 -1426.16 -15.0628 5.9633 31.0968 -2294.44 -2294.44 -2294.44 -16.0628 4.9633 30.0968 -161.129 -161.129 -161.129 -16.0628 5.9633 30.0968 -545.549 -545.549 -545.549 -15.0628 4.9633 32.0968 -7.23515 -7.23515 -7.23515 -15.0628 4.9633 33.0968 26.1184 26.1184 26.1184 -15.0628 5.9633 33.0968 -70.9921 -70.9921 -70.9921 -16.0628 4.9633 32.0968 -25.684 -25.684 -25.684 -16.0628 4.9633 33.0968 100.843 100.843 100.843 -16.0628 5.9633 32.0968 45.8115 45.8115 45.8115 -16.0628 5.9633 33.0968 -70.8935 -70.8935 -70.8935 -15.0628 2.9633000000000003 34.0968 16.8038 16.8038 16.8038 -15.0628 3.9633000000000003 34.0968 -46.5532 -46.5532 -46.5532 -16.0628 2.9633000000000003 34.0968 171.615 171.615 171.615 -16.0628 3.9633000000000003 34.0968 106.374 106.374 106.374 -16.0628 4.9633 34.0968 173.468 173.468 173.468 -13.0628 6.9633 30.0968 1.4991 1.4991 1.4991 -13.0628 7.9633 30.0968 -17.2578 -17.2578 -17.2578 -14.0628 6.9633 30.0968 67.1715 67.1715 67.1715 -14.0628 6.9633 31.0968 511.266 511.266 511.266 -14.0628 7.9633 30.0968 -161.701 -161.701 -161.701 -14.0628 7.9633 31.0968 -584.398 -584.398 -584.398 -14.0628 6.9633 32.0968 15.6372 15.6372 15.6372 -14.0628 7.9633 32.0968 0.682286 0.682286 0.682286 -14.0628 8.9633 30.0968 -14.7051 -14.7051 -14.7051 -14.0628 8.9633 31.0968 22.1495 22.1495 22.1495 -14.0628 9.9633 30.0968 -82.8684 -82.8684 -82.8684 -14.0628 9.9633 31.0968 71.3079 71.3079 71.3079 -14.0628 8.9633 32.0968 55.0436 55.0436 55.0436 -14.0628 9.9633 32.0968 148.403 148.403 148.403 -15.0628 6.9633 30.0968 1043.92 1043.92 1043.92 -15.0628 6.9633 31.0968 -388.217 -388.217 -388.217 -15.0628 7.9633 30.0968 -35.5117 -35.5117 -35.5117 -16.0628 6.9633 30.0968 1155.94 1155.94 1155.94 -16.0628 6.9633 31.0968 -548.636 -548.636 -548.636 -16.0628 7.9633 30.0968 294.632 294.632 294.632 -15.0628 6.9633 32.0968 -71.9217 -71.9217 -71.9217 -15.0628 6.9633 33.0968 -15.3388 -15.3388 -15.3388 -15.0628 7.9633 32.0968 10.9607 10.9607 10.9607 -15.0628 7.9633 33.0968 27.7799 27.7799 27.7799 -16.0628 6.9633 32.0968 -13.8352 -13.8352 -13.8352 -16.0628 6.9633 33.0968 -8.94731 -8.94731 -8.94731 -16.0628 7.9633 32.0968 -9.60546 -9.60546 -9.60546 -16.0628 7.9633 33.0968 69.4118 69.4118 69.4118 -15.0628 9.9633 31.0968 51.3976 51.3976 51.3976 -16.0628 9.9633 31.0968 107.052 107.052 107.052 -15.0628 8.9633 32.0968 -25.9433 -25.9433 -25.9433 -15.0628 8.9633 33.0968 2.63471 2.63471 2.63471 -15.0628 9.9633 32.0968 82.3518 82.3518 82.3518 -16.0628 8.9633 32.0968 -76.6591 -76.6591 -76.6591 -16.0628 8.9633 33.0968 -13.8069 -13.8069 -13.8069 -16.0628 9.9633 32.0968 26.1317 26.1317 26.1317 -18.0628 -2.0366999999999997 25.0968 -36.6789 -36.6789 -36.6789 -20.0628 -4.0367 22.0968 1.15383 1.15383 1.15383 -20.0628 -4.0367 23.0968 29.5463 29.5463 29.5463 -20.0628 -4.0367 24.0968 -10.0718 -10.0718 -10.0718 -19.0628 -2.0366999999999997 23.0968 0.446377 0.446377 0.446377 -20.0628 -3.0366999999999997 22.0968 -2.62086 -2.62086 -2.62086 -20.0628 -3.0366999999999997 23.0968 1.60082 1.60082 1.60082 -20.0628 -2.0366999999999997 22.0968 -10.2823 -10.2823 -10.2823 -20.0628 -2.0366999999999997 23.0968 -0.0693072 -0.0693072 -0.0693072 -19.0628 -2.0366999999999997 24.0968 -1.41873 -1.41873 -1.41873 -19.0628 -2.0366999999999997 25.0968 361.162 361.162 361.162 -20.0628 -3.0366999999999997 24.0968 18.5202 18.5202 18.5202 -20.0628 -2.0366999999999997 24.0968 9.00108 9.00108 9.00108 -20.0628 -2.0366999999999997 25.0968 -28.0763 -28.0763 -28.0763 -17.0628 -2.0366999999999997 26.0968 50.3422 50.3422 50.3422 -18.0628 -2.0366999999999997 26.0968 -274.006 -274.006 -274.006 -18.0628 -2.0366999999999997 27.0968 -47.0428 -47.0428 -47.0428 -18.0628 -2.0366999999999997 28.0968 -3.49826 -3.49826 -3.49826 -19.0628 -2.0366999999999997 26.0968 350.274 350.274 350.274 -19.0628 -2.0366999999999997 27.0968 76.4354 76.4354 76.4354 -20.0628 -2.0366999999999997 26.0968 62.5179 62.5179 62.5179 -20.0628 -2.0366999999999997 27.0968 -102.515 -102.515 -102.515 -19.0628 -2.0366999999999997 28.0968 -39.7448 -39.7448 -39.7448 -17.0628 -1.0366999999999997 22.0968 38.878 38.878 38.878 -17.0628 -1.0366999999999997 23.0968 -3.14572 -3.14572 -3.14572 -17.0628 -0.03669999999999973 22.0968 54.5864 54.5864 54.5864 -17.0628 -0.03669999999999973 23.0968 32.2082 32.2082 32.2082 -18.0628 -1.0366999999999997 22.0968 14.542 14.542 14.542 -18.0628 -1.0366999999999997 23.0968 -18.5281 -18.5281 -18.5281 -18.0628 -0.03669999999999973 23.0968 22.4544 22.4544 22.4544 -17.0628 -1.0366999999999997 24.0968 -12.0101 -12.0101 -12.0101 -17.0628 -1.0366999999999997 25.0968 0.922384 0.922384 0.922384 -17.0628 -0.03669999999999973 24.0968 -21.59 -21.59 -21.59 -17.0628 -0.03669999999999973 25.0968 19.5587 19.5587 19.5587 -18.0628 -1.0366999999999997 24.0968 10.5797 10.5797 10.5797 -18.0628 -1.0366999999999997 25.0968 -2.47683 -2.47683 -2.47683 -18.0628 -0.03669999999999973 24.0968 -12.828 -12.828 -12.828 -18.0628 -0.03669999999999973 25.0968 -7.75714 -7.75714 -7.75714 -17.0628 0.9633000000000003 22.0968 18113.6 18113.6 18113.6 -17.0628 0.9633000000000003 23.0968 -10799.1 -10799.1 -10799.1 -17.0628 1.9633000000000003 22.0968 22999.4 22999.4 22999.4 -17.0628 1.9633000000000003 23.0968 -8906.05 -8906.05 -8906.05 -18.0628 0.9633000000000003 23.0968 -19355.6 -19355.6 -19355.6 -18.0628 1.9633000000000003 22.0968 -14363.5 -14363.5 -14363.5 -18.0628 1.9633000000000003 23.0968 -9092.83 -9092.83 -9092.83 -17.0628 0.9633000000000003 24.0968 18.8722 18.8722 18.8722 -17.0628 0.9633000000000003 25.0968 59.0892 59.0892 59.0892 -17.0628 1.9633000000000003 24.0968 19.5881 19.5881 19.5881 -17.0628 1.9633000000000003 25.0968 10.7494 10.7494 10.7494 -18.0628 0.9633000000000003 24.0968 -40.6437 -40.6437 -40.6437 -18.0628 0.9633000000000003 25.0968 -68.4572 -68.4572 -68.4572 -18.0628 1.9633000000000003 24.0968 10.0532 10.0532 10.0532 -18.0628 1.9633000000000003 25.0968 -9.81106 -9.81106 -9.81106 -19.0628 -1.0366999999999997 22.0968 21.1066 21.1066 21.1066 -19.0628 -1.0366999999999997 23.0968 1.10914 1.10914 1.10914 -19.0628 -0.03669999999999973 22.0968 -20.2019 -20.2019 -20.2019 -19.0628 -0.03669999999999973 23.0968 13.9667 13.9667 13.9667 -20.0628 -1.0366999999999997 23.0968 -4.14556 -4.14556 -4.14556 -20.0628 -0.03669999999999973 22.0968 -20.6408 -20.6408 -20.6408 -20.0628 -0.03669999999999973 23.0968 4.20081 4.20081 4.20081 -19.0628 -1.0366999999999997 24.0968 4.94269 4.94269 4.94269 -19.0628 -1.0366999999999997 25.0968 17.2805 17.2805 17.2805 -20.0628 -1.0366999999999997 25.0968 133.397 133.397 133.397 -19.0628 0.9633000000000003 24.0968 -52.1692 -52.1692 -52.1692 -19.0628 1.9633000000000003 24.0968 -12.84 -12.84 -12.84 -20.0628 0.9633000000000003 25.0968 -0.80182 -0.80182 -0.80182 -20.0628 1.9633000000000003 24.0968 -4.15499 -4.15499 -4.15499 -20.0628 1.9633000000000003 25.0968 -1.84132 -1.84132 -1.84132 -17.0628 -1.0366999999999997 26.0968 4.13758 4.13758 4.13758 -17.0628 -1.0366999999999997 27.0968 -4.81741 -4.81741 -4.81741 -17.0628 -0.03669999999999973 26.0968 35.0339 35.0339 35.0339 -17.0628 -0.03669999999999973 27.0968 3.86444 3.86444 3.86444 -18.0628 -1.0366999999999997 26.0968 5.68979 5.68979 5.68979 -18.0628 -1.0366999999999997 27.0968 11.2901 11.2901 11.2901 -18.0628 -0.03669999999999973 27.0968 17.4223 17.4223 17.4223 -17.0628 -0.03669999999999973 28.0968 4.64296 4.64296 4.64296 -18.0628 -1.0366999999999997 28.0968 -13.1656 -13.1656 -13.1656 -18.0628 -0.03669999999999973 28.0968 -20.45 -20.45 -20.45 -17.0628 1.9633000000000003 26.0968 67.3623 67.3623 67.3623 -17.0628 0.9633000000000003 28.0968 -5.07767 -5.07767 -5.07767 -17.0628 0.9633000000000003 29.0968 -10.4471 -10.4471 -10.4471 -17.0628 1.9633000000000003 28.0968 -11.7104 -11.7104 -11.7104 -17.0628 1.9633000000000003 29.0968 -19.8295 -19.8295 -19.8295 -18.0628 0.9633000000000003 28.0968 19.4401 19.4401 19.4401 -18.0628 0.9633000000000003 29.0968 -0.386487 -0.386487 -0.386487 -18.0628 1.9633000000000003 28.0968 -5.42753 -5.42753 -5.42753 -18.0628 1.9633000000000003 29.0968 3.74193 3.74193 3.74193 -19.0628 -0.03669999999999973 27.0968 69.3549 69.3549 69.3549 -20.0628 -1.0366999999999997 26.0968 -12.304 -12.304 -12.304 -20.0628 -1.0366999999999997 27.0968 -61.1695 -61.1695 -61.1695 -20.0628 -0.03669999999999973 26.0968 -136.856 -136.856 -136.856 -20.0628 -0.03669999999999973 27.0968 -278.553 -278.553 -278.553 -19.0628 -1.0366999999999997 28.0968 2.0734 2.0734 2.0734 -19.0628 -0.03669999999999973 28.0968 7.68674 7.68674 7.68674 -20.0628 -1.0366999999999997 28.0968 3.24694 3.24694 3.24694 -20.0628 -0.03669999999999973 28.0968 1.82342 1.82342 1.82342 -19.0628 0.9633000000000003 27.0968 -17.4748 -17.4748 -17.4748 -19.0628 1.9633000000000003 26.0968 7.91697 7.91697 7.91697 -19.0628 1.9633000000000003 27.0968 -10.08 -10.08 -10.08 -20.0628 0.9633000000000003 26.0968 -5.39936 -5.39936 -5.39936 -20.0628 0.9633000000000003 27.0968 -2.63724 -2.63724 -2.63724 -20.0628 1.9633000000000003 26.0968 -2.37536 -2.37536 -2.37536 -20.0628 1.9633000000000003 27.0968 -0.964894 -0.964894 -0.964894 -19.0628 0.9633000000000003 28.0968 -1.30271 -1.30271 -1.30271 -19.0628 1.9633000000000003 28.0968 -5.89534 -5.89534 -5.89534 -19.0628 1.9633000000000003 29.0968 2.51591 2.51591 2.51591 -21.0628 -4.0367 22.0968 9.27427 9.27427 9.27427 -21.0628 -4.0367 23.0968 -13.9252 -13.9252 -13.9252 -22.0628 -4.0367 22.0968 -15.3192 -15.3192 -15.3192 -22.0628 -4.0367 23.0968 -12.3948 -12.3948 -12.3948 -21.0628 -4.0367 24.0968 -2.68732 -2.68732 -2.68732 -21.0628 -4.0367 25.0968 6.4213 6.4213 6.4213 -22.0628 -4.0367 24.0968 12.2793 12.2793 12.2793 -22.0628 -4.0367 25.0968 -3.20964 -3.20964 -3.20964 -21.0628 -3.0366999999999997 22.0968 -6.4045 -6.4045 -6.4045 -21.0628 -2.0366999999999997 22.0968 -16.567 -16.567 -16.567 -22.0628 -3.0366999999999997 22.0968 -7.10465 -7.10465 -7.10465 -22.0628 -2.0366999999999997 22.0968 -7.2607 -7.2607 -7.2607 -21.0628 -3.0366999999999997 24.0968 12.1146 12.1146 12.1146 -21.0628 -3.0366999999999997 25.0968 -22.1082 -22.1082 -22.1082 -21.0628 -2.0366999999999997 24.0968 28.2787 28.2787 28.2787 -21.0628 -2.0366999999999997 25.0968 142.672 142.672 142.672 -22.0628 -3.0366999999999997 24.0968 26.031 26.031 26.031 -22.0628 -3.0366999999999997 25.0968 -15.5787 -15.5787 -15.5787 -22.0628 -2.0366999999999997 25.0968 10.4761 10.4761 10.4761 -23.0628 -4.0367 22.0968 -5.41194 -5.41194 -5.41194 -23.0628 -4.0367 23.0968 15.9748 15.9748 15.9748 -23.0628 -4.0367 24.0968 20.3528 20.3528 20.3528 -23.0628 -3.0366999999999997 22.0968 1.1479 1.1479 1.1479 -23.0628 -3.0366999999999997 23.0968 14.2435 14.2435 14.2435 -23.0628 -2.0366999999999997 22.0968 -62.1242 -62.1242 -62.1242 -23.0628 -2.0366999999999997 23.0968 -9.8249 -9.8249 -9.8249 -24.0628 -3.0366999999999997 23.0968 14.5766 14.5766 14.5766 -24.0628 -2.0366999999999997 22.0968 -682.52 -682.52 -682.52 -24.0628 -2.0366999999999997 23.0968 -45.6622 -45.6622 -45.6622 -23.0628 -3.0366999999999997 24.0968 11.2971 11.2971 11.2971 -23.0628 -3.0366999999999997 25.0968 -13.4879 -13.4879 -13.4879 -23.0628 -2.0366999999999997 25.0968 -43.1719 -43.1719 -43.1719 -24.0628 -3.0366999999999997 24.0968 -33.4276 -33.4276 -33.4276 -24.0628 -3.0366999999999997 25.0968 -9.88771 -9.88771 -9.88771 -24.0628 -2.0366999999999997 25.0968 43.2863 43.2863 43.2863 -21.0628 -2.0366999999999997 26.0968 -86.1331 -86.1331 -86.1331 -22.0628 -2.0366999999999997 26.0968 4.63129 4.63129 4.63129 -23.0628 -2.0366999999999997 26.0968 -56.037 -56.037 -56.037 -24.0628 -2.0366999999999997 26.0968 16.978 16.978 16.978 -21.0628 -1.0366999999999997 22.0968 -13.3675 -13.3675 -13.3675 -21.0628 -1.0366999999999997 23.0968 -36.2091 -36.2091 -36.2091 -21.0628 -0.03669999999999973 22.0968 39.7952 39.7952 39.7952 -21.0628 -0.03669999999999973 23.0968 6.69058 6.69058 6.69058 -22.0628 -1.0366999999999997 22.0968 -14.6404 -14.6404 -14.6404 -22.0628 -0.03669999999999973 22.0968 -63.4353 -63.4353 -63.4353 -22.0628 -0.03669999999999973 23.0968 42.5648 42.5648 42.5648 -22.0628 -0.03669999999999973 24.0968 51.6117 51.6117 51.6117 -22.0628 -0.03669999999999973 25.0968 26.098 26.098 26.098 -21.0628 0.9633000000000003 22.0968 22.3181 22.3181 22.3181 -21.0628 0.9633000000000003 23.0968 -10.9237 -10.9237 -10.9237 -21.0628 1.9633000000000003 22.0968 -112.622 -112.622 -112.622 -21.0628 1.9633000000000003 23.0968 195.194 195.194 195.194 -22.0628 0.9633000000000003 22.0968 -25.5172 -25.5172 -25.5172 -22.0628 0.9633000000000003 23.0968 8.03985 8.03985 8.03985 -22.0628 1.9633000000000003 22.0968 21.1015 21.1015 21.1015 -22.0628 1.9633000000000003 23.0968 24.1522 24.1522 24.1522 -21.0628 0.9633000000000003 24.0968 11.3761 11.3761 11.3761 -21.0628 0.9633000000000003 25.0968 9.39676 9.39676 9.39676 -21.0628 1.9633000000000003 24.0968 -19.1665 -19.1665 -19.1665 -21.0628 1.9633000000000003 25.0968 1.17393 1.17393 1.17393 -22.0628 0.9633000000000003 24.0968 28.9994 28.9994 28.9994 -22.0628 0.9633000000000003 25.0968 17.0573 17.0573 17.0573 -22.0628 1.9633000000000003 24.0968 12.4061 12.4061 12.4061 -22.0628 1.9633000000000003 25.0968 -1.28575 -1.28575 -1.28575 -23.0628 -1.0366999999999997 22.0968 104.072 104.072 104.072 -23.0628 -0.03669999999999973 22.0968 8.60666 8.60666 8.60666 -23.0628 -0.03669999999999973 23.0968 29.2198 29.2198 29.2198 -24.0628 -1.0366999999999997 22.0968 -565.115 -565.115 -565.115 -24.0628 -1.0366999999999997 23.0968 -11.0096 -11.0096 -11.0096 -24.0628 -0.03669999999999973 22.0968 -122.101 -122.101 -122.101 -24.0628 -0.03669999999999973 23.0968 23.4689 23.4689 23.4689 -23.0628 -1.0366999999999997 25.0968 -68.4155 -68.4155 -68.4155 -23.0628 -0.03669999999999973 24.0968 29.4632 29.4632 29.4632 -23.0628 -0.03669999999999973 25.0968 11.1654 11.1654 11.1654 -24.0628 -1.0366999999999997 25.0968 17.405 17.405 17.405 -24.0628 -0.03669999999999973 24.0968 12.8028 12.8028 12.8028 -24.0628 -0.03669999999999973 25.0968 -4.26202 -4.26202 -4.26202 -23.0628 0.9633000000000003 22.0968 -34.3209 -34.3209 -34.3209 -23.0628 0.9633000000000003 23.0968 -55.4362 -55.4362 -55.4362 -23.0628 1.9633000000000003 22.0968 -45.7417 -45.7417 -45.7417 -23.0628 1.9633000000000003 23.0968 -54.0397 -54.0397 -54.0397 -24.0628 0.9633000000000003 22.0968 -5.60873 -5.60873 -5.60873 -24.0628 0.9633000000000003 23.0968 -34.4402 -34.4402 -34.4402 -24.0628 1.9633000000000003 23.0968 -42.6058 -42.6058 -42.6058 -23.0628 0.9633000000000003 24.0968 28.1063 28.1063 28.1063 -23.0628 0.9633000000000003 25.0968 -11.0961 -11.0961 -11.0961 -23.0628 1.9633000000000003 24.0968 23.8679 23.8679 23.8679 -23.0628 1.9633000000000003 25.0968 3.09113 3.09113 3.09113 -24.0628 1.9633000000000003 24.0968 5.04655 5.04655 5.04655 -24.0628 1.9633000000000003 25.0968 6.25356 6.25356 6.25356 -21.0628 -1.0366999999999997 26.0968 -125.883 -125.883 -125.883 -21.0628 -0.03669999999999973 26.0968 -66.551 -66.551 -66.551 -22.0628 -1.0366999999999997 26.0968 -37.1827 -37.1827 -37.1827 -22.0628 -0.03669999999999973 26.0968 -12.6173 -12.6173 -12.6173 -21.0628 0.9633000000000003 26.0968 11.1285 11.1285 11.1285 -21.0628 1.9633000000000003 26.0968 3.5875 3.5875 3.5875 -21.0628 1.9633000000000003 27.0968 -1.01131 -1.01131 -1.01131 -22.0628 0.9633000000000003 26.0968 11.3509 11.3509 11.3509 -22.0628 0.9633000000000003 27.0968 -3.83969 -3.83969 -3.83969 -22.0628 1.9633000000000003 26.0968 4.40652 4.40652 4.40652 -22.0628 1.9633000000000003 27.0968 3.8388 3.8388 3.8388 -21.0628 1.9633000000000003 28.0968 -1.10689 -1.10689 -1.10689 -22.0628 0.9633000000000003 28.0968 -3.32175 -3.32175 -3.32175 -22.0628 0.9633000000000003 29.0968 -0.60776 -0.60776 -0.60776 -22.0628 1.9633000000000003 28.0968 -1.15928 -1.15928 -1.15928 -22.0628 1.9633000000000003 29.0968 -1.37436 -1.37436 -1.37436 -23.0628 -1.0366999999999997 26.0968 -21.53 -21.53 -21.53 -23.0628 -0.03669999999999973 26.0968 -6.57494 -6.57494 -6.57494 -23.0628 -0.03669999999999973 27.0968 -1.01728 -1.01728 -1.01728 -24.0628 -1.0366999999999997 26.0968 7.31388 7.31388 7.31388 -24.0628 -0.03669999999999973 26.0968 -0.599511 -0.599511 -0.599511 -24.0628 -0.03669999999999973 27.0968 -11.997 -11.997 -11.997 -23.0628 -0.03669999999999973 28.0968 -3.57024 -3.57024 -3.57024 -23.0628 -0.03669999999999973 29.0968 2.79329 2.79329 2.79329 -24.0628 -0.03669999999999973 28.0968 -0.743598 -0.743598 -0.743598 -24.0628 -0.03669999999999973 29.0968 -2.59356 -2.59356 -2.59356 -23.0628 0.9633000000000003 26.0968 -5.03444 -5.03444 -5.03444 -23.0628 0.9633000000000003 27.0968 -5.53625 -5.53625 -5.53625 -23.0628 1.9633000000000003 26.0968 2.24261 2.24261 2.24261 -24.0628 0.9633000000000003 26.0968 0.321169 0.321169 0.321169 -24.0628 1.9633000000000003 26.0968 -2.98881 -2.98881 -2.98881 -23.0628 0.9633000000000003 28.0968 -1.50919 -1.50919 -1.50919 -23.0628 0.9633000000000003 29.0968 6.36578 6.36578 6.36578 -23.0628 1.9633000000000003 29.0968 -1.58618 -1.58618 -1.58618 -24.0628 0.9633000000000003 29.0968 5.46694 5.46694 5.46694 -24.0628 1.9633000000000003 29.0968 -0.48341 -0.48341 -0.48341 -17.0628 1.9633000000000003 32.0968 4.81763 4.81763 4.81763 -17.0628 1.9633000000000003 33.0968 0.0768765 0.0768765 0.0768765 -18.0628 1.9633000000000003 32.0968 13.9929 13.9929 13.9929 -18.0628 1.9633000000000003 33.0968 -1.39025 -1.39025 -1.39025 -17.0628 1.9633000000000003 34.0968 -3.39483 -3.39483 -3.39483 -24.0628 1.9633000000000003 33.0968 8.1729 8.1729 8.1729 -24.0628 1.9633000000000003 34.0968 11.0275 11.0275 11.0275 -24.0628 1.9633000000000003 35.0968 -5.82535 -5.82535 -5.82535 -24.0628 1.9633000000000003 36.0968 0.660566 0.660566 0.660566 -17.0628 2.9633000000000003 22.0968 -10896.3 -10896.3 -10896.3 -17.0628 2.9633000000000003 23.0968 2273.18 2273.18 2273.18 -17.0628 3.9633000000000003 22.0968 -5.92282 -5.92282 -5.92282 -18.0628 2.9633000000000003 22.0968 1401.39 1401.39 1401.39 -18.0628 2.9633000000000003 23.0968 -11326.2 -11326.2 -11326.2 -18.0628 3.9633000000000003 22.0968 12.4697 12.4697 12.4697 -17.0628 2.9633000000000003 24.0968 2.77316 2.77316 2.77316 -17.0628 2.9633000000000003 25.0968 23.8535 23.8535 23.8535 -17.0628 3.9633000000000003 24.0968 322.738 322.738 322.738 -17.0628 3.9633000000000003 25.0968 27.4672 27.4672 27.4672 -18.0628 2.9633000000000003 25.0968 -2.8207 -2.8207 -2.8207 -18.0628 3.9633000000000003 25.0968 -11.133 -11.133 -11.133 -17.0628 4.9633 22.0968 213.497 213.497 213.497 -17.0628 5.9633 22.0968 14.0822 14.0822 14.0822 -17.0628 5.9633 23.0968 259.979 259.979 259.979 -18.0628 4.9633 22.0968 14.7868 14.7868 14.7868 -18.0628 5.9633 22.0968 11.0183 11.0183 11.0183 -17.0628 4.9633 24.0968 119.431 119.431 119.431 -17.0628 4.9633 25.0968 94.6094 94.6094 94.6094 -17.0628 5.9633 24.0968 58.9249 58.9249 58.9249 -17.0628 5.9633 25.0968 254.98 254.98 254.98 -18.0628 4.9633 25.0968 18.651 18.651 18.651 -18.0628 5.9633 25.0968 61.7758 61.7758 61.7758 -19.0628 2.9633000000000003 22.0968 -3146.62 -3146.62 -3146.62 -19.0628 2.9633000000000003 23.0968 4334.66 4334.66 4334.66 -19.0628 3.9633000000000003 22.0968 8.10693 8.10693 8.10693 -19.0628 3.9633000000000003 23.0968 6.20968 6.20968 6.20968 -20.0628 2.9633000000000003 22.0968 -26.7289 -26.7289 -26.7289 -20.0628 2.9633000000000003 23.0968 -53.1144 -53.1144 -53.1144 -20.0628 3.9633000000000003 22.0968 220.943 220.943 220.943 -20.0628 3.9633000000000003 23.0968 -24.0198 -24.0198 -24.0198 -19.0628 2.9633000000000003 25.0968 -2.81671 -2.81671 -2.81671 -19.0628 3.9633000000000003 25.0968 -12.9316 -12.9316 -12.9316 -20.0628 2.9633000000000003 24.0968 -9.85718 -9.85718 -9.85718 -20.0628 2.9633000000000003 25.0968 4.3382 4.3382 4.3382 -20.0628 3.9633000000000003 24.0968 -4.29877 -4.29877 -4.29877 -20.0628 3.9633000000000003 25.0968 -0.536914 -0.536914 -0.536914 -19.0628 4.9633 22.0968 -7.43346 -7.43346 -7.43346 -19.0628 4.9633 23.0968 6.67931 6.67931 6.67931 -20.0628 4.9633 22.0968 19.1197 19.1197 19.1197 -20.0628 4.9633 23.0968 -12.4982 -12.4982 -12.4982 -20.0628 5.9633 23.0968 4.2092 4.2092 4.2092 -19.0628 4.9633 24.0968 -1.34097 -1.34097 -1.34097 -19.0628 4.9633 25.0968 -3.53479 -3.53479 -3.53479 -20.0628 4.9633 24.0968 -6.50933 -6.50933 -6.50933 -20.0628 5.9633 24.0968 -2.84597 -2.84597 -2.84597 -17.0628 2.9633000000000003 26.0968 -5.27461 -5.27461 -5.27461 -17.0628 3.9633000000000003 26.0968 -211.692 -211.692 -211.692 -17.0628 3.9633000000000003 27.0968 -154.574 -154.574 -154.574 -18.0628 2.9633000000000003 26.0968 -2.85458 -2.85458 -2.85458 -18.0628 3.9633000000000003 26.0968 -24.2273 -24.2273 -24.2273 -18.0628 3.9633000000000003 27.0968 -4.19855 -4.19855 -4.19855 -17.0628 2.9633000000000003 29.0968 -217.611 -217.611 -217.611 -17.0628 3.9633000000000003 28.0968 66.1104 66.1104 66.1104 -17.0628 3.9633000000000003 29.0968 -127.541 -127.541 -127.541 -18.0628 2.9633000000000003 29.0968 171.686 171.686 171.686 -18.0628 3.9633000000000003 28.0968 -257.941 -257.941 -257.941 -18.0628 3.9633000000000003 29.0968 -182.864 -182.864 -182.864 -17.0628 4.9633 26.0968 -130.722 -130.722 -130.722 -17.0628 4.9633 27.0968 -412.13 -412.13 -412.13 -17.0628 5.9633 26.0968 19.294 19.294 19.294 -17.0628 5.9633 27.0968 -92.5639 -92.5639 -92.5639 -18.0628 4.9633 26.0968 7.18023 7.18023 7.18023 -18.0628 4.9633 27.0968 0.684526 0.684526 0.684526 -18.0628 5.9633 26.0968 26.7342 26.7342 26.7342 -18.0628 5.9633 27.0968 -3.53441 -3.53441 -3.53441 -17.0628 4.9633 28.0968 -364.623 -364.623 -364.623 -17.0628 4.9633 29.0968 79.4177 79.4177 79.4177 -17.0628 5.9633 28.0968 7.74657 7.74657 7.74657 -17.0628 5.9633 29.0968 8.24944 8.24944 8.24944 -18.0628 4.9633 28.0968 -291.207 -291.207 -291.207 -18.0628 4.9633 29.0968 206.159 206.159 206.159 -18.0628 5.9633 29.0968 -0.178204 -0.178204 -0.178204 -19.0628 2.9633000000000003 26.0968 0.853067 0.853067 0.853067 -19.0628 2.9633000000000003 27.0968 -3.4039 -3.4039 -3.4039 -19.0628 3.9633000000000003 26.0968 1.78645 1.78645 1.78645 -19.0628 3.9633000000000003 27.0968 0.636008 0.636008 0.636008 -20.0628 2.9633000000000003 26.0968 4.24378 4.24378 4.24378 -20.0628 2.9633000000000003 27.0968 -0.38709 -0.38709 -0.38709 -20.0628 3.9633000000000003 26.0968 5.39642 5.39642 5.39642 -20.0628 3.9633000000000003 27.0968 1.7887 1.7887 1.7887 -19.0628 2.9633000000000003 28.0968 2.03057 2.03057 2.03057 -19.0628 2.9633000000000003 29.0968 -3.66667 -3.66667 -3.66667 -19.0628 3.9633000000000003 28.0968 -0.131728 -0.131728 -0.131728 -19.0628 3.9633000000000003 29.0968 -1.21177 -1.21177 -1.21177 -20.0628 2.9633000000000003 28.0968 0.0639515 0.0639515 0.0639515 -20.0628 2.9633000000000003 29.0968 -2.28264 -2.28264 -2.28264 -20.0628 3.9633000000000003 28.0968 -1.81161 -1.81161 -1.81161 -20.0628 3.9633000000000003 29.0968 6.03541 6.03541 6.03541 -19.0628 4.9633 26.0968 -1.77376 -1.77376 -1.77376 -19.0628 4.9633 27.0968 -1.46227 -1.46227 -1.46227 -19.0628 5.9633 26.0968 -4.64956 -4.64956 -4.64956 -19.0628 5.9633 27.0968 17.3364 17.3364 17.3364 -20.0628 4.9633 26.0968 0.801151 0.801151 0.801151 -20.0628 4.9633 27.0968 -0.075018 -0.075018 -0.075018 -20.0628 5.9633 27.0968 -1.27019 -1.27019 -1.27019 -19.0628 4.9633 28.0968 -2.22064 -2.22064 -2.22064 -19.0628 4.9633 29.0968 -3.42451 -3.42451 -3.42451 -19.0628 5.9633 29.0968 0.281258 0.281258 0.281258 -20.0628 4.9633 28.0968 1.02506 1.02506 1.02506 -20.0628 4.9633 29.0968 -11.7086 -11.7086 -11.7086 -20.0628 5.9633 28.0968 1.01342 1.01342 1.01342 -20.0628 5.9633 29.0968 -0.606738 -0.606738 -0.606738 -17.0628 6.9633 22.0968 -215.626 -215.626 -215.626 -17.0628 6.9633 23.0968 -23.7184 -23.7184 -23.7184 -17.0628 7.9633 22.0968 12.1259 12.1259 12.1259 -17.0628 7.9633 23.0968 -8.70289 -8.70289 -8.70289 -18.0628 6.9633 22.0968 16.2709 16.2709 16.2709 -18.0628 7.9633 22.0968 -4.19227 -4.19227 -4.19227 -18.0628 7.9633 23.0968 -4.33726 -4.33726 -4.33726 -17.0628 6.9633 24.0968 34.9867 34.9867 34.9867 -17.0628 6.9633 25.0968 1.54901 1.54901 1.54901 -17.0628 7.9633 24.0968 -9.87436 -9.87436 -9.87436 -18.0628 6.9633 24.0968 -54.1152 -54.1152 -54.1152 -18.0628 6.9633 25.0968 48.9161 48.9161 48.9161 -18.0628 7.9633 24.0968 -21.5901 -21.5901 -21.5901 -18.0628 7.9633 25.0968 -25.513 -25.513 -25.513 -18.0628 8.9633 22.0968 33.9538 33.9538 33.9538 -18.0628 9.9633 22.0968 1.87409 1.87409 1.87409 -18.0628 8.9633 25.0968 4.25913 4.25913 4.25913 -19.0628 7.9633 22.0968 -9.96594 -9.96594 -9.96594 -19.0628 7.9633 23.0968 3.04562 3.04562 3.04562 -20.0628 6.9633 22.0968 4.12754 4.12754 4.12754 -20.0628 6.9633 23.0968 2.05201 2.05201 2.05201 -20.0628 7.9633 22.0968 -18.5473 -18.5473 -18.5473 -20.0628 7.9633 23.0968 3.44528 3.44528 3.44528 -19.0628 6.9633 24.0968 6.96524 6.96524 6.96524 -19.0628 7.9633 24.0968 2.14073 2.14073 2.14073 -19.0628 7.9633 25.0968 16.8927 16.8927 16.8927 -20.0628 6.9633 24.0968 -0.549166 -0.549166 -0.549166 -20.0628 7.9633 24.0968 -2.14097 -2.14097 -2.14097 -20.0628 7.9633 25.0968 -4.53291 -4.53291 -4.53291 -19.0628 8.9633 22.0968 34.6183 34.6183 34.6183 -19.0628 9.9633 22.0968 -41.2651 -41.2651 -41.2651 -20.0628 8.9633 22.0968 -41.9634 -41.9634 -41.9634 -20.0628 9.9633 22.0968 -42.2473 -42.2473 -42.2473 -19.0628 8.9633 24.0968 -5.89888 -5.89888 -5.89888 -19.0628 8.9633 25.0968 1.75085 1.75085 1.75085 -20.0628 8.9633 25.0968 29.5616 29.5616 29.5616 -17.0628 6.9633 26.0968 21.9438 21.9438 21.9438 -17.0628 6.9633 27.0968 10.5936 10.5936 10.5936 -17.0628 7.9633 27.0968 -54.0066 -54.0066 -54.0066 -18.0628 6.9633 26.0968 -11.7167 -11.7167 -11.7167 -18.0628 6.9633 27.0968 -25.5952 -25.5952 -25.5952 -18.0628 7.9633 26.0968 45.9311 45.9311 45.9311 -18.0628 7.9633 27.0968 -60.6436 -60.6436 -60.6436 -17.0628 6.9633 28.0968 -25.7274 -25.7274 -25.7274 -17.0628 6.9633 29.0968 -12.7546 -12.7546 -12.7546 -17.0628 7.9633 28.0968 36.5227 36.5227 36.5227 -18.0628 6.9633 28.0968 24.7127 24.7127 24.7127 -18.0628 6.9633 29.0968 -0.0994178 -0.0994178 -0.0994178 -18.0628 7.9633 28.0968 -1.37972 -1.37972 -1.37972 -17.0628 8.9633 27.0968 -34.1911 -34.1911 -34.1911 -17.0628 9.9633 26.0968 -3.34441 -3.34441 -3.34441 -17.0628 9.9633 27.0968 -10.0414 -10.0414 -10.0414 -18.0628 8.9633 26.0968 53.5752 53.5752 53.5752 -18.0628 8.9633 27.0968 -30.3061 -30.3061 -30.3061 -18.0628 9.9633 27.0968 -32.8818 -32.8818 -32.8818 -17.0628 9.9633 28.0968 -1.85298 -1.85298 -1.85298 -18.0628 8.9633 28.0968 -31.8158 -31.8158 -31.8158 -18.0628 9.9633 28.0968 -16.8511 -16.8511 -16.8511 -18.0628 9.9633 29.0968 -9.24528 -9.24528 -9.24528 -19.0628 6.9633 27.0968 -15.5991 -15.5991 -15.5991 -19.0628 7.9633 27.0968 18.5738 18.5738 18.5738 -20.0628 6.9633 27.0968 1.32552 1.32552 1.32552 -20.0628 7.9633 26.0968 2.59829 2.59829 2.59829 -20.0628 7.9633 27.0968 1.33193 1.33193 1.33193 -19.0628 6.9633 28.0968 100.537 100.537 100.537 -19.0628 6.9633 29.0968 -0.510868 -0.510868 -0.510868 -19.0628 7.9633 28.0968 45.8799 45.8799 45.8799 -19.0628 7.9633 29.0968 1.84083 1.84083 1.84083 -20.0628 6.9633 28.0968 6.7292 6.7292 6.7292 -20.0628 6.9633 29.0968 -3.41577 -3.41577 -3.41577 -20.0628 7.9633 28.0968 4.99127 4.99127 4.99127 -19.0628 8.9633 26.0968 25.0322 25.0322 25.0322 -19.0628 8.9633 27.0968 -29.3877 -29.3877 -29.3877 -19.0628 9.9633 26.0968 20.8435 20.8435 20.8435 -19.0628 9.9633 27.0968 9.41459 9.41459 9.41459 -20.0628 8.9633 26.0968 -5.79737 -5.79737 -5.79737 -20.0628 8.9633 27.0968 1.39157 1.39157 1.39157 -20.0628 9.9633 26.0968 -1.24871 -1.24871 -1.24871 -19.0628 8.9633 28.0968 -15.569 -15.569 -15.569 -19.0628 8.9633 29.0968 -2.86603 -2.86603 -2.86603 -19.0628 9.9633 28.0968 -13.7398 -13.7398 -13.7398 -19.0628 9.9633 29.0968 -3.17326 -3.17326 -3.17326 -20.0628 8.9633 28.0968 1.51367 1.51367 1.51367 -20.0628 8.9633 29.0968 2.73344 2.73344 2.73344 -20.0628 9.9633 28.0968 2.54275 2.54275 2.54275 -20.0628 9.9633 29.0968 6.30475 6.30475 6.30475 -21.0628 2.9633000000000003 22.0968 246.112 246.112 246.112 -21.0628 2.9633000000000003 23.0968 132.905 132.905 132.905 -21.0628 3.9633000000000003 22.0968 93.8085 93.8085 93.8085 -21.0628 3.9633000000000003 23.0968 194.931 194.931 194.931 -22.0628 2.9633000000000003 22.0968 -329.769 -329.769 -329.769 -22.0628 2.9633000000000003 23.0968 171.966 171.966 171.966 -22.0628 3.9633000000000003 22.0968 58.0771 58.0771 58.0771 -22.0628 3.9633000000000003 23.0968 -131.088 -131.088 -131.088 -21.0628 2.9633000000000003 25.0968 1.57371 1.57371 1.57371 -21.0628 3.9633000000000003 24.0968 -9.33272 -9.33272 -9.33272 -21.0628 3.9633000000000003 25.0968 5.42661 5.42661 5.42661 -22.0628 3.9633000000000003 25.0968 19.1565 19.1565 19.1565 -21.0628 4.9633 22.0968 -8.52825 -8.52825 -8.52825 -21.0628 4.9633 23.0968 -6.4857 -6.4857 -6.4857 -21.0628 5.9633 22.0968 2.70229 2.70229 2.70229 -21.0628 5.9633 23.0968 -0.605659 -0.605659 -0.605659 -22.0628 4.9633 22.0968 -1.74442 -1.74442 -1.74442 -22.0628 4.9633 23.0968 -27.773 -27.773 -27.773 -21.0628 4.9633 24.0968 -39.2454 -39.2454 -39.2454 -21.0628 4.9633 25.0968 5.94104 5.94104 5.94104 -21.0628 5.9633 24.0968 -0.665445 -0.665445 -0.665445 -21.0628 5.9633 25.0968 5.43451 5.43451 5.43451 -22.0628 4.9633 24.0968 40.687 40.687 40.687 -22.0628 4.9633 25.0968 -46.1965 -46.1965 -46.1965 -22.0628 5.9633 24.0968 18.2277 18.2277 18.2277 -22.0628 5.9633 25.0968 -1.14793 -1.14793 -1.14793 -23.0628 2.9633000000000003 22.0968 -30.9086 -30.9086 -30.9086 -23.0628 2.9633000000000003 23.0968 78.5173 78.5173 78.5173 -24.0628 2.9633000000000003 24.0968 20.6059 20.6059 20.6059 -24.0628 2.9633000000000003 25.0968 22.0262 22.0262 22.0262 -24.0628 3.9633000000000003 25.0968 13.2593 13.2593 13.2593 -24.0628 4.9633 23.0968 -23.4235 -23.4235 -23.4235 -24.0628 5.9633 22.0968 -4.54788 -4.54788 -4.54788 -24.0628 5.9633 23.0968 -17.1643 -17.1643 -17.1643 -23.0628 4.9633 25.0968 -30.339 -30.339 -30.339 -23.0628 5.9633 25.0968 -0.275767 -0.275767 -0.275767 -24.0628 4.9633 24.0968 -6.41305 -6.41305 -6.41305 -24.0628 4.9633 25.0968 -12.4518 -12.4518 -12.4518 -24.0628 5.9633 24.0968 -1.73838 -1.73838 -1.73838 -24.0628 5.9633 25.0968 0.417397 0.417397 0.417397 -21.0628 2.9633000000000003 26.0968 -12.494 -12.494 -12.494 -21.0628 2.9633000000000003 27.0968 1.51217 1.51217 1.51217 -21.0628 3.9633000000000003 26.0968 -13.7895 -13.7895 -13.7895 -21.0628 2.9633000000000003 28.0968 0.295967 0.295967 0.295967 -21.0628 2.9633000000000003 29.0968 2.01769 2.01769 2.01769 -21.0628 3.9633000000000003 29.0968 -1.66613 -1.66613 -1.66613 -22.0628 2.9633000000000003 28.0968 -1.97316 -1.97316 -1.97316 -22.0628 2.9633000000000003 29.0968 -13.447 -13.447 -13.447 -22.0628 3.9633000000000003 28.0968 1.37008 1.37008 1.37008 -22.0628 3.9633000000000003 29.0968 -0.277179 -0.277179 -0.277179 -22.0628 5.9633 27.0968 -4.12183 -4.12183 -4.12183 -21.0628 4.9633 28.0968 1.42894 1.42894 1.42894 -21.0628 4.9633 29.0968 -5.56585 -5.56585 -5.56585 -21.0628 5.9633 28.0968 -1.36958 -1.36958 -1.36958 -21.0628 5.9633 29.0968 0.361228 0.361228 0.361228 -22.0628 4.9633 28.0968 -2.37935 -2.37935 -2.37935 -22.0628 4.9633 29.0968 -15.6564 -15.6564 -15.6564 -22.0628 5.9633 28.0968 -1.50658 -1.50658 -1.50658 -22.0628 5.9633 29.0968 -0.240157 -0.240157 -0.240157 -23.0628 3.9633000000000003 27.0968 1.93481 1.93481 1.93481 -24.0628 2.9633000000000003 27.0968 -1.41832 -1.41832 -1.41832 -24.0628 3.9633000000000003 26.0968 66.6079 66.6079 66.6079 -24.0628 3.9633000000000003 27.0968 7.50815 7.50815 7.50815 -23.0628 2.9633000000000003 29.0968 0.437932 0.437932 0.437932 -23.0628 3.9633000000000003 28.0968 -0.486786 -0.486786 -0.486786 -23.0628 3.9633000000000003 29.0968 0.383681 0.383681 0.383681 -24.0628 2.9633000000000003 29.0968 -0.368004 -0.368004 -0.368004 -24.0628 3.9633000000000003 29.0968 6.39903 6.39903 6.39903 -23.0628 4.9633 26.0968 -31.5436 -31.5436 -31.5436 -23.0628 4.9633 27.0968 0.376925 0.376925 0.376925 -23.0628 5.9633 26.0968 4.75332 4.75332 4.75332 -23.0628 5.9633 27.0968 -0.0570842 -0.0570842 -0.0570842 -24.0628 4.9633 26.0968 -55.572 -55.572 -55.572 -24.0628 4.9633 27.0968 -0.749693 -0.749693 -0.749693 -24.0628 5.9633 26.0968 0.505893 0.505893 0.505893 -24.0628 5.9633 27.0968 -1.5361 -1.5361 -1.5361 -23.0628 4.9633 28.0968 0.395597 0.395597 0.395597 -23.0628 4.9633 29.0968 0.118187 0.118187 0.118187 -23.0628 5.9633 28.0968 -0.0334946 -0.0334946 -0.0334946 -23.0628 5.9633 29.0968 -0.885637 -0.885637 -0.885637 -24.0628 4.9633 28.0968 7.72325 7.72325 7.72325 -24.0628 4.9633 29.0968 2.60743 2.60743 2.60743 -24.0628 5.9633 28.0968 0.883355 0.883355 0.883355 -24.0628 5.9633 29.0968 7.85794 7.85794 7.85794 -21.0628 6.9633 22.0968 8.30679 8.30679 8.30679 -21.0628 6.9633 23.0968 -0.987328 -0.987328 -0.987328 -21.0628 7.9633 22.0968 -50.6693 -50.6693 -50.6693 -21.0628 7.9633 23.0968 -0.967496 -0.967496 -0.967496 -22.0628 6.9633 22.0968 -0.940888 -0.940888 -0.940888 -22.0628 6.9633 23.0968 -3.07058 -3.07058 -3.07058 -22.0628 7.9633 22.0968 122.577 122.577 122.577 -22.0628 7.9633 23.0968 91.4039 91.4039 91.4039 -21.0628 6.9633 24.0968 -12.7563 -12.7563 -12.7563 -21.0628 6.9633 25.0968 -2.15272 -2.15272 -2.15272 -21.0628 7.9633 24.0968 -15.0598 -15.0598 -15.0598 -21.0628 7.9633 25.0968 10.0579 10.0579 10.0579 -22.0628 6.9633 24.0968 4.02569 4.02569 4.02569 -22.0628 6.9633 25.0968 -7.07093 -7.07093 -7.07093 -22.0628 7.9633 24.0968 -7.16394 -7.16394 -7.16394 -22.0628 7.9633 25.0968 -1.80044 -1.80044 -1.80044 -21.0628 8.9633 22.0968 53.5369 53.5369 53.5369 -21.0628 8.9633 23.0968 -4.6347 -4.6347 -4.6347 -21.0628 9.9633 22.0968 61.4206 61.4206 61.4206 -21.0628 9.9633 23.0968 7.48794 7.48794 7.48794 -22.0628 8.9633 23.0968 -32.9116 -32.9116 -32.9116 -21.0628 8.9633 24.0968 -4.69 -4.69 -4.69 -21.0628 8.9633 25.0968 -6.42432 -6.42432 -6.42432 -21.0628 9.9633 24.0968 17.9034 17.9034 17.9034 -21.0628 9.9633 25.0968 2.22199 2.22199 2.22199 -22.0628 8.9633 24.0968 -11.2986 -11.2986 -11.2986 -22.0628 8.9633 25.0968 33.5601 33.5601 33.5601 -22.0628 9.9633 25.0968 17.4578 17.4578 17.4578 -23.0628 6.9633 22.0968 -0.684805 -0.684805 -0.684805 -23.0628 6.9633 23.0968 -1.38848 -1.38848 -1.38848 -23.0628 7.9633 22.0968 61.8553 61.8553 61.8553 -23.0628 7.9633 23.0968 63.3166 63.3166 63.3166 -24.0628 6.9633 22.0968 -10.8214 -10.8214 -10.8214 -24.0628 6.9633 23.0968 5.65346 5.65346 5.65346 -24.0628 7.9633 22.0968 22.4857 22.4857 22.4857 -24.0628 7.9633 23.0968 38.928 38.928 38.928 -23.0628 6.9633 24.0968 -1.86968 -1.86968 -1.86968 -23.0628 6.9633 25.0968 2.08342 2.08342 2.08342 -23.0628 7.9633 24.0968 10.4169 10.4169 10.4169 -23.0628 7.9633 25.0968 8.25946 8.25946 8.25946 -24.0628 6.9633 24.0968 7.10685 7.10685 7.10685 -24.0628 6.9633 25.0968 -2.75307 -2.75307 -2.75307 -24.0628 7.9633 24.0968 -0.712019 -0.712019 -0.712019 -24.0628 7.9633 25.0968 2.26839 2.26839 2.26839 -24.0628 8.9633 22.0968 -7.75625 -7.75625 -7.75625 -24.0628 8.9633 23.0968 -16.7541 -16.7541 -16.7541 -24.0628 9.9633 22.0968 -8.8072 -8.8072 -8.8072 -24.0628 9.9633 23.0968 -104.098 -104.098 -104.098 -23.0628 9.9633 25.0968 17.3353 17.3353 17.3353 -24.0628 8.9633 24.0968 0.35944 0.35944 0.35944 -24.0628 8.9633 25.0968 0.578354 0.578354 0.578354 -24.0628 9.9633 24.0968 -6.65831 -6.65831 -6.65831 -24.0628 9.9633 25.0968 2.24249 2.24249 2.24249 -21.0628 7.9633 26.0968 -6.79359 -6.79359 -6.79359 -21.0628 7.9633 27.0968 0.948615 0.948615 0.948615 -22.0628 6.9633 26.0968 -8.05294 -8.05294 -8.05294 -22.0628 6.9633 27.0968 -6.47855 -6.47855 -6.47855 -22.0628 7.9633 26.0968 10.6413 10.6413 10.6413 -22.0628 7.9633 27.0968 -3.44317 -3.44317 -3.44317 -21.0628 6.9633 28.0968 -1.4976 -1.4976 -1.4976 -21.0628 6.9633 29.0968 3.60451 3.60451 3.60451 -21.0628 7.9633 28.0968 -8.07367 -8.07367 -8.07367 -21.0628 7.9633 29.0968 4.26521 4.26521 4.26521 -22.0628 6.9633 28.0968 11.3098 11.3098 11.3098 -22.0628 7.9633 28.0968 -11.3112 -11.3112 -11.3112 -22.0628 7.9633 29.0968 0.247211 0.247211 0.247211 -21.0628 8.9633 26.0968 -1.54684 -1.54684 -1.54684 -21.0628 8.9633 27.0968 7.34344 7.34344 7.34344 -21.0628 9.9633 26.0968 -9.03305 -9.03305 -9.03305 -22.0628 8.9633 26.0968 4.4578 4.4578 4.4578 -22.0628 8.9633 27.0968 7.29836 7.29836 7.29836 -22.0628 9.9633 26.0968 5.44492 5.44492 5.44492 -22.0628 9.9633 27.0968 -1.05641 -1.05641 -1.05641 -21.0628 8.9633 28.0968 -7.6879 -7.6879 -7.6879 -21.0628 8.9633 29.0968 -1.08155 -1.08155 -1.08155 -21.0628 9.9633 29.0968 -0.421314 -0.421314 -0.421314 -22.0628 8.9633 28.0968 -7.93456 -7.93456 -7.93456 -22.0628 8.9633 29.0968 0.327756 0.327756 0.327756 -22.0628 9.9633 28.0968 -1.60681 -1.60681 -1.60681 -22.0628 9.9633 29.0968 -1.02771 -1.02771 -1.02771 -23.0628 6.9633 26.0968 7.31001 7.31001 7.31001 -23.0628 6.9633 27.0968 -0.091934 -0.091934 -0.091934 -23.0628 7.9633 26.0968 -1.95755 -1.95755 -1.95755 -23.0628 7.9633 27.0968 8.28754 8.28754 8.28754 -24.0628 7.9633 26.0968 1.95424 1.95424 1.95424 -23.0628 6.9633 28.0968 3.67125 3.67125 3.67125 -23.0628 6.9633 29.0968 0.12042 0.12042 0.12042 -23.0628 7.9633 28.0968 6.54922 6.54922 6.54922 -23.0628 7.9633 29.0968 -0.032989 -0.032989 -0.032989 -24.0628 6.9633 28.0968 0.672567 0.672567 0.672567 -23.0628 8.9633 26.0968 -9.44496 -9.44496 -9.44496 -23.0628 8.9633 27.0968 1.54733 1.54733 1.54733 -23.0628 9.9633 26.0968 -9.1802 -9.1802 -9.1802 -23.0628 9.9633 27.0968 -2.48783 -2.48783 -2.48783 -24.0628 8.9633 26.0968 2.93359 2.93359 2.93359 -24.0628 8.9633 27.0968 -3.77281 -3.77281 -3.77281 -24.0628 9.9633 26.0968 -9.19962 -9.19962 -9.19962 -24.0628 9.9633 27.0968 -1.45361 -1.45361 -1.45361 -23.0628 8.9633 28.0968 3.30095 3.30095 3.30095 -23.0628 8.9633 29.0968 2.79598 2.79598 2.79598 -23.0628 9.9633 28.0968 0.41462 0.41462 0.41462 -23.0628 9.9633 29.0968 4.01831 4.01831 4.01831 -24.0628 8.9633 29.0968 -1.70484 -1.70484 -1.70484 -24.0628 9.9633 28.0968 -0.152185 -0.152185 -0.152185 -24.0628 9.9633 29.0968 -5.92343 -5.92343 -5.92343 -17.0628 2.9633000000000003 30.0968 214.284 214.284 214.284 -17.0628 2.9633000000000003 31.0968 3.78008 3.78008 3.78008 -17.0628 3.9633000000000003 30.0968 -180.756 -180.756 -180.756 -17.0628 3.9633000000000003 31.0968 -4.51755 -4.51755 -4.51755 -18.0628 2.9633000000000003 30.0968 118.652 118.652 118.652 -18.0628 2.9633000000000003 31.0968 3.65807 3.65807 3.65807 -18.0628 3.9633000000000003 30.0968 -231.797 -231.797 -231.797 -18.0628 3.9633000000000003 31.0968 -4.18462 -4.18462 -4.18462 -17.0628 2.9633000000000003 32.0968 -45.4216 -45.4216 -45.4216 -17.0628 2.9633000000000003 33.0968 -77.6299 -77.6299 -77.6299 -18.0628 2.9633000000000003 32.0968 106.432 106.432 106.432 -18.0628 2.9633000000000003 33.0968 -28.5011 -28.5011 -28.5011 -18.0628 3.9633000000000003 33.0968 -61.6958 -61.6958 -61.6958 -17.0628 5.9633 30.0968 9.9321 9.9321 9.9321 -18.0628 4.9633 30.0968 -296.081 -296.081 -296.081 -18.0628 4.9633 31.0968 -3.71922 -3.71922 -3.71922 -18.0628 5.9633 30.0968 2.37281 2.37281 2.37281 -18.0628 5.9633 31.0968 -3.93075 -3.93075 -3.93075 -17.0628 4.9633 33.0968 -50.5598 -50.5598 -50.5598 -17.0628 5.9633 33.0968 50.4871 50.4871 50.4871 -18.0628 4.9633 32.0968 -71.8028 -71.8028 -71.8028 -18.0628 4.9633 33.0968 -33.3966 -33.3966 -33.3966 -18.0628 5.9633 32.0968 -3.15195 -3.15195 -3.15195 -18.0628 5.9633 33.0968 3.58018 3.58018 3.58018 -19.0628 2.9633000000000003 31.0968 5.51893 5.51893 5.51893 -19.0628 3.9633000000000003 30.0968 -12.1661 -12.1661 -12.1661 -19.0628 3.9633000000000003 31.0968 1.62111 1.62111 1.62111 -20.0628 3.9633000000000003 30.0968 16.1094 16.1094 16.1094 -20.0628 3.9633000000000003 31.0968 1.59934 1.59934 1.59934 -19.0628 2.9633000000000003 32.0968 6.45151 6.45151 6.45151 -19.0628 2.9633000000000003 33.0968 10.0931 10.0931 10.0931 -19.0628 3.9633000000000003 32.0968 -0.081398 -0.081398 -0.081398 -19.0628 3.9633000000000003 33.0968 2.65097 2.65097 2.65097 -19.0628 4.9633 30.0968 3.83739 3.83739 3.83739 -19.0628 4.9633 31.0968 -3.60096 -3.60096 -3.60096 -19.0628 5.9633 30.0968 0.861027 0.861027 0.861027 -19.0628 5.9633 31.0968 1.42914 1.42914 1.42914 -20.0628 4.9633 31.0968 -1.16323 -1.16323 -1.16323 -20.0628 5.9633 30.0968 0.367188 0.367188 0.367188 -20.0628 5.9633 31.0968 -0.180873 -0.180873 -0.180873 -19.0628 4.9633 32.0968 -7.23163 -7.23163 -7.23163 -19.0628 4.9633 33.0968 -9.06162 -9.06162 -9.06162 -19.0628 5.9633 32.0968 4.80292 4.80292 4.80292 -19.0628 5.9633 33.0968 11.4132 11.4132 11.4132 -20.0628 4.9633 32.0968 4.87102 4.87102 4.87102 -20.0628 5.9633 32.0968 6.6851 6.6851 6.6851 -20.0628 5.9633 33.0968 -8.10225 -8.10225 -8.10225 -17.0628 2.9633000000000003 34.0968 -55.9195 -55.9195 -55.9195 -17.0628 3.9633000000000003 34.0968 -37.2897 -37.2897 -37.2897 -18.0628 2.9633000000000003 34.0968 62.5406 62.5406 62.5406 -18.0628 3.9633000000000003 34.0968 -32.8544 -32.8544 -32.8544 -17.0628 4.9633 34.0968 -29.9934 -29.9934 -29.9934 -18.0628 4.9633 34.0968 -173.086 -173.086 -173.086 -17.0628 6.9633 30.0968 -7.39849 -7.39849 -7.39849 -18.0628 6.9633 30.0968 1.41274 1.41274 1.41274 -18.0628 7.9633 31.0968 0.498953 0.498953 0.498953 -17.0628 6.9633 33.0968 57.8871 57.8871 57.8871 -17.0628 7.9633 32.0968 8.94665 8.94665 8.94665 -17.0628 7.9633 33.0968 21.863 21.863 21.863 -18.0628 6.9633 32.0968 1.18965 1.18965 1.18965 -18.0628 6.9633 33.0968 4.4634 4.4634 4.4634 -18.0628 7.9633 32.0968 -1.58557 -1.58557 -1.58557 -18.0628 7.9633 33.0968 2.51718 2.51718 2.51718 -17.0628 8.9633 30.0968 7.74792 7.74792 7.74792 -17.0628 8.9633 31.0968 -13.5966 -13.5966 -13.5966 -17.0628 9.9633 30.0968 16.6721 16.6721 16.6721 -17.0628 9.9633 31.0968 32.0522 32.0522 32.0522 -18.0628 8.9633 30.0968 -0.992767 -0.992767 -0.992767 -18.0628 8.9633 31.0968 -1.21691 -1.21691 -1.21691 -18.0628 9.9633 30.0968 5.20726 5.20726 5.20726 -17.0628 8.9633 32.0968 -22.7721 -22.7721 -22.7721 -17.0628 9.9633 32.0968 -0.575288 -0.575288 -0.575288 -18.0628 8.9633 32.0968 -0.822405 -0.822405 -0.822405 -18.0628 8.9633 33.0968 1.32058 1.32058 1.32058 -18.0628 9.9633 32.0968 -0.63643 -0.63643 -0.63643 -18.0628 9.9633 33.0968 -0.231327 -0.231327 -0.231327 -19.0628 6.9633 30.0968 -2.94518 -2.94518 -2.94518 -19.0628 6.9633 31.0968 -0.015103 -0.015103 -0.015103 -19.0628 7.9633 30.0968 -2.43345 -2.43345 -2.43345 -19.0628 7.9633 31.0968 -0.977795 -0.977795 -0.977795 -20.0628 6.9633 30.0968 0.131431 0.131431 0.131431 -20.0628 6.9633 31.0968 1.15305 1.15305 1.15305 -20.0628 7.9633 30.0968 0.835269 0.835269 0.835269 -20.0628 7.9633 31.0968 -0.0707982 -0.0707982 -0.0707982 -19.0628 6.9633 32.0968 2.0953 2.0953 2.0953 -19.0628 6.9633 33.0968 -0.578733 -0.578733 -0.578733 -19.0628 7.9633 32.0968 0.557548 0.557548 0.557548 -19.0628 7.9633 33.0968 -0.0277241 -0.0277241 -0.0277241 -20.0628 6.9633 32.0968 2.04687 2.04687 2.04687 -20.0628 6.9633 33.0968 -0.124535 -0.124535 -0.124535 -20.0628 7.9633 32.0968 1.09222 1.09222 1.09222 -19.0628 8.9633 30.0968 -0.954256 -0.954256 -0.954256 -19.0628 8.9633 31.0968 -0.576035 -0.576035 -0.576035 -19.0628 9.9633 30.0968 -2.16452 -2.16452 -2.16452 -19.0628 9.9633 31.0968 -1.43997 -1.43997 -1.43997 -20.0628 8.9633 30.0968 0.261686 0.261686 0.261686 -20.0628 8.9633 31.0968 -0.149893 -0.149893 -0.149893 -20.0628 9.9633 30.0968 0.513841 0.513841 0.513841 -20.0628 9.9633 31.0968 0.339627 0.339627 0.339627 -19.0628 8.9633 32.0968 -0.103634 -0.103634 -0.103634 -19.0628 9.9633 32.0968 -0.397095 -0.397095 -0.397095 -19.0628 9.9633 33.0968 -0.373823 -0.373823 -0.373823 -20.0628 8.9633 32.0968 0.339524 0.339524 0.339524 -20.0628 9.9633 32.0968 1.25296 1.25296 1.25296 -20.0628 9.9633 33.0968 -0.407253 -0.407253 -0.407253 -18.0628 6.9633 34.0968 5.55125 5.55125 5.55125 -18.0628 7.9633 34.0968 -1.89666 -1.89666 -1.89666 -18.0628 7.9633 35.0968 -0.00889802 -0.00889802 -0.00889802 -18.0628 8.9633 34.0968 -4.9533 -4.9533 -4.9533 -18.0628 8.9633 35.0968 1.38361 1.38361 1.38361 -18.0628 9.9633 34.0968 -0.404419 -0.404419 -0.404419 -19.0628 6.9633 34.0968 17.0447 17.0447 17.0447 -19.0628 6.9633 35.0968 -1.6891 -1.6891 -1.6891 -19.0628 7.9633 34.0968 0.110944 0.110944 0.110944 -19.0628 7.9633 35.0968 -0.342871 -0.342871 -0.342871 -20.0628 6.9633 34.0968 -1.09975 -1.09975 -1.09975 -20.0628 6.9633 35.0968 -0.578143 -0.578143 -0.578143 -20.0628 7.9633 35.0968 0.390239 0.390239 0.390239 -20.0628 7.9633 36.0968 -1.10598 -1.10598 -1.10598 -19.0628 8.9633 35.0968 -0.54477 -0.54477 -0.54477 -19.0628 9.9633 34.0968 -1.26858 -1.26858 -1.26858 -19.0628 9.9633 35.0968 0.598954 0.598954 0.598954 -20.0628 8.9633 35.0968 -0.935349 -0.935349 -0.935349 -20.0628 9.9633 34.0968 -0.186021 -0.186021 -0.186021 -20.0628 9.9633 35.0968 -0.519276 -0.519276 -0.519276 -20.0628 8.9633 36.0968 0.117418 0.117418 0.117418 -20.0628 9.9633 36.0968 -0.832064 -0.832064 -0.832064 -21.0628 3.9633000000000003 30.0968 13.8405 13.8405 13.8405 -21.0628 3.9633000000000003 31.0968 9.63443 9.63443 9.63443 -22.0628 3.9633000000000003 30.0968 8.20532 8.20532 8.20532 -22.0628 3.9633000000000003 31.0968 7.55917 7.55917 7.55917 -22.0628 3.9633000000000003 32.0968 -0.0382769 -0.0382769 -0.0382769 -22.0628 3.9633000000000003 33.0968 0.391335 0.391335 0.391335 -21.0628 4.9633 31.0968 4.90724 4.90724 4.90724 -21.0628 5.9633 30.0968 -0.570807 -0.570807 -0.570807 -21.0628 5.9633 31.0968 0.0193092 0.0193092 0.0193092 -22.0628 4.9633 30.0968 -11.7109 -11.7109 -11.7109 -22.0628 4.9633 31.0968 -7.06033 -7.06033 -7.06033 -22.0628 5.9633 30.0968 -1.58927 -1.58927 -1.58927 -22.0628 5.9633 31.0968 0.0833308 0.0833308 0.0833308 -21.0628 4.9633 32.0968 1.66939 1.66939 1.66939 -21.0628 4.9633 33.0968 0.906634 0.906634 0.906634 -21.0628 5.9633 32.0968 1.06324 1.06324 1.06324 -21.0628 5.9633 33.0968 -0.191846 -0.191846 -0.191846 -22.0628 4.9633 32.0968 0.079729 0.079729 0.079729 -22.0628 4.9633 33.0968 1.53689 1.53689 1.53689 -22.0628 5.9633 32.0968 -0.198052 -0.198052 -0.198052 -22.0628 5.9633 33.0968 -3.01829 -3.01829 -3.01829 -23.0628 2.9633000000000003 30.0968 0.933895 0.933895 0.933895 -23.0628 2.9633000000000003 31.0968 0.337129 0.337129 0.337129 -23.0628 3.9633000000000003 30.0968 0.359146 0.359146 0.359146 -23.0628 3.9633000000000003 31.0968 0.141485 0.141485 0.141485 -24.0628 2.9633000000000003 30.0968 -0.982579 -0.982579 -0.982579 -24.0628 2.9633000000000003 31.0968 1.0438 1.0438 1.0438 -24.0628 3.9633000000000003 30.0968 -0.252493 -0.252493 -0.252493 -24.0628 3.9633000000000003 31.0968 0.479487 0.479487 0.479487 -23.0628 2.9633000000000003 32.0968 0.988665 0.988665 0.988665 -23.0628 2.9633000000000003 33.0968 5.9028 5.9028 5.9028 -23.0628 3.9633000000000003 32.0968 -0.86469 -0.86469 -0.86469 -23.0628 3.9633000000000003 33.0968 3.41336 3.41336 3.41336 -24.0628 2.9633000000000003 32.0968 -2.21373 -2.21373 -2.21373 -24.0628 2.9633000000000003 33.0968 -2.35644 -2.35644 -2.35644 -24.0628 3.9633000000000003 32.0968 2.85398 2.85398 2.85398 -23.0628 4.9633 30.0968 1.53335 1.53335 1.53335 -23.0628 5.9633 30.0968 0.725051 0.725051 0.725051 -23.0628 5.9633 31.0968 -0.571438 -0.571438 -0.571438 -24.0628 4.9633 30.0968 1.25698 1.25698 1.25698 -24.0628 5.9633 30.0968 -2.35555 -2.35555 -2.35555 -23.0628 4.9633 32.0968 1.02292 1.02292 1.02292 -23.0628 4.9633 33.0968 -2.77434 -2.77434 -2.77434 -23.0628 5.9633 32.0968 -0.235707 -0.235707 -0.235707 -22.0628 3.9633000000000003 34.0968 0.890651 0.890651 0.890651 -21.0628 4.9633 34.0968 1.83 1.83 1.83 -21.0628 5.9633 34.0968 -0.127805 -0.127805 -0.127805 -21.0628 5.9633 35.0968 0.17296 0.17296 0.17296 -22.0628 4.9633 34.0968 2.00126 2.00126 2.00126 -22.0628 4.9633 35.0968 -1.12842 -1.12842 -1.12842 -22.0628 5.9633 34.0968 -0.132776 -0.132776 -0.132776 -22.0628 5.9633 35.0968 2.28872 2.28872 2.28872 -21.0628 5.9633 36.0968 -8.99529 -8.99529 -8.99529 -22.0628 5.9633 36.0968 6.31855 6.31855 6.31855 -23.0628 2.9633000000000003 34.0968 -0.888087 -0.888087 -0.888087 -23.0628 2.9633000000000003 35.0968 1.74667 1.74667 1.74667 -23.0628 3.9633000000000003 34.0968 2.19698 2.19698 2.19698 -23.0628 3.9633000000000003 35.0968 -13.9303 -13.9303 -13.9303 -24.0628 2.9633000000000003 34.0968 -2.55417 -2.55417 -2.55417 -24.0628 2.9633000000000003 35.0968 2.80845 2.80845 2.80845 -23.0628 2.9633000000000003 36.0968 -2.02588 -2.02588 -2.02588 -23.0628 3.9633000000000003 36.0968 -0.56807 -0.56807 -0.56807 -24.0628 2.9633000000000003 36.0968 0.928116 0.928116 0.928116 -24.0628 3.9633000000000003 36.0968 0.0575687 0.0575687 0.0575687 -24.0628 3.9633000000000003 37.0968 -0.284684 -0.284684 -0.284684 -23.0628 4.9633 34.0968 -1.94139 -1.94139 -1.94139 -23.0628 4.9633 35.0968 -1.4761 -1.4761 -1.4761 -23.0628 5.9633 35.0968 -0.593143 -0.593143 -0.593143 -24.0628 4.9633 35.0968 0.160666 0.160666 0.160666 -24.0628 5.9633 34.0968 -0.610192 -0.610192 -0.610192 -24.0628 5.9633 35.0968 1.41652 1.41652 1.41652 -23.0628 4.9633 36.0968 -0.57502 -0.57502 -0.57502 -24.0628 4.9633 36.0968 -3.19025 -3.19025 -3.19025 -24.0628 5.9633 36.0968 0.640296 0.640296 0.640296 -21.0628 6.9633 30.0968 0.688815 0.688815 0.688815 -21.0628 6.9633 31.0968 -0.132902 -0.132902 -0.132902 -21.0628 7.9633 30.0968 -0.456665 -0.456665 -0.456665 -21.0628 7.9633 31.0968 0.0715052 0.0715052 0.0715052 -22.0628 6.9633 30.0968 0.761011 0.761011 0.761011 -22.0628 6.9633 31.0968 0.0241315 0.0241315 0.0241315 -22.0628 7.9633 30.0968 0.891928 0.891928 0.891928 -22.0628 7.9633 31.0968 0.208143 0.208143 0.208143 -21.0628 6.9633 32.0968 -0.187429 -0.187429 -0.187429 -21.0628 6.9633 33.0968 0.246102 0.246102 0.246102 -21.0628 7.9633 32.0968 -0.947861 -0.947861 -0.947861 -22.0628 6.9633 32.0968 0.174099 0.174099 0.174099 -22.0628 6.9633 33.0968 -0.0300534 -0.0300534 -0.0300534 -22.0628 7.9633 32.0968 -0.630539 -0.630539 -0.630539 -21.0628 8.9633 30.0968 0.0637852 0.0637852 0.0637852 -21.0628 9.9633 30.0968 2.44299 2.44299 2.44299 -22.0628 8.9633 30.0968 -1.25039 -1.25039 -1.25039 -22.0628 8.9633 31.0968 -2.23272 -2.23272 -2.23272 -22.0628 9.9633 30.0968 -0.394192 -0.394192 -0.394192 -22.0628 9.9633 31.0968 0.521321 0.521321 0.521321 -21.0628 9.9633 32.0968 0.564589 0.564589 0.564589 -21.0628 9.9633 33.0968 -0.485349 -0.485349 -0.485349 -22.0628 9.9633 32.0968 -0.724296 -0.724296 -0.724296 -22.0628 9.9633 33.0968 -0.435261 -0.435261 -0.435261 -23.0628 6.9633 30.0968 -0.212884 -0.212884 -0.212884 -23.0628 6.9633 31.0968 -1.01094 -1.01094 -1.01094 -23.0628 7.9633 30.0968 -0.735789 -0.735789 -0.735789 -23.0628 7.9633 31.0968 0.0837247 0.0837247 0.0837247 -24.0628 6.9633 30.0968 -0.45901 -0.45901 -0.45901 -24.0628 6.9633 31.0968 0.62104 0.62104 0.62104 -24.0628 7.9633 30.0968 -0.192978 -0.192978 -0.192978 -24.0628 7.9633 31.0968 -0.453961 -0.453961 -0.453961 -23.0628 6.9633 32.0968 -2.12881 -2.12881 -2.12881 -23.0628 7.9633 32.0968 -0.57046 -0.57046 -0.57046 -23.0628 7.9633 33.0968 -1.55319 -1.55319 -1.55319 -24.0628 6.9633 32.0968 0.597044 0.597044 0.597044 -24.0628 6.9633 33.0968 1.35421 1.35421 1.35421 -24.0628 7.9633 32.0968 -0.90297 -0.90297 -0.90297 -24.0628 7.9633 33.0968 -0.337812 -0.337812 -0.337812 -23.0628 8.9633 30.0968 1.27534 1.27534 1.27534 -23.0628 8.9633 31.0968 3.87178 3.87178 3.87178 -23.0628 9.9633 30.0968 -2.62279 -2.62279 -2.62279 -23.0628 9.9633 31.0968 5.20512 5.20512 5.20512 -24.0628 8.9633 30.0968 -2.21841 -2.21841 -2.21841 -24.0628 8.9633 31.0968 4.81864 4.81864 4.81864 -24.0628 9.9633 30.0968 -1.92472 -1.92472 -1.92472 -24.0628 9.9633 31.0968 -12.8966 -12.8966 -12.8966 -23.0628 8.9633 32.0968 0.213643 0.213643 0.213643 -23.0628 8.9633 33.0968 0.0250365 0.0250365 0.0250365 -23.0628 9.9633 32.0968 0.0968338 0.0968338 0.0968338 -23.0628 9.9633 33.0968 1.06247 1.06247 1.06247 -24.0628 8.9633 33.0968 0.304728 0.304728 0.304728 -24.0628 9.9633 32.0968 -4.98116 -4.98116 -4.98116 -24.0628 9.9633 33.0968 -11.6515 -11.6515 -11.6515 -21.0628 6.9633 34.0968 -0.915908 -0.915908 -0.915908 -21.0628 6.9633 35.0968 -0.325005 -0.325005 -0.325005 -22.0628 6.9633 35.0968 -0.46547 -0.46547 -0.46547 -21.0628 6.9633 36.0968 -0.653594 -0.653594 -0.653594 -21.0628 7.9633 36.0968 0.644439 0.644439 0.644439 -21.0628 7.9633 37.0968 1.71875 1.71875 1.71875 -22.0628 6.9633 36.0968 -0.154133 -0.154133 -0.154133 -22.0628 7.9633 36.0968 -0.291328 -0.291328 -0.291328 -22.0628 7.9633 37.0968 0.959846 0.959846 0.959846 -21.0628 8.9633 34.0968 0.839555 0.839555 0.839555 -21.0628 9.9633 34.0968 -1.13115 -1.13115 -1.13115 -21.0628 9.9633 35.0968 -0.18109 -0.18109 -0.18109 -22.0628 8.9633 34.0968 0.962022 0.962022 0.962022 -22.0628 9.9633 34.0968 -0.653427 -0.653427 -0.653427 -22.0628 9.9633 35.0968 0.104269 0.104269 0.104269 -21.0628 8.9633 36.0968 -0.45095 -0.45095 -0.45095 -21.0628 8.9633 37.0968 0.759989 0.759989 0.759989 -21.0628 9.9633 36.0968 0.268029 0.268029 0.268029 -21.0628 9.9633 37.0968 0.329396 0.329396 0.329396 -22.0628 8.9633 37.0968 -0.0812268 -0.0812268 -0.0812268 -22.0628 9.9633 36.0968 0.302422 0.302422 0.302422 -22.0628 9.9633 37.0968 -0.0218226 -0.0218226 -0.0218226 -23.0628 6.9633 35.0968 -1.88537 -1.88537 -1.88537 -23.0628 7.9633 35.0968 -0.109707 -0.109707 -0.109707 -24.0628 6.9633 35.0968 0.0938687 0.0938687 0.0938687 -24.0628 7.9633 35.0968 -0.486979 -0.486979 -0.486979 -23.0628 6.9633 36.0968 -8.93491 -8.93491 -8.93491 -23.0628 7.9633 36.0968 -35.4057 -35.4057 -35.4057 -23.0628 7.9633 37.0968 12.2104 12.2104 12.2104 -24.0628 6.9633 36.0968 -3.62834 -3.62834 -3.62834 -24.0628 7.9633 36.0968 19.63 19.63 19.63 -23.0628 8.9633 34.0968 0.0767467 0.0767467 0.0767467 -23.0628 8.9633 35.0968 -0.513523 -0.513523 -0.513523 -23.0628 9.9633 34.0968 0.562622 0.562622 0.562622 -23.0628 9.9633 35.0968 -0.633139 -0.633139 -0.633139 -24.0628 8.9633 34.0968 -0.3786 -0.3786 -0.3786 -24.0628 8.9633 35.0968 0.773253 0.773253 0.773253 -24.0628 9.9633 34.0968 2.99309 2.99309 2.99309 -24.0628 9.9633 35.0968 0.532747 0.532747 0.532747 -23.0628 8.9633 36.0968 -19.9112 -19.9112 -19.9112 -23.0628 8.9633 37.0968 29.4026 29.4026 29.4026 -23.0628 9.9633 36.0968 -11.9239 -11.9239 -11.9239 -24.0628 8.9633 36.0968 -11.009 -11.009 -11.009 -24.0628 9.9633 36.0968 8.3553 8.3553 8.3553 -8.0628 10.9633 20.0968 0.81698 0.81698 0.81698 -8.0628 10.9633 21.0968 4.99449 4.99449 4.99449 -8.0628 11.9633 20.0968 -1.51422 -1.51422 -1.51422 -8.0628 11.9633 21.0968 -2.74118 -2.74118 -2.74118 -8.0628 12.9633 19.0968 2.92842 2.92842 2.92842 -8.0628 12.9633 20.0968 -0.900137 -0.900137 -0.900137 -8.0628 12.9633 21.0968 -2.1513 -2.1513 -2.1513 -8.0628 13.9633 20.0968 0.149145 0.149145 0.149145 -8.0628 13.9633 21.0968 -1.7233 -1.7233 -1.7233 -12.0628 16.9633 10.096800000000002 -371.832 -371.832 -371.832 -12.0628 16.9633 11.096800000000002 -632.81 -632.81 -632.81 -12.0628 17.9633 10.096800000000002 -656.653 -656.653 -656.653 -12.0628 17.9633 11.096800000000002 404.32 404.32 404.32 -12.0628 16.9633 12.096800000000002 63.3022 63.3022 63.3022 -12.0628 17.9633 12.096800000000002 1667.11 1667.11 1667.11 -13.0628 11.9633 13.096800000000002 -1.10485 -1.10485 -1.10485 -14.0628 10.9633 12.096800000000002 5.00671 5.00671 5.00671 -14.0628 10.9633 13.096800000000002 -4.76891 -4.76891 -4.76891 -14.0628 11.9633 12.096800000000002 0.607422 0.607422 0.607422 -14.0628 11.9633 13.096800000000002 2.63422 2.63422 2.63422 -13.0628 12.9633 13.096800000000002 3.31577 3.31577 3.31577 -13.0628 13.9633 13.096800000000002 -5.88391 -5.88391 -5.88391 -14.0628 12.9633 12.096800000000002 -0.270615 -0.270615 -0.270615 -14.0628 12.9633 13.096800000000002 1.62437 1.62437 1.62437 -14.0628 13.9633 12.096800000000002 0.361022 0.361022 0.361022 -14.0628 13.9633 13.096800000000002 2.80886 2.80886 2.80886 -15.0628 11.9633 11.096800000000002 -0.0214187 -0.0214187 -0.0214187 -16.0628 11.9633 11.096800000000002 12.4517 12.4517 12.4517 -15.0628 10.9633 12.096800000000002 1.13564 1.13564 1.13564 -15.0628 10.9633 13.096800000000002 1.35993 1.35993 1.35993 -15.0628 11.9633 12.096800000000002 0.735562 0.735562 0.735562 -16.0628 10.9633 12.096800000000002 2.59272 2.59272 2.59272 -16.0628 10.9633 13.096800000000002 -1.86728 -1.86728 -1.86728 -16.0628 11.9633 12.096800000000002 -0.987245 -0.987245 -0.987245 -15.0628 12.9633 11.096800000000002 0.982531 0.982531 0.982531 -15.0628 13.9633 11.096800000000002 5.15383 5.15383 5.15383 -16.0628 12.9633 11.096800000000002 -5.0625 -5.0625 -5.0625 -16.0628 13.9633 11.096800000000002 7.05981 7.05981 7.05981 -15.0628 12.9633 12.096800000000002 0.233534 0.233534 0.233534 -15.0628 13.9633 12.096800000000002 -0.197061 -0.197061 -0.197061 -15.0628 13.9633 13.096800000000002 -7.36663 -7.36663 -7.36663 -16.0628 12.9633 12.096800000000002 3.69623 3.69623 3.69623 -16.0628 13.9633 12.096800000000002 -3.5449 -3.5449 -3.5449 -16.0628 13.9633 13.096800000000002 3.69586 3.69586 3.69586 -13.0628 17.9633 9.096800000000002 -346.939 -346.939 -346.939 -14.0628 17.9633 9.096800000000002 -4.11014 -4.11014 -4.11014 -15.0628 17.9633 9.096800000000002 -3.84524 -3.84524 -3.84524 -14.0628 15.9633 12.096800000000002 -3.54769 -3.54769 -3.54769 -14.0628 15.9633 13.096800000000002 -8.12834 -8.12834 -8.12834 -13.0628 16.9633 10.096800000000002 131.48 131.48 131.48 -13.0628 16.9633 11.096800000000002 193.119 193.119 193.119 -13.0628 17.9633 10.096800000000002 -54.9627 -54.9627 -54.9627 -14.0628 16.9633 10.096800000000002 1.11503 1.11503 1.11503 -14.0628 16.9633 11.096800000000002 -3.22185 -3.22185 -3.22185 -14.0628 17.9633 10.096800000000002 -1.64974 -1.64974 -1.64974 -13.0628 16.9633 12.096800000000002 17.7679 17.7679 17.7679 -13.0628 16.9633 13.096800000000002 147.624 147.624 147.624 -13.0628 17.9633 12.096800000000002 -67.0849 -67.0849 -67.0849 -13.0628 17.9633 13.096800000000002 -62.3561 -62.3561 -62.3561 -14.0628 16.9633 12.096800000000002 -6.77309 -6.77309 -6.77309 -14.0628 16.9633 13.096800000000002 -0.434823 -0.434823 -0.434823 -15.0628 15.9633 11.096800000000002 5.19661 5.19661 5.19661 -15.0628 15.9633 12.096800000000002 7.84219 7.84219 7.84219 -15.0628 15.9633 13.096800000000002 8.56944 8.56944 8.56944 -16.0628 14.9633 13.096800000000002 -6.17285 -6.17285 -6.17285 -16.0628 15.9633 12.096800000000002 14.255 14.255 14.255 -16.0628 15.9633 13.096800000000002 15.6765 15.6765 15.6765 -15.0628 16.9633 10.096800000000002 -1.64283 -1.64283 -1.64283 -15.0628 16.9633 11.096800000000002 -9.78997 -9.78997 -9.78997 -15.0628 17.9633 10.096800000000002 -0.710408 -0.710408 -0.710408 -16.0628 16.9633 10.096800000000002 3.84964 3.84964 3.84964 -16.0628 16.9633 11.096800000000002 -5.57841 -5.57841 -5.57841 -16.0628 17.9633 10.096800000000002 -4.57996 -4.57996 -4.57996 -16.0628 17.9633 11.096800000000002 -3.6241 -3.6241 -3.6241 -15.0628 16.9633 12.096800000000002 -0.0221176 -0.0221176 -0.0221176 -16.0628 16.9633 12.096800000000002 -4.81475 -4.81475 -4.81475 -11.0628 11.9633 15.096800000000002 -1.16326 -1.16326 -1.16326 -12.0628 10.9633 15.096800000000002 9.41805 9.41805 9.41805 -12.0628 11.9633 14.096800000000002 1.00647 1.00647 1.00647 -12.0628 11.9633 15.096800000000002 15.8155 15.8155 15.8155 -11.0628 10.9633 17.0968 -2.99826 -2.99826 -2.99826 -11.0628 11.9633 16.0968 -1.27173 -1.27173 -1.27173 -11.0628 11.9633 17.0968 7.48974 7.48974 7.48974 -12.0628 10.9633 16.0968 7.43902 7.43902 7.43902 -12.0628 10.9633 17.0968 -0.878248 -0.878248 -0.878248 -12.0628 11.9633 16.0968 5.90228 5.90228 5.90228 -12.0628 11.9633 17.0968 4.84821 4.84821 4.84821 -11.0628 12.9633 15.096800000000002 10.798 10.798 10.798 -11.0628 13.9633 15.096800000000002 -3.5708 -3.5708 -3.5708 -12.0628 12.9633 14.096800000000002 2.78421 2.78421 2.78421 -12.0628 12.9633 15.096800000000002 3.80171 3.80171 3.80171 -12.0628 13.9633 14.096800000000002 6.51219 6.51219 6.51219 -12.0628 13.9633 15.096800000000002 -6.92574 -6.92574 -6.92574 -11.0628 12.9633 16.0968 -4.50268 -4.50268 -4.50268 -11.0628 12.9633 17.0968 -14.7309 -14.7309 -14.7309 -11.0628 13.9633 16.0968 4.52437 4.52437 4.52437 -11.0628 13.9633 17.0968 1.23043 1.23043 1.23043 -12.0628 12.9633 17.0968 29.6536 29.6536 29.6536 -12.0628 13.9633 16.0968 -21.0955 -21.0955 -21.0955 -12.0628 13.9633 17.0968 -15.958 -15.958 -15.958 -9.0628 10.9633 19.0968 4.27946 4.27946 4.27946 -9.0628 11.9633 19.0968 -5.57153 -5.57153 -5.57153 -10.0628 10.9633 19.0968 5.26869 5.26869 5.26869 -10.0628 11.9633 19.0968 -0.893961 -0.893961 -0.893961 -9.0628 10.9633 20.0968 1.44885 1.44885 1.44885 -9.0628 10.9633 21.0968 4.01363 4.01363 4.01363 -9.0628 11.9633 20.0968 13.0566 13.0566 13.0566 -9.0628 11.9633 21.0968 -1.61224 -1.61224 -1.61224 -10.0628 10.9633 20.0968 -9.56254 -9.56254 -9.56254 -10.0628 11.9633 20.0968 6.29632 6.29632 6.29632 -9.0628 12.9633 19.0968 25.1442 25.1442 25.1442 -9.0628 13.9633 19.0968 14.9933 14.9933 14.9933 -10.0628 12.9633 19.0968 -12.6724 -12.6724 -12.6724 -10.0628 13.9633 19.0968 -37.1552 -37.1552 -37.1552 -9.0628 12.9633 20.0968 33.625 33.625 33.625 -9.0628 12.9633 21.0968 1.52445 1.52445 1.52445 -9.0628 13.9633 20.0968 19.4949 19.4949 19.4949 -9.0628 13.9633 21.0968 4.18977 4.18977 4.18977 -10.0628 13.9633 20.0968 -15.3335 -15.3335 -15.3335 -10.0628 13.9633 21.0968 -1.6113 -1.6113 -1.6113 -11.0628 10.9633 18.0968 7.63297 7.63297 7.63297 -11.0628 10.9633 19.0968 2.19799 2.19799 2.19799 -11.0628 11.9633 19.0968 28.7198 28.7198 28.7198 -12.0628 10.9633 18.0968 2.04381 2.04381 2.04381 -12.0628 10.9633 19.0968 -2.32469 -2.32469 -2.32469 -12.0628 11.9633 18.0968 -0.0611386 -0.0611386 -0.0611386 -12.0628 11.9633 19.0968 3.7602 3.7602 3.7602 -11.0628 10.9633 20.0968 -10.3965 -10.3965 -10.3965 -12.0628 10.9633 20.0968 11.0528 11.0528 11.0528 -12.0628 10.9633 21.0968 -3.15563 -3.15563 -3.15563 -12.0628 11.9633 20.0968 4.2288 4.2288 4.2288 -11.0628 12.9633 19.0968 -35.5755 -35.5755 -35.5755 -11.0628 13.9633 18.0968 -21.1645 -21.1645 -21.1645 -11.0628 13.9633 19.0968 -36.3662 -36.3662 -36.3662 -12.0628 12.9633 18.0968 48.7806 48.7806 48.7806 -12.0628 12.9633 19.0968 0.190629 0.190629 0.190629 -12.0628 13.9633 18.0968 0.452648 0.452648 0.452648 -12.0628 13.9633 19.0968 -4.93729 -4.93729 -4.93729 -11.0628 13.9633 21.0968 -9.22882 -9.22882 -9.22882 -12.0628 12.9633 20.0968 1.25738 1.25738 1.25738 -12.0628 12.9633 21.0968 -2.98817 -2.98817 -2.98817 -12.0628 13.9633 20.0968 -0.100879 -0.100879 -0.100879 -12.0628 13.9633 21.0968 -2.98327 -2.98327 -2.98327 -10.0628 14.9633 17.0968 702.551 702.551 702.551 -10.0628 15.9633 17.0968 603.738 603.738 603.738 -10.0628 16.9633 17.0968 -1310.59 -1310.59 -1310.59 -10.0628 17.9633 17.0968 -3.51102 -3.51102 -3.51102 -12.0628 14.9633 15.096800000000002 -0.975954 -0.975954 -0.975954 -11.0628 14.9633 16.0968 -3.40885 -3.40885 -3.40885 -11.0628 14.9633 17.0968 5.11515 5.11515 5.11515 -11.0628 15.9633 16.0968 -0.779461 -0.779461 -0.779461 -11.0628 15.9633 17.0968 33.9736 33.9736 33.9736 -12.0628 14.9633 16.0968 14.0763 14.0763 14.0763 -12.0628 14.9633 17.0968 -23.0031 -23.0031 -23.0031 -12.0628 15.9633 16.0968 24.0462 24.0462 24.0462 -11.0628 16.9633 16.0968 0.898697 0.898697 0.898697 -11.0628 16.9633 17.0968 -1.14899 -1.14899 -1.14899 -11.0628 17.9633 17.0968 -12.1906 -12.1906 -12.1906 -12.0628 16.9633 16.0968 16.3696 16.3696 16.3696 -12.0628 17.9633 16.0968 -5.51761 -5.51761 -5.51761 -12.0628 17.9633 17.0968 -24.1815 -24.1815 -24.1815 -10.0628 14.9633 18.0968 -23.1523 -23.1523 -23.1523 -10.0628 14.9633 19.0968 -11.5143 -11.5143 -11.5143 -10.0628 15.9633 18.0968 -8.51525 -8.51525 -8.51525 -10.0628 14.9633 20.0968 8.61116 8.61116 8.61116 -10.0628 14.9633 21.0968 12.3695 12.3695 12.3695 -10.0628 16.9633 18.0968 -4.78243 -4.78243 -4.78243 -10.0628 16.9633 19.0968 6.76247 6.76247 6.76247 -10.0628 17.9633 18.0968 -3.73632 -3.73632 -3.73632 -10.0628 17.9633 19.0968 1.02408 1.02408 1.02408 -11.0628 14.9633 18.0968 -53.5471 -53.5471 -53.5471 -11.0628 14.9633 19.0968 -4.49382 -4.49382 -4.49382 -11.0628 15.9633 18.0968 -8.63947 -8.63947 -8.63947 -11.0628 15.9633 19.0968 9.96786 9.96786 9.96786 -12.0628 14.9633 19.0968 9.01987 9.01987 9.01987 -12.0628 15.9633 19.0968 2.56892 2.56892 2.56892 -11.0628 14.9633 20.0968 -12.1582 -12.1582 -12.1582 -11.0628 14.9633 21.0968 -11.2781 -11.2781 -11.2781 -12.0628 14.9633 20.0968 6.10122 6.10122 6.10122 -12.0628 14.9633 21.0968 -0.140541 -0.140541 -0.140541 -12.0628 15.9633 20.0968 -31.9518 -31.9518 -31.9518 -11.0628 16.9633 19.0968 5.32252 5.32252 5.32252 -11.0628 17.9633 18.0968 -9.07825 -9.07825 -9.07825 -11.0628 17.9633 19.0968 4.67688 4.67688 4.67688 -12.0628 17.9633 19.0968 1.13013 1.13013 1.13013 -11.0628 16.9633 20.0968 -20.9889 -20.9889 -20.9889 -11.0628 17.9633 20.0968 6.91574 6.91574 6.91574 -12.0628 16.9633 20.0968 -12.9571 -12.9571 -12.9571 -12.0628 17.9633 20.0968 7.08513 7.08513 7.08513 -13.0628 10.9633 15.096800000000002 -3.60699 -3.60699 -3.60699 -13.0628 11.9633 14.096800000000002 4.57921 4.57921 4.57921 -13.0628 11.9633 15.096800000000002 -5.05216 -5.05216 -5.05216 -14.0628 10.9633 14.096800000000002 -4.66667 -4.66667 -4.66667 -14.0628 11.9633 14.096800000000002 -6.22429 -6.22429 -6.22429 -14.0628 11.9633 15.096800000000002 -12.0754 -12.0754 -12.0754 -13.0628 10.9633 16.0968 -1.72928 -1.72928 -1.72928 -13.0628 11.9633 16.0968 -13.488 -13.488 -13.488 -14.0628 10.9633 16.0968 1.68557 1.68557 1.68557 -14.0628 11.9633 16.0968 9.91361 9.91361 9.91361 -13.0628 12.9633 14.096800000000002 5.9612 5.9612 5.9612 -13.0628 13.9633 14.096800000000002 2.87955 2.87955 2.87955 -13.0628 13.9633 15.096800000000002 4.82027 4.82027 4.82027 -14.0628 12.9633 15.096800000000002 -14.4143 -14.4143 -14.4143 -14.0628 13.9633 14.096800000000002 -2.10752 -2.10752 -2.10752 -14.0628 13.9633 15.096800000000002 0.342323 0.342323 0.342323 -14.0628 12.9633 16.0968 -21.4965 -21.4965 -21.4965 -14.0628 13.9633 16.0968 -26.8758 -26.8758 -26.8758 -15.0628 10.9633 14.096800000000002 4.97185 4.97185 4.97185 -15.0628 10.9633 15.096800000000002 5.06219 5.06219 5.06219 -15.0628 11.9633 14.096800000000002 10.4403 10.4403 10.4403 -15.0628 11.9633 15.096800000000002 15.2628 15.2628 15.2628 -16.0628 10.9633 14.096800000000002 1.37032 1.37032 1.37032 -16.0628 10.9633 15.096800000000002 1.4396 1.4396 1.4396 -16.0628 11.9633 14.096800000000002 4.62385 4.62385 4.62385 -16.0628 11.9633 15.096800000000002 2.07355 2.07355 2.07355 -15.0628 10.9633 16.0968 0.259103 0.259103 0.259103 -15.0628 10.9633 17.0968 1.52662 1.52662 1.52662 -15.0628 11.9633 16.0968 -12.2114 -12.2114 -12.2114 -15.0628 11.9633 17.0968 8.30735 8.30735 8.30735 -16.0628 10.9633 16.0968 -1.59919 -1.59919 -1.59919 -16.0628 10.9633 17.0968 -6.21553 -6.21553 -6.21553 -16.0628 11.9633 16.0968 -14.079 -14.079 -14.079 -16.0628 11.9633 17.0968 -3.90733 -3.90733 -3.90733 -15.0628 12.9633 15.096800000000002 15.7001 15.7001 15.7001 -15.0628 13.9633 14.096800000000002 11.0911 11.0911 11.0911 -15.0628 13.9633 15.096800000000002 4.31325 4.31325 4.31325 -16.0628 12.9633 15.096800000000002 -2.54642 -2.54642 -2.54642 -16.0628 13.9633 14.096800000000002 8.12585 8.12585 8.12585 -15.0628 12.9633 16.0968 -22.6042 -22.6042 -22.6042 -15.0628 12.9633 17.0968 -17.8867 -17.8867 -17.8867 -15.0628 13.9633 16.0968 14.5899 14.5899 14.5899 -16.0628 12.9633 16.0968 -2.09594 -2.09594 -2.09594 -16.0628 12.9633 17.0968 25.8712 25.8712 25.8712 -16.0628 13.9633 16.0968 -13.3345 -13.3345 -13.3345 -16.0628 13.9633 17.0968 20.5983 20.5983 20.5983 -13.0628 10.9633 19.0968 -4.4743 -4.4743 -4.4743 -13.0628 11.9633 18.0968 19.5336 19.5336 19.5336 -13.0628 11.9633 19.0968 -2.42617 -2.42617 -2.42617 -14.0628 10.9633 19.0968 -0.962213 -0.962213 -0.962213 -13.0628 10.9633 20.0968 -0.895585 -0.895585 -0.895585 -13.0628 10.9633 21.0968 -0.169158 -0.169158 -0.169158 -13.0628 11.9633 20.0968 1.93184 1.93184 1.93184 -14.0628 10.9633 20.0968 0.0895385 0.0895385 0.0895385 -14.0628 10.9633 21.0968 -0.969261 -0.969261 -0.969261 -14.0628 11.9633 20.0968 2.62324 2.62324 2.62324 -14.0628 11.9633 21.0968 -1.93662 -1.93662 -1.93662 -13.0628 12.9633 18.0968 11.1047 11.1047 11.1047 -13.0628 12.9633 19.0968 -16.0179 -16.0179 -16.0179 -13.0628 13.9633 18.0968 6.77735 6.77735 6.77735 -13.0628 13.9633 19.0968 6.35522 6.35522 6.35522 -14.0628 12.9633 18.0968 5.93885 5.93885 5.93885 -14.0628 12.9633 19.0968 -5.98757 -5.98757 -5.98757 -14.0628 13.9633 18.0968 -7.99483 -7.99483 -7.99483 -14.0628 13.9633 19.0968 -4.58193 -4.58193 -4.58193 -13.0628 12.9633 20.0968 3.2606 3.2606 3.2606 -13.0628 13.9633 20.0968 2.52222 2.52222 2.52222 -13.0628 13.9633 21.0968 -1.85297 -1.85297 -1.85297 -14.0628 12.9633 20.0968 4.87679 4.87679 4.87679 -14.0628 12.9633 21.0968 4.26486 4.26486 4.26486 -14.0628 13.9633 21.0968 -0.608851 -0.608851 -0.608851 -15.0628 10.9633 18.0968 0.568019 0.568019 0.568019 -15.0628 10.9633 19.0968 0.639607 0.639607 0.639607 -16.0628 10.9633 18.0968 0.602065 0.602065 0.602065 -16.0628 10.9633 19.0968 -0.746953 -0.746953 -0.746953 -16.0628 11.9633 18.0968 -1.54492 -1.54492 -1.54492 -16.0628 11.9633 19.0968 -6.62236 -6.62236 -6.62236 -15.0628 10.9633 20.0968 2.25094 2.25094 2.25094 -15.0628 10.9633 21.0968 2.65238 2.65238 2.65238 -15.0628 11.9633 20.0968 3.60088 3.60088 3.60088 -15.0628 11.9633 21.0968 13.8188 13.8188 13.8188 -16.0628 10.9633 20.0968 -67.8272 -67.8272 -67.8272 -16.0628 10.9633 21.0968 -125.123 -125.123 -125.123 -16.0628 11.9633 20.0968 -34.9472 -34.9472 -34.9472 -16.0628 11.9633 21.0968 85.2824 85.2824 85.2824 -15.0628 12.9633 18.0968 -0.764377 -0.764377 -0.764377 -15.0628 12.9633 19.0968 5.63464 5.63464 5.63464 -15.0628 13.9633 18.0968 -8.54732 -8.54732 -8.54732 -15.0628 13.9633 19.0968 -2.1475 -2.1475 -2.1475 -16.0628 12.9633 18.0968 40.4416 40.4416 40.4416 -16.0628 12.9633 19.0968 53.1806 53.1806 53.1806 -16.0628 13.9633 18.0968 -20.5419 -20.5419 -20.5419 -15.0628 12.9633 20.0968 -7.29108 -7.29108 -7.29108 -15.0628 12.9633 21.0968 4.57909 4.57909 4.57909 -15.0628 13.9633 20.0968 -3.52343 -3.52343 -3.52343 -15.0628 13.9633 21.0968 1.53866 1.53866 1.53866 -16.0628 12.9633 20.0968 -71.9208 -71.9208 -71.9208 -16.0628 12.9633 21.0968 37.8124 37.8124 37.8124 -16.0628 13.9633 20.0968 5.09193 5.09193 5.09193 -16.0628 13.9633 21.0968 1.86657 1.86657 1.86657 -13.0628 14.9633 15.096800000000002 6.19614 6.19614 6.19614 -14.0628 14.9633 15.096800000000002 2.86616 2.86616 2.86616 -14.0628 15.9633 14.096800000000002 3.68561 3.68561 3.68561 -13.0628 14.9633 16.0968 29.1633 29.1633 29.1633 -13.0628 15.9633 16.0968 38.9701 38.9701 38.9701 -14.0628 14.9633 16.0968 6.73752 6.73752 6.73752 -14.0628 15.9633 16.0968 1.00275 1.00275 1.00275 -13.0628 16.9633 14.096800000000002 -21.2633 -21.2633 -21.2633 -13.0628 17.9633 14.096800000000002 -1.58462 -1.58462 -1.58462 -14.0628 16.9633 14.096800000000002 4.51691 4.51691 4.51691 -14.0628 17.9633 14.096800000000002 2.36788 2.36788 2.36788 -13.0628 16.9633 16.0968 0.0819597 0.0819597 0.0819597 -13.0628 17.9633 16.0968 22.8028 22.8028 22.8028 -14.0628 16.9633 16.0968 -3.14073 -3.14073 -3.14073 -14.0628 17.9633 16.0968 10.4439 10.4439 10.4439 -15.0628 14.9633 14.096800000000002 3.98685 3.98685 3.98685 -15.0628 14.9633 15.096800000000002 -0.765001 -0.765001 -0.765001 -15.0628 15.9633 14.096800000000002 -0.223567 -0.223567 -0.223567 -15.0628 15.9633 15.096800000000002 -12.3125 -12.3125 -12.3125 -16.0628 14.9633 14.096800000000002 -0.46995 -0.46995 -0.46995 -16.0628 14.9633 15.096800000000002 -1.5605 -1.5605 -1.5605 -16.0628 15.9633 14.096800000000002 1.13823 1.13823 1.13823 -16.0628 15.9633 15.096800000000002 -8.51351 -8.51351 -8.51351 -15.0628 14.9633 16.0968 21.2176 21.2176 21.2176 -15.0628 15.9633 16.0968 -19.0283 -19.0283 -19.0283 -15.0628 15.9633 17.0968 -27.5117 -27.5117 -27.5117 -16.0628 14.9633 16.0968 3.73967 3.73967 3.73967 -16.0628 14.9633 17.0968 31.0069 31.0069 31.0069 -16.0628 15.9633 16.0968 -3.78559 -3.78559 -3.78559 -16.0628 15.9633 17.0968 0.469293 0.469293 0.469293 -15.0628 16.9633 14.096800000000002 -1.24542 -1.24542 -1.24542 -15.0628 16.9633 15.096800000000002 -14.3822 -14.3822 -14.3822 -15.0628 17.9633 14.096800000000002 2.87574 2.87574 2.87574 -15.0628 17.9633 15.096800000000002 -10.7892 -10.7892 -10.7892 -16.0628 17.9633 14.096800000000002 1.35374 1.35374 1.35374 -16.0628 17.9633 15.096800000000002 -2.4001 -2.4001 -2.4001 -15.0628 16.9633 16.0968 -5.60295 -5.60295 -5.60295 -15.0628 16.9633 17.0968 2.49481 2.49481 2.49481 -15.0628 17.9633 16.0968 -2.76566 -2.76566 -2.76566 -15.0628 17.9633 17.0968 -25.2798 -25.2798 -25.2798 -16.0628 16.9633 16.0968 -2.60651 -2.60651 -2.60651 -16.0628 16.9633 17.0968 -3.58116 -3.58116 -3.58116 -16.0628 17.9633 16.0968 -3.36735 -3.36735 -3.36735 -16.0628 17.9633 17.0968 4.08006 4.08006 4.08006 -13.0628 14.9633 19.0968 5.6308 5.6308 5.6308 -13.0628 15.9633 19.0968 3.3292 3.3292 3.3292 -14.0628 14.9633 19.0968 4.85003 4.85003 4.85003 -13.0628 14.9633 20.0968 6.04941 6.04941 6.04941 -13.0628 14.9633 21.0968 7.10969 7.10969 7.10969 -13.0628 15.9633 20.0968 -2.01319 -2.01319 -2.01319 -13.0628 15.9633 21.0968 2.92736 2.92736 2.92736 -14.0628 14.9633 20.0968 2.50838 2.50838 2.50838 -14.0628 14.9633 21.0968 3.5128 3.5128 3.5128 -14.0628 15.9633 21.0968 0.990825 0.990825 0.990825 -13.0628 16.9633 19.0968 6.26682 6.26682 6.26682 -13.0628 17.9633 19.0968 7.16417 7.16417 7.16417 -14.0628 17.9633 19.0968 5.62301 5.62301 5.62301 -13.0628 16.9633 20.0968 -19.0644 -19.0644 -19.0644 -13.0628 16.9633 21.0968 -1.41907 -1.41907 -1.41907 -13.0628 17.9633 20.0968 96.6394 96.6394 96.6394 -14.0628 16.9633 20.0968 -54.2257 -54.2257 -54.2257 -14.0628 16.9633 21.0968 -58.5044 -58.5044 -58.5044 -14.0628 17.9633 20.0968 69.2784 69.2784 69.2784 -14.0628 17.9633 21.0968 -84.2424 -84.2424 -84.2424 -15.0628 14.9633 18.0968 -3.39092 -3.39092 -3.39092 -15.0628 14.9633 19.0968 -4.40618 -4.40618 -4.40618 -15.0628 15.9633 18.0968 -6.62342 -6.62342 -6.62342 -16.0628 14.9633 18.0968 -27.3828 -27.3828 -27.3828 -16.0628 14.9633 19.0968 -25.7985 -25.7985 -25.7985 -16.0628 15.9633 18.0968 -0.123958 -0.123958 -0.123958 -16.0628 15.9633 19.0968 -4.03401 -4.03401 -4.03401 -15.0628 14.9633 20.0968 -2.03339 -2.03339 -2.03339 -15.0628 14.9633 21.0968 5.51531 5.51531 5.51531 -15.0628 15.9633 21.0968 11.1427 11.1427 11.1427 -16.0628 14.9633 20.0968 -4.77207 -4.77207 -4.77207 -16.0628 14.9633 21.0968 2.5492 2.5492 2.5492 -16.0628 15.9633 20.0968 -8.41288 -8.41288 -8.41288 -16.0628 15.9633 21.0968 -4.77688 -4.77688 -4.77688 -15.0628 17.9633 18.0968 9.57222 9.57222 9.57222 -15.0628 17.9633 19.0968 4.0272 4.0272 4.0272 -16.0628 16.9633 18.0968 -4.24027 -4.24027 -4.24027 -16.0628 17.9633 18.0968 0.291111 0.291111 0.291111 -15.0628 16.9633 21.0968 3.49642 3.49642 3.49642 -15.0628 17.9633 20.0968 97.8829 97.8829 97.8829 -15.0628 17.9633 21.0968 -40.6714 -40.6714 -40.6714 -16.0628 16.9633 21.0968 -88.8031 -88.8031 -88.8031 -16.0628 17.9633 21.0968 4.77579 4.77579 4.77579 -12.0628 18.9633 10.096800000000002 -19.184 -19.184 -19.184 -12.0628 18.9633 11.096800000000002 -344.781 -344.781 -344.781 -12.0628 19.9633 10.096800000000002 -33.4859 -33.4859 -33.4859 -12.0628 19.9633 11.096800000000002 135.613 135.613 135.613 -12.0628 18.9633 12.096800000000002 -202.809 -202.809 -202.809 -12.0628 19.9633 12.096800000000002 207.938 207.938 207.938 -13.0628 18.9633 9.096800000000002 -72.5515 -72.5515 -72.5515 -13.0628 19.9633 9.096800000000002 98.654 98.654 98.654 -14.0628 18.9633 9.096800000000002 -0.945467 -0.945467 -0.945467 -14.0628 19.9633 9.096800000000002 -0.573511 -0.573511 -0.573511 -15.0628 18.9633 9.096800000000002 0.262422 0.262422 0.262422 -15.0628 19.9633 9.096800000000002 1.20159 1.20159 1.20159 -13.0628 18.9633 10.096800000000002 -91.8587 -91.8587 -91.8587 -13.0628 19.9633 10.096800000000002 119.539 119.539 119.539 -13.0628 19.9633 11.096800000000002 -96.7064 -96.7064 -96.7064 -14.0628 19.9633 10.096800000000002 -1.80777 -1.80777 -1.80777 -14.0628 19.9633 11.096800000000002 -2.59349 -2.59349 -2.59349 -13.0628 18.9633 12.096800000000002 42.6074 42.6074 42.6074 -13.0628 18.9633 13.096800000000002 53.9274 53.9274 53.9274 -13.0628 19.9633 12.096800000000002 -93.5324 -93.5324 -93.5324 -13.0628 19.9633 13.096800000000002 8.05544 8.05544 8.05544 -14.0628 18.9633 12.096800000000002 1.23306 1.23306 1.23306 -14.0628 18.9633 13.096800000000002 -20.9728 -20.9728 -20.9728 -14.0628 19.9633 12.096800000000002 10.3206 10.3206 10.3206 -14.0628 19.9633 13.096800000000002 7.06005 7.06005 7.06005 -13.0628 20.9633 11.096800000000002 -4.64509 -4.64509 -4.64509 -14.0628 20.9633 11.096800000000002 2.30331 2.30331 2.30331 -13.0628 20.9633 12.096800000000002 -97.9396 -97.9396 -97.9396 -14.0628 20.9633 12.096800000000002 1.79619 1.79619 1.79619 -15.0628 18.9633 10.096800000000002 2.31311 2.31311 2.31311 -15.0628 19.9633 10.096800000000002 1.18074 1.18074 1.18074 -15.0628 19.9633 11.096800000000002 -1.85998 -1.85998 -1.85998 -16.0628 18.9633 10.096800000000002 -1.16091 -1.16091 -1.16091 -16.0628 18.9633 11.096800000000002 -0.999091 -0.999091 -0.999091 -16.0628 19.9633 11.096800000000002 2.07077 2.07077 2.07077 -15.0628 18.9633 12.096800000000002 5.3688 5.3688 5.3688 -15.0628 18.9633 13.096800000000002 15.8057 15.8057 15.8057 -15.0628 19.9633 12.096800000000002 -3.7046 -3.7046 -3.7046 -15.0628 19.9633 13.096800000000002 8.31919 8.31919 8.31919 -16.0628 18.9633 12.096800000000002 -5.97146 -5.97146 -5.97146 -16.0628 18.9633 13.096800000000002 -5.48239 -5.48239 -5.48239 -16.0628 19.9633 12.096800000000002 -12.4688 -12.4688 -12.4688 -16.0628 19.9633 13.096800000000002 1.6042 1.6042 1.6042 -11.0628 18.9633 17.0968 24.4289 24.4289 24.4289 -12.0628 18.9633 16.0968 -6.39447 -6.39447 -6.39447 -12.0628 18.9633 17.0968 16.4399 16.4399 16.4399 -11.0628 18.9633 18.0968 -0.203147 -0.203147 -0.203147 -11.0628 18.9633 19.0968 -6.21511 -6.21511 -6.21511 -12.0628 18.9633 18.0968 -0.085553 -0.085553 -0.085553 -12.0628 18.9633 19.0968 -8.21054 -8.21054 -8.21054 -14.0628 18.9633 14.096800000000002 -17.1576 -17.1576 -17.1576 -13.0628 18.9633 16.0968 3.22113 3.22113 3.22113 -13.0628 18.9633 17.0968 -3.79323 -3.79323 -3.79323 -13.0628 19.9633 17.0968 -6.6544 -6.6544 -6.6544 -14.0628 18.9633 16.0968 -1.73337 -1.73337 -1.73337 -14.0628 18.9633 17.0968 0.708053 0.708053 0.708053 -14.0628 19.9633 17.0968 -0.346195 -0.346195 -0.346195 -15.0628 18.9633 14.096800000000002 15.0294 15.0294 15.0294 -16.0628 18.9633 14.096800000000002 4.69582 4.69582 4.69582 -16.0628 18.9633 15.096800000000002 -2.00288 -2.00288 -2.00288 -15.0628 18.9633 17.0968 7.65457 7.65457 7.65457 -16.0628 18.9633 16.0968 0.0583599 0.0583599 0.0583599 -16.0628 18.9633 17.0968 0.42884 0.42884 0.42884 -13.0628 18.9633 18.0968 -5.74925 -5.74925 -5.74925 -13.0628 18.9633 19.0968 2.60279 2.60279 2.60279 -13.0628 19.9633 18.0968 7.19853 7.19853 7.19853 -14.0628 18.9633 18.0968 -0.0555811 -0.0555811 -0.0555811 -14.0628 18.9633 19.0968 4.32589 4.32589 4.32589 -14.0628 19.9633 18.0968 0.300973 0.300973 0.300973 -15.0628 18.9633 18.0968 2.17673 2.17673 2.17673 -15.0628 18.9633 19.0968 -0.16074 -0.16074 -0.16074 -16.0628 18.9633 18.0968 2.18847 2.18847 2.18847 -16.0628 18.9633 19.0968 -8.04193 -8.04193 -8.04193 -16.0628 19.9633 18.0968 6.26296 6.26296 6.26296 -16.0628 19.9633 19.0968 -4.49046 -4.49046 -4.49046 -15.0628 18.9633 20.0968 -63.8728 -63.8728 -63.8728 -15.0628 18.9633 21.0968 166.801 166.801 166.801 -16.0628 18.9633 20.0968 -8.88886 -8.88886 -8.88886 -16.0628 18.9633 21.0968 28.8964 28.8964 28.8964 -16.0628 19.9633 20.0968 -16.5371 -16.5371 -16.5371 -16.0628 19.9633 21.0968 -13.4941 -13.4941 -13.4941 -16.0628 20.9633 19.0968 3.12779 3.12779 3.12779 -16.0628 20.9633 20.0968 7.4372 7.4372 7.4372 -17.0628 10.9633 9.096800000000002 3.07454 3.07454 3.07454 -18.0628 10.9633 8.096800000000002 -1.97909 -1.97909 -1.97909 -18.0628 10.9633 9.096800000000002 0.862013 0.862013 0.862013 -18.0628 11.9633 9.096800000000002 2.51965 2.51965 2.51965 -18.0628 13.9633 7.096800000000002 0.258212 0.258212 0.258212 -17.0628 13.9633 8.096800000000002 -7.83646 -7.83646 -7.83646 -17.0628 13.9633 9.096800000000002 -3.18777 -3.18777 -3.18777 -18.0628 12.9633 8.096800000000002 0.181068 0.181068 0.181068 -18.0628 12.9633 9.096800000000002 0.144171 0.144171 0.144171 -18.0628 13.9633 8.096800000000002 3.05194 3.05194 3.05194 -18.0628 13.9633 9.096800000000002 6.67789 6.67789 6.67789 -19.0628 10.9633 8.096800000000002 23.635 23.635 23.635 -19.0628 10.9633 9.096800000000002 1.55742 1.55742 1.55742 -19.0628 11.9633 9.096800000000002 -0.840001 -0.840001 -0.840001 -20.0628 10.9633 9.096800000000002 9.57673 9.57673 9.57673 -20.0628 11.9633 8.096800000000002 -1.15014 -1.15014 -1.15014 -20.0628 11.9633 9.096800000000002 3.97713 3.97713 3.97713 -19.0628 13.9633 7.096800000000002 1.19302 1.19302 1.19302 -20.0628 13.9633 7.096800000000002 -1.4643 -1.4643 -1.4643 -19.0628 12.9633 8.096800000000002 2.01969 2.01969 2.01969 -19.0628 12.9633 9.096800000000002 -5.71087 -5.71087 -5.71087 -19.0628 13.9633 8.096800000000002 0.59493 0.59493 0.59493 -20.0628 12.9633 8.096800000000002 -4.4892 -4.4892 -4.4892 -20.0628 12.9633 9.096800000000002 -3.40597 -3.40597 -3.40597 -20.0628 13.9633 8.096800000000002 -1.27737 -1.27737 -1.27737 -20.0628 13.9633 9.096800000000002 5.66953 5.66953 5.66953 -17.0628 10.9633 10.096800000000002 -0.457593 -0.457593 -0.457593 -17.0628 10.9633 11.096800000000002 1.55907 1.55907 1.55907 -18.0628 10.9633 10.096800000000002 0.010082 0.010082 0.010082 -18.0628 10.9633 11.096800000000002 2.29149 2.29149 2.29149 -18.0628 11.9633 10.096800000000002 -2.0499 -2.0499 -2.0499 -17.0628 10.9633 12.096800000000002 -0.277086 -0.277086 -0.277086 -17.0628 10.9633 13.096800000000002 2.40797 2.40797 2.40797 -17.0628 11.9633 12.096800000000002 -1.29243 -1.29243 -1.29243 -18.0628 10.9633 12.096800000000002 -0.16445 -0.16445 -0.16445 -18.0628 10.9633 13.096800000000002 -0.652363 -0.652363 -0.652363 -18.0628 11.9633 12.096800000000002 -4.84405 -4.84405 -4.84405 -17.0628 13.9633 10.096800000000002 11.6152 11.6152 11.6152 -18.0628 12.9633 10.096800000000002 8.25642 8.25642 8.25642 -18.0628 12.9633 11.096800000000002 2.35631 2.35631 2.35631 -18.0628 13.9633 10.096800000000002 9.47958 9.47958 9.47958 -18.0628 13.9633 11.096800000000002 -0.317011 -0.317011 -0.317011 -17.0628 12.9633 12.096800000000002 -6.8518 -6.8518 -6.8518 -17.0628 13.9633 12.096800000000002 -5.13738 -5.13738 -5.13738 -17.0628 13.9633 13.096800000000002 -3.48021 -3.48021 -3.48021 -18.0628 12.9633 12.096800000000002 2.37285 2.37285 2.37285 -18.0628 12.9633 13.096800000000002 4.72532 4.72532 4.72532 -18.0628 13.9633 12.096800000000002 0.633714 0.633714 0.633714 -18.0628 13.9633 13.096800000000002 6.64591 6.64591 6.64591 -19.0628 10.9633 10.096800000000002 5.03071 5.03071 5.03071 -19.0628 10.9633 11.096800000000002 0.187095 0.187095 0.187095 -19.0628 11.9633 10.096800000000002 -0.498476 -0.498476 -0.498476 -19.0628 11.9633 11.096800000000002 3.51493 3.51493 3.51493 -20.0628 10.9633 10.096800000000002 8.69812 8.69812 8.69812 -20.0628 10.9633 11.096800000000002 -1.34864 -1.34864 -1.34864 -20.0628 11.9633 10.096800000000002 -4.23072 -4.23072 -4.23072 -20.0628 11.9633 11.096800000000002 -1.48172 -1.48172 -1.48172 -19.0628 10.9633 12.096800000000002 0.791204 0.791204 0.791204 -19.0628 10.9633 13.096800000000002 -1.23604 -1.23604 -1.23604 -19.0628 11.9633 12.096800000000002 1.82528 1.82528 1.82528 -19.0628 11.9633 13.096800000000002 0.513659 0.513659 0.513659 -20.0628 10.9633 13.096800000000002 0.453664 0.453664 0.453664 -20.0628 11.9633 12.096800000000002 -0.64296 -0.64296 -0.64296 -20.0628 11.9633 13.096800000000002 -1.22676 -1.22676 -1.22676 -19.0628 12.9633 10.096800000000002 0.894651 0.894651 0.894651 -19.0628 12.9633 11.096800000000002 2.59813 2.59813 2.59813 -19.0628 13.9633 11.096800000000002 -0.69794 -0.69794 -0.69794 -19.0628 12.9633 12.096800000000002 -1.69018 -1.69018 -1.69018 -19.0628 12.9633 13.096800000000002 -0.219389 -0.219389 -0.219389 -19.0628 13.9633 12.096800000000002 0.475333 0.475333 0.475333 -19.0628 13.9633 13.096800000000002 0.292247 0.292247 0.292247 -20.0628 12.9633 12.096800000000002 2.10593 2.10593 2.10593 -20.0628 12.9633 13.096800000000002 1.89191 1.89191 1.89191 -20.0628 13.9633 12.096800000000002 0.0892329 0.0892329 0.0892329 -20.0628 13.9633 13.096800000000002 -6.27038 -6.27038 -6.27038 -18.0628 14.9633 7.096800000000002 3.26793 3.26793 3.26793 -18.0628 15.9633 7.096800000000002 -1.21532 -1.21532 -1.21532 -17.0628 14.9633 8.096800000000002 -7.26484 -7.26484 -7.26484 -17.0628 14.9633 9.096800000000002 -8.49508 -8.49508 -8.49508 -17.0628 15.9633 8.096800000000002 0.634999 0.634999 0.634999 -17.0628 15.9633 9.096800000000002 2.15494 2.15494 2.15494 -18.0628 14.9633 8.096800000000002 1.67382 1.67382 1.67382 -18.0628 15.9633 8.096800000000002 9.3012 9.3012 9.3012 -18.0628 15.9633 9.096800000000002 12.9755 12.9755 12.9755 -19.0628 14.9633 7.096800000000002 1.17744 1.17744 1.17744 -19.0628 15.9633 7.096800000000002 -4.57044 -4.57044 -4.57044 -20.0628 14.9633 7.096800000000002 -2.29721 -2.29721 -2.29721 -20.0628 15.9633 7.096800000000002 -1.25842 -1.25842 -1.25842 -19.0628 15.9633 8.096800000000002 -1.8899 -1.8899 -1.8899 -19.0628 15.9633 9.096800000000002 -7.19589 -7.19589 -7.19589 -20.0628 14.9633 8.096800000000002 -2.70494 -2.70494 -2.70494 -20.0628 14.9633 9.096800000000002 -1.65975 -1.65975 -1.65975 -20.0628 15.9633 8.096800000000002 3.47411 3.47411 3.47411 -19.0628 16.9633 8.096800000000002 7.5371 7.5371 7.5371 -19.0628 16.9633 9.096800000000002 0.196193 0.196193 0.196193 -19.0628 17.9633 8.096800000000002 -0.37784 -0.37784 -0.37784 -19.0628 17.9633 9.096800000000002 1.37928 1.37928 1.37928 -20.0628 16.9633 8.096800000000002 1.60439 1.60439 1.60439 -20.0628 17.9633 8.096800000000002 6.57087 6.57087 6.57087 -20.0628 17.9633 9.096800000000002 8.29692 8.29692 8.29692 -17.0628 14.9633 10.096800000000002 -4.34007 -4.34007 -4.34007 -18.0628 14.9633 10.096800000000002 -24.7361 -24.7361 -24.7361 -18.0628 14.9633 11.096800000000002 -2.0067 -2.0067 -2.0067 -18.0628 15.9633 10.096800000000002 0.932924 0.932924 0.932924 -18.0628 15.9633 11.096800000000002 -18.1657 -18.1657 -18.1657 -17.0628 14.9633 12.096800000000002 0.726042 0.726042 0.726042 -17.0628 14.9633 13.096800000000002 2.76593 2.76593 2.76593 -17.0628 15.9633 12.096800000000002 2.57003 2.57003 2.57003 -17.0628 15.9633 13.096800000000002 -9.66615 -9.66615 -9.66615 -18.0628 14.9633 12.096800000000002 -2.49365 -2.49365 -2.49365 -18.0628 14.9633 13.096800000000002 -2.3379 -2.3379 -2.3379 -18.0628 15.9633 12.096800000000002 -6.7015 -6.7015 -6.7015 -18.0628 15.9633 13.096800000000002 -29.3887 -29.3887 -29.3887 -17.0628 16.9633 11.096800000000002 10.5656 10.5656 10.5656 -17.0628 17.9633 11.096800000000002 40.0423 40.0423 40.0423 -18.0628 16.9633 10.096800000000002 -30.799 -30.799 -30.799 -18.0628 16.9633 11.096800000000002 -53.9447 -53.9447 -53.9447 -17.0628 16.9633 12.096800000000002 -18.717 -18.717 -18.717 -17.0628 17.9633 12.096800000000002 -15.4698 -15.4698 -15.4698 -17.0628 17.9633 13.096800000000002 -27.1583 -27.1583 -27.1583 -18.0628 16.9633 12.096800000000002 66.6512 66.6512 66.6512 -18.0628 16.9633 13.096800000000002 -6.84432 -6.84432 -6.84432 -18.0628 17.9633 12.096800000000002 -49.0303 -49.0303 -49.0303 -18.0628 17.9633 13.096800000000002 18.2187 18.2187 18.2187 -19.0628 15.9633 11.096800000000002 2.67489 2.67489 2.67489 -19.0628 14.9633 12.096800000000002 -1.22782 -1.22782 -1.22782 -19.0628 15.9633 12.096800000000002 0.743272 0.743272 0.743272 -19.0628 15.9633 13.096800000000002 3.03083 3.03083 3.03083 -20.0628 14.9633 12.096800000000002 -2.98499 -2.98499 -2.98499 -20.0628 14.9633 13.096800000000002 1.93031 1.93031 1.93031 -20.0628 15.9633 12.096800000000002 0.439528 0.439528 0.439528 -20.0628 15.9633 13.096800000000002 -2.44634 -2.44634 -2.44634 -19.0628 16.9633 10.096800000000002 41.906 41.906 41.906 -19.0628 16.9633 11.096800000000002 11.448 11.448 11.448 -19.0628 17.9633 10.096800000000002 48.4635 48.4635 48.4635 -19.0628 17.9633 11.096800000000002 -1.57933 -1.57933 -1.57933 -20.0628 16.9633 11.096800000000002 -1.13036 -1.13036 -1.13036 -20.0628 17.9633 10.096800000000002 1.52977 1.52977 1.52977 -20.0628 17.9633 11.096800000000002 -0.093727 -0.093727 -0.093727 -19.0628 16.9633 12.096800000000002 -35.8868 -35.8868 -35.8868 -19.0628 16.9633 13.096800000000002 1.0723 1.0723 1.0723 -20.0628 16.9633 12.096800000000002 -2.21544 -2.21544 -2.21544 -20.0628 16.9633 13.096800000000002 76.1949 76.1949 76.1949 -21.0628 10.9633 9.096800000000002 -33.2081 -33.2081 -33.2081 -21.0628 11.9633 8.096800000000002 -0.456268 -0.456268 -0.456268 -21.0628 11.9633 9.096800000000002 0.197291 0.197291 0.197291 -22.0628 10.9633 8.096800000000002 8.88719 8.88719 8.88719 -22.0628 10.9633 9.096800000000002 -15.8556 -15.8556 -15.8556 -22.0628 11.9633 8.096800000000002 0.569569 0.569569 0.569569 -22.0628 11.9633 9.096800000000002 0.0346186 0.0346186 0.0346186 -21.0628 12.9633 8.096800000000002 21.9216 21.9216 21.9216 -21.0628 13.9633 8.096800000000002 46.4728 46.4728 46.4728 -21.0628 13.9633 9.096800000000002 3.89172 3.89172 3.89172 -22.0628 12.9633 8.096800000000002 33.5549 33.5549 33.5549 -22.0628 12.9633 9.096800000000002 -6.06456 -6.06456 -6.06456 -22.0628 13.9633 8.096800000000002 3.58303 3.58303 3.58303 -22.0628 13.9633 9.096800000000002 -34.9777 -34.9777 -34.9777 -23.0628 10.9633 8.096800000000002 -22.1774 -22.1774 -22.1774 -23.0628 11.9633 8.096800000000002 -9.10455 -9.10455 -9.10455 -23.0628 11.9633 9.096800000000002 14.4603 14.4603 14.4603 -24.0628 10.9633 8.096800000000002 -18.3011 -18.3011 -18.3011 -24.0628 11.9633 8.096800000000002 9.5135 9.5135 9.5135 -24.0628 11.9633 9.096800000000002 25.2408 25.2408 25.2408 -23.0628 12.9633 9.096800000000002 -62.01 -62.01 -62.01 -23.0628 13.9633 9.096800000000002 -22.866 -22.866 -22.866 -24.0628 12.9633 9.096800000000002 -19.0042 -19.0042 -19.0042 -24.0628 13.9633 9.096800000000002 13.9749 13.9749 13.9749 -21.0628 10.9633 10.096800000000002 -6.58104 -6.58104 -6.58104 -21.0628 10.9633 11.096800000000002 2.60632 2.60632 2.60632 -21.0628 11.9633 10.096800000000002 -0.129074 -0.129074 -0.129074 -21.0628 11.9633 11.096800000000002 -2.11633 -2.11633 -2.11633 -22.0628 10.9633 10.096800000000002 -12.9531 -12.9531 -12.9531 -22.0628 10.9633 11.096800000000002 3.6212 3.6212 3.6212 -22.0628 11.9633 10.096800000000002 -2.57485 -2.57485 -2.57485 -22.0628 11.9633 11.096800000000002 -0.0850232 -0.0850232 -0.0850232 -21.0628 10.9633 12.096800000000002 -1.88873 -1.88873 -1.88873 -21.0628 10.9633 13.096800000000002 1.09159 1.09159 1.09159 -21.0628 11.9633 12.096800000000002 -3.05828 -3.05828 -3.05828 -21.0628 11.9633 13.096800000000002 3.03073 3.03073 3.03073 -22.0628 10.9633 12.096800000000002 -2.48265 -2.48265 -2.48265 -22.0628 11.9633 12.096800000000002 6.12474 6.12474 6.12474 -22.0628 11.9633 13.096800000000002 1.76671 1.76671 1.76671 -21.0628 12.9633 11.096800000000002 -9.26769 -9.26769 -9.26769 -21.0628 13.9633 11.096800000000002 -14.5103 -14.5103 -14.5103 -22.0628 12.9633 10.096800000000002 9.08195 9.08195 9.08195 -22.0628 12.9633 11.096800000000002 18.8055 18.8055 18.8055 -22.0628 13.9633 10.096800000000002 -6.09602 -6.09602 -6.09602 -22.0628 13.9633 11.096800000000002 19.7113 19.7113 19.7113 -21.0628 12.9633 12.096800000000002 4.4481 4.4481 4.4481 -21.0628 12.9633 13.096800000000002 1.02522 1.02522 1.02522 -21.0628 13.9633 12.096800000000002 18.5951 18.5951 18.5951 -21.0628 13.9633 13.096800000000002 -10.1206 -10.1206 -10.1206 -22.0628 12.9633 12.096800000000002 -8.38795 -8.38795 -8.38795 -22.0628 13.9633 12.096800000000002 30.8233 30.8233 30.8233 -22.0628 13.9633 13.096800000000002 8.31302 8.31302 8.31302 -23.0628 10.9633 11.096800000000002 -2.40923 -2.40923 -2.40923 -23.0628 11.9633 10.096800000000002 1.28016 1.28016 1.28016 -23.0628 11.9633 11.096800000000002 -1.03697 -1.03697 -1.03697 -24.0628 10.9633 11.096800000000002 -1.20907 -1.20907 -1.20907 -24.0628 11.9633 11.096800000000002 -0.17179 -0.17179 -0.17179 -23.0628 10.9633 12.096800000000002 -5.78247 -5.78247 -5.78247 -23.0628 10.9633 13.096800000000002 -3.63719 -3.63719 -3.63719 -23.0628 11.9633 12.096800000000002 -6.81985 -6.81985 -6.81985 -23.0628 11.9633 13.096800000000002 0.53464 0.53464 0.53464 -24.0628 10.9633 12.096800000000002 -0.80318 -0.80318 -0.80318 -24.0628 10.9633 13.096800000000002 -5.83548 -5.83548 -5.83548 -24.0628 11.9633 12.096800000000002 3.678 3.678 3.678 -24.0628 11.9633 13.096800000000002 -0.841955 -0.841955 -0.841955 -23.0628 12.9633 10.096800000000002 -14.3703 -14.3703 -14.3703 -23.0628 12.9633 11.096800000000002 31.6883 31.6883 31.6883 -23.0628 13.9633 10.096800000000002 -7.29158 -7.29158 -7.29158 -23.0628 13.9633 11.096800000000002 11.2103 11.2103 11.2103 -24.0628 12.9633 10.096800000000002 0.67561 0.67561 0.67561 -24.0628 12.9633 11.096800000000002 13.3126 13.3126 13.3126 -24.0628 13.9633 10.096800000000002 0.0626176 0.0626176 0.0626176 -24.0628 13.9633 11.096800000000002 4.35255 4.35255 4.35255 -23.0628 12.9633 12.096800000000002 13.9837 13.9837 13.9837 -23.0628 12.9633 13.096800000000002 23.0809 23.0809 23.0809 -23.0628 13.9633 12.096800000000002 3.46929 3.46929 3.46929 -23.0628 13.9633 13.096800000000002 10.5546 10.5546 10.5546 -24.0628 12.9633 12.096800000000002 14.6375 14.6375 14.6375 -24.0628 13.9633 12.096800000000002 7.88725 7.88725 7.88725 -24.0628 13.9633 13.096800000000002 8.71762 8.71762 8.71762 -21.0628 14.9633 8.096800000000002 1.56403 1.56403 1.56403 -21.0628 14.9633 9.096800000000002 5.63272 5.63272 5.63272 -21.0628 15.9633 8.096800000000002 2.23105 2.23105 2.23105 -21.0628 15.9633 9.096800000000002 -2.17403 -2.17403 -2.17403 -22.0628 14.9633 9.096800000000002 -13.9002 -13.9002 -13.9002 -22.0628 15.9633 8.096800000000002 0.800337 0.800337 0.800337 -22.0628 15.9633 9.096800000000002 -0.271017 -0.271017 -0.271017 -21.0628 16.9633 8.096800000000002 -2.37224 -2.37224 -2.37224 -21.0628 17.9633 8.096800000000002 5.341 5.341 5.341 -21.0628 17.9633 9.096800000000002 5.68164 5.68164 5.68164 -22.0628 16.9633 8.096800000000002 11.3192 11.3192 11.3192 -22.0628 16.9633 9.096800000000002 -0.47398 -0.47398 -0.47398 -22.0628 17.9633 9.096800000000002 3.49566 3.49566 3.49566 -23.0628 14.9633 9.096800000000002 18.4731 18.4731 18.4731 -24.0628 14.9633 9.096800000000002 -0.93623 -0.93623 -0.93623 -21.0628 14.9633 10.096800000000002 -15.5882 -15.5882 -15.5882 -21.0628 14.9633 11.096800000000002 -17.8158 -17.8158 -17.8158 -21.0628 15.9633 10.096800000000002 -2.37959 -2.37959 -2.37959 -21.0628 15.9633 11.096800000000002 -0.867226 -0.867226 -0.867226 -22.0628 14.9633 10.096800000000002 -19.3383 -19.3383 -19.3383 -22.0628 14.9633 11.096800000000002 -13.3503 -13.3503 -13.3503 -22.0628 15.9633 10.096800000000002 0.554119 0.554119 0.554119 -22.0628 15.9633 11.096800000000002 -0.56467 -0.56467 -0.56467 -21.0628 14.9633 12.096800000000002 -12.3262 -12.3262 -12.3262 -21.0628 14.9633 13.096800000000002 5.50542 5.50542 5.50542 -21.0628 15.9633 12.096800000000002 -1.3491 -1.3491 -1.3491 -22.0628 14.9633 12.096800000000002 1.72792 1.72792 1.72792 -22.0628 14.9633 13.096800000000002 -0.474047 -0.474047 -0.474047 -22.0628 15.9633 12.096800000000002 -0.0391266 -0.0391266 -0.0391266 -22.0628 15.9633 13.096800000000002 -0.089203 -0.089203 -0.089203 -21.0628 16.9633 10.096800000000002 -10.1557 -10.1557 -10.1557 -21.0628 16.9633 11.096800000000002 2.95734 2.95734 2.95734 -21.0628 17.9633 10.096800000000002 -4.3742 -4.3742 -4.3742 -21.0628 17.9633 11.096800000000002 -3.41308 -3.41308 -3.41308 -22.0628 16.9633 10.096800000000002 -11.0138 -11.0138 -11.0138 -22.0628 16.9633 11.096800000000002 3.9864 3.9864 3.9864 -22.0628 17.9633 10.096800000000002 -2.02187 -2.02187 -2.02187 -22.0628 17.9633 11.096800000000002 -0.628097 -0.628097 -0.628097 -21.0628 16.9633 12.096800000000002 22.6796 22.6796 22.6796 -21.0628 16.9633 13.096800000000002 27.5039 27.5039 27.5039 -21.0628 17.9633 12.096800000000002 -41.1305 -41.1305 -41.1305 -21.0628 17.9633 13.096800000000002 -29.2806 -29.2806 -29.2806 -22.0628 16.9633 12.096800000000002 -38.8302 -38.8302 -38.8302 -22.0628 16.9633 13.096800000000002 -6.96248 -6.96248 -6.96248 -22.0628 17.9633 12.096800000000002 -92.2476 -92.2476 -92.2476 -22.0628 17.9633 13.096800000000002 -38.0682 -38.0682 -38.0682 -23.0628 14.9633 10.096800000000002 18.994 18.994 18.994 -23.0628 15.9633 10.096800000000002 -0.74328 -0.74328 -0.74328 -23.0628 15.9633 11.096800000000002 0.211955 0.211955 0.211955 -24.0628 14.9633 10.096800000000002 -1.09013 -1.09013 -1.09013 -24.0628 15.9633 10.096800000000002 -2.50462 -2.50462 -2.50462 -24.0628 15.9633 11.096800000000002 6.26316 6.26316 6.26316 -23.0628 14.9633 12.096800000000002 -10.1626 -10.1626 -10.1626 -23.0628 14.9633 13.096800000000002 -3.39712 -3.39712 -3.39712 -23.0628 15.9633 12.096800000000002 3.28628 3.28628 3.28628 -23.0628 15.9633 13.096800000000002 -3.82649 -3.82649 -3.82649 -24.0628 14.9633 12.096800000000002 -26.0031 -26.0031 -26.0031 -24.0628 14.9633 13.096800000000002 -21.0568 -21.0568 -21.0568 -24.0628 15.9633 12.096800000000002 9.01024 9.01024 9.01024 -24.0628 15.9633 13.096800000000002 -37.169 -37.169 -37.169 -23.0628 16.9633 11.096800000000002 -2.04162 -2.04162 -2.04162 -23.0628 17.9633 11.096800000000002 0.293817 0.293817 0.293817 -24.0628 16.9633 11.096800000000002 6.04293 6.04293 6.04293 -24.0628 17.9633 11.096800000000002 -0.425563 -0.425563 -0.425563 -23.0628 16.9633 12.096800000000002 -0.399116 -0.399116 -0.399116 -24.0628 16.9633 12.096800000000002 -11.9873 -11.9873 -11.9873 -24.0628 16.9633 13.096800000000002 44.9114 44.9114 44.9114 -24.0628 17.9633 12.096800000000002 -7.93502 -7.93502 -7.93502 -17.0628 11.9633 15.096800000000002 -6.30898 -6.30898 -6.30898 -18.0628 11.9633 15.096800000000002 -0.301406 -0.301406 -0.301406 -17.0628 10.9633 17.0968 3.75887 3.75887 3.75887 -17.0628 11.9633 16.0968 -20.9992 -20.9992 -20.9992 -17.0628 11.9633 17.0968 -1.83581 -1.83581 -1.83581 -18.0628 10.9633 17.0968 2.46052 2.46052 2.46052 -18.0628 11.9633 16.0968 1.61426 1.61426 1.61426 -18.0628 11.9633 17.0968 0.345856 0.345856 0.345856 -17.0628 12.9633 15.096800000000002 -2.60279 -2.60279 -2.60279 -18.0628 12.9633 14.096800000000002 -0.950038 -0.950038 -0.950038 -18.0628 12.9633 15.096800000000002 0.235377 0.235377 0.235377 -18.0628 13.9633 14.096800000000002 -0.937757 -0.937757 -0.937757 -18.0628 13.9633 15.096800000000002 2.43369 2.43369 2.43369 -17.0628 12.9633 16.0968 6.79024 6.79024 6.79024 -17.0628 12.9633 17.0968 4.60991 4.60991 4.60991 -17.0628 13.9633 16.0968 1.55583 1.55583 1.55583 -17.0628 13.9633 17.0968 -60.2268 -60.2268 -60.2268 -18.0628 12.9633 16.0968 2.5667 2.5667 2.5667 -18.0628 12.9633 17.0968 -20.9474 -20.9474 -20.9474 -18.0628 13.9633 16.0968 -8.12759 -8.12759 -8.12759 -18.0628 13.9633 17.0968 -64.0951 -64.0951 -64.0951 -19.0628 10.9633 14.096800000000002 -2.3645 -2.3645 -2.3645 -19.0628 10.9633 15.096800000000002 0.536085 0.536085 0.536085 -19.0628 11.9633 14.096800000000002 -1.52302 -1.52302 -1.52302 -19.0628 11.9633 15.096800000000002 0.0547251 0.0547251 0.0547251 -20.0628 10.9633 14.096800000000002 -0.795424 -0.795424 -0.795424 -20.0628 10.9633 15.096800000000002 0.539773 0.539773 0.539773 -20.0628 11.9633 14.096800000000002 -2.95558 -2.95558 -2.95558 -20.0628 11.9633 15.096800000000002 -0.222684 -0.222684 -0.222684 -19.0628 10.9633 16.0968 1.53535 1.53535 1.53535 -19.0628 10.9633 17.0968 -3.21712 -3.21712 -3.21712 -19.0628 11.9633 16.0968 -2.46438 -2.46438 -2.46438 -19.0628 11.9633 17.0968 0.361585 0.361585 0.361585 -20.0628 10.9633 16.0968 12.4105 12.4105 12.4105 -20.0628 10.9633 17.0968 6.98717 6.98717 6.98717 -20.0628 11.9633 16.0968 8.73477 8.73477 8.73477 -20.0628 11.9633 17.0968 -0.196648 -0.196648 -0.196648 -19.0628 12.9633 14.096800000000002 7.27041 7.27041 7.27041 -19.0628 12.9633 15.096800000000002 -1.38495 -1.38495 -1.38495 -19.0628 13.9633 14.096800000000002 2.79721 2.79721 2.79721 -19.0628 13.9633 15.096800000000002 6.64156 6.64156 6.64156 -20.0628 12.9633 14.096800000000002 2.79784 2.79784 2.79784 -20.0628 12.9633 15.096800000000002 3.07341 3.07341 3.07341 -20.0628 13.9633 14.096800000000002 -2.50488 -2.50488 -2.50488 -20.0628 13.9633 15.096800000000002 3.44365 3.44365 3.44365 -19.0628 12.9633 17.0968 1.90364 1.90364 1.90364 -19.0628 13.9633 16.0968 5.64239 5.64239 5.64239 -19.0628 13.9633 17.0968 -6.57082 -6.57082 -6.57082 -20.0628 12.9633 16.0968 5.30317 5.30317 5.30317 -20.0628 12.9633 17.0968 7.46092 7.46092 7.46092 -20.0628 13.9633 16.0968 -0.776157 -0.776157 -0.776157 -20.0628 13.9633 17.0968 -2.14 -2.14 -2.14 -17.0628 10.9633 18.0968 -0.406042 -0.406042 -0.406042 -17.0628 10.9633 19.0968 -7.16023 -7.16023 -7.16023 -17.0628 11.9633 18.0968 -8.75359 -8.75359 -8.75359 -17.0628 11.9633 19.0968 3.19911 3.19911 3.19911 -18.0628 10.9633 18.0968 1.96908 1.96908 1.96908 -18.0628 11.9633 18.0968 -0.978208 -0.978208 -0.978208 -18.0628 11.9633 19.0968 -0.247967 -0.247967 -0.247967 -17.0628 10.9633 20.0968 33.2754 33.2754 33.2754 -17.0628 10.9633 21.0968 75.0796 75.0796 75.0796 -17.0628 11.9633 20.0968 36.2283 36.2283 36.2283 -17.0628 11.9633 21.0968 13.1456 13.1456 13.1456 -18.0628 10.9633 21.0968 71.4143 71.4143 71.4143 -18.0628 11.9633 20.0968 147.197 147.197 147.197 -18.0628 11.9633 21.0968 3.06897 3.06897 3.06897 -17.0628 13.9633 18.0968 -57.5393 -57.5393 -57.5393 -17.0628 13.9633 19.0968 28.4597 28.4597 28.4597 -18.0628 12.9633 18.0968 4.51652 4.51652 4.51652 -18.0628 12.9633 19.0968 43.2085 43.2085 43.2085 -18.0628 13.9633 18.0968 -8.24549 -8.24549 -8.24549 -18.0628 13.9633 19.0968 55.3366 55.3366 55.3366 -17.0628 12.9633 20.0968 69.0394 69.0394 69.0394 -17.0628 12.9633 21.0968 -36.4326 -36.4326 -36.4326 -17.0628 13.9633 20.0968 7.76027 7.76027 7.76027 -17.0628 13.9633 21.0968 -6.30449 -6.30449 -6.30449 -18.0628 12.9633 20.0968 5.53405 5.53405 5.53405 -18.0628 12.9633 21.0968 -20.716 -20.716 -20.716 -18.0628 13.9633 20.0968 -1.48807 -1.48807 -1.48807 -18.0628 13.9633 21.0968 7.36569 7.36569 7.36569 -19.0628 10.9633 18.0968 -9.00027 -9.00027 -9.00027 -19.0628 11.9633 18.0968 -9.05899 -9.05899 -9.05899 -20.0628 10.9633 18.0968 -4.1679 -4.1679 -4.1679 -20.0628 10.9633 19.0968 -4.3754 -4.3754 -4.3754 -20.0628 11.9633 18.0968 -2.03209 -2.03209 -2.03209 -20.0628 11.9633 19.0968 0.0705478 0.0705478 0.0705478 -19.0628 10.9633 21.0968 7.31249 7.31249 7.31249 -19.0628 11.9633 21.0968 8.33773 8.33773 8.33773 -20.0628 10.9633 21.0968 -4.60762 -4.60762 -4.60762 -19.0628 12.9633 18.0968 -3.37232 -3.37232 -3.37232 -19.0628 12.9633 19.0968 -2.6323 -2.6323 -2.6323 -19.0628 13.9633 19.0968 -4.50109 -4.50109 -4.50109 -20.0628 12.9633 18.0968 -5.65179 -5.65179 -5.65179 -20.0628 12.9633 19.0968 -1.22137 -1.22137 -1.22137 -20.0628 13.9633 18.0968 -3.99273 -3.99273 -3.99273 -20.0628 13.9633 19.0968 -0.588223 -0.588223 -0.588223 -19.0628 12.9633 20.0968 0.726796 0.726796 0.726796 -19.0628 12.9633 21.0968 -0.627444 -0.627444 -0.627444 -19.0628 13.9633 20.0968 3.66624 3.66624 3.66624 -19.0628 13.9633 21.0968 -5.92282 -5.92282 -5.92282 -20.0628 12.9633 20.0968 -0.414294 -0.414294 -0.414294 -20.0628 12.9633 21.0968 2.23418 2.23418 2.23418 -20.0628 13.9633 20.0968 -3.63685 -3.63685 -3.63685 -20.0628 13.9633 21.0968 4.83924 4.83924 4.83924 -17.0628 14.9633 16.0968 -0.0495437 -0.0495437 -0.0495437 -17.0628 14.9633 17.0968 -13.3919 -13.3919 -13.3919 -17.0628 15.9633 16.0968 -0.415964 -0.415964 -0.415964 -17.0628 15.9633 17.0968 3.94556 3.94556 3.94556 -18.0628 14.9633 16.0968 5.59698 5.59698 5.59698 -18.0628 14.9633 17.0968 -23.597 -23.597 -23.597 -18.0628 15.9633 17.0968 5.20599 5.20599 5.20599 -17.0628 17.9633 14.096800000000002 1.60826 1.60826 1.60826 -17.0628 17.9633 15.096800000000002 1.51306 1.51306 1.51306 -18.0628 16.9633 14.096800000000002 -3.05673 -3.05673 -3.05673 -18.0628 17.9633 14.096800000000002 0.917998 0.917998 0.917998 -18.0628 17.9633 15.096800000000002 -1.84162 -1.84162 -1.84162 -17.0628 16.9633 16.0968 2.34428 2.34428 2.34428 -17.0628 16.9633 17.0968 0.847108 0.847108 0.847108 -17.0628 17.9633 16.0968 -0.0247799 -0.0247799 -0.0247799 -18.0628 16.9633 17.0968 -4.63267 -4.63267 -4.63267 -19.0628 14.9633 15.096800000000002 3.45345 3.45345 3.45345 -19.0628 15.9633 15.096800000000002 1.66923 1.66923 1.66923 -20.0628 14.9633 14.096800000000002 -0.60826 -0.60826 -0.60826 -20.0628 14.9633 15.096800000000002 1.22467 1.22467 1.22467 -20.0628 15.9633 14.096800000000002 1.2405 1.2405 1.2405 -20.0628 15.9633 15.096800000000002 0.815847 0.815847 0.815847 -19.0628 14.9633 16.0968 13.6239 13.6239 13.6239 -19.0628 15.9633 16.0968 -3.43868 -3.43868 -3.43868 -19.0628 15.9633 17.0968 16.3585 16.3585 16.3585 -20.0628 14.9633 16.0968 0.294046 0.294046 0.294046 -20.0628 15.9633 16.0968 4.56169 4.56169 4.56169 -20.0628 15.9633 17.0968 17.0251 17.0251 17.0251 -19.0628 16.9633 14.096800000000002 3.3122 3.3122 3.3122 -19.0628 17.9633 14.096800000000002 13.5278 13.5278 13.5278 -19.0628 17.9633 15.096800000000002 2.57952 2.57952 2.57952 -20.0628 16.9633 14.096800000000002 16.4572 16.4572 16.4572 -20.0628 16.9633 15.096800000000002 -8.41122 -8.41122 -8.41122 -20.0628 17.9633 14.096800000000002 50.4803 50.4803 50.4803 -20.0628 17.9633 15.096800000000002 7.95876 7.95876 7.95876 -19.0628 16.9633 17.0968 9.0326 9.0326 9.0326 -20.0628 16.9633 16.0968 -21.548 -21.548 -21.548 -20.0628 16.9633 17.0968 -14.0326 -14.0326 -14.0326 -20.0628 17.9633 16.0968 -9.75766 -9.75766 -9.75766 -17.0628 14.9633 18.0968 -39.6828 -39.6828 -39.6828 -17.0628 14.9633 19.0968 24.7394 24.7394 24.7394 -17.0628 15.9633 18.0968 -6.16402 -6.16402 -6.16402 -17.0628 15.9633 19.0968 -1.87341 -1.87341 -1.87341 -18.0628 15.9633 18.0968 -5.76539 -5.76539 -5.76539 -17.0628 14.9633 20.0968 4.29051 4.29051 4.29051 -17.0628 14.9633 21.0968 4.68647 4.68647 4.68647 -17.0628 15.9633 20.0968 -7.48179 -7.48179 -7.48179 -18.0628 14.9633 20.0968 19.3944 19.3944 19.3944 -18.0628 14.9633 21.0968 12.9706 12.9706 12.9706 -17.0628 16.9633 18.0968 -1.02467 -1.02467 -1.02467 -17.0628 16.9633 19.0968 1.58868 1.58868 1.58868 -17.0628 17.9633 19.0968 -1.9479 -1.9479 -1.9479 -18.0628 16.9633 18.0968 1.46693 1.46693 1.46693 -18.0628 16.9633 19.0968 -6.6306 -6.6306 -6.6306 -18.0628 17.9633 18.0968 3.10106 3.10106 3.10106 -18.0628 17.9633 19.0968 2.09363 2.09363 2.09363 -18.0628 17.9633 20.0968 -8.15913 -8.15913 -8.15913 -18.0628 17.9633 21.0968 8.66734 8.66734 8.66734 -19.0628 15.9633 18.0968 7.93348 7.93348 7.93348 -20.0628 14.9633 19.0968 -6.90915 -6.90915 -6.90915 -19.0628 14.9633 20.0968 1.73872 1.73872 1.73872 -19.0628 14.9633 21.0968 -20.0037 -20.0037 -20.0037 -19.0628 15.9633 21.0968 -32.2954 -32.2954 -32.2954 -20.0628 14.9633 20.0968 1.02715 1.02715 1.02715 -20.0628 14.9633 21.0968 -1.9454 -1.9454 -1.9454 -20.0628 15.9633 21.0968 -18.3567 -18.3567 -18.3567 -19.0628 16.9633 18.0968 -1.84229 -1.84229 -1.84229 -19.0628 16.9633 19.0968 1.87858 1.87858 1.87858 -19.0628 17.9633 18.0968 1.72244 1.72244 1.72244 -19.0628 17.9633 19.0968 1.11964 1.11964 1.11964 -20.0628 16.9633 18.0968 -6.18975 -6.18975 -6.18975 -20.0628 17.9633 18.0968 2.18014 2.18014 2.18014 -19.0628 16.9633 20.0968 1.3589 1.3589 1.3589 -19.0628 16.9633 21.0968 8.84374 8.84374 8.84374 -19.0628 17.9633 20.0968 -7.32597 -7.32597 -7.32597 -19.0628 17.9633 21.0968 -1.85759 -1.85759 -1.85759 -20.0628 16.9633 21.0968 29.2079 29.2079 29.2079 -20.0628 17.9633 20.0968 6.69613 6.69613 6.69613 -20.0628 17.9633 21.0968 -11.1731 -11.1731 -11.1731 -21.0628 10.9633 14.096800000000002 1.22477 1.22477 1.22477 -22.0628 10.9633 15.096800000000002 1.82718 1.82718 1.82718 -21.0628 10.9633 17.0968 5.66793 5.66793 5.66793 -21.0628 11.9633 17.0968 4.74069 4.74069 4.74069 -22.0628 10.9633 17.0968 -4.96356 -4.96356 -4.96356 -22.0628 11.9633 17.0968 -0.55205 -0.55205 -0.55205 -21.0628 12.9633 14.096800000000002 -2.63102 -2.63102 -2.63102 -21.0628 12.9633 15.096800000000002 3.7648 3.7648 3.7648 -21.0628 13.9633 14.096800000000002 -5.55764 -5.55764 -5.55764 -21.0628 13.9633 15.096800000000002 -4.09939 -4.09939 -4.09939 -22.0628 12.9633 15.096800000000002 -3.20299 -3.20299 -3.20299 -22.0628 13.9633 15.096800000000002 2.66322 2.66322 2.66322 -21.0628 12.9633 16.0968 6.04493 6.04493 6.04493 -21.0628 12.9633 17.0968 -2.1746 -2.1746 -2.1746 -21.0628 13.9633 16.0968 -0.127577 -0.127577 -0.127577 -21.0628 13.9633 17.0968 5.12046 5.12046 5.12046 -22.0628 12.9633 16.0968 -0.949438 -0.949438 -0.949438 -22.0628 12.9633 17.0968 0.576481 0.576481 0.576481 -22.0628 13.9633 16.0968 0.501995 0.501995 0.501995 -22.0628 13.9633 17.0968 3.76098 3.76098 3.76098 -23.0628 10.9633 14.096800000000002 -3.3617 -3.3617 -3.3617 -23.0628 10.9633 15.096800000000002 1.96836 1.96836 1.96836 -23.0628 11.9633 14.096800000000002 -14.3548 -14.3548 -14.3548 -23.0628 11.9633 15.096800000000002 1.41534 1.41534 1.41534 -24.0628 10.9633 14.096800000000002 -3.3877 -3.3877 -3.3877 -24.0628 10.9633 15.096800000000002 -3.22207 -3.22207 -3.22207 -24.0628 11.9633 14.096800000000002 -11.494 -11.494 -11.494 -24.0628 11.9633 15.096800000000002 -3.41805 -3.41805 -3.41805 -23.0628 10.9633 16.0968 -9.61172 -9.61172 -9.61172 -23.0628 10.9633 17.0968 -3.01938 -3.01938 -3.01938 -23.0628 11.9633 16.0968 -5.42024 -5.42024 -5.42024 -23.0628 11.9633 17.0968 -3.72727 -3.72727 -3.72727 -24.0628 10.9633 16.0968 -0.735932 -0.735932 -0.735932 -24.0628 11.9633 16.0968 -1.37855 -1.37855 -1.37855 -24.0628 11.9633 17.0968 -3.88984 -3.88984 -3.88984 -23.0628 12.9633 15.096800000000002 -2.48122 -2.48122 -2.48122 -24.0628 12.9633 15.096800000000002 -1.66107 -1.66107 -1.66107 -23.0628 12.9633 16.0968 -3.95779 -3.95779 -3.95779 -23.0628 13.9633 16.0968 -1.02236 -1.02236 -1.02236 -23.0628 13.9633 17.0968 -1.49561 -1.49561 -1.49561 -24.0628 12.9633 16.0968 0.0291547 0.0291547 0.0291547 -24.0628 12.9633 17.0968 -1.21291 -1.21291 -1.21291 -24.0628 13.9633 16.0968 -1.95325 -1.95325 -1.95325 -24.0628 13.9633 17.0968 4.6859 4.6859 4.6859 -21.0628 10.9633 18.0968 -4.88704 -4.88704 -4.88704 -21.0628 10.9633 19.0968 -0.384315 -0.384315 -0.384315 -21.0628 11.9633 18.0968 -7.14496 -7.14496 -7.14496 -21.0628 11.9633 19.0968 -1.64473 -1.64473 -1.64473 -22.0628 10.9633 18.0968 -0.564025 -0.564025 -0.564025 -22.0628 11.9633 18.0968 0.729962 0.729962 0.729962 -22.0628 11.9633 19.0968 -5.01098 -5.01098 -5.01098 -22.0628 11.9633 20.0968 -1.7196 -1.7196 -1.7196 -22.0628 11.9633 21.0968 -0.142873 -0.142873 -0.142873 -21.0628 12.9633 18.0968 5.18106 5.18106 5.18106 -21.0628 12.9633 19.0968 -1.53621 -1.53621 -1.53621 -21.0628 13.9633 18.0968 -3.06144 -3.06144 -3.06144 -21.0628 13.9633 19.0968 -2.6424 -2.6424 -2.6424 -22.0628 12.9633 18.0968 2.23474 2.23474 2.23474 -22.0628 12.9633 19.0968 0.409268 0.409268 0.409268 -22.0628 13.9633 18.0968 4.40208 4.40208 4.40208 -22.0628 13.9633 19.0968 -6.23532 -6.23532 -6.23532 -21.0628 12.9633 20.0968 -0.367496 -0.367496 -0.367496 -21.0628 12.9633 21.0968 2.07442 2.07442 2.07442 -21.0628 13.9633 20.0968 0.294413 0.294413 0.294413 -21.0628 13.9633 21.0968 7.91658 7.91658 7.91658 -22.0628 12.9633 20.0968 -0.708591 -0.708591 -0.708591 -22.0628 12.9633 21.0968 -9.12686 -9.12686 -9.12686 -22.0628 13.9633 20.0968 -1.30544 -1.30544 -1.30544 -22.0628 13.9633 21.0968 -10.8786 -10.8786 -10.8786 -23.0628 11.9633 18.0968 -7.73545 -7.73545 -7.73545 -23.0628 11.9633 19.0968 6.57981 6.57981 6.57981 -24.0628 11.9633 19.0968 -6.59931 -6.59931 -6.59931 -23.0628 11.9633 20.0968 0.825206 0.825206 0.825206 -23.0628 11.9633 21.0968 -0.122556 -0.122556 -0.122556 -24.0628 11.9633 20.0968 0.375171 0.375171 0.375171 -24.0628 11.9633 21.0968 5.72699 5.72699 5.72699 -23.0628 12.9633 18.0968 -7.55729 -7.55729 -7.55729 -23.0628 12.9633 19.0968 -9.47293 -9.47293 -9.47293 -23.0628 13.9633 18.0968 -1.16015 -1.16015 -1.16015 -24.0628 12.9633 18.0968 3.40996 3.40996 3.40996 -24.0628 12.9633 19.0968 -3.43827 -3.43827 -3.43827 -24.0628 13.9633 18.0968 10.6264 10.6264 10.6264 -23.0628 12.9633 20.0968 6.31177 6.31177 6.31177 -23.0628 12.9633 21.0968 23.2071 23.2071 23.2071 -23.0628 13.9633 21.0968 18.5435 18.5435 18.5435 -24.0628 12.9633 21.0968 -15.6164 -15.6164 -15.6164 -24.0628 13.9633 21.0968 -39.1359 -39.1359 -39.1359 -21.0628 14.9633 14.096800000000002 -0.193883 -0.193883 -0.193883 -21.0628 14.9633 15.096800000000002 1.15732 1.15732 1.15732 -21.0628 15.9633 14.096800000000002 1.43904 1.43904 1.43904 -21.0628 15.9633 15.096800000000002 -1.65399 -1.65399 -1.65399 -22.0628 14.9633 14.096800000000002 -2.76954 -2.76954 -2.76954 -22.0628 14.9633 15.096800000000002 -0.555281 -0.555281 -0.555281 -22.0628 15.9633 14.096800000000002 -4.24651 -4.24651 -4.24651 -22.0628 15.9633 15.096800000000002 -0.802452 -0.802452 -0.802452 -21.0628 14.9633 16.0968 -0.887253 -0.887253 -0.887253 -21.0628 15.9633 16.0968 -1.8251 -1.8251 -1.8251 -21.0628 15.9633 17.0968 3.28145 3.28145 3.28145 -22.0628 14.9633 16.0968 -0.921694 -0.921694 -0.921694 -22.0628 15.9633 16.0968 -1.681 -1.681 -1.681 -22.0628 15.9633 17.0968 1.33035 1.33035 1.33035 -21.0628 16.9633 14.096800000000002 27.6513 27.6513 27.6513 -21.0628 16.9633 15.096800000000002 1.6679 1.6679 1.6679 -21.0628 17.9633 14.096800000000002 -3.19668 -3.19668 -3.19668 -21.0628 17.9633 15.096800000000002 2.04758 2.04758 2.04758 -22.0628 16.9633 14.096800000000002 20.4279 20.4279 20.4279 -22.0628 16.9633 15.096800000000002 2.17176 2.17176 2.17176 -22.0628 17.9633 14.096800000000002 -20.7194 -20.7194 -20.7194 -22.0628 17.9633 15.096800000000002 2.75288 2.75288 2.75288 -21.0628 16.9633 16.0968 -0.0320563 -0.0320563 -0.0320563 -21.0628 16.9633 17.0968 0.00317582 0.00317582 0.00317582 -21.0628 17.9633 16.0968 -1.30331 -1.30331 -1.30331 -21.0628 17.9633 17.0968 -3.79494 -3.79494 -3.79494 -22.0628 16.9633 16.0968 -0.919753 -0.919753 -0.919753 -22.0628 16.9633 17.0968 1.1033 1.1033 1.1033 -22.0628 17.9633 16.0968 -0.304045 -0.304045 -0.304045 -22.0628 17.9633 17.0968 -1.07624 -1.07624 -1.07624 -23.0628 14.9633 15.096800000000002 -3.74885 -3.74885 -3.74885 -23.0628 15.9633 14.096800000000002 11.2481 11.2481 11.2481 -23.0628 15.9633 15.096800000000002 4.73168 4.73168 4.73168 -24.0628 14.9633 15.096800000000002 6.05362 6.05362 6.05362 -23.0628 14.9633 16.0968 -0.441485 -0.441485 -0.441485 -23.0628 14.9633 17.0968 -2.43149 -2.43149 -2.43149 -23.0628 15.9633 16.0968 -3.94425 -3.94425 -3.94425 -23.0628 15.9633 17.0968 -2.18924 -2.18924 -2.18924 -24.0628 14.9633 16.0968 3.35189 3.35189 3.35189 -24.0628 14.9633 17.0968 2.89662 2.89662 2.89662 -24.0628 15.9633 17.0968 -2.81472 -2.81472 -2.81472 -23.0628 16.9633 14.096800000000002 13.4503 13.4503 13.4503 -23.0628 16.9633 15.096800000000002 -7.21678 -7.21678 -7.21678 -23.0628 17.9633 14.096800000000002 0.701331 0.701331 0.701331 -23.0628 17.9633 15.096800000000002 0.964781 0.964781 0.964781 -23.0628 16.9633 16.0968 -0.521222 -0.521222 -0.521222 -23.0628 16.9633 17.0968 3.20066 3.20066 3.20066 -23.0628 17.9633 16.0968 1.22245 1.22245 1.22245 -24.0628 16.9633 17.0968 1.14365 1.14365 1.14365 -24.0628 17.9633 16.0968 0.121234 0.121234 0.121234 -24.0628 17.9633 17.0968 8.6641 8.6641 8.6641 -22.0628 14.9633 18.0968 -0.637917 -0.637917 -0.637917 -22.0628 14.9633 19.0968 3.25271 3.25271 3.25271 -22.0628 15.9633 18.0968 -0.459767 -0.459767 -0.459767 -22.0628 15.9633 19.0968 -0.928783 -0.928783 -0.928783 -21.0628 14.9633 20.0968 -4.17105 -4.17105 -4.17105 -21.0628 14.9633 21.0968 -5.85242 -5.85242 -5.85242 -21.0628 15.9633 21.0968 5.19103 5.19103 5.19103 -22.0628 14.9633 20.0968 -1.87696 -1.87696 -1.87696 -22.0628 15.9633 20.0968 -2.63492 -2.63492 -2.63492 -22.0628 15.9633 21.0968 8.12119 8.12119 8.12119 -21.0628 16.9633 18.0968 3.57785 3.57785 3.57785 -21.0628 16.9633 19.0968 4.39119 4.39119 4.39119 -21.0628 17.9633 18.0968 3.33064 3.33064 3.33064 -21.0628 17.9633 19.0968 -2.74609 -2.74609 -2.74609 -22.0628 16.9633 18.0968 0.947977 0.947977 0.947977 -22.0628 16.9633 19.0968 3.72566 3.72566 3.72566 -22.0628 17.9633 18.0968 3.37638 3.37638 3.37638 -22.0628 17.9633 19.0968 -1.57082 -1.57082 -1.57082 -21.0628 16.9633 20.0968 -1.02707 -1.02707 -1.02707 -21.0628 16.9633 21.0968 3.60127 3.60127 3.60127 -21.0628 17.9633 20.0968 -1.60742 -1.60742 -1.60742 -21.0628 17.9633 21.0968 -0.401641 -0.401641 -0.401641 -22.0628 16.9633 20.0968 -7.01188 -7.01188 -7.01188 -22.0628 16.9633 21.0968 -1.05502 -1.05502 -1.05502 -22.0628 17.9633 20.0968 -1.6897 -1.6897 -1.6897 -22.0628 17.9633 21.0968 -2.92989 -2.92989 -2.92989 -23.0628 14.9633 18.0968 -3.33028 -3.33028 -3.33028 -23.0628 15.9633 18.0968 -1.00509 -1.00509 -1.00509 -23.0628 15.9633 19.0968 0.28347 0.28347 0.28347 -24.0628 14.9633 18.0968 4.88455 4.88455 4.88455 -23.0628 16.9633 19.0968 -1.6486 -1.6486 -1.6486 -23.0628 17.9633 18.0968 -0.171186 -0.171186 -0.171186 -23.0628 17.9633 19.0968 -4.54711 -4.54711 -4.54711 -24.0628 16.9633 19.0968 -1.96897 -1.96897 -1.96897 -24.0628 17.9633 18.0968 1.48302 1.48302 1.48302 -24.0628 17.9633 19.0968 -0.024799 -0.024799 -0.024799 -23.0628 16.9633 20.0968 -2.98393 -2.98393 -2.98393 -23.0628 16.9633 21.0968 1.17066 1.17066 1.17066 -24.0628 16.9633 20.0968 3.83332 3.83332 3.83332 -24.0628 16.9633 21.0968 29.5436 29.5436 29.5436 -24.0628 17.9633 20.0968 -20.686 -20.686 -20.686 -17.0628 18.9633 11.096800000000002 29.7816 29.7816 29.7816 -17.0628 18.9633 12.096800000000002 13.8178 13.8178 13.8178 -17.0628 18.9633 13.096800000000002 -7.99093 -7.99093 -7.99093 -18.0628 18.9633 13.096800000000002 -1.73159 -1.73159 -1.73159 -22.0628 18.9633 11.096800000000002 -3.46915 -3.46915 -3.46915 -22.0628 18.9633 12.096800000000002 43.7168 43.7168 43.7168 -22.0628 18.9633 13.096800000000002 -2.19791 -2.19791 -2.19791 -23.0628 18.9633 11.096800000000002 2.42696 2.42696 2.42696 -24.0628 18.9633 11.096800000000002 2.12193 2.12193 2.12193 -23.0628 18.9633 12.096800000000002 0.331412 0.331412 0.331412 -23.0628 18.9633 13.096800000000002 -1.06153 -1.06153 -1.06153 -23.0628 19.9633 13.096800000000002 9.4301 9.4301 9.4301 -24.0628 18.9633 12.096800000000002 -4.42333 -4.42333 -4.42333 -24.0628 18.9633 13.096800000000002 -9.70542 -9.70542 -9.70542 -24.0628 19.9633 12.096800000000002 1.2108 1.2108 1.2108 -24.0628 19.9633 13.096800000000002 9.78008 9.78008 9.78008 -23.0628 20.9633 13.096800000000002 -0.936754 -0.936754 -0.936754 -23.0628 21.9633 13.096800000000002 -6.86688 -6.86688 -6.86688 -24.0628 20.9633 13.096800000000002 2.95899 2.95899 2.95899 -24.0628 21.9633 13.096800000000002 -1.01162 -1.01162 -1.01162 -23.0628 22.9633 13.096800000000002 -90.9598 -90.9598 -90.9598 -23.0628 23.9633 13.096800000000002 -83.8921 -83.8921 -83.8921 -24.0628 22.9633 13.096800000000002 92.8038 92.8038 92.8038 -24.0628 23.9633 13.096800000000002 -35.758 -35.758 -35.758 -17.0628 18.9633 14.096800000000002 -3.48869 -3.48869 -3.48869 -17.0628 18.9633 15.096800000000002 1.94704 1.94704 1.94704 -18.0628 18.9633 14.096800000000002 0.450062 0.450062 0.450062 -18.0628 18.9633 15.096800000000002 -6.75832 -6.75832 -6.75832 -17.0628 18.9633 16.0968 -0.495451 -0.495451 -0.495451 -17.0628 18.9633 17.0968 -0.359166 -0.359166 -0.359166 -17.0628 19.9633 16.0968 -1.50707 -1.50707 -1.50707 -17.0628 19.9633 17.0968 -1.4067 -1.4067 -1.4067 -18.0628 18.9633 16.0968 -14.0927 -14.0927 -14.0927 -18.0628 19.9633 16.0968 0.693504 0.693504 0.693504 -18.0628 19.9633 17.0968 -0.298373 -0.298373 -0.298373 -19.0628 18.9633 15.096800000000002 0.899108 0.899108 0.899108 -19.0628 19.9633 15.096800000000002 4.69671 4.69671 4.69671 -20.0628 18.9633 15.096800000000002 11.332 11.332 11.332 -20.0628 19.9633 15.096800000000002 -2.04872 -2.04872 -2.04872 -19.0628 18.9633 17.0968 0.45376 0.45376 0.45376 -19.0628 19.9633 16.0968 1.16016 1.16016 1.16016 -19.0628 19.9633 17.0968 0.120008 0.120008 0.120008 -20.0628 19.9633 16.0968 1.11512 1.11512 1.11512 -20.0628 19.9633 17.0968 0.41976 0.41976 0.41976 -19.0628 20.9633 16.0968 -0.160338 -0.160338 -0.160338 -19.0628 20.9633 17.0968 -1.07511 -1.07511 -1.07511 -20.0628 20.9633 16.0968 0.453582 0.453582 0.453582 -20.0628 20.9633 17.0968 9.22337 9.22337 9.22337 -17.0628 18.9633 18.0968 0.613856 0.613856 0.613856 -17.0628 19.9633 18.0968 0.284795 0.284795 0.284795 -17.0628 19.9633 19.0968 1.88484 1.88484 1.88484 -18.0628 18.9633 18.0968 -2.73908 -2.73908 -2.73908 -18.0628 18.9633 19.0968 2.7713 2.7713 2.7713 -18.0628 19.9633 18.0968 1.6366 1.6366 1.6366 -18.0628 19.9633 19.0968 -0.415946 -0.415946 -0.415946 -17.0628 19.9633 20.0968 -3.63534 -3.63534 -3.63534 -17.0628 19.9633 21.0968 8.28315 8.28315 8.28315 -17.0628 20.9633 18.0968 3.8992 3.8992 3.8992 -17.0628 20.9633 19.0968 -4.88891 -4.88891 -4.88891 -18.0628 20.9633 18.0968 4.94186 4.94186 4.94186 -18.0628 20.9633 19.0968 -2.17363 -2.17363 -2.17363 -18.0628 21.9633 19.0968 14.2332 14.2332 14.2332 -17.0628 20.9633 20.0968 -5.49394 -5.49394 -5.49394 -17.0628 20.9633 21.0968 7.84458 7.84458 7.84458 -17.0628 21.9633 21.0968 -0.0286925 -0.0286925 -0.0286925 -18.0628 20.9633 20.0968 0.894697 0.894697 0.894697 -18.0628 20.9633 21.0968 -1.92678 -1.92678 -1.92678 -18.0628 21.9633 20.0968 -12.011 -12.011 -12.011 -18.0628 21.9633 21.0968 -10.773 -10.773 -10.773 -19.0628 18.9633 18.0968 1.17561 1.17561 1.17561 -19.0628 18.9633 19.0968 -6.26267 -6.26267 -6.26267 -19.0628 19.9633 18.0968 -6.31774 -6.31774 -6.31774 -19.0628 19.9633 19.0968 5.53737 5.53737 5.53737 -20.0628 18.9633 19.0968 -5.97601 -5.97601 -5.97601 -20.0628 19.9633 18.0968 7.28428 7.28428 7.28428 -20.0628 19.9633 19.0968 -6.00653 -6.00653 -6.00653 -19.0628 18.9633 20.0968 -4.83056 -4.83056 -4.83056 -19.0628 18.9633 21.0968 9.71278 9.71278 9.71278 -19.0628 19.9633 20.0968 -5.19947 -5.19947 -5.19947 -20.0628 18.9633 20.0968 0.19982 0.19982 0.19982 -20.0628 18.9633 21.0968 3.01092 3.01092 3.01092 -19.0628 20.9633 18.0968 -1.1993 -1.1993 -1.1993 -19.0628 20.9633 19.0968 -5.53626 -5.53626 -5.53626 -19.0628 21.9633 18.0968 9.66953 9.66953 9.66953 -19.0628 21.9633 19.0968 -4.16979 -4.16979 -4.16979 -20.0628 20.9633 18.0968 -2.52219 -2.52219 -2.52219 -20.0628 20.9633 19.0968 1.15688 1.15688 1.15688 -20.0628 21.9633 18.0968 -4.21621 -4.21621 -4.21621 -20.0628 21.9633 19.0968 -0.657732 -0.657732 -0.657732 -19.0628 21.9633 20.0968 -7.20189 -7.20189 -7.20189 -19.0628 21.9633 21.0968 -14.4246 -14.4246 -14.4246 -20.0628 21.9633 21.0968 28.0451 28.0451 28.0451 -18.0628 22.9633 19.0968 7.9506 7.9506 7.9506 -18.0628 22.9633 20.0968 -0.353808 -0.353808 -0.353808 -19.0628 22.9633 19.0968 -5.53828 -5.53828 -5.53828 -20.0628 22.9633 19.0968 -8.57051 -8.57051 -8.57051 -19.0628 22.9633 20.0968 12.4999 12.4999 12.4999 -19.0628 22.9633 21.0968 -7.03835 -7.03835 -7.03835 -20.0628 22.9633 20.0968 25.9468 25.9468 25.9468 -20.0628 22.9633 21.0968 40.2122 40.2122 40.2122 -21.0628 18.9633 15.096800000000002 1.24332 1.24332 1.24332 -21.0628 19.9633 15.096800000000002 -0.0519252 -0.0519252 -0.0519252 -22.0628 18.9633 14.096800000000002 -11.9746 -11.9746 -11.9746 -22.0628 18.9633 15.096800000000002 0.0444223 0.0444223 0.0444223 -22.0628 19.9633 14.096800000000002 1.74584 1.74584 1.74584 -22.0628 19.9633 15.096800000000002 -0.485132 -0.485132 -0.485132 -21.0628 18.9633 16.0968 2.84058 2.84058 2.84058 -21.0628 19.9633 16.0968 0.561984 0.561984 0.561984 -21.0628 19.9633 17.0968 0.243105 0.243105 0.243105 -22.0628 18.9633 16.0968 1.52005 1.52005 1.52005 -22.0628 18.9633 17.0968 -7.4234 -7.4234 -7.4234 -22.0628 19.9633 16.0968 -0.280044 -0.280044 -0.280044 -22.0628 20.9633 14.096800000000002 5.04174 5.04174 5.04174 -22.0628 20.9633 15.096800000000002 15.4033 15.4033 15.4033 -22.0628 21.9633 14.096800000000002 -9.73929 -9.73929 -9.73929 -22.0628 21.9633 15.096800000000002 8.11225 8.11225 8.11225 -21.0628 20.9633 16.0968 -10.4887 -10.4887 -10.4887 -21.0628 20.9633 17.0968 7.3476 7.3476 7.3476 -21.0628 21.9633 16.0968 -1.79641 -1.79641 -1.79641 -21.0628 21.9633 17.0968 -3.55476 -3.55476 -3.55476 -22.0628 20.9633 16.0968 -0.74159 -0.74159 -0.74159 -22.0628 21.9633 16.0968 -0.305103 -0.305103 -0.305103 -22.0628 21.9633 17.0968 -0.73228 -0.73228 -0.73228 -23.0628 18.9633 14.096800000000002 -5.00695 -5.00695 -5.00695 -23.0628 18.9633 15.096800000000002 -14.0746 -14.0746 -14.0746 -23.0628 19.9633 14.096800000000002 13.2964 13.2964 13.2964 -23.0628 19.9633 15.096800000000002 3.64445 3.64445 3.64445 -23.0628 18.9633 16.0968 0.55224 0.55224 0.55224 -23.0628 18.9633 17.0968 -1.57771 -1.57771 -1.57771 -23.0628 19.9633 16.0968 -2.7881 -2.7881 -2.7881 -23.0628 19.9633 17.0968 -0.596054 -0.596054 -0.596054 -24.0628 18.9633 16.0968 -1.00073 -1.00073 -1.00073 -24.0628 18.9633 17.0968 5.00496 5.00496 5.00496 -24.0628 19.9633 16.0968 -1.0007 -1.0007 -1.0007 -24.0628 19.9633 17.0968 -2.47399 -2.47399 -2.47399 -23.0628 20.9633 14.096800000000002 12.9186 12.9186 12.9186 -23.0628 21.9633 14.096800000000002 3.56598 3.56598 3.56598 -23.0628 20.9633 16.0968 -4.03859 -4.03859 -4.03859 -23.0628 20.9633 17.0968 -0.347785 -0.347785 -0.347785 -23.0628 21.9633 16.0968 -0.460364 -0.460364 -0.460364 -23.0628 21.9633 17.0968 -5.30452 -5.30452 -5.30452 -24.0628 20.9633 17.0968 -6.05961 -6.05961 -6.05961 -24.0628 21.9633 16.0968 5.82259 5.82259 5.82259 -24.0628 21.9633 17.0968 -1.41925 -1.41925 -1.41925 -22.0628 18.9633 18.0968 -8.08599 -8.08599 -8.08599 -21.0628 18.9633 20.0968 -1.14062 -1.14062 -1.14062 -22.0628 19.9633 21.0968 8.0302 8.0302 8.0302 -21.0628 20.9633 18.0968 -0.582135 -0.582135 -0.582135 -21.0628 20.9633 19.0968 -13.316 -13.316 -13.316 -21.0628 21.9633 18.0968 -0.878115 -0.878115 -0.878115 -21.0628 21.9633 19.0968 16.0597 16.0597 16.0597 -22.0628 20.9633 19.0968 -21.3596 -21.3596 -21.3596 -22.0628 21.9633 18.0968 -1.3933 -1.3933 -1.3933 -22.0628 21.9633 19.0968 -1.29906 -1.29906 -1.29906 -21.0628 20.9633 20.0968 -2.26831 -2.26831 -2.26831 -21.0628 20.9633 21.0968 0.989594 0.989594 0.989594 -21.0628 21.9633 20.0968 1.21015 1.21015 1.21015 -21.0628 21.9633 21.0968 26.1111 26.1111 26.1111 -22.0628 20.9633 20.0968 -8.12129 -8.12129 -8.12129 -22.0628 20.9633 21.0968 0.763008 0.763008 0.763008 -23.0628 18.9633 18.0968 5.6973 5.6973 5.6973 -23.0628 18.9633 19.0968 1.84551 1.84551 1.84551 -23.0628 19.9633 18.0968 -1.65518 -1.65518 -1.65518 -23.0628 19.9633 19.0968 -5.93321 -5.93321 -5.93321 -24.0628 18.9633 18.0968 2.83881 2.83881 2.83881 -24.0628 18.9633 19.0968 -2.14826 -2.14826 -2.14826 -24.0628 19.9633 19.0968 2.61898 2.61898 2.61898 -23.0628 19.9633 20.0968 -5.39293 -5.39293 -5.39293 -23.0628 19.9633 21.0968 2.96275 2.96275 2.96275 -24.0628 18.9633 20.0968 -30.0053 -30.0053 -30.0053 -23.0628 20.9633 18.0968 -4.46655 -4.46655 -4.46655 -23.0628 20.9633 19.0968 0.927042 0.927042 0.927042 -23.0628 21.9633 18.0968 2.33267 2.33267 2.33267 -24.0628 20.9633 19.0968 2.13124 2.13124 2.13124 -24.0628 21.9633 19.0968 -8.44569 -8.44569 -8.44569 -23.0628 20.9633 20.0968 -0.76622 -0.76622 -0.76622 -23.0628 20.9633 21.0968 0.116797 0.116797 0.116797 -24.0628 20.9633 20.0968 4.88217 4.88217 4.88217 -24.0628 20.9633 21.0968 -9.34689 -9.34689 -9.34689 -24.0628 21.9633 20.0968 11.0393 11.0393 11.0393 -24.0628 21.9633 21.0968 -19.3729 -19.3729 -19.3729 -22.0628 22.9633 14.096800000000002 -7.88081 -7.88081 -7.88081 -22.0628 22.9633 15.096800000000002 -4.10135 -4.10135 -4.10135 -22.0628 23.9633 14.096800000000002 -0.0650381 -0.0650381 -0.0650381 -22.0628 23.9633 15.096800000000002 1.16036 1.16036 1.16036 -21.0628 22.9633 16.0968 -1.85582 -1.85582 -1.85582 -21.0628 22.9633 17.0968 0.785019 0.785019 0.785019 -21.0628 23.9633 16.0968 -1.52438 -1.52438 -1.52438 -21.0628 23.9633 17.0968 -5.11572 -5.11572 -5.11572 -22.0628 22.9633 16.0968 2.66518 2.66518 2.66518 -22.0628 22.9633 17.0968 6.49712 6.49712 6.49712 -22.0628 23.9633 16.0968 -1.30686 -1.30686 -1.30686 -22.0628 23.9633 17.0968 -1.11541 -1.11541 -1.11541 -22.0628 24.9633 15.096800000000002 5.72894 5.72894 5.72894 -22.0628 24.9633 16.0968 8.63128 8.63128 8.63128 -23.0628 22.9633 14.096800000000002 25.3775 25.3775 25.3775 -23.0628 23.9633 14.096800000000002 42.752 42.752 42.752 -23.0628 23.9633 15.096800000000002 23.5534 23.5534 23.5534 -24.0628 23.9633 14.096800000000002 -22.2792 -22.2792 -22.2792 -24.0628 23.9633 15.096800000000002 44.0327 44.0327 44.0327 -23.0628 22.9633 17.0968 2.31641 2.31641 2.31641 -23.0628 23.9633 17.0968 1.435 1.435 1.435 -24.0628 22.9633 17.0968 -4.52422 -4.52422 -4.52422 -24.0628 23.9633 17.0968 -0.380524 -0.380524 -0.380524 -23.0628 24.9633 14.096800000000002 28.2109 28.2109 28.2109 -23.0628 24.9633 15.096800000000002 -13.0666 -13.0666 -13.0666 -23.0628 25.9633 15.096800000000002 1.26993 1.26993 1.26993 -24.0628 24.9633 14.096800000000002 77.0058 77.0058 77.0058 -24.0628 24.9633 15.096800000000002 26.6168 26.6168 26.6168 -24.0628 25.9633 15.096800000000002 6.02579 6.02579 6.02579 -23.0628 24.9633 16.0968 5.13062 5.13062 5.13062 -23.0628 24.9633 17.0968 -9.78582 -9.78582 -9.78582 -23.0628 25.9633 16.0968 -2.39048 -2.39048 -2.39048 -24.0628 24.9633 16.0968 -3.91305 -3.91305 -3.91305 -24.0628 24.9633 17.0968 -2.17895 -2.17895 -2.17895 -24.0628 25.9633 16.0968 2.50383 2.50383 2.50383 -21.0628 22.9633 19.0968 5.32717 5.32717 5.32717 -21.0628 22.9633 20.0968 12.2438 12.2438 12.2438 -21.0628 22.9633 21.0968 -4.7461 -4.7461 -4.7461 -24.0628 22.9633 18.0968 -14.8323 -14.8323 -14.8323 -24.0628 23.9633 18.0968 3.80006 3.80006 3.80006 -9.0628 10.9633 22.0968 0.725299 0.725299 0.725299 -9.0628 11.9633 22.0968 -4.57834 -4.57834 -4.57834 -10.0628 10.9633 22.0968 -7.38962 -7.38962 -7.38962 -10.0628 10.9633 23.0968 15.8225 15.8225 15.8225 -10.0628 11.9633 22.0968 1.01861 1.01861 1.01861 -10.0628 11.9633 23.0968 31.2207 31.2207 31.2207 -9.0628 12.9633 22.0968 -6.48415 -6.48415 -6.48415 -9.0628 13.9633 22.0968 -0.0349163 -0.0349163 -0.0349163 -10.0628 12.9633 22.0968 5.73537 5.73537 5.73537 -10.0628 13.9633 22.0968 0.332929 0.332929 0.332929 -11.0628 10.9633 22.0968 9.39971 9.39971 9.39971 -11.0628 10.9633 23.0968 18.0177 18.0177 18.0177 -11.0628 11.9633 22.0968 7.25132 7.25132 7.25132 -11.0628 11.9633 23.0968 29.3712 29.3712 29.3712 -12.0628 10.9633 22.0968 -2.33984 -2.33984 -2.33984 -12.0628 10.9633 23.0968 5.14521 5.14521 5.14521 -12.0628 11.9633 23.0968 -28.4235 -28.4235 -28.4235 -11.0628 10.9633 24.0968 -24.4759 -24.4759 -24.4759 -11.0628 10.9633 25.0968 -12.4745 -12.4745 -12.4745 -11.0628 11.9633 24.0968 8.69951 8.69951 8.69951 -11.0628 11.9633 25.0968 20.6582 20.6582 20.6582 -12.0628 10.9633 24.0968 -19.4791 -19.4791 -19.4791 -12.0628 11.9633 24.0968 10.2363 10.2363 10.2363 -12.0628 11.9633 25.0968 16.383 16.383 16.383 -11.0628 12.9633 22.0968 5.14115 5.14115 5.14115 -11.0628 12.9633 23.0968 -5.80583 -5.80583 -5.80583 -11.0628 13.9633 22.0968 -2.90565 -2.90565 -2.90565 -12.0628 12.9633 22.0968 -2.98497 -2.98497 -2.98497 -12.0628 12.9633 23.0968 -0.71581 -0.71581 -0.71581 -12.0628 13.9633 22.0968 -7.5019 -7.5019 -7.5019 -12.0628 12.9633 24.0968 -7.2297 -7.2297 -7.2297 -12.0628 12.9633 25.0968 3.67054 3.67054 3.67054 -11.0628 10.9633 26.0968 86.5754 86.5754 86.5754 -12.0628 10.9633 26.0968 -189.199 -189.199 -189.199 -12.0628 11.9633 26.0968 -49.2695 -49.2695 -49.2695 -11.0628 14.9633 22.0968 35.2337 35.2337 35.2337 -13.0628 10.9633 23.0968 1.62838 1.62838 1.62838 -13.0628 11.9633 22.0968 -11.747 -11.747 -11.747 -13.0628 11.9633 23.0968 -1.6637 -1.6637 -1.6637 -14.0628 10.9633 23.0968 -1.71916 -1.71916 -1.71916 -14.0628 11.9633 22.0968 -5.90256 -5.90256 -5.90256 -14.0628 11.9633 23.0968 2.0057 2.0057 2.0057 -13.0628 11.9633 24.0968 2.90266 2.90266 2.90266 -13.0628 11.9633 25.0968 5.54443 5.54443 5.54443 -14.0628 10.9633 24.0968 -1.18108 -1.18108 -1.18108 -14.0628 10.9633 25.0968 -0.162644 -0.162644 -0.162644 -14.0628 11.9633 24.0968 5.08058 5.08058 5.08058 -14.0628 11.9633 25.0968 -4.81945 -4.81945 -4.81945 -13.0628 12.9633 22.0968 -11.0211 -11.0211 -11.0211 -13.0628 12.9633 23.0968 -8.94611 -8.94611 -8.94611 -13.0628 13.9633 22.0968 -5.911 -5.911 -5.911 -14.0628 12.9633 22.0968 -0.803425 -0.803425 -0.803425 -14.0628 12.9633 23.0968 -3.42133 -3.42133 -3.42133 -14.0628 13.9633 22.0968 5.98388 5.98388 5.98388 -14.0628 13.9633 23.0968 10.4902 10.4902 10.4902 -13.0628 12.9633 24.0968 -3.81809 -3.81809 -3.81809 -13.0628 12.9633 25.0968 5.34295 5.34295 5.34295 -15.0628 10.9633 23.0968 -5.84407 -5.84407 -5.84407 -15.0628 11.9633 22.0968 -4.11543 -4.11543 -4.11543 -15.0628 11.9633 23.0968 -4.16203 -4.16203 -4.16203 -16.0628 10.9633 22.0968 -91.8208 -91.8208 -91.8208 -16.0628 10.9633 23.0968 7.79856 7.79856 7.79856 -16.0628 11.9633 22.0968 -59.3332 -59.3332 -59.3332 -16.0628 11.9633 23.0968 27.0891 27.0891 27.0891 -15.0628 10.9633 24.0968 -20.4447 -20.4447 -20.4447 -15.0628 11.9633 24.0968 -5.16548 -5.16548 -5.16548 -15.0628 12.9633 22.0968 4.32268 4.32268 4.32268 -15.0628 12.9633 23.0968 -11.7739 -11.7739 -11.7739 -15.0628 13.9633 22.0968 8.83859 8.83859 8.83859 -15.0628 13.9633 23.0968 -4.8918 -4.8918 -4.8918 -16.0628 12.9633 22.0968 36.1065 36.1065 36.1065 -16.0628 12.9633 23.0968 35.7992 35.7992 35.7992 -16.0628 13.9633 23.0968 5.22521 5.22521 5.22521 -13.0628 10.9633 26.0968 -13.8142 -13.8142 -13.8142 -13.0628 11.9633 26.0968 -4.59468 -4.59468 -4.59468 -14.0628 10.9633 26.0968 0.367784 0.367784 0.367784 -14.0628 10.9633 27.0968 8.79913 8.79913 8.79913 -14.0628 11.9633 26.0968 -1.69725 -1.69725 -1.69725 -14.0628 11.9633 27.0968 4.72374 4.72374 4.72374 -14.0628 10.9633 28.0968 -12.5075 -12.5075 -12.5075 -14.0628 10.9633 29.0968 90.9947 90.9947 90.9947 -14.0628 11.9633 28.0968 -5.49576 -5.49576 -5.49576 -14.0628 11.9633 29.0968 62.3678 62.3678 62.3678 -15.0628 10.9633 27.0968 -6.40595 -6.40595 -6.40595 -15.0628 11.9633 27.0968 -25.9801 -25.9801 -25.9801 -16.0628 10.9633 26.0968 11.3371 11.3371 11.3371 -16.0628 10.9633 27.0968 1.11624 1.11624 1.11624 -16.0628 11.9633 26.0968 21.8573 21.8573 21.8573 -16.0628 11.9633 27.0968 39.5718 39.5718 39.5718 -15.0628 10.9633 29.0968 -71.0681 -71.0681 -71.0681 -15.0628 11.9633 28.0968 -13.1935 -13.1935 -13.1935 -15.0628 11.9633 29.0968 1.13644 1.13644 1.13644 -16.0628 10.9633 29.0968 -36.8768 -36.8768 -36.8768 -16.0628 11.9633 28.0968 -7.97192 -7.97192 -7.97192 -16.0628 11.9633 29.0968 18.2667 18.2667 18.2667 -16.0628 12.9633 26.0968 -21.812 -21.812 -21.812 -16.0628 12.9633 27.0968 -18.0476 -18.0476 -18.0476 -16.0628 13.9633 27.0968 -1.9656 -1.9656 -1.9656 -16.0628 12.9633 28.0968 -123.316 -123.316 -123.316 -16.0628 12.9633 29.0968 -87.7756 -87.7756 -87.7756 -16.0628 13.9633 28.0968 -164.638 -164.638 -164.638 -14.0628 14.9633 22.0968 11.4477 11.4477 11.4477 -14.0628 15.9633 22.0968 -8.44167 -8.44167 -8.44167 -15.0628 14.9633 22.0968 7.80143 7.80143 7.80143 -15.0628 14.9633 23.0968 -0.730691 -0.730691 -0.730691 -15.0628 15.9633 22.0968 49.4076 49.4076 49.4076 -16.0628 14.9633 22.0968 -6.537 -6.537 -6.537 -16.0628 14.9633 23.0968 -4.12872 -4.12872 -4.12872 -16.0628 15.9633 22.0968 -3.90619 -3.90619 -3.90619 -15.0628 16.9633 22.0968 -128.381 -128.381 -128.381 -15.0628 17.9633 22.0968 -42.0753 -42.0753 -42.0753 -16.0628 16.9633 22.0968 38.6677 38.6677 38.6677 -16.0628 17.9633 22.0968 -50.5631 -50.5631 -50.5631 -14.0628 10.9633 30.0968 -195.131 -195.131 -195.131 -14.0628 10.9633 31.0968 -56.6117 -56.6117 -56.6117 -15.0628 10.9633 30.0968 -104.748 -104.748 -104.748 -15.0628 10.9633 31.0968 -100.03 -100.03 -100.03 -15.0628 11.9633 30.0968 -143.852 -143.852 -143.852 -16.0628 10.9633 30.0968 -77.4657 -77.4657 -77.4657 -16.0628 10.9633 31.0968 95.4185 95.4185 95.4185 -16.0628 11.9633 30.0968 24.1967 24.1967 24.1967 -15.0628 10.9633 32.0968 13.488 13.488 13.488 -16.0628 10.9633 32.0968 15.2023 15.2023 15.2023 -16.0628 18.9633 22.0968 42.1479 42.1479 42.1479 -16.0628 19.9633 22.0968 -7.88122 -7.88122 -7.88122 -17.0628 11.9633 22.0968 -25.247 -25.247 -25.247 -17.0628 12.9633 22.0968 13.0071 13.0071 13.0071 -17.0628 12.9633 23.0968 -16.512 -16.512 -16.512 -17.0628 13.9633 22.0968 23.5655 23.5655 23.5655 -17.0628 13.9633 23.0968 2.17989 2.17989 2.17989 -19.0628 10.9633 22.0968 -21.9051 -21.9051 -21.9051 -19.0628 11.9633 22.0968 -3.07072 -3.07072 -3.07072 -20.0628 10.9633 22.0968 -22.3169 -22.3169 -22.3169 -20.0628 11.9633 22.0968 6.86435 6.86435 6.86435 -19.0628 12.9633 22.0968 -25.2947 -25.2947 -25.2947 -20.0628 12.9633 22.0968 -10.2773 -10.2773 -10.2773 -17.0628 10.9633 26.0968 2.55488 2.55488 2.55488 -17.0628 10.9633 27.0968 5.41885 5.41885 5.41885 -17.0628 11.9633 26.0968 26.9631 26.9631 26.9631 -18.0628 10.9633 26.0968 8.67156 8.67156 8.67156 -18.0628 10.9633 27.0968 36.7945 36.7945 36.7945 -18.0628 11.9633 26.0968 1.42595 1.42595 1.42595 -18.0628 11.9633 27.0968 12.2101 12.2101 12.2101 -17.0628 10.9633 28.0968 -3.18198 -3.18198 -3.18198 -17.0628 10.9633 29.0968 11.3732 11.3732 11.3732 -17.0628 11.9633 29.0968 -11.7761 -11.7761 -11.7761 -18.0628 10.9633 28.0968 -7.24479 -7.24479 -7.24479 -18.0628 10.9633 29.0968 -58.929 -58.929 -58.929 -18.0628 11.9633 28.0968 -3.77173 -3.77173 -3.77173 -18.0628 11.9633 29.0968 14.7711 14.7711 14.7711 -17.0628 12.9633 26.0968 18.6074 18.6074 18.6074 -17.0628 13.9633 26.0968 -4.53698 -4.53698 -4.53698 -17.0628 13.9633 27.0968 3.08666 3.08666 3.08666 -18.0628 12.9633 26.0968 -1.34922 -1.34922 -1.34922 -18.0628 12.9633 27.0968 0.353621 0.353621 0.353621 -18.0628 13.9633 26.0968 3.21583 3.21583 3.21583 -18.0628 13.9633 27.0968 -4.36412 -4.36412 -4.36412 -17.0628 12.9633 28.0968 -2.14532 -2.14532 -2.14532 -17.0628 12.9633 29.0968 13.5103 13.5103 13.5103 -17.0628 13.9633 28.0968 165.78 165.78 165.78 -18.0628 12.9633 28.0968 39.3448 39.3448 39.3448 -18.0628 12.9633 29.0968 81.7044 81.7044 81.7044 -18.0628 13.9633 28.0968 98.3779 98.3779 98.3779 -19.0628 10.9633 26.0968 20.9043 20.9043 20.9043 -19.0628 10.9633 27.0968 15.2308 15.2308 15.2308 -19.0628 11.9633 26.0968 6.84612 6.84612 6.84612 -19.0628 11.9633 27.0968 11.1214 11.1214 11.1214 -20.0628 10.9633 26.0968 -1.57517 -1.57517 -1.57517 -20.0628 10.9633 27.0968 6.16112 6.16112 6.16112 -20.0628 11.9633 27.0968 2.04836 2.04836 2.04836 -19.0628 10.9633 28.0968 -8.28279 -8.28279 -8.28279 -19.0628 11.9633 28.0968 -0.826699 -0.826699 -0.826699 -20.0628 10.9633 28.0968 4.21088 4.21088 4.21088 -20.0628 10.9633 29.0968 0.0429187 0.0429187 0.0429187 -20.0628 11.9633 28.0968 -7.47867 -7.47867 -7.47867 -19.0628 12.9633 26.0968 -2.11374 -2.11374 -2.11374 -19.0628 12.9633 27.0968 -8.3252 -8.3252 -8.3252 -19.0628 13.9633 27.0968 -5.31203 -5.31203 -5.31203 -20.0628 12.9633 26.0968 -11.1228 -11.1228 -11.1228 -20.0628 12.9633 27.0968 6.80601 6.80601 6.80601 -20.0628 13.9633 26.0968 -9.76136 -9.76136 -9.76136 -20.0628 13.9633 27.0968 3.15728 3.15728 3.15728 -19.0628 12.9633 28.0968 -0.042901 -0.042901 -0.042901 -19.0628 12.9633 29.0968 -44.1941 -44.1941 -44.1941 -19.0628 13.9633 28.0968 -7.09526 -7.09526 -7.09526 -19.0628 13.9633 29.0968 -44.7412 -44.7412 -44.7412 -20.0628 12.9633 28.0968 6.71396 6.71396 6.71396 -20.0628 12.9633 29.0968 36.8134 36.8134 36.8134 -20.0628 13.9633 28.0968 7.31646 7.31646 7.31646 -20.0628 13.9633 29.0968 22.3488 22.3488 22.3488 -17.0628 14.9633 22.0968 -5.44461 -5.44461 -5.44461 -17.0628 14.9633 23.0968 -2.72505 -2.72505 -2.72505 -17.0628 15.9633 22.0968 17.1709 17.1709 17.1709 -17.0628 15.9633 23.0968 99.2017 99.2017 99.2017 -18.0628 14.9633 22.0968 26.706 26.706 26.706 -18.0628 15.9633 22.0968 -3.87711 -3.87711 -3.87711 -18.0628 15.9633 23.0968 -23.8287 -23.8287 -23.8287 -17.0628 16.9633 22.0968 -102.343 -102.343 -102.343 -17.0628 16.9633 23.0968 125.804 125.804 125.804 -17.0628 17.9633 22.0968 5.1505 5.1505 5.1505 -17.0628 17.9633 23.0968 -54.129 -54.129 -54.129 -18.0628 16.9633 22.0968 -13.1323 -13.1323 -13.1323 -18.0628 16.9633 23.0968 30.6009 30.6009 30.6009 -18.0628 17.9633 22.0968 -0.354068 -0.354068 -0.354068 -18.0628 17.9633 23.0968 2.96186 2.96186 2.96186 -17.0628 17.9633 24.0968 -2.52653 -2.52653 -2.52653 -18.0628 17.9633 24.0968 1.74725 1.74725 1.74725 -19.0628 14.9633 22.0968 -22.4332 -22.4332 -22.4332 -19.0628 15.9633 22.0968 -0.846392 -0.846392 -0.846392 -20.0628 15.9633 22.0968 35.2035 35.2035 35.2035 -19.0628 16.9633 22.0968 -23.9614 -23.9614 -23.9614 -19.0628 17.9633 22.0968 -4.32244 -4.32244 -4.32244 -19.0628 17.9633 23.0968 -2.66541 -2.66541 -2.66541 -20.0628 16.9633 22.0968 12.8686 12.8686 12.8686 -20.0628 17.9633 22.0968 -10.3441 -10.3441 -10.3441 -20.0628 14.9633 26.0968 -0.725359 -0.725359 -0.725359 -20.0628 14.9633 27.0968 13.6704 13.6704 13.6704 -20.0628 14.9633 28.0968 3.01564 3.01564 3.01564 -20.0628 14.9633 29.0968 17.0832 17.0832 17.0832 -21.0628 10.9633 22.0968 1.15771 1.15771 1.15771 -21.0628 10.9633 23.0968 -66.0938 -66.0938 -66.0938 -21.0628 11.9633 22.0968 0.353807 0.353807 0.353807 -21.0628 11.9633 23.0968 36.2413 36.2413 36.2413 -22.0628 11.9633 23.0968 26.3351 26.3351 26.3351 -21.0628 10.9633 24.0968 -50.5827 -50.5827 -50.5827 -21.0628 10.9633 25.0968 -17.8854 -17.8854 -17.8854 -21.0628 11.9633 24.0968 17.0828 17.0828 17.0828 -21.0628 11.9633 25.0968 -1.38744 -1.38744 -1.38744 -22.0628 10.9633 24.0968 -54.1496 -54.1496 -54.1496 -22.0628 10.9633 25.0968 -14.736 -14.736 -14.736 -22.0628 11.9633 24.0968 -32.1954 -32.1954 -32.1954 -22.0628 11.9633 25.0968 -7.58575 -7.58575 -7.58575 -21.0628 12.9633 22.0968 -15.6079 -15.6079 -15.6079 -21.0628 12.9633 23.0968 2.91392 2.91392 2.91392 -21.0628 13.9633 22.0968 -19.3251 -19.3251 -19.3251 -21.0628 13.9633 23.0968 27.6987 27.6987 27.6987 -22.0628 12.9633 23.0968 -2.695 -2.695 -2.695 -22.0628 13.9633 22.0968 -4.82289 -4.82289 -4.82289 -22.0628 13.9633 23.0968 -23.1676 -23.1676 -23.1676 -21.0628 12.9633 25.0968 7.07523 7.07523 7.07523 -22.0628 12.9633 24.0968 -7.8565 -7.8565 -7.8565 -22.0628 12.9633 25.0968 -4.0843 -4.0843 -4.0843 -22.0628 13.9633 24.0968 -7.67962 -7.67962 -7.67962 -22.0628 13.9633 25.0968 -16.2012 -16.2012 -16.2012 -24.0628 10.9633 22.0968 20.2538 20.2538 20.2538 -24.0628 10.9633 23.0968 0.547803 0.547803 0.547803 -24.0628 11.9633 22.0968 10.4335 10.4335 10.4335 -24.0628 11.9633 23.0968 37.1168 37.1168 37.1168 -23.0628 10.9633 25.0968 -9.26409 -9.26409 -9.26409 -24.0628 10.9633 24.0968 -19.0474 -19.0474 -19.0474 -24.0628 10.9633 25.0968 5.79576 5.79576 5.79576 -24.0628 11.9633 24.0968 43.0252 43.0252 43.0252 -23.0628 12.9633 23.0968 31.1394 31.1394 31.1394 -23.0628 13.9633 22.0968 28.6498 28.6498 28.6498 -23.0628 13.9633 23.0968 -32.4052 -32.4052 -32.4052 -24.0628 12.9633 22.0968 -23.4815 -23.4815 -23.4815 -24.0628 12.9633 23.0968 1.50104 1.50104 1.50104 -24.0628 13.9633 22.0968 -20.2424 -20.2424 -20.2424 -24.0628 13.9633 23.0968 3.56681 3.56681 3.56681 -23.0628 12.9633 24.0968 27.5547 27.5547 27.5547 -23.0628 13.9633 24.0968 18.383 18.383 18.383 -23.0628 13.9633 25.0968 19.3598 19.3598 19.3598 -24.0628 12.9633 24.0968 -3.05498 -3.05498 -3.05498 -24.0628 12.9633 25.0968 22.6713 22.6713 22.6713 -24.0628 13.9633 24.0968 -11.3516 -11.3516 -11.3516 -24.0628 13.9633 25.0968 -17.4669 -17.4669 -17.4669 -21.0628 10.9633 26.0968 -3.34585 -3.34585 -3.34585 -21.0628 10.9633 27.0968 -1.62441 -1.62441 -1.62441 -21.0628 11.9633 26.0968 3.26047 3.26047 3.26047 -21.0628 11.9633 27.0968 -0.578326 -0.578326 -0.578326 -22.0628 10.9633 26.0968 5.22438 5.22438 5.22438 -22.0628 10.9633 27.0968 -1.6945 -1.6945 -1.6945 -22.0628 11.9633 26.0968 0.367338 0.367338 0.367338 -22.0628 11.9633 27.0968 -1.22359 -1.22359 -1.22359 -21.0628 10.9633 28.0968 -7.49804 -7.49804 -7.49804 -21.0628 10.9633 29.0968 -2.55366 -2.55366 -2.55366 -21.0628 11.9633 28.0968 -2.0503 -2.0503 -2.0503 -22.0628 10.9633 28.0968 1.98702 1.98702 1.98702 -21.0628 12.9633 26.0968 -2.68072 -2.68072 -2.68072 -21.0628 12.9633 27.0968 6.37146 6.37146 6.37146 -21.0628 13.9633 26.0968 -4.6683 -4.6683 -4.6683 -22.0628 12.9633 26.0968 -1.05415 -1.05415 -1.05415 -22.0628 12.9633 27.0968 -5.29483 -5.29483 -5.29483 -22.0628 13.9633 26.0968 -15.3204 -15.3204 -15.3204 -21.0628 12.9633 28.0968 -11.5566 -11.5566 -11.5566 -21.0628 12.9633 29.0968 43.9242 43.9242 43.9242 -21.0628 13.9633 29.0968 8.70939 8.70939 8.70939 -22.0628 12.9633 28.0968 0.931364 0.931364 0.931364 -22.0628 12.9633 29.0968 1.4687 1.4687 1.4687 -22.0628 13.9633 28.0968 -8.12235 -8.12235 -8.12235 -22.0628 13.9633 29.0968 5.8187 5.8187 5.8187 -23.0628 10.9633 26.0968 -13.4187 -13.4187 -13.4187 -23.0628 10.9633 27.0968 -7.45275 -7.45275 -7.45275 -23.0628 11.9633 26.0968 81.8172 81.8172 81.8172 -23.0628 11.9633 27.0968 34.807 34.807 34.807 -24.0628 10.9633 26.0968 -27.1749 -27.1749 -27.1749 -24.0628 10.9633 27.0968 -52.5247 -52.5247 -52.5247 -24.0628 11.9633 26.0968 23.6655 23.6655 23.6655 -24.0628 11.9633 27.0968 -79.5126 -79.5126 -79.5126 -23.0628 10.9633 28.0968 18.7617 18.7617 18.7617 -23.0628 11.9633 28.0968 -92.3338 -92.3338 -92.3338 -24.0628 10.9633 28.0968 34.1472 34.1472 34.1472 -24.0628 10.9633 29.0968 -5.28739 -5.28739 -5.28739 -24.0628 11.9633 28.0968 -79.0441 -79.0441 -79.0441 -24.0628 11.9633 29.0968 0.428386 0.428386 0.428386 -23.0628 12.9633 26.0968 17.2187 17.2187 17.2187 -23.0628 12.9633 27.0968 0.652063 0.652063 0.652063 -23.0628 13.9633 26.0968 -35.8666 -35.8666 -35.8666 -23.0628 13.9633 27.0968 60.0049 60.0049 60.0049 -24.0628 12.9633 26.0968 57.6502 57.6502 57.6502 -24.0628 12.9633 27.0968 60.3563 60.3563 60.3563 -24.0628 13.9633 26.0968 7.95941 7.95941 7.95941 -23.0628 12.9633 28.0968 6.24111 6.24111 6.24111 -23.0628 12.9633 29.0968 1.22479 1.22479 1.22479 -23.0628 13.9633 28.0968 16.9545 16.9545 16.9545 -23.0628 13.9633 29.0968 0.00575489 0.00575489 0.00575489 -24.0628 12.9633 28.0968 25.1549 25.1549 25.1549 -24.0628 12.9633 29.0968 -0.905523 -0.905523 -0.905523 -24.0628 13.9633 29.0968 -4.37903 -4.37903 -4.37903 -21.0628 17.9633 22.0968 -2.33095 -2.33095 -2.33095 -22.0628 16.9633 22.0968 1.80976 1.80976 1.80976 -22.0628 17.9633 22.0968 -8.95492 -8.95492 -8.95492 -22.0628 17.9633 23.0968 -3.34499 -3.34499 -3.34499 -23.0628 14.9633 22.0968 16.0739 16.0739 16.0739 -23.0628 14.9633 25.0968 7.26298 7.26298 7.26298 -24.0628 14.9633 24.0968 -7.88945 -7.88945 -7.88945 -24.0628 14.9633 25.0968 -13.0584 -13.0584 -13.0584 -24.0628 15.9633 24.0968 0.42518 0.42518 0.42518 -24.0628 15.9633 25.0968 1.32732 1.32732 1.32732 -23.0628 16.9633 22.0968 -3.6865 -3.6865 -3.6865 -23.0628 16.9633 23.0968 -0.931506 -0.931506 -0.931506 -23.0628 17.9633 22.0968 16.1811 16.1811 16.1811 -23.0628 17.9633 23.0968 -5.13849 -5.13849 -5.13849 -24.0628 16.9633 22.0968 -20.9989 -20.9989 -20.9989 -24.0628 16.9633 23.0968 1.41234 1.41234 1.41234 -24.0628 17.9633 22.0968 35.956 35.956 35.956 -24.0628 17.9633 23.0968 0.138297 0.138297 0.138297 -24.0628 16.9633 25.0968 18.6157 18.6157 18.6157 -24.0628 17.9633 24.0968 -16.35 -16.35 -16.35 -21.0628 14.9633 26.0968 7.16113 7.16113 7.16113 -21.0628 14.9633 27.0968 70.3937 70.3937 70.3937 -21.0628 15.9633 27.0968 5.39035 5.39035 5.39035 -22.0628 14.9633 26.0968 -63.5897 -63.5897 -63.5897 -22.0628 14.9633 27.0968 62.3037 62.3037 62.3037 -22.0628 15.9633 27.0968 32.5594 32.5594 32.5594 -21.0628 14.9633 28.0968 17.5849 17.5849 17.5849 -21.0628 14.9633 29.0968 -0.875579 -0.875579 -0.875579 -21.0628 15.9633 28.0968 -5.9925 -5.9925 -5.9925 -21.0628 15.9633 29.0968 3.61342 3.61342 3.61342 -22.0628 14.9633 28.0968 27.6274 27.6274 27.6274 -22.0628 14.9633 29.0968 -4.22594 -4.22594 -4.22594 -22.0628 15.9633 28.0968 -53.1345 -53.1345 -53.1345 -22.0628 15.9633 29.0968 -1.30143 -1.30143 -1.30143 -21.0628 16.9633 29.0968 10.2349 10.2349 10.2349 -22.0628 16.9633 28.0968 -6.4517 -6.4517 -6.4517 -22.0628 16.9633 29.0968 0.328468 0.328468 0.328468 -22.0628 17.9633 28.0968 3.40838 3.40838 3.40838 -22.0628 17.9633 29.0968 0.470581 0.470581 0.470581 -23.0628 14.9633 26.0968 -69.923 -69.923 -69.923 -23.0628 14.9633 27.0968 -11.0794 -11.0794 -11.0794 -24.0628 14.9633 26.0968 -0.374183 -0.374183 -0.374183 -24.0628 14.9633 27.0968 -3.21534 -3.21534 -3.21534 -24.0628 15.9633 26.0968 4.63912 4.63912 4.63912 -24.0628 15.9633 27.0968 -1.27581 -1.27581 -1.27581 -23.0628 14.9633 28.0968 25.6416 25.6416 25.6416 -23.0628 14.9633 29.0968 3.14944 3.14944 3.14944 -23.0628 15.9633 28.0968 -18.5834 -18.5834 -18.5834 -24.0628 14.9633 28.0968 5.43174 5.43174 5.43174 -24.0628 15.9633 28.0968 0.443829 0.443829 0.443829 -24.0628 16.9633 26.0968 6.63144 6.63144 6.63144 -23.0628 16.9633 28.0968 -3.68848 -3.68848 -3.68848 -23.0628 17.9633 28.0968 -0.744245 -0.744245 -0.744245 -23.0628 17.9633 29.0968 -3.2073 -3.2073 -3.2073 -24.0628 16.9633 28.0968 2.32417 2.32417 2.32417 -24.0628 17.9633 28.0968 10.4636 10.4636 10.4636 -17.0628 10.9633 30.0968 -2.5909 -2.5909 -2.5909 -17.0628 10.9633 31.0968 -38.4644 -38.4644 -38.4644 -18.0628 10.9633 30.0968 -9.77378 -9.77378 -9.77378 -19.0628 11.9633 30.0968 -29.5373 -29.5373 -29.5373 -19.0628 11.9633 31.0968 -31.0645 -31.0645 -31.0645 -20.0628 10.9633 30.0968 -8.90472 -8.90472 -8.90472 -20.0628 10.9633 31.0968 -3.42509 -3.42509 -3.42509 -20.0628 11.9633 30.0968 11.2979 11.2979 11.2979 -20.0628 11.9633 31.0968 -36.0831 -36.0831 -36.0831 -19.0628 11.9633 32.0968 -0.0840347 -0.0840347 -0.0840347 -20.0628 10.9633 32.0968 2.86306 2.86306 2.86306 -20.0628 11.9633 32.0968 -8.84313 -8.84313 -8.84313 -19.0628 12.9633 30.0968 17.153 17.153 17.153 -19.0628 12.9633 31.0968 -12.3874 -12.3874 -12.3874 -19.0628 13.9633 30.0968 24.0844 24.0844 24.0844 -19.0628 13.9633 31.0968 -4.54775 -4.54775 -4.54775 -20.0628 12.9633 30.0968 21.1223 21.1223 21.1223 -20.0628 13.9633 30.0968 -23.5717 -23.5717 -23.5717 -19.0628 12.9633 32.0968 -1.05696 -1.05696 -1.05696 -19.0628 13.9633 32.0968 -2.28469 -2.28469 -2.28469 -20.0628 12.9633 32.0968 0.259789 0.259789 0.259789 -20.0628 13.9633 32.0968 -3.91785 -3.91785 -3.91785 -19.0628 14.9633 30.0968 -8.49953 -8.49953 -8.49953 -19.0628 14.9633 31.0968 -18.6106 -18.6106 -18.6106 -20.0628 14.9633 30.0968 -4.07499 -4.07499 -4.07499 -20.0628 14.9633 31.0968 -0.198196 -0.198196 -0.198196 -19.0628 14.9633 32.0968 -1.81732 -1.81732 -1.81732 -20.0628 14.9633 32.0968 -9.36243 -9.36243 -9.36243 -21.0628 10.9633 30.0968 2.10726 2.10726 2.10726 -21.0628 10.9633 31.0968 -0.501983 -0.501983 -0.501983 -21.0628 11.9633 30.0968 3.06017 3.06017 3.06017 -21.0628 11.9633 31.0968 -45.759 -45.759 -45.759 -22.0628 10.9633 30.0968 -0.00133786 -0.00133786 -0.00133786 -22.0628 10.9633 31.0968 0.594122 0.594122 0.594122 -22.0628 11.9633 30.0968 -0.614708 -0.614708 -0.614708 -22.0628 11.9633 31.0968 -0.754714 -0.754714 -0.754714 -21.0628 10.9633 32.0968 -2.21819 -2.21819 -2.21819 -21.0628 10.9633 33.0968 -2.32328 -2.32328 -2.32328 -21.0628 11.9633 32.0968 -4.37365 -4.37365 -4.37365 -22.0628 10.9633 32.0968 3.082 3.082 3.082 -22.0628 10.9633 33.0968 0.504774 0.504774 0.504774 -22.0628 11.9633 32.0968 5.13807 5.13807 5.13807 -22.0628 11.9633 33.0968 0.469911 0.469911 0.469911 -21.0628 12.9633 30.0968 14.6483 14.6483 14.6483 -21.0628 12.9633 31.0968 6.01953 6.01953 6.01953 -21.0628 13.9633 30.0968 -9.86666 -9.86666 -9.86666 -21.0628 13.9633 31.0968 14.6169 14.6169 14.6169 -22.0628 12.9633 30.0968 -1.22616 -1.22616 -1.22616 -22.0628 12.9633 31.0968 0.217932 0.217932 0.217932 -22.0628 13.9633 30.0968 4.3 4.3 4.3 -22.0628 13.9633 31.0968 3.55443 3.55443 3.55443 -21.0628 12.9633 32.0968 -0.565968 -0.565968 -0.565968 -21.0628 13.9633 32.0968 -0.386611 -0.386611 -0.386611 -22.0628 12.9633 32.0968 6.04641 6.04641 6.04641 -22.0628 12.9633 33.0968 0.156149 0.156149 0.156149 -22.0628 13.9633 32.0968 1.78978 1.78978 1.78978 -22.0628 13.9633 33.0968 0.378359 0.378359 0.378359 -23.0628 10.9633 30.0968 -0.633915 -0.633915 -0.633915 -23.0628 10.9633 31.0968 -1.47208 -1.47208 -1.47208 -23.0628 11.9633 30.0968 -1.77081 -1.77081 -1.77081 -23.0628 11.9633 31.0968 -1.1127 -1.1127 -1.1127 -24.0628 10.9633 30.0968 0.199204 0.199204 0.199204 -24.0628 11.9633 30.0968 0.47472 0.47472 0.47472 -23.0628 10.9633 32.0968 1.87003 1.87003 1.87003 -23.0628 10.9633 33.0968 -1.16009 -1.16009 -1.16009 -23.0628 11.9633 32.0968 7.38379 7.38379 7.38379 -23.0628 11.9633 33.0968 -0.696827 -0.696827 -0.696827 -24.0628 10.9633 32.0968 -6.35666 -6.35666 -6.35666 -24.0628 10.9633 33.0968 -15.0484 -15.0484 -15.0484 -24.0628 11.9633 33.0968 6.94509 6.94509 6.94509 -23.0628 12.9633 30.0968 2.97992 2.97992 2.97992 -23.0628 13.9633 30.0968 1.59505 1.59505 1.59505 -23.0628 13.9633 31.0968 -5.77412 -5.77412 -5.77412 -24.0628 12.9633 30.0968 3.8288 3.8288 3.8288 -24.0628 13.9633 30.0968 -0.954399 -0.954399 -0.954399 -24.0628 13.9633 31.0968 -0.925089 -0.925089 -0.925089 -23.0628 12.9633 33.0968 -4.16403 -4.16403 -4.16403 -23.0628 13.9633 32.0968 -2.3403 -2.3403 -2.3403 -23.0628 13.9633 33.0968 -1.87674 -1.87674 -1.87674 -24.0628 12.9633 33.0968 -0.0744253 -0.0744253 -0.0744253 -24.0628 13.9633 32.0968 -0.717305 -0.717305 -0.717305 -24.0628 13.9633 33.0968 -1.71328 -1.71328 -1.71328 -22.0628 10.9633 34.0968 -6.26649 -6.26649 -6.26649 -22.0628 10.9633 35.0968 -0.671032 -0.671032 -0.671032 -22.0628 10.9633 36.0968 0.0449966 0.0449966 0.0449966 -23.0628 10.9633 34.0968 -3.14651 -3.14651 -3.14651 -23.0628 10.9633 35.0968 -1.91484 -1.91484 -1.91484 -23.0628 11.9633 34.0968 -2.85351 -2.85351 -2.85351 -23.0628 11.9633 35.0968 -1.13644 -1.13644 -1.13644 -24.0628 10.9633 34.0968 3.91535 3.91535 3.91535 -24.0628 10.9633 35.0968 0.796876 0.796876 0.796876 -24.0628 11.9633 35.0968 2.83792 2.83792 2.83792 -23.0628 10.9633 36.0968 -2.2607 -2.2607 -2.2607 -24.0628 11.9633 36.0968 0.512063 0.512063 0.512063 -23.0628 12.9633 34.0968 0.298808 0.298808 0.298808 -23.0628 12.9633 35.0968 -2.59866 -2.59866 -2.59866 -24.0628 12.9633 34.0968 -0.207926 -0.207926 -0.207926 -24.0628 12.9633 35.0968 1.49406 1.49406 1.49406 -24.0628 13.9633 34.0968 0.0960263 0.0960263 0.0960263 -24.0628 13.9633 35.0968 0.147803 0.147803 0.147803 -24.0628 12.9633 36.0968 -0.438403 -0.438403 -0.438403 -21.0628 14.9633 30.0968 11.329 11.329 11.329 -21.0628 14.9633 31.0968 -8.37005 -8.37005 -8.37005 -22.0628 14.9633 30.0968 0.352531 0.352531 0.352531 -22.0628 15.9633 30.0968 -4.70153 -4.70153 -4.70153 -21.0628 14.9633 32.0968 -4.99854 -4.99854 -4.99854 -22.0628 16.9633 30.0968 -0.325307 -0.325307 -0.325307 -22.0628 17.9633 30.0968 -2.91692 -2.91692 -2.91692 -23.0628 14.9633 30.0968 2.47739 2.47739 2.47739 -23.0628 14.9633 31.0968 -4.96339 -4.96339 -4.96339 -23.0628 15.9633 30.0968 3.01781 3.01781 3.01781 -23.0628 15.9633 31.0968 18.1608 18.1608 18.1608 -24.0628 14.9633 30.0968 1.48373 1.48373 1.48373 -24.0628 14.9633 31.0968 -11.6866 -11.6866 -11.6866 -24.0628 15.9633 30.0968 0.840237 0.840237 0.840237 -24.0628 15.9633 31.0968 4.38798 4.38798 4.38798 -23.0628 14.9633 32.0968 -3.45047 -3.45047 -3.45047 -24.0628 14.9633 32.0968 7.70383 7.70383 7.70383 -23.0628 16.9633 30.0968 0.546164 0.546164 0.546164 -23.0628 16.9633 31.0968 -12.7621 -12.7621 -12.7621 -23.0628 17.9633 30.0968 1.95923 1.95923 1.95923 -23.0628 17.9633 31.0968 -1.38427 -1.38427 -1.38427 -24.0628 16.9633 31.0968 12.5753 12.5753 12.5753 -24.0628 17.9633 31.0968 -0.254433 -0.254433 -0.254433 -17.0628 18.9633 22.0968 3.37388 3.37388 3.37388 -17.0628 18.9633 23.0968 -1.12972 -1.12972 -1.12972 -17.0628 19.9633 22.0968 9.32004 9.32004 9.32004 -17.0628 19.9633 23.0968 3.12215 3.12215 3.12215 -18.0628 18.9633 23.0968 -6.16381 -6.16381 -6.16381 -17.0628 18.9633 24.0968 1.13604 1.13604 1.13604 -17.0628 18.9633 25.0968 -1.14871 -1.14871 -1.14871 -17.0628 19.9633 24.0968 7.47282 7.47282 7.47282 -17.0628 19.9633 25.0968 -3.9418 -3.9418 -3.9418 -18.0628 18.9633 24.0968 3.47924 3.47924 3.47924 -18.0628 18.9633 25.0968 4.14335 4.14335 4.14335 -18.0628 19.9633 25.0968 -0.0383609 -0.0383609 -0.0383609 -17.0628 20.9633 22.0968 0.427052 0.427052 0.427052 -17.0628 20.9633 23.0968 -2.05133 -2.05133 -2.05133 -17.0628 21.9633 22.0968 6.34222 6.34222 6.34222 -17.0628 21.9633 23.0968 -0.604829 -0.604829 -0.604829 -18.0628 20.9633 23.0968 2.93752 2.93752 2.93752 -18.0628 21.9633 22.0968 -4.3779 -4.3779 -4.3779 -18.0628 21.9633 23.0968 -1.49816 -1.49816 -1.49816 -17.0628 20.9633 24.0968 4.24026 4.24026 4.24026 -17.0628 20.9633 25.0968 -1.30598 -1.30598 -1.30598 -17.0628 21.9633 24.0968 -6.83149 -6.83149 -6.83149 -17.0628 21.9633 25.0968 3.05399 3.05399 3.05399 -18.0628 20.9633 25.0968 -0.817224 -0.817224 -0.817224 -18.0628 21.9633 24.0968 1.86581 1.86581 1.86581 -18.0628 21.9633 25.0968 3.33984 3.33984 3.33984 -19.0628 18.9633 22.0968 2.30267 2.30267 2.30267 -19.0628 18.9633 23.0968 -0.290282 -0.290282 -0.290282 -20.0628 18.9633 22.0968 -0.880886 -0.880886 -0.880886 -20.0628 18.9633 23.0968 -6.03363 -6.03363 -6.03363 -20.0628 19.9633 22.0968 1.54247 1.54247 1.54247 -20.0628 19.9633 23.0968 3.87476 3.87476 3.87476 -19.0628 18.9633 24.0968 -61.7805 -61.7805 -61.7805 -19.0628 18.9633 25.0968 -118.363 -118.363 -118.363 -19.0628 19.9633 25.0968 -114.697 -114.697 -114.697 -20.0628 18.9633 24.0968 197.954 197.954 197.954 -20.0628 19.9633 24.0968 -136.731 -136.731 -136.731 -20.0628 19.9633 25.0968 148.398 148.398 148.398 -19.0628 21.9633 22.0968 -23.8045 -23.8045 -23.8045 -20.0628 21.9633 22.0968 -4.9831 -4.9831 -4.9831 -19.0628 20.9633 25.0968 -3.13929 -3.13929 -3.13929 -19.0628 21.9633 24.0968 1.23232 1.23232 1.23232 -19.0628 21.9633 25.0968 -0.835242 -0.835242 -0.835242 -20.0628 20.9633 24.0968 1.50118 1.50118 1.50118 -20.0628 20.9633 25.0968 -4.05253 -4.05253 -4.05253 -20.0628 21.9633 25.0968 1.15783 1.15783 1.15783 -18.0628 19.9633 26.0968 1.6115 1.6115 1.6115 -18.0628 20.9633 26.0968 -0.582234 -0.582234 -0.582234 -18.0628 21.9633 26.0968 -1.75052 -1.75052 -1.75052 -19.0628 19.9633 26.0968 -96.9874 -96.9874 -96.9874 -20.0628 19.9633 26.0968 23.2483 23.2483 23.2483 -19.0628 20.9633 26.0968 -3.37612 -3.37612 -3.37612 -19.0628 21.9633 26.0968 -0.14662 -0.14662 -0.14662 -20.0628 20.9633 26.0968 0.976498 0.976498 0.976498 -18.0628 22.9633 22.0968 -4.89134 -4.89134 -4.89134 -18.0628 22.9633 23.0968 3.97231 3.97231 3.97231 -18.0628 22.9633 24.0968 -5.23534 -5.23534 -5.23534 -19.0628 22.9633 22.0968 -42.0218 -42.0218 -42.0218 -19.0628 22.9633 23.0968 -0.941959 -0.941959 -0.941959 -19.0628 23.9633 22.0968 -29.6324 -29.6324 -29.6324 -19.0628 23.9633 23.0968 -0.829567 -0.829567 -0.829567 -20.0628 22.9633 22.0968 12.8455 12.8455 12.8455 -20.0628 23.9633 22.0968 -1.51368 -1.51368 -1.51368 -20.0628 23.9633 23.0968 1.20734 1.20734 1.20734 -19.0628 22.9633 24.0968 -0.564472 -0.564472 -0.564472 -19.0628 22.9633 25.0968 -1.507 -1.507 -1.507 -19.0628 23.9633 24.0968 1.00878 1.00878 1.00878 -20.0628 22.9633 24.0968 -0.422619 -0.422619 -0.422619 -20.0628 22.9633 25.0968 1.92694 1.92694 1.92694 -20.0628 23.9633 24.0968 -3.15671 -3.15671 -3.15671 -21.0628 18.9633 22.0968 -1.51752 -1.51752 -1.51752 -21.0628 19.9633 22.0968 -2.04287 -2.04287 -2.04287 -21.0628 19.9633 23.0968 -1.10598 -1.10598 -1.10598 -22.0628 18.9633 22.0968 0.225063 0.225063 0.225063 -22.0628 18.9633 23.0968 -3.75017 -3.75017 -3.75017 -22.0628 19.9633 22.0968 0.0857505 0.0857505 0.0857505 -21.0628 19.9633 24.0968 160.296 160.296 160.296 -21.0628 20.9633 22.0968 -3.41734 -3.41734 -3.41734 -21.0628 20.9633 23.0968 0.353779 0.353779 0.353779 -21.0628 21.9633 22.0968 4.34667 4.34667 4.34667 -21.0628 21.9633 23.0968 0.82854 0.82854 0.82854 -22.0628 20.9633 22.0968 -1.99862 -1.99862 -1.99862 -22.0628 21.9633 23.0968 9.12309 9.12309 9.12309 -21.0628 20.9633 24.0968 1.43886 1.43886 1.43886 -21.0628 20.9633 25.0968 -0.495833 -0.495833 -0.495833 -21.0628 21.9633 24.0968 2.26684 2.26684 2.26684 -21.0628 21.9633 25.0968 1.31834 1.31834 1.31834 -22.0628 21.9633 24.0968 5.86416 5.86416 5.86416 -23.0628 18.9633 22.0968 -1.56639 -1.56639 -1.56639 -23.0628 18.9633 23.0968 -1.68183 -1.68183 -1.68183 -23.0628 19.9633 22.0968 -2.00857 -2.00857 -2.00857 -23.0628 19.9633 23.0968 -1.7275 -1.7275 -1.7275 -24.0628 18.9633 23.0968 7.10148 7.10148 7.10148 -24.0628 19.9633 23.0968 -4.71348 -4.71348 -4.71348 -23.0628 18.9633 24.0968 14.927 14.927 14.927 -23.0628 19.9633 24.0968 0.802387 0.802387 0.802387 -24.0628 18.9633 24.0968 47.6379 47.6379 47.6379 -24.0628 19.9633 24.0968 30.8377 30.8377 30.8377 -23.0628 20.9633 22.0968 5.4436 5.4436 5.4436 -23.0628 20.9633 23.0968 6.49563 6.49563 6.49563 -24.0628 20.9633 22.0968 -1.23489 -1.23489 -1.23489 -24.0628 20.9633 23.0968 3.92743 3.92743 3.92743 -24.0628 21.9633 22.0968 -12.0162 -12.0162 -12.0162 -24.0628 20.9633 24.0968 -123.014 -123.014 -123.014 -22.0628 18.9633 28.0968 -2.5513 -2.5513 -2.5513 -22.0628 18.9633 29.0968 3.15023 3.15023 3.15023 -22.0628 19.9633 29.0968 2.02546 2.02546 2.02546 -23.0628 18.9633 28.0968 0.430515 0.430515 0.430515 -23.0628 18.9633 29.0968 -0.514363 -0.514363 -0.514363 -23.0628 19.9633 28.0968 -2.11495 -2.11495 -2.11495 -23.0628 19.9633 29.0968 -1.31248 -1.31248 -1.31248 -24.0628 18.9633 28.0968 2.47906 2.47906 2.47906 -24.0628 19.9633 28.0968 -1.2628 -1.2628 -1.2628 -24.0628 19.9633 29.0968 6.03396 6.03396 6.03396 -21.0628 22.9633 22.0968 3.66943 3.66943 3.66943 -21.0628 22.9633 23.0968 -0.63594 -0.63594 -0.63594 -21.0628 23.9633 22.0968 -10.6915 -10.6915 -10.6915 -21.0628 23.9633 23.0968 -1.79736 -1.79736 -1.79736 -22.0628 22.9633 23.0968 0.206443 0.206443 0.206443 -21.0628 22.9633 24.0968 0.248446 0.248446 0.248446 -21.0628 22.9633 25.0968 2.47438 2.47438 2.47438 -21.0628 23.9633 24.0968 -1.37847 -1.37847 -1.37847 -22.0628 22.9633 24.0968 6.73682 6.73682 6.73682 -22.0628 18.9633 30.0968 6.94141 6.94141 6.94141 -22.0628 19.9633 30.0968 1.53395 1.53395 1.53395 -23.0628 18.9633 30.0968 4.12992 4.12992 4.12992 -23.0628 18.9633 31.0968 -3.04432 -3.04432 -3.04432 -23.0628 19.9633 30.0968 7.98366 7.98366 7.98366 -23.0628 19.9633 31.0968 -7.90022 -7.90022 -7.90022 -24.0628 18.9633 31.0968 -9.48686 -9.48686 -9.48686 -24.0628 19.9633 30.0968 5.93981 5.93981 5.93981 -24.0628 19.9633 31.0968 0.332241 0.332241 0.332241 -25.0628 -3.0366999999999997 19.0968 45.4496 45.4496 45.4496 -25.0628 -2.0366999999999997 19.0968 12.8461 12.8461 12.8461 -25.0628 -3.0366999999999997 20.0968 -17.2446 -17.2446 -17.2446 -25.0628 -2.0366999999999997 20.0968 -93.9798 -93.9798 -93.9798 -26.0628 -2.0366999999999997 20.0968 264.241 264.241 264.241 -26.0628 -2.0366999999999997 21.0968 171.401 171.401 171.401 -27.0628 -2.0366999999999997 20.0968 -232.795 -232.795 -232.795 -27.0628 -2.0366999999999997 21.0968 -251.172 -251.172 -251.172 -28.0628 -2.0366999999999997 20.0968 -239.188 -239.188 -239.188 -28.0628 -2.0366999999999997 21.0968 -174.27 -174.27 -174.27 -26.0628 1.9633000000000003 15.096800000000002 20.1992 20.1992 20.1992 -25.0628 1.9633000000000003 16.0968 -12.5199 -12.5199 -12.5199 -25.0628 1.9633000000000003 17.0968 18.2824 18.2824 18.2824 -26.0628 0.9633000000000003 16.0968 -6.99286 -6.99286 -6.99286 -26.0628 0.9633000000000003 17.0968 3.70968 3.70968 3.70968 -26.0628 1.9633000000000003 16.0968 3.94415 3.94415 3.94415 -26.0628 1.9633000000000003 17.0968 33.7505 33.7505 33.7505 -27.0628 1.9633000000000003 15.096800000000002 2.3787 2.3787 2.3787 -28.0628 1.9633000000000003 15.096800000000002 5.56973 5.56973 5.56973 -27.0628 0.9633000000000003 16.0968 0.150519 0.150519 0.150519 -27.0628 0.9633000000000003 17.0968 -7.57622 -7.57622 -7.57622 -27.0628 1.9633000000000003 16.0968 7.92501 7.92501 7.92501 -27.0628 1.9633000000000003 17.0968 -2.74968 -2.74968 -2.74968 -28.0628 1.9633000000000003 16.0968 -5.62737 -5.62737 -5.62737 -28.0628 1.9633000000000003 17.0968 0.203923 0.203923 0.203923 -25.0628 -0.03669999999999973 20.0968 -540.511 -540.511 -540.511 -25.0628 -0.03669999999999973 21.0968 425.852 425.852 425.852 -26.0628 -1.0366999999999997 20.0968 184.251 184.251 184.251 -26.0628 -1.0366999999999997 21.0968 88.5347 88.5347 88.5347 -26.0628 -0.03669999999999973 20.0968 5.46721 5.46721 5.46721 -26.0628 -0.03669999999999973 21.0968 54.4919 54.4919 54.4919 -25.0628 0.9633000000000003 18.0968 -7.27681 -7.27681 -7.27681 -25.0628 0.9633000000000003 19.0968 51.0104 51.0104 51.0104 -25.0628 1.9633000000000003 18.0968 -21.4535 -21.4535 -21.4535 -26.0628 0.9633000000000003 18.0968 4.76247 4.76247 4.76247 -26.0628 0.9633000000000003 19.0968 -43.7117 -43.7117 -43.7117 -26.0628 1.9633000000000003 18.0968 -39.4725 -39.4725 -39.4725 -25.0628 0.9633000000000003 20.0968 17.0613 17.0613 17.0613 -25.0628 0.9633000000000003 21.0968 143.383 143.383 143.383 -25.0628 1.9633000000000003 20.0968 14.3622 14.3622 14.3622 -25.0628 1.9633000000000003 21.0968 -98.2642 -98.2642 -98.2642 -26.0628 0.9633000000000003 20.0968 -57.2738 -57.2738 -57.2738 -27.0628 -1.0366999999999997 19.0968 38.9352 38.9352 38.9352 -27.0628 -0.03669999999999973 19.0968 2.18134 2.18134 2.18134 -28.0628 -1.0366999999999997 19.0968 26.2503 26.2503 26.2503 -28.0628 -0.03669999999999973 19.0968 -8.84355 -8.84355 -8.84355 -27.0628 -1.0366999999999997 20.0968 -57.0416 -57.0416 -57.0416 -27.0628 -0.03669999999999973 20.0968 9.86416 9.86416 9.86416 -28.0628 -1.0366999999999997 20.0968 -279.676 -279.676 -279.676 -28.0628 -0.03669999999999973 20.0968 -2.71234 -2.71234 -2.71234 -27.0628 0.9633000000000003 18.0968 -21.2969 -21.2969 -21.2969 -27.0628 0.9633000000000003 19.0968 -24.8972 -24.8972 -24.8972 -27.0628 1.9633000000000003 18.0968 -17.7797 -17.7797 -17.7797 -27.0628 1.9633000000000003 19.0968 -21.8141 -21.8141 -21.8141 -28.0628 0.9633000000000003 19.0968 2.24648 2.24648 2.24648 -28.0628 1.9633000000000003 18.0968 -0.746577 -0.746577 -0.746577 -28.0628 1.9633000000000003 19.0968 2.55137 2.55137 2.55137 -27.0628 0.9633000000000003 20.0968 -12.1066 -12.1066 -12.1066 -28.0628 0.9633000000000003 20.0968 -0.0977287 -0.0977287 -0.0977287 -28.0628 0.9633000000000003 21.0968 0.255853 0.255853 0.255853 -28.0628 1.9633000000000003 21.0968 -0.0732298 -0.0732298 -0.0732298 -29.0628 -2.0366999999999997 20.0968 -124.26 -124.26 -124.26 -29.0628 -2.0366999999999997 21.0968 51.3718 51.3718 51.3718 -29.0628 -1.0366999999999997 19.0968 6.96144 6.96144 6.96144 -29.0628 -0.03669999999999973 19.0968 -18.5967 -18.5967 -18.5967 -29.0628 -1.0366999999999997 20.0968 62.1592 62.1592 62.1592 -29.0628 -1.0366999999999997 21.0968 107.857 107.857 107.857 -29.0628 -0.03669999999999973 20.0968 -7.68043 -7.68043 -7.68043 -29.0628 -0.03669999999999973 21.0968 -4.19254 -4.19254 -4.19254 -29.0628 0.9633000000000003 19.0968 1.5092 1.5092 1.5092 -29.0628 1.9633000000000003 19.0968 2.05616 2.05616 2.05616 -30.0628 0.9633000000000003 19.0968 1.71248 1.71248 1.71248 -30.0628 1.9633000000000003 18.0968 -2.40798 -2.40798 -2.40798 -30.0628 1.9633000000000003 19.0968 -3.04629 -3.04629 -3.04629 -29.0628 0.9633000000000003 20.0968 -0.632158 -0.632158 -0.632158 -29.0628 0.9633000000000003 21.0968 -1.59329 -1.59329 -1.59329 -29.0628 1.9633000000000003 20.0968 2.78406 2.78406 2.78406 -29.0628 1.9633000000000003 21.0968 -4.44534 -4.44534 -4.44534 -30.0628 0.9633000000000003 20.0968 1.74838 1.74838 1.74838 -30.0628 0.9633000000000003 21.0968 -2.55659 -2.55659 -2.55659 -30.0628 1.9633000000000003 21.0968 -2.54772 -2.54772 -2.54772 -31.0628 0.9633000000000003 19.0968 1.43219 1.43219 1.43219 -31.0628 1.9633000000000003 18.0968 2.82669 2.82669 2.82669 -31.0628 1.9633000000000003 19.0968 3.39154 3.39154 3.39154 -32.062799999999996 0.9633000000000003 19.0968 -1.56655 -1.56655 -1.56655 -32.062799999999996 1.9633000000000003 18.0968 0.607292 0.607292 0.607292 -32.062799999999996 1.9633000000000003 19.0968 -0.293879 -0.293879 -0.293879 -31.0628 0.9633000000000003 20.0968 -0.456654 -0.456654 -0.456654 -31.0628 0.9633000000000003 21.0968 3.52219 3.52219 3.52219 -31.0628 1.9633000000000003 21.0968 3.30773 3.30773 3.30773 -32.062799999999996 0.9633000000000003 20.0968 -1.07397 -1.07397 -1.07397 -32.062799999999996 0.9633000000000003 21.0968 7.56594 7.56594 7.56594 -32.062799999999996 1.9633000000000003 20.0968 4.19474 4.19474 4.19474 -32.062799999999996 1.9633000000000003 21.0968 20.3396 20.3396 20.3396 -25.0628 2.9633000000000003 11.096800000000002 -2.16881 -2.16881 -2.16881 -25.0628 3.9633000000000003 11.096800000000002 1.68349 1.68349 1.68349 -26.0628 2.9633000000000003 11.096800000000002 -0.146271 -0.146271 -0.146271 -26.0628 3.9633000000000003 11.096800000000002 -0.195357 -0.195357 -0.195357 -25.0628 2.9633000000000003 12.096800000000002 -0.102728 -0.102728 -0.102728 -25.0628 2.9633000000000003 13.096800000000002 -5.06904 -5.06904 -5.06904 -25.0628 3.9633000000000003 13.096800000000002 0.135338 0.135338 0.135338 -26.0628 2.9633000000000003 12.096800000000002 -1.35702 -1.35702 -1.35702 -26.0628 2.9633000000000003 13.096800000000002 -0.639259 -0.639259 -0.639259 -26.0628 3.9633000000000003 12.096800000000002 1.09146 1.09146 1.09146 -26.0628 3.9633000000000003 13.096800000000002 0.0951023 0.0951023 0.0951023 -25.0628 4.9633 11.096800000000002 -3.29174 -3.29174 -3.29174 -25.0628 5.9633 11.096800000000002 1.23232 1.23232 1.23232 -26.0628 4.9633 11.096800000000002 0.538403 0.538403 0.538403 -26.0628 5.9633 11.096800000000002 0.516712 0.516712 0.516712 -25.0628 4.9633 13.096800000000002 4.14274 4.14274 4.14274 -25.0628 5.9633 12.096800000000002 -0.748784 -0.748784 -0.748784 -25.0628 5.9633 13.096800000000002 -1.93141 -1.93141 -1.93141 -26.0628 4.9633 12.096800000000002 0.338066 0.338066 0.338066 -26.0628 4.9633 13.096800000000002 -0.605918 -0.605918 -0.605918 -26.0628 5.9633 12.096800000000002 1.39099 1.39099 1.39099 -26.0628 5.9633 13.096800000000002 1.03365 1.03365 1.03365 -27.0628 3.9633000000000003 11.096800000000002 -2.23919 -2.23919 -2.23919 -28.0628 3.9633000000000003 10.096800000000002 -2.37731 -2.37731 -2.37731 -28.0628 3.9633000000000003 11.096800000000002 -1.58976 -1.58976 -1.58976 -27.0628 2.9633000000000003 13.096800000000002 -1.76958 -1.76958 -1.76958 -27.0628 3.9633000000000003 12.096800000000002 -1.57412 -1.57412 -1.57412 -27.0628 3.9633000000000003 13.096800000000002 0.264392 0.264392 0.264392 -28.0628 2.9633000000000003 12.096800000000002 -8.23094 -8.23094 -8.23094 -28.0628 2.9633000000000003 13.096800000000002 -4.77637 -4.77637 -4.77637 -28.0628 3.9633000000000003 12.096800000000002 2.92658 2.92658 2.92658 -28.0628 3.9633000000000003 13.096800000000002 -4.6057 -4.6057 -4.6057 -27.0628 4.9633 10.096800000000002 1.29343 1.29343 1.29343 -27.0628 4.9633 11.096800000000002 2.14269 2.14269 2.14269 -27.0628 5.9633 10.096800000000002 0.665093 0.665093 0.665093 -27.0628 5.9633 11.096800000000002 0.059885 0.059885 0.059885 -28.0628 4.9633 10.096800000000002 -1.21055 -1.21055 -1.21055 -28.0628 5.9633 10.096800000000002 1.20762 1.20762 1.20762 -27.0628 4.9633 12.096800000000002 -2.49904 -2.49904 -2.49904 -27.0628 4.9633 13.096800000000002 -2.20731 -2.20731 -2.20731 -27.0628 5.9633 12.096800000000002 -1.27027 -1.27027 -1.27027 -27.0628 5.9633 13.096800000000002 -0.929858 -0.929858 -0.929858 -28.0628 4.9633 13.096800000000002 -18.8257 -18.8257 -18.8257 -28.0628 5.9633 13.096800000000002 -12.5835 -12.5835 -12.5835 -25.0628 9.9633 8.096800000000002 -6.27181 -6.27181 -6.27181 -25.0628 9.9633 9.096800000000002 -6.31073 -6.31073 -6.31073 -26.0628 9.9633 9.096800000000002 -2.28154 -2.28154 -2.28154 -25.0628 6.9633 10.096800000000002 51.0551 51.0551 51.0551 -25.0628 6.9633 11.096800000000002 3.37069 3.37069 3.37069 -25.0628 7.9633 10.096800000000002 71.5974 71.5974 71.5974 -25.0628 7.9633 11.096800000000002 1.18864 1.18864 1.18864 -26.0628 7.9633 10.096800000000002 0.0428654 0.0428654 0.0428654 -26.0628 7.9633 11.096800000000002 0.762744 0.762744 0.762744 -25.0628 6.9633 12.096800000000002 -1.52361 -1.52361 -1.52361 -25.0628 6.9633 13.096800000000002 -4.41994 -4.41994 -4.41994 -25.0628 7.9633 12.096800000000002 -0.918853 -0.918853 -0.918853 -25.0628 7.9633 13.096800000000002 1.9761 1.9761 1.9761 -26.0628 6.9633 13.096800000000002 -4.38009 -4.38009 -4.38009 -26.0628 7.9633 12.096800000000002 4.15847 4.15847 4.15847 -26.0628 7.9633 13.096800000000002 -2.63277 -2.63277 -2.63277 -25.0628 8.9633 10.096800000000002 -2.86951 -2.86951 -2.86951 -25.0628 9.9633 10.096800000000002 6.05844 6.05844 6.05844 -26.0628 8.9633 10.096800000000002 -2.42633 -2.42633 -2.42633 -26.0628 8.9633 11.096800000000002 -0.361808 -0.361808 -0.361808 -26.0628 9.9633 10.096800000000002 -4.16611 -4.16611 -4.16611 -26.0628 9.9633 11.096800000000002 2.43865 2.43865 2.43865 -25.0628 8.9633 13.096800000000002 0.276757 0.276757 0.276757 -25.0628 9.9633 13.096800000000002 -0.611187 -0.611187 -0.611187 -26.0628 8.9633 12.096800000000002 4.88304 4.88304 4.88304 -26.0628 8.9633 13.096800000000002 0.358555 0.358555 0.358555 -26.0628 9.9633 12.096800000000002 -18.0672 -18.0672 -18.0672 -26.0628 9.9633 13.096800000000002 -45.2779 -45.2779 -45.2779 -27.0628 6.9633 10.096800000000002 1.58796 1.58796 1.58796 -27.0628 6.9633 11.096800000000002 -0.0245177 -0.0245177 -0.0245177 -27.0628 7.9633 11.096800000000002 0.428729 0.428729 0.428729 -28.0628 6.9633 10.096800000000002 0.941771 0.941771 0.941771 -28.0628 7.9633 10.096800000000002 -1.0234 -1.0234 -1.0234 -28.0628 7.9633 11.096800000000002 0.286042 0.286042 0.286042 -27.0628 6.9633 12.096800000000002 -2.73601 -2.73601 -2.73601 -27.0628 6.9633 13.096800000000002 -6.074 -6.074 -6.074 -27.0628 7.9633 12.096800000000002 -4.0183 -4.0183 -4.0183 -27.0628 7.9633 13.096800000000002 -0.239334 -0.239334 -0.239334 -28.0628 6.9633 12.096800000000002 -10.1346 -10.1346 -10.1346 -28.0628 6.9633 13.096800000000002 -25.2035 -25.2035 -25.2035 -28.0628 7.9633 12.096800000000002 4.4365 4.4365 4.4365 -28.0628 7.9633 13.096800000000002 -1.14474 -1.14474 -1.14474 -27.0628 8.9633 11.096800000000002 -2.78272 -2.78272 -2.78272 -27.0628 9.9633 10.096800000000002 2.38254 2.38254 2.38254 -27.0628 9.9633 11.096800000000002 22.0551 22.0551 22.0551 -28.0628 8.9633 11.096800000000002 -3.07759 -3.07759 -3.07759 -28.0628 9.9633 11.096800000000002 13.7806 13.7806 13.7806 -27.0628 8.9633 12.096800000000002 2.19052 2.19052 2.19052 -27.0628 8.9633 13.096800000000002 -4.23013 -4.23013 -4.23013 -27.0628 9.9633 12.096800000000002 13.1547 13.1547 13.1547 -27.0628 9.9633 13.096800000000002 -49.2881 -49.2881 -49.2881 -28.0628 8.9633 12.096800000000002 2.81004 2.81004 2.81004 -28.0628 9.9633 12.096800000000002 -12.4563 -12.4563 -12.4563 -29.0628 2.9633000000000003 11.096800000000002 -1.53148 -1.53148 -1.53148 -29.0628 3.9633000000000003 10.096800000000002 0.760913 0.760913 0.760913 -29.0628 3.9633000000000003 11.096800000000002 0.419544 0.419544 0.419544 -30.0628 2.9633000000000003 11.096800000000002 0.205656 0.205656 0.205656 -30.0628 3.9633000000000003 11.096800000000002 -1.81817 -1.81817 -1.81817 -29.0628 2.9633000000000003 12.096800000000002 0.803242 0.803242 0.803242 -29.0628 2.9633000000000003 13.096800000000002 -1.55829 -1.55829 -1.55829 -29.0628 3.9633000000000003 12.096800000000002 2.93743 2.93743 2.93743 -30.0628 2.9633000000000003 12.096800000000002 -1.1029 -1.1029 -1.1029 -30.0628 2.9633000000000003 13.096800000000002 -1.24445 -1.24445 -1.24445 -30.0628 3.9633000000000003 12.096800000000002 -0.387888 -0.387888 -0.387888 -30.0628 3.9633000000000003 13.096800000000002 1.40363 1.40363 1.40363 -29.0628 4.9633 10.096800000000002 -0.646141 -0.646141 -0.646141 -29.0628 4.9633 11.096800000000002 15.0762 15.0762 15.0762 -29.0628 5.9633 10.096800000000002 1.29446 1.29446 1.29446 -30.0628 4.9633 10.096800000000002 -0.171764 -0.171764 -0.171764 -30.0628 4.9633 11.096800000000002 -3.19946 -3.19946 -3.19946 -30.0628 5.9633 10.096800000000002 1.00035 1.00035 1.00035 -30.0628 5.9633 11.096800000000002 -111.719 -111.719 -111.719 -29.0628 5.9633 12.096800000000002 27.4427 27.4427 27.4427 -29.0628 5.9633 13.096800000000002 15.5497 15.5497 15.5497 -30.0628 5.9633 13.096800000000002 -106.719 -106.719 -106.719 -31.0628 3.9633000000000003 11.096800000000002 -6.706 -6.706 -6.706 -32.062799999999996 3.9633000000000003 11.096800000000002 3.81019 3.81019 3.81019 -31.0628 2.9633000000000003 12.096800000000002 -0.793598 -0.793598 -0.793598 -31.0628 2.9633000000000003 13.096800000000002 -1.92974 -1.92974 -1.92974 -31.0628 3.9633000000000003 12.096800000000002 3.90256 3.90256 3.90256 -31.0628 3.9633000000000003 13.096800000000002 5.44262 5.44262 5.44262 -32.062799999999996 3.9633000000000003 12.096800000000002 -3.24507 -3.24507 -3.24507 -32.062799999999996 3.9633000000000003 13.096800000000002 1.54018 1.54018 1.54018 -31.0628 4.9633 11.096800000000002 -59.5363 -59.5363 -59.5363 -31.0628 5.9633 11.096800000000002 211.725 211.725 211.725 -32.062799999999996 4.9633 11.096800000000002 84.3379 84.3379 84.3379 -32.062799999999996 5.9633 11.096800000000002 153.619 153.619 153.619 -31.0628 4.9633 13.096800000000002 16.4143 16.4143 16.4143 -31.0628 5.9633 13.096800000000002 22.4464 22.4464 22.4464 -32.062799999999996 4.9633 12.096800000000002 -20.945 -20.945 -20.945 -32.062799999999996 4.9633 13.096800000000002 -128.295 -128.295 -128.295 -32.062799999999996 5.9633 12.096800000000002 -28.8775 -28.8775 -28.8775 -32.062799999999996 5.9633 13.096800000000002 -29.5194 -29.5194 -29.5194 -29.0628 6.9633 10.096800000000002 0.152863 0.152863 0.152863 -29.0628 7.9633 10.096800000000002 -0.367805 -0.367805 -0.367805 -29.0628 7.9633 11.096800000000002 1.17851 1.17851 1.17851 -30.0628 6.9633 10.096800000000002 0.619146 0.619146 0.619146 -30.0628 6.9633 11.096800000000002 18.3038 18.3038 18.3038 -30.0628 7.9633 11.096800000000002 -6.3443 -6.3443 -6.3443 -29.0628 6.9633 12.096800000000002 6.93998 6.93998 6.93998 -29.0628 6.9633 13.096800000000002 -11.4391 -11.4391 -11.4391 -29.0628 7.9633 12.096800000000002 -0.132561 -0.132561 -0.132561 -29.0628 7.9633 13.096800000000002 2.67878 2.67878 2.67878 -30.0628 6.9633 12.096800000000002 -132.73 -132.73 -132.73 -30.0628 6.9633 13.096800000000002 -110.262 -110.262 -110.262 -30.0628 7.9633 12.096800000000002 -1.36217 -1.36217 -1.36217 -30.0628 7.9633 13.096800000000002 -31.4672 -31.4672 -31.4672 -29.0628 8.9633 11.096800000000002 3.80693 3.80693 3.80693 -29.0628 9.9633 11.096800000000002 -0.258988 -0.258988 -0.258988 -30.0628 9.9633 11.096800000000002 4.20781 4.20781 4.20781 -29.0628 8.9633 12.096800000000002 6.71989 6.71989 6.71989 -29.0628 9.9633 12.096800000000002 -1.51517 -1.51517 -1.51517 -29.0628 9.9633 13.096800000000002 -1.74778 -1.74778 -1.74778 -30.0628 8.9633 12.096800000000002 -9.04666 -9.04666 -9.04666 -30.0628 8.9633 13.096800000000002 38.071 38.071 38.071 -30.0628 9.9633 12.096800000000002 20.3102 20.3102 20.3102 -30.0628 9.9633 13.096800000000002 -94.2244 -94.2244 -94.2244 -31.0628 6.9633 11.096800000000002 -52.2976 -52.2976 -52.2976 -32.062799999999996 6.9633 11.096800000000002 223.912 223.912 223.912 -31.0628 6.9633 12.096800000000002 21.48 21.48 21.48 -31.0628 6.9633 13.096800000000002 -140.98 -140.98 -140.98 -31.0628 7.9633 12.096800000000002 -7.60267 -7.60267 -7.60267 -32.062799999999996 6.9633 12.096800000000002 24.4076 24.4076 24.4076 -32.062799999999996 6.9633 13.096800000000002 147.14 147.14 147.14 -32.062799999999996 7.9633 12.096800000000002 37.2008 37.2008 37.2008 -31.0628 9.9633 11.096800000000002 -21.8534 -21.8534 -21.8534 -32.062799999999996 8.9633 11.096800000000002 3.14359 3.14359 3.14359 -32.062799999999996 9.9633 11.096800000000002 -16.7886 -16.7886 -16.7886 -31.0628 8.9633 12.096800000000002 99.5636 99.5636 99.5636 -31.0628 9.9633 12.096800000000002 34.4528 34.4528 34.4528 -31.0628 9.9633 13.096800000000002 -106.937 -106.937 -106.937 -32.062799999999996 8.9633 12.096800000000002 -16.1389 -16.1389 -16.1389 -32.062799999999996 8.9633 13.096800000000002 -34.5236 -34.5236 -34.5236 -32.062799999999996 9.9633 12.096800000000002 63.9745 63.9745 63.9745 -32.062799999999996 9.9633 13.096800000000002 22.6701 22.6701 22.6701 -25.0628 2.9633000000000003 14.096800000000002 -1.27788 -1.27788 -1.27788 -25.0628 2.9633000000000003 15.096800000000002 3.06262 3.06262 3.06262 -25.0628 3.9633000000000003 14.096800000000002 -2.52828 -2.52828 -2.52828 -26.0628 2.9633000000000003 14.096800000000002 11.3415 11.3415 11.3415 -26.0628 2.9633000000000003 15.096800000000002 0.284032 0.284032 0.284032 -26.0628 3.9633000000000003 14.096800000000002 5.14032 5.14032 5.14032 -26.0628 3.9633000000000003 15.096800000000002 -2.29171 -2.29171 -2.29171 -25.0628 2.9633000000000003 16.0968 1.37574 1.37574 1.37574 -25.0628 2.9633000000000003 17.0968 7.89879 7.89879 7.89879 -25.0628 3.9633000000000003 16.0968 14.5872 14.5872 14.5872 -25.0628 3.9633000000000003 17.0968 -36.1059 -36.1059 -36.1059 -26.0628 2.9633000000000003 16.0968 -1.5793 -1.5793 -1.5793 -26.0628 3.9633000000000003 16.0968 10.3853 10.3853 10.3853 -26.0628 3.9633000000000003 17.0968 14.4376 14.4376 14.4376 -25.0628 4.9633 14.096800000000002 4.37582 4.37582 4.37582 -25.0628 5.9633 14.096800000000002 1.04097 1.04097 1.04097 -25.0628 5.9633 15.096800000000002 -8.67809 -8.67809 -8.67809 -26.0628 4.9633 14.096800000000002 0.217558 0.217558 0.217558 -26.0628 4.9633 15.096800000000002 0.353602 0.353602 0.353602 -26.0628 5.9633 14.096800000000002 -0.529652 -0.529652 -0.529652 -26.0628 5.9633 15.096800000000002 -13.6048 -13.6048 -13.6048 -25.0628 4.9633 16.0968 29.5995 29.5995 29.5995 -25.0628 4.9633 17.0968 -14.4688 -14.4688 -14.4688 -25.0628 5.9633 16.0968 18.9037 18.9037 18.9037 -25.0628 5.9633 17.0968 -2.38523 -2.38523 -2.38523 -26.0628 4.9633 16.0968 -6.52931 -6.52931 -6.52931 -26.0628 4.9633 17.0968 -37.0014 -37.0014 -37.0014 -26.0628 5.9633 16.0968 18.1807 18.1807 18.1807 -26.0628 5.9633 17.0968 -12.7406 -12.7406 -12.7406 -27.0628 2.9633000000000003 15.096800000000002 5.63251 5.63251 5.63251 -27.0628 3.9633000000000003 14.096800000000002 2.22662 2.22662 2.22662 -27.0628 3.9633000000000003 15.096800000000002 0.103822 0.103822 0.103822 -28.0628 2.9633000000000003 14.096800000000002 -0.0721285 -0.0721285 -0.0721285 -28.0628 2.9633000000000003 15.096800000000002 -1.41956 -1.41956 -1.41956 -28.0628 3.9633000000000003 14.096800000000002 2.78069 2.78069 2.78069 -28.0628 3.9633000000000003 15.096800000000002 -0.0702709 -0.0702709 -0.0702709 -27.0628 3.9633000000000003 16.0968 -4.5995 -4.5995 -4.5995 -27.0628 3.9633000000000003 17.0968 46.8082 46.8082 46.8082 -28.0628 2.9633000000000003 16.0968 1.44377 1.44377 1.44377 -28.0628 2.9633000000000003 17.0968 5.06064 5.06064 5.06064 -28.0628 3.9633000000000003 16.0968 -29.2525 -29.2525 -29.2525 -28.0628 3.9633000000000003 17.0968 -17.6757 -17.6757 -17.6757 -27.0628 4.9633 14.096800000000002 1.24324 1.24324 1.24324 -27.0628 4.9633 15.096800000000002 -0.734573 -0.734573 -0.734573 -27.0628 5.9633 14.096800000000002 -6.01495 -6.01495 -6.01495 -27.0628 5.9633 15.096800000000002 0.156877 0.156877 0.156877 -28.0628 4.9633 14.096800000000002 6.16998 6.16998 6.16998 -28.0628 4.9633 15.096800000000002 4.56711 4.56711 4.56711 -28.0628 5.9633 14.096800000000002 -0.946179 -0.946179 -0.946179 -27.0628 4.9633 16.0968 -1.78063 -1.78063 -1.78063 -27.0628 4.9633 17.0968 -16.3845 -16.3845 -16.3845 -27.0628 5.9633 16.0968 -0.546984 -0.546984 -0.546984 -27.0628 5.9633 17.0968 -2.23949 -2.23949 -2.23949 -28.0628 4.9633 16.0968 13.9654 13.9654 13.9654 -28.0628 4.9633 17.0968 -6.93305 -6.93305 -6.93305 -28.0628 5.9633 16.0968 27.7737 27.7737 27.7737 -28.0628 5.9633 17.0968 -3.35724 -3.35724 -3.35724 -25.0628 2.9633000000000003 18.0968 120.794 120.794 120.794 -25.0628 3.9633000000000003 18.0968 -60.7245 -60.7245 -60.7245 -25.0628 3.9633000000000003 19.0968 20.4683 20.4683 20.4683 -26.0628 3.9633000000000003 19.0968 -82.4951 -82.4951 -82.4951 -25.0628 2.9633000000000003 20.0968 -62.7677 -62.7677 -62.7677 -25.0628 2.9633000000000003 21.0968 -59.9027 -59.9027 -59.9027 -25.0628 3.9633000000000003 20.0968 69.4189 69.4189 69.4189 -25.0628 3.9633000000000003 21.0968 9.85004 9.85004 9.85004 -26.0628 2.9633000000000003 20.0968 -262.242 -262.242 -262.242 -26.0628 2.9633000000000003 21.0968 53.3193 53.3193 53.3193 -26.0628 3.9633000000000003 20.0968 -8.87427 -8.87427 -8.87427 -26.0628 3.9633000000000003 21.0968 -3.57767 -3.57767 -3.57767 -25.0628 4.9633 18.0968 10.9667 10.9667 10.9667 -25.0628 4.9633 19.0968 -84.1466 -84.1466 -84.1466 -25.0628 5.9633 18.0968 3.24243 3.24243 3.24243 -25.0628 5.9633 19.0968 20.1136 20.1136 20.1136 -26.0628 5.9633 18.0968 -0.900078 -0.900078 -0.900078 -25.0628 4.9633 20.0968 185.066 185.066 185.066 -25.0628 4.9633 21.0968 -6.68124 -6.68124 -6.68124 -25.0628 5.9633 20.0968 -2.21571 -2.21571 -2.21571 -25.0628 5.9633 21.0968 -2.65676 -2.65676 -2.65676 -26.0628 4.9633 20.0968 12.634 12.634 12.634 -26.0628 4.9633 21.0968 -18.9458 -18.9458 -18.9458 -26.0628 5.9633 21.0968 -8.16402 -8.16402 -8.16402 -27.0628 3.9633000000000003 19.0968 -118.7 -118.7 -118.7 -28.0628 2.9633000000000003 18.0968 3.41094 3.41094 3.41094 -28.0628 2.9633000000000003 19.0968 3.35875 3.35875 3.35875 -28.0628 3.9633000000000003 18.0968 -5.67928 -5.67928 -5.67928 -28.0628 3.9633000000000003 19.0968 0.489091 0.489091 0.489091 -27.0628 2.9633000000000003 21.0968 100.064 100.064 100.064 -27.0628 3.9633000000000003 20.0968 52.3699 52.3699 52.3699 -27.0628 3.9633000000000003 21.0968 74.2702 74.2702 74.2702 -28.0628 2.9633000000000003 20.0968 1.29459 1.29459 1.29459 -28.0628 2.9633000000000003 21.0968 6.08015 6.08015 6.08015 -28.0628 3.9633000000000003 20.0968 -0.604739 -0.604739 -0.604739 -28.0628 3.9633000000000003 21.0968 5.46697 5.46697 5.46697 -27.0628 5.9633 18.0968 -1.36027 -1.36027 -1.36027 -28.0628 4.9633 18.0968 2.35455 2.35455 2.35455 -28.0628 4.9633 19.0968 3.27092 3.27092 3.27092 -28.0628 5.9633 18.0968 -16.856 -16.856 -16.856 -27.0628 4.9633 20.0968 92.1096 92.1096 92.1096 -27.0628 4.9633 21.0968 -4.02865 -4.02865 -4.02865 -27.0628 5.9633 21.0968 -8.26166 -8.26166 -8.26166 -28.0628 4.9633 20.0968 -1.05558 -1.05558 -1.05558 -28.0628 4.9633 21.0968 -1.43149 -1.43149 -1.43149 -28.0628 5.9633 21.0968 -1.36673 -1.36673 -1.36673 -25.0628 6.9633 14.096800000000002 -8.0499 -8.0499 -8.0499 -25.0628 6.9633 15.096800000000002 5.01947 5.01947 5.01947 -25.0628 7.9633 14.096800000000002 -5.85445 -5.85445 -5.85445 -25.0628 7.9633 15.096800000000002 0.718631 0.718631 0.718631 -26.0628 6.9633 15.096800000000002 3.37069 3.37069 3.37069 -25.0628 6.9633 16.0968 5.19791 5.19791 5.19791 -25.0628 6.9633 17.0968 3.42792 3.42792 3.42792 -25.0628 7.9633 16.0968 5.27977 5.27977 5.27977 -25.0628 7.9633 17.0968 3.05503 3.05503 3.05503 -26.0628 6.9633 16.0968 2.71242 2.71242 2.71242 -26.0628 7.9633 16.0968 -2.81537 -2.81537 -2.81537 -26.0628 7.9633 17.0968 -2.42755 -2.42755 -2.42755 -25.0628 8.9633 14.096800000000002 -2.02096 -2.02096 -2.02096 -25.0628 8.9633 15.096800000000002 -1.90357 -1.90357 -1.90357 -25.0628 9.9633 14.096800000000002 3.52138 3.52138 3.52138 -25.0628 9.9633 15.096800000000002 -3.44992 -3.44992 -3.44992 -26.0628 8.9633 14.096800000000002 1.01786 1.01786 1.01786 -26.0628 9.9633 14.096800000000002 7.56396 7.56396 7.56396 -26.0628 9.9633 15.096800000000002 1.97603 1.97603 1.97603 -25.0628 8.9633 16.0968 3.17047 3.17047 3.17047 -25.0628 8.9633 17.0968 3.01856 3.01856 3.01856 -25.0628 9.9633 16.0968 -3.12261 -3.12261 -3.12261 -25.0628 9.9633 17.0968 0.210928 0.210928 0.210928 -26.0628 8.9633 17.0968 -2.14312 -2.14312 -2.14312 -26.0628 9.9633 16.0968 1.59092 1.59092 1.59092 -26.0628 9.9633 17.0968 5.55418 5.55418 5.55418 -27.0628 7.9633 14.096800000000002 2.24171 2.24171 2.24171 -28.0628 7.9633 14.096800000000002 -11.4104 -11.4104 -11.4104 -28.0628 7.9633 15.096800000000002 -3.84039 -3.84039 -3.84039 -27.0628 6.9633 16.0968 1.12531 1.12531 1.12531 -27.0628 6.9633 17.0968 -2.97802 -2.97802 -2.97802 -27.0628 7.9633 17.0968 8.01371 8.01371 8.01371 -28.0628 6.9633 17.0968 19.8014 19.8014 19.8014 -28.0628 7.9633 17.0968 -0.780735 -0.780735 -0.780735 -27.0628 8.9633 14.096800000000002 -7.45311 -7.45311 -7.45311 -27.0628 9.9633 14.096800000000002 10.3229 10.3229 10.3229 -27.0628 9.9633 15.096800000000002 -1.25166 -1.25166 -1.25166 -28.0628 8.9633 14.096800000000002 -7.00369 -7.00369 -7.00369 -28.0628 8.9633 15.096800000000002 -6.05761 -6.05761 -6.05761 -28.0628 9.9633 14.096800000000002 5.90875 5.90875 5.90875 -28.0628 9.9633 15.096800000000002 -6.22791 -6.22791 -6.22791 -27.0628 8.9633 17.0968 8.3845 8.3845 8.3845 -27.0628 9.9633 16.0968 -2.98268 -2.98268 -2.98268 -27.0628 9.9633 17.0968 -1.87654 -1.87654 -1.87654 -28.0628 9.9633 16.0968 -4.61727 -4.61727 -4.61727 -28.0628 9.9633 17.0968 4.30525 4.30525 4.30525 -25.0628 6.9633 18.0968 -1.85457 -1.85457 -1.85457 -25.0628 7.9633 18.0968 -12.7885 -12.7885 -12.7885 -25.0628 7.9633 19.0968 -4.0578 -4.0578 -4.0578 -26.0628 6.9633 18.0968 -2.50207 -2.50207 -2.50207 -26.0628 7.9633 18.0968 -3.74414 -3.74414 -3.74414 -26.0628 7.9633 19.0968 -4.34873 -4.34873 -4.34873 -25.0628 6.9633 20.0968 9.46041 9.46041 9.46041 -25.0628 6.9633 21.0968 -3.37571 -3.37571 -3.37571 -25.0628 7.9633 20.0968 0.679569 0.679569 0.679569 -25.0628 7.9633 21.0968 -0.537936 -0.537936 -0.537936 -26.0628 6.9633 21.0968 -29.1649 -29.1649 -29.1649 -26.0628 7.9633 20.0968 0.129678 0.129678 0.129678 -26.0628 7.9633 21.0968 -4.76401 -4.76401 -4.76401 -25.0628 8.9633 18.0968 -0.170718 -0.170718 -0.170718 -25.0628 8.9633 19.0968 -0.969807 -0.969807 -0.969807 -25.0628 9.9633 18.0968 -0.339817 -0.339817 -0.339817 -25.0628 9.9633 19.0968 0.559345 0.559345 0.559345 -26.0628 8.9633 18.0968 -4.89526 -4.89526 -4.89526 -26.0628 8.9633 19.0968 7.91992 7.91992 7.91992 -26.0628 9.9633 18.0968 -5.69926 -5.69926 -5.69926 -25.0628 8.9633 20.0968 1.31165 1.31165 1.31165 -25.0628 8.9633 21.0968 -0.244205 -0.244205 -0.244205 -26.0628 8.9633 20.0968 2.06246 2.06246 2.06246 -26.0628 8.9633 21.0968 -2.49535 -2.49535 -2.49535 -27.0628 6.9633 18.0968 -3.81428 -3.81428 -3.81428 -27.0628 6.9633 19.0968 -8.3227 -8.3227 -8.3227 -27.0628 7.9633 18.0968 9.15278 9.15278 9.15278 -27.0628 7.9633 19.0968 7.10818 7.10818 7.10818 -28.0628 6.9633 18.0968 -21.0197 -21.0197 -21.0197 -28.0628 6.9633 19.0968 0.611232 0.611232 0.611232 -28.0628 7.9633 18.0968 23.1199 23.1199 23.1199 -28.0628 7.9633 19.0968 4.97158 4.97158 4.97158 -27.0628 6.9633 20.0968 -11.3985 -11.3985 -11.3985 -27.0628 6.9633 21.0968 -29.2193 -29.2193 -29.2193 -27.0628 7.9633 20.0968 8.88709 8.88709 8.88709 -27.0628 7.9633 21.0968 -3.53755 -3.53755 -3.53755 -28.0628 6.9633 20.0968 -8.32585 -8.32585 -8.32585 -28.0628 6.9633 21.0968 -8.95571 -8.95571 -8.95571 -28.0628 7.9633 20.0968 5.33615 5.33615 5.33615 -28.0628 7.9633 21.0968 0.38424 0.38424 0.38424 -27.0628 8.9633 18.0968 25.5323 25.5323 25.5323 -27.0628 8.9633 19.0968 30.9268 30.9268 30.9268 -27.0628 9.9633 18.0968 6.87646 6.87646 6.87646 -27.0628 9.9633 19.0968 4.56702 4.56702 4.56702 -28.0628 8.9633 18.0968 0.544165 0.544165 0.544165 -28.0628 8.9633 19.0968 -7.0074 -7.0074 -7.0074 -28.0628 9.9633 18.0968 -14.2372 -14.2372 -14.2372 -28.0628 9.9633 19.0968 -34.7269 -34.7269 -34.7269 -27.0628 8.9633 20.0968 1.97694 1.97694 1.97694 -28.0628 8.9633 20.0968 25.4399 25.4399 25.4399 -29.0628 2.9633000000000003 14.096800000000002 2.71302 2.71302 2.71302 -29.0628 2.9633000000000003 15.096800000000002 0.0224649 0.0224649 0.0224649 -29.0628 3.9633000000000003 15.096800000000002 -2.01287 -2.01287 -2.01287 -30.0628 2.9633000000000003 14.096800000000002 1.05773 1.05773 1.05773 -30.0628 2.9633000000000003 15.096800000000002 0.661883 0.661883 0.661883 -30.0628 3.9633000000000003 14.096800000000002 4.19931 4.19931 4.19931 -30.0628 3.9633000000000003 15.096800000000002 4.51019 4.51019 4.51019 -29.0628 2.9633000000000003 17.0968 0.878868 0.878868 0.878868 -29.0628 3.9633000000000003 16.0968 2.47946 2.47946 2.47946 -29.0628 3.9633000000000003 17.0968 -8.45299 -8.45299 -8.45299 -30.0628 3.9633000000000003 16.0968 -5.79174 -5.79174 -5.79174 -30.0628 4.9633 15.096800000000002 23.5897 23.5897 23.5897 -30.0628 5.9633 14.096800000000002 14.056 14.056 14.056 -29.0628 4.9633 16.0968 2.11409 2.11409 2.11409 -29.0628 4.9633 17.0968 -7.88411 -7.88411 -7.88411 -29.0628 5.9633 16.0968 7.67127 7.67127 7.67127 -29.0628 5.9633 17.0968 0.402037 0.402037 0.402037 -30.0628 4.9633 16.0968 21.5199 21.5199 21.5199 -30.0628 4.9633 17.0968 5.34436 5.34436 5.34436 -30.0628 5.9633 17.0968 -1.07788 -1.07788 -1.07788 -31.0628 3.9633000000000003 14.096800000000002 9.50105 9.50105 9.50105 -31.0628 3.9633000000000003 15.096800000000002 0.91627 0.91627 0.91627 -31.0628 4.9633 14.096800000000002 5.40566 5.40566 5.40566 -31.0628 4.9633 15.096800000000002 2.51951 2.51951 2.51951 -31.0628 5.9633 14.096800000000002 -8.64138 -8.64138 -8.64138 -31.0628 5.9633 15.096800000000002 -16.6625 -16.6625 -16.6625 -32.062799999999996 4.9633 14.096800000000002 1.07586 1.07586 1.07586 -32.062799999999996 4.9633 15.096800000000002 7.2785 7.2785 7.2785 -32.062799999999996 5.9633 14.096800000000002 -24.3449 -24.3449 -24.3449 -32.062799999999996 5.9633 15.096800000000002 -3.23297 -3.23297 -3.23297 -31.0628 4.9633 16.0968 -0.602881 -0.602881 -0.602881 -31.0628 4.9633 17.0968 -14.9522 -14.9522 -14.9522 -31.0628 5.9633 16.0968 2.16256 2.16256 2.16256 -31.0628 5.9633 17.0968 -0.786074 -0.786074 -0.786074 -32.062799999999996 4.9633 16.0968 20.7463 20.7463 20.7463 -32.062799999999996 5.9633 16.0968 19.0425 19.0425 19.0425 -32.062799999999996 5.9633 17.0968 17.7888 17.7888 17.7888 -29.0628 2.9633000000000003 18.0968 6.73596 6.73596 6.73596 -29.0628 2.9633000000000003 19.0968 4.02636 4.02636 4.02636 -29.0628 3.9633000000000003 18.0968 -0.342933 -0.342933 -0.342933 -29.0628 3.9633000000000003 19.0968 -4.50363 -4.50363 -4.50363 -30.0628 2.9633000000000003 18.0968 -1.36724 -1.36724 -1.36724 -30.0628 2.9633000000000003 19.0968 -0.0289614 -0.0289614 -0.0289614 -30.0628 3.9633000000000003 18.0968 -10.7745 -10.7745 -10.7745 -30.0628 3.9633000000000003 19.0968 -9.52103 -9.52103 -9.52103 -29.0628 2.9633000000000003 21.0968 0.847168 0.847168 0.847168 -29.0628 3.9633000000000003 20.0968 -1.739 -1.739 -1.739 -29.0628 3.9633000000000003 21.0968 3.50217 3.50217 3.50217 -30.0628 2.9633000000000003 21.0968 3.7475 3.7475 3.7475 -30.0628 3.9633000000000003 20.0968 5.2108 5.2108 5.2108 -30.0628 3.9633000000000003 21.0968 1.85083 1.85083 1.85083 -29.0628 4.9633 18.0968 10.6627 10.6627 10.6627 -29.0628 4.9633 19.0968 0.118075 0.118075 0.118075 -29.0628 5.9633 18.0968 11.6765 11.6765 11.6765 -29.0628 5.9633 19.0968 -2.67084 -2.67084 -2.67084 -30.0628 4.9633 19.0968 1.62424 1.62424 1.62424 -30.0628 5.9633 18.0968 -17.9704 -17.9704 -17.9704 -30.0628 5.9633 19.0968 4.37224 4.37224 4.37224 -29.0628 4.9633 20.0968 -1.12491 -1.12491 -1.12491 -29.0628 4.9633 21.0968 -5.02076 -5.02076 -5.02076 -29.0628 5.9633 20.0968 -0.938394 -0.938394 -0.938394 -29.0628 5.9633 21.0968 3.86779 3.86779 3.86779 -30.0628 4.9633 20.0968 -1.96322 -1.96322 -1.96322 -30.0628 4.9633 21.0968 -3.05832 -3.05832 -3.05832 -30.0628 5.9633 20.0968 0.543387 0.543387 0.543387 -30.0628 5.9633 21.0968 0.158649 0.158649 0.158649 -31.0628 2.9633000000000003 18.0968 -0.705218 -0.705218 -0.705218 -31.0628 3.9633000000000003 18.0968 -1.71545 -1.71545 -1.71545 -31.0628 3.9633000000000003 19.0968 -1.36681 -1.36681 -1.36681 -32.062799999999996 2.9633000000000003 18.0968 -0.391176 -0.391176 -0.391176 -32.062799999999996 2.9633000000000003 19.0968 -0.602754 -0.602754 -0.602754 -32.062799999999996 3.9633000000000003 18.0968 5.33347 5.33347 5.33347 -32.062799999999996 3.9633000000000003 19.0968 3.73252 3.73252 3.73252 -31.0628 2.9633000000000003 21.0968 8.95803 8.95803 8.95803 -31.0628 3.9633000000000003 20.0968 0.543913 0.543913 0.543913 -31.0628 3.9633000000000003 21.0968 8.60021 8.60021 8.60021 -31.0628 4.9633 18.0968 8.24603 8.24603 8.24603 -31.0628 4.9633 19.0968 11.4991 11.4991 11.4991 -31.0628 5.9633 18.0968 17.7558 17.7558 17.7558 -31.0628 5.9633 19.0968 11.1365 11.1365 11.1365 -32.062799999999996 4.9633 18.0968 -24.0555 -24.0555 -24.0555 -32.062799999999996 4.9633 19.0968 -2.11763 -2.11763 -2.11763 -32.062799999999996 5.9633 18.0968 2.31378 2.31378 2.31378 -31.0628 5.9633 21.0968 3.89377 3.89377 3.89377 -29.0628 6.9633 14.096800000000002 0.392812 0.392812 0.392812 -29.0628 7.9633 14.096800000000002 2.80688 2.80688 2.80688 -29.0628 7.9633 15.096800000000002 2.02575 2.02575 2.02575 -30.0628 6.9633 14.096800000000002 19.8653 19.8653 19.8653 -30.0628 6.9633 15.096800000000002 11.6974 11.6974 11.6974 -30.0628 7.9633 14.096800000000002 -8.5293 -8.5293 -8.5293 -30.0628 7.9633 15.096800000000002 -4.97856 -4.97856 -4.97856 -29.0628 6.9633 17.0968 -5.09159 -5.09159 -5.09159 -29.0628 7.9633 17.0968 41.4244 41.4244 41.4244 -30.0628 7.9633 16.0968 -22.5096 -22.5096 -22.5096 -29.0628 8.9633 14.096800000000002 -4.16096 -4.16096 -4.16096 -29.0628 8.9633 15.096800000000002 5.13869 5.13869 5.13869 -29.0628 9.9633 14.096800000000002 3.61994 3.61994 3.61994 -29.0628 9.9633 15.096800000000002 2.84738 2.84738 2.84738 -30.0628 8.9633 14.096800000000002 117.87 117.87 117.87 -30.0628 8.9633 15.096800000000002 4.95803 4.95803 4.95803 -30.0628 9.9633 14.096800000000002 -66.6281 -66.6281 -66.6281 -30.0628 9.9633 15.096800000000002 6.12012 6.12012 6.12012 -29.0628 8.9633 16.0968 4.37705 4.37705 4.37705 -29.0628 8.9633 17.0968 -5.23165 -5.23165 -5.23165 -29.0628 9.9633 16.0968 2.1833 2.1833 2.1833 -29.0628 9.9633 17.0968 8.47059 8.47059 8.47059 -30.0628 8.9633 16.0968 5.96054 5.96054 5.96054 -30.0628 8.9633 17.0968 11.8069 11.8069 11.8069 -30.0628 9.9633 17.0968 2.89632 2.89632 2.89632 -31.0628 6.9633 14.096800000000002 6.40096 6.40096 6.40096 -31.0628 6.9633 15.096800000000002 -3.05284 -3.05284 -3.05284 -31.0628 7.9633 14.096800000000002 -19.1655 -19.1655 -19.1655 -31.0628 7.9633 15.096800000000002 -12.9454 -12.9454 -12.9454 -32.062799999999996 6.9633 14.096800000000002 11.5361 11.5361 11.5361 -32.062799999999996 6.9633 15.096800000000002 16.6922 16.6922 16.6922 -32.062799999999996 7.9633 15.096800000000002 3.77339 3.77339 3.77339 -31.0628 6.9633 16.0968 -2.48389 -2.48389 -2.48389 -31.0628 6.9633 17.0968 -3.29226 -3.29226 -3.29226 -31.0628 7.9633 16.0968 7.92893 7.92893 7.92893 -31.0628 7.9633 17.0968 12.6964 12.6964 12.6964 -32.062799999999996 6.9633 16.0968 46.9378 46.9378 46.9378 -32.062799999999996 6.9633 17.0968 -1.73055 -1.73055 -1.73055 -32.062799999999996 7.9633 16.0968 23.846 23.846 23.846 -32.062799999999996 7.9633 17.0968 -19.8885 -19.8885 -19.8885 -31.0628 8.9633 15.096800000000002 7.14641 7.14641 7.14641 -31.0628 9.9633 14.096800000000002 80.3386 80.3386 80.3386 -31.0628 9.9633 15.096800000000002 14.0202 14.0202 14.0202 -32.062799999999996 9.9633 14.096800000000002 61.5221 61.5221 61.5221 -32.062799999999996 9.9633 15.096800000000002 -33.2656 -33.2656 -33.2656 -31.0628 8.9633 16.0968 2.41172 2.41172 2.41172 -31.0628 8.9633 17.0968 6.80121 6.80121 6.80121 -31.0628 9.9633 16.0968 24.4432 24.4432 24.4432 -31.0628 9.9633 17.0968 -15.6146 -15.6146 -15.6146 -32.062799999999996 8.9633 16.0968 -0.710499 -0.710499 -0.710499 -32.062799999999996 8.9633 17.0968 -7.35447 -7.35447 -7.35447 -32.062799999999996 9.9633 16.0968 16.1496 16.1496 16.1496 -32.062799999999996 9.9633 17.0968 -27.4181 -27.4181 -27.4181 -29.0628 6.9633 18.0968 -30.5112 -30.5112 -30.5112 -29.0628 6.9633 19.0968 -3.95475 -3.95475 -3.95475 -29.0628 7.9633 18.0968 17.0937 17.0937 17.0937 -29.0628 7.9633 19.0968 -9.37322 -9.37322 -9.37322 -30.0628 6.9633 18.0968 4.44934 4.44934 4.44934 -30.0628 6.9633 19.0968 -1.80363 -1.80363 -1.80363 -30.0628 7.9633 18.0968 -1.273 -1.273 -1.273 -30.0628 7.9633 19.0968 -4.33074 -4.33074 -4.33074 -29.0628 6.9633 20.0968 4.23793 4.23793 4.23793 -29.0628 6.9633 21.0968 -4.35124 -4.35124 -4.35124 -29.0628 7.9633 20.0968 0.731657 0.731657 0.731657 -29.0628 7.9633 21.0968 -5.65983 -5.65983 -5.65983 -30.0628 6.9633 20.0968 2.03603 2.03603 2.03603 -30.0628 6.9633 21.0968 -0.747066 -0.747066 -0.747066 -30.0628 7.9633 20.0968 -9.82138 -9.82138 -9.82138 -30.0628 7.9633 21.0968 -3.96775 -3.96775 -3.96775 -29.0628 8.9633 18.0968 15.1783 15.1783 15.1783 -29.0628 9.9633 18.0968 -9.51726 -9.51726 -9.51726 -29.0628 9.9633 19.0968 -18.19 -18.19 -18.19 -30.0628 8.9633 18.0968 2.70004 2.70004 2.70004 -30.0628 8.9633 19.0968 3.98834 3.98834 3.98834 -30.0628 9.9633 18.0968 3.77444 3.77444 3.77444 -30.0628 9.9633 19.0968 -13.2218 -13.2218 -13.2218 -29.0628 8.9633 20.0968 21.7442 21.7442 21.7442 -29.0628 9.9633 20.0968 -3.28554 -3.28554 -3.28554 -30.0628 8.9633 20.0968 7.43633 7.43633 7.43633 -30.0628 8.9633 21.0968 0.121818 0.121818 0.121818 -30.0628 9.9633 20.0968 -7.49345 -7.49345 -7.49345 -31.0628 6.9633 18.0968 6.33983 6.33983 6.33983 -31.0628 6.9633 19.0968 9.05425 9.05425 9.05425 -31.0628 7.9633 18.0968 -6.92442 -6.92442 -6.92442 -31.0628 7.9633 19.0968 -4.37095 -4.37095 -4.37095 -32.062799999999996 6.9633 18.0968 5.03744 5.03744 5.03744 -32.062799999999996 6.9633 19.0968 5.36336 5.36336 5.36336 -32.062799999999996 7.9633 18.0968 -2.96529 -2.96529 -2.96529 -31.0628 7.9633 20.0968 -17.9108 -17.9108 -17.9108 -31.0628 7.9633 21.0968 -0.378932 -0.378932 -0.378932 -32.062799999999996 6.9633 21.0968 3.12943 3.12943 3.12943 -32.062799999999996 7.9633 21.0968 -2.35471 -2.35471 -2.35471 -31.0628 8.9633 19.0968 -4.81224 -4.81224 -4.81224 -31.0628 9.9633 18.0968 -25.7556 -25.7556 -25.7556 -31.0628 9.9633 19.0968 -8.0389 -8.0389 -8.0389 -32.062799999999996 9.9633 18.0968 -21.3664 -21.3664 -21.3664 -31.0628 8.9633 20.0968 0.314625 0.314625 0.314625 -31.0628 8.9633 21.0968 1.61493 1.61493 1.61493 -31.0628 9.9633 20.0968 7.71698 7.71698 7.71698 -31.0628 9.9633 21.0968 1.82528 1.82528 1.82528 -32.062799999999996 8.9633 21.0968 0.5746 0.5746 0.5746 -32.062799999999996 9.9633 20.0968 -6.4849 -6.4849 -6.4849 -32.062799999999996 9.9633 21.0968 1.55971 1.55971 1.55971 -35.062799999999996 1.9633000000000003 17.0968 2.21616 2.21616 2.21616 -36.062799999999996 1.9633000000000003 17.0968 86.7814 86.7814 86.7814 -33.062799999999996 1.9633000000000003 19.0968 2.12834 2.12834 2.12834 -33.062799999999996 0.9633000000000003 21.0968 9.66201 9.66201 9.66201 -33.062799999999996 1.9633000000000003 20.0968 -1.23608 -1.23608 -1.23608 -33.062799999999996 1.9633000000000003 21.0968 -5.10768 -5.10768 -5.10768 -34.062799999999996 0.9633000000000003 21.0968 3.70251 3.70251 3.70251 -34.062799999999996 1.9633000000000003 21.0968 -1.33225 -1.33225 -1.33225 -35.062799999999996 0.9633000000000003 18.0968 0.356855 0.356855 0.356855 -35.062799999999996 0.9633000000000003 19.0968 -0.715059 -0.715059 -0.715059 -35.062799999999996 1.9633000000000003 18.0968 1.08433 1.08433 1.08433 -35.062799999999996 1.9633000000000003 19.0968 1.73298 1.73298 1.73298 -36.062799999999996 0.9633000000000003 18.0968 53.2761 53.2761 53.2761 -36.062799999999996 0.9633000000000003 19.0968 36.8542 36.8542 36.8542 -36.062799999999996 1.9633000000000003 18.0968 37.1052 37.1052 37.1052 -36.062799999999996 1.9633000000000003 19.0968 3.91466 3.91466 3.91466 -35.062799999999996 0.9633000000000003 21.0968 -0.603175 -0.603175 -0.603175 -35.062799999999996 1.9633000000000003 20.0968 0.138892 0.138892 0.138892 -35.062799999999996 1.9633000000000003 21.0968 -0.649627 -0.649627 -0.649627 -36.062799999999996 1.9633000000000003 20.0968 -13.4455 -13.4455 -13.4455 -36.062799999999996 1.9633000000000003 21.0968 0.492672 0.492672 0.492672 -37.062799999999996 1.9633000000000003 17.0968 18.467 18.467 18.467 -38.062799999999996 1.9633000000000003 17.0968 0.87406 0.87406 0.87406 -37.062799999999996 0.9633000000000003 18.0968 -13.068 -13.068 -13.068 -37.062799999999996 0.9633000000000003 19.0968 5.75063 5.75063 5.75063 -37.062799999999996 1.9633000000000003 18.0968 -29.5659 -29.5659 -29.5659 -37.062799999999996 1.9633000000000003 19.0968 -9.07753 -9.07753 -9.07753 -38.062799999999996 0.9633000000000003 18.0968 -13.6363 -13.6363 -13.6363 -38.062799999999996 0.9633000000000003 19.0968 -5.79428 -5.79428 -5.79428 -38.062799999999996 1.9633000000000003 18.0968 -43.1744 -43.1744 -43.1744 -38.062799999999996 1.9633000000000003 19.0968 -24.554 -24.554 -24.554 -37.062799999999996 1.9633000000000003 20.0968 2.99638 2.99638 2.99638 -33.062799999999996 4.9633 13.096800000000002 -19.4428 -19.4428 -19.4428 -33.062799999999996 5.9633 12.096800000000002 4.69017 4.69017 4.69017 -33.062799999999996 5.9633 13.096800000000002 29.7352 29.7352 29.7352 -34.062799999999996 4.9633 13.096800000000002 -14.9168 -14.9168 -14.9168 -34.062799999999996 5.9633 12.096800000000002 18.9298 18.9298 18.9298 -34.062799999999996 5.9633 13.096800000000002 107.194 107.194 107.194 -35.062799999999996 4.9633 13.096800000000002 -93.7588 -93.7588 -93.7588 -35.062799999999996 5.9633 12.096800000000002 140.666 140.666 140.666 -35.062799999999996 5.9633 13.096800000000002 -96.5794 -96.5794 -96.5794 -33.062799999999996 6.9633 11.096800000000002 -0.201906 -0.201906 -0.201906 -33.062799999999996 7.9633 11.096800000000002 9.76766 9.76766 9.76766 -34.062799999999996 7.9633 11.096800000000002 -37.9469 -37.9469 -37.9469 -33.062799999999996 6.9633 12.096800000000002 -21.2056 -21.2056 -21.2056 -33.062799999999996 7.9633 12.096800000000002 0.86086 0.86086 0.86086 -34.062799999999996 6.9633 12.096800000000002 31.739 31.739 31.739 -34.062799999999996 7.9633 12.096800000000002 -51.7321 -51.7321 -51.7321 -33.062799999999996 8.9633 11.096800000000002 4.0093 4.0093 4.0093 -33.062799999999996 9.9633 11.096800000000002 -2.74104 -2.74104 -2.74104 -34.062799999999996 8.9633 11.096800000000002 -19.3497 -19.3497 -19.3497 -34.062799999999996 9.9633 11.096800000000002 61.1162 61.1162 61.1162 -33.062799999999996 8.9633 12.096800000000002 1.10432 1.10432 1.10432 -33.062799999999996 9.9633 13.096800000000002 2.02188 2.02188 2.02188 -34.062799999999996 8.9633 12.096800000000002 -75.7724 -75.7724 -75.7724 -34.062799999999996 9.9633 12.096800000000002 19.0206 19.0206 19.0206 -35.062799999999996 6.9633 12.096800000000002 12.9241 12.9241 12.9241 -35.062799999999996 6.9633 13.096800000000002 59.9224 59.9224 59.9224 -35.062799999999996 7.9633 12.096800000000002 125.172 125.172 125.172 -35.062799999999996 7.9633 13.096800000000002 -5.62962 -5.62962 -5.62962 -35.062799999999996 8.9633 11.096800000000002 -49.2229 -49.2229 -49.2229 -35.062799999999996 9.9633 11.096800000000002 147.058 147.058 147.058 -35.062799999999996 8.9633 12.096800000000002 -136.453 -136.453 -136.453 -35.062799999999996 8.9633 13.096800000000002 2.9052 2.9052 2.9052 -35.062799999999996 9.9633 12.096800000000002 5.6019 5.6019 5.6019 -35.062799999999996 9.9633 13.096800000000002 -19.2114 -19.2114 -19.2114 -33.062799999999996 4.9633 14.096800000000002 -11.0014 -11.0014 -11.0014 -33.062799999999996 4.9633 15.096800000000002 -28.797 -28.797 -28.797 -33.062799999999996 5.9633 15.096800000000002 -32.5248 -32.5248 -32.5248 -34.062799999999996 4.9633 14.096800000000002 -37.9664 -37.9664 -37.9664 -34.062799999999996 4.9633 15.096800000000002 16.152 16.152 16.152 -34.062799999999996 5.9633 15.096800000000002 -94.142 -94.142 -94.142 -33.062799999999996 4.9633 16.0968 82.0171 82.0171 82.0171 -33.062799999999996 4.9633 17.0968 31.3783 31.3783 31.3783 -33.062799999999996 5.9633 16.0968 -2.36268 -2.36268 -2.36268 -33.062799999999996 5.9633 17.0968 6.61459 6.61459 6.61459 -34.062799999999996 4.9633 16.0968 30.5509 30.5509 30.5509 -34.062799999999996 4.9633 17.0968 -16.3486 -16.3486 -16.3486 -34.062799999999996 5.9633 16.0968 -36.4762 -36.4762 -36.4762 -35.062799999999996 2.9633000000000003 17.0968 0.787361 0.787361 0.787361 -35.062799999999996 3.9633000000000003 17.0968 12.1419 12.1419 12.1419 -36.062799999999996 2.9633000000000003 17.0968 12.5114 12.5114 12.5114 -36.062799999999996 3.9633000000000003 17.0968 -52.7843 -52.7843 -52.7843 -35.062799999999996 4.9633 14.096800000000002 -10.5677 -10.5677 -10.5677 -35.062799999999996 4.9633 15.096800000000002 -48.7079 -48.7079 -48.7079 -35.062799999999996 5.9633 14.096800000000002 -228.516 -228.516 -228.516 -35.062799999999996 5.9633 15.096800000000002 -68.0222 -68.0222 -68.0222 -35.062799999999996 4.9633 16.0968 37.8957 37.8957 37.8957 -35.062799999999996 4.9633 17.0968 4.01511 4.01511 4.01511 -35.062799999999996 5.9633 16.0968 34.8177 34.8177 34.8177 -35.062799999999996 5.9633 17.0968 -34.5155 -34.5155 -34.5155 -36.062799999999996 4.9633 17.0968 19.4446 19.4446 19.4446 -33.062799999999996 2.9633000000000003 19.0968 -0.356095 -0.356095 -0.356095 -33.062799999999996 3.9633000000000003 18.0968 -10.4352 -10.4352 -10.4352 -33.062799999999996 3.9633000000000003 19.0968 5.61303 5.61303 5.61303 -34.062799999999996 2.9633000000000003 18.0968 -0.460498 -0.460498 -0.460498 -34.062799999999996 2.9633000000000003 19.0968 -1.21146 -1.21146 -1.21146 -34.062799999999996 3.9633000000000003 18.0968 -5.02963 -5.02963 -5.02963 -34.062799999999996 3.9633000000000003 19.0968 -12.7302 -12.7302 -12.7302 -33.062799999999996 2.9633000000000003 20.0968 -3.90699 -3.90699 -3.90699 -33.062799999999996 2.9633000000000003 21.0968 -2.4333 -2.4333 -2.4333 -33.062799999999996 3.9633000000000003 20.0968 1.24909 1.24909 1.24909 -33.062799999999996 3.9633000000000003 21.0968 -9.79394 -9.79394 -9.79394 -34.062799999999996 2.9633000000000003 20.0968 -0.407916 -0.407916 -0.407916 -34.062799999999996 2.9633000000000003 21.0968 1.89818 1.89818 1.89818 -34.062799999999996 3.9633000000000003 20.0968 0.860235 0.860235 0.860235 -34.062799999999996 3.9633000000000003 21.0968 -7.60653 -7.60653 -7.60653 -33.062799999999996 4.9633 18.0968 -24.8054 -24.8054 -24.8054 -33.062799999999996 5.9633 18.0968 -13.4962 -13.4962 -13.4962 -34.062799999999996 4.9633 18.0968 -10.5341 -10.5341 -10.5341 -34.062799999999996 4.9633 19.0968 -5.50047 -5.50047 -5.50047 -34.062799999999996 5.9633 18.0968 3.66981 3.66981 3.66981 -34.062799999999996 5.9633 19.0968 12.8331 12.8331 12.8331 -33.062799999999996 4.9633 20.0968 3.93543 3.93543 3.93543 -33.062799999999996 4.9633 21.0968 -6.44025 -6.44025 -6.44025 -33.062799999999996 5.9633 21.0968 1.15722 1.15722 1.15722 -34.062799999999996 4.9633 20.0968 -6.40418 -6.40418 -6.40418 -34.062799999999996 4.9633 21.0968 1.28555 1.28555 1.28555 -34.062799999999996 5.9633 20.0968 -6.09094 -6.09094 -6.09094 -34.062799999999996 5.9633 21.0968 4.9016 4.9016 4.9016 -35.062799999999996 2.9633000000000003 18.0968 0.825754 0.825754 0.825754 -35.062799999999996 2.9633000000000003 19.0968 -0.487937 -0.487937 -0.487937 -35.062799999999996 3.9633000000000003 18.0968 2.51374 2.51374 2.51374 -35.062799999999996 3.9633000000000003 19.0968 -21.3363 -21.3363 -21.3363 -35.062799999999996 2.9633000000000003 20.0968 -1.55158 -1.55158 -1.55158 -35.062799999999996 2.9633000000000003 21.0968 -0.0764854 -0.0764854 -0.0764854 -35.062799999999996 3.9633000000000003 20.0968 0.00163412 0.00163412 0.00163412 -35.062799999999996 3.9633000000000003 21.0968 2.6588 2.6588 2.6588 -36.062799999999996 2.9633000000000003 20.0968 6.58975 6.58975 6.58975 -36.062799999999996 2.9633000000000003 21.0968 0.493386 0.493386 0.493386 -36.062799999999996 3.9633000000000003 20.0968 1.00765 1.00765 1.00765 -36.062799999999996 3.9633000000000003 21.0968 0.0782512 0.0782512 0.0782512 -35.062799999999996 4.9633 18.0968 14.1449 14.1449 14.1449 -35.062799999999996 4.9633 19.0968 -19.3747 -19.3747 -19.3747 -35.062799999999996 5.9633 18.0968 -20.5308 -20.5308 -20.5308 -35.062799999999996 5.9633 19.0968 13.7994 13.7994 13.7994 -36.062799999999996 4.9633 18.0968 8.53113 8.53113 8.53113 -36.062799999999996 5.9633 18.0968 15.3471 15.3471 15.3471 -36.062799999999996 5.9633 19.0968 21.8655 21.8655 21.8655 -35.062799999999996 4.9633 20.0968 -10.6993 -10.6993 -10.6993 -35.062799999999996 4.9633 21.0968 -3.59095 -3.59095 -3.59095 -35.062799999999996 5.9633 21.0968 5.51124 5.51124 5.51124 -36.062799999999996 4.9633 21.0968 -3.37687 -3.37687 -3.37687 -33.062799999999996 6.9633 15.096800000000002 -64.3385 -64.3385 -64.3385 -33.062799999999996 7.9633 15.096800000000002 74.0791 74.0791 74.0791 -34.062799999999996 6.9633 14.096800000000002 69.773 69.773 69.773 -34.062799999999996 6.9633 15.096800000000002 62.0682 62.0682 62.0682 -34.062799999999996 7.9633 14.096800000000002 3.99857 3.99857 3.99857 -34.062799999999996 7.9633 15.096800000000002 3.0971 3.0971 3.0971 -33.062799999999996 6.9633 16.0968 -82.8822 -82.8822 -82.8822 -33.062799999999996 6.9633 17.0968 -23.0233 -23.0233 -23.0233 -33.062799999999996 7.9633 16.0968 -13.4313 -13.4313 -13.4313 -33.062799999999996 7.9633 17.0968 -44.4911 -44.4911 -44.4911 -34.062799999999996 7.9633 16.0968 35.4224 35.4224 35.4224 -34.062799999999996 7.9633 17.0968 29.5942 29.5942 29.5942 -33.062799999999996 8.9633 15.096800000000002 7.51475 7.51475 7.51475 -33.062799999999996 9.9633 14.096800000000002 -4.27535 -4.27535 -4.27535 -33.062799999999996 9.9633 15.096800000000002 -29.5199 -29.5199 -29.5199 -34.062799999999996 8.9633 15.096800000000002 -36.2048 -36.2048 -36.2048 -34.062799999999996 9.9633 14.096800000000002 -20.5227 -20.5227 -20.5227 -34.062799999999996 9.9633 15.096800000000002 -33.3375 -33.3375 -33.3375 -33.062799999999996 8.9633 16.0968 -15.9457 -15.9457 -15.9457 -33.062799999999996 8.9633 17.0968 -8.88054 -8.88054 -8.88054 -33.062799999999996 9.9633 16.0968 31.7542 31.7542 31.7542 -33.062799999999996 9.9633 17.0968 -80.5979 -80.5979 -80.5979 -34.062799999999996 8.9633 16.0968 49.5866 49.5866 49.5866 -34.062799999999996 8.9633 17.0968 13.4086 13.4086 13.4086 -34.062799999999996 9.9633 16.0968 30.2115 30.2115 30.2115 -35.062799999999996 6.9633 14.096800000000002 -22.054 -22.054 -22.054 -35.062799999999996 6.9633 15.096800000000002 57.3271 57.3271 57.3271 -35.062799999999996 7.9633 14.096800000000002 -34.6127 -34.6127 -34.6127 -35.062799999999996 7.9633 15.096800000000002 -46.6244 -46.6244 -46.6244 -35.062799999999996 6.9633 16.0968 31.1426 31.1426 31.1426 -35.062799999999996 6.9633 17.0968 37.9249 37.9249 37.9249 -35.062799999999996 7.9633 16.0968 63.6292 63.6292 63.6292 -35.062799999999996 7.9633 17.0968 1.67647 1.67647 1.67647 -36.062799999999996 6.9633 17.0968 -45.7454 -45.7454 -45.7454 -35.062799999999996 8.9633 14.096800000000002 -3.11593 -3.11593 -3.11593 -35.062799999999996 8.9633 15.096800000000002 -28.8386 -28.8386 -28.8386 -35.062799999999996 9.9633 14.096800000000002 34.4726 34.4726 34.4726 -35.062799999999996 9.9633 15.096800000000002 -6.29594 -6.29594 -6.29594 -36.062799999999996 8.9633 14.096800000000002 0.354261 0.354261 0.354261 -36.062799999999996 8.9633 15.096800000000002 4.37706 4.37706 4.37706 -36.062799999999996 9.9633 14.096800000000002 -27.8062 -27.8062 -27.8062 -35.062799999999996 8.9633 16.0968 38.8027 38.8027 38.8027 -35.062799999999996 8.9633 17.0968 28.1155 28.1155 28.1155 -35.062799999999996 9.9633 16.0968 -6.64668 -6.64668 -6.64668 -35.062799999999996 9.9633 17.0968 -19.4793 -19.4793 -19.4793 -36.062799999999996 8.9633 16.0968 0.100691 0.100691 0.100691 -36.062799999999996 8.9633 17.0968 23.4996 23.4996 23.4996 -36.062799999999996 9.9633 17.0968 46.2868 46.2868 46.2868 -33.062799999999996 6.9633 18.0968 -8.10966 -8.10966 -8.10966 -33.062799999999996 6.9633 19.0968 -8.27837 -8.27837 -8.27837 -33.062799999999996 7.9633 18.0968 13.4126 13.4126 13.4126 -33.062799999999996 7.9633 19.0968 1.15225 1.15225 1.15225 -34.062799999999996 6.9633 18.0968 -15.7905 -15.7905 -15.7905 -34.062799999999996 6.9633 19.0968 -3.05738 -3.05738 -3.05738 -34.062799999999996 7.9633 18.0968 31.1924 31.1924 31.1924 -34.062799999999996 7.9633 19.0968 -5.11754 -5.11754 -5.11754 -33.062799999999996 6.9633 20.0968 3.23552 3.23552 3.23552 -33.062799999999996 6.9633 21.0968 5.68786 5.68786 5.68786 -33.062799999999996 7.9633 20.0968 2.26284 2.26284 2.26284 -33.062799999999996 7.9633 21.0968 -13.9535 -13.9535 -13.9535 -34.062799999999996 6.9633 20.0968 6.0532 6.0532 6.0532 -34.062799999999996 6.9633 21.0968 1.45102 1.45102 1.45102 -34.062799999999996 7.9633 20.0968 -3.56744 -3.56744 -3.56744 -33.062799999999996 8.9633 18.0968 2.5808 2.5808 2.5808 -34.062799999999996 8.9633 18.0968 -15.3397 -15.3397 -15.3397 -34.062799999999996 8.9633 19.0968 -3.1252 -3.1252 -3.1252 -33.062799999999996 8.9633 21.0968 -11.7535 -11.7535 -11.7535 -33.062799999999996 9.9633 21.0968 -38.8112 -38.8112 -38.8112 -34.062799999999996 8.9633 20.0968 -25.7986 -25.7986 -25.7986 -34.062799999999996 8.9633 21.0968 6.39536 6.39536 6.39536 -34.062799999999996 9.9633 21.0968 -15.2929 -15.2929 -15.2929 -35.062799999999996 6.9633 18.0968 -19.5136 -19.5136 -19.5136 -35.062799999999996 6.9633 19.0968 -9.01233 -9.01233 -9.01233 -35.062799999999996 7.9633 18.0968 4.8868 4.8868 4.8868 -36.062799999999996 6.9633 19.0968 33.6162 33.6162 33.6162 -36.062799999999996 7.9633 19.0968 -6.35683 -6.35683 -6.35683 -35.062799999999996 6.9633 20.0968 -9.22647 -9.22647 -9.22647 -35.062799999999996 7.9633 20.0968 9.48663 9.48663 9.48663 -35.062799999999996 7.9633 21.0968 2.68398 2.68398 2.68398 -36.062799999999996 6.9633 20.0968 14.1896 14.1896 14.1896 -36.062799999999996 7.9633 20.0968 2.56711 2.56711 2.56711 -36.062799999999996 7.9633 21.0968 0.523587 0.523587 0.523587 -35.062799999999996 8.9633 18.0968 -13.3549 -13.3549 -13.3549 -35.062799999999996 8.9633 19.0968 12.5091 12.5091 12.5091 -35.062799999999996 9.9633 18.0968 -4.80787 -4.80787 -4.80787 -35.062799999999996 9.9633 19.0968 36.2244 36.2244 36.2244 -36.062799999999996 8.9633 18.0968 16.2573 16.2573 16.2573 -36.062799999999996 8.9633 19.0968 -38.3863 -38.3863 -38.3863 -36.062799999999996 9.9633 18.0968 -4.80435 -4.80435 -4.80435 -36.062799999999996 9.9633 19.0968 -52.0808 -52.0808 -52.0808 -35.062799999999996 8.9633 20.0968 38.387 38.387 38.387 -35.062799999999996 8.9633 21.0968 38.1787 38.1787 38.1787 -35.062799999999996 9.9633 20.0968 1.89989 1.89989 1.89989 -35.062799999999996 9.9633 21.0968 10.5248 10.5248 10.5248 -36.062799999999996 8.9633 20.0968 1.06519 1.06519 1.06519 -36.062799999999996 8.9633 21.0968 54.9018 54.9018 54.9018 -36.062799999999996 9.9633 20.0968 -11.0754 -11.0754 -11.0754 -36.062799999999996 9.9633 21.0968 56.9972 56.9972 56.9972 -37.062799999999996 2.9633000000000003 17.0968 1.98466 1.98466 1.98466 -37.062799999999996 3.9633000000000003 17.0968 23.1682 23.1682 23.1682 -38.062799999999996 2.9633000000000003 17.0968 18.0894 18.0894 18.0894 -38.062799999999996 3.9633000000000003 17.0968 -22.4731 -22.4731 -22.4731 -37.062799999999996 4.9633 17.0968 -11.1696 -11.1696 -11.1696 -37.062799999999996 2.9633000000000003 19.0968 -17.9325 -17.9325 -17.9325 -37.062799999999996 3.9633000000000003 18.0968 -74.0268 -74.0268 -74.0268 -38.062799999999996 2.9633000000000003 18.0968 -26.7846 -26.7846 -26.7846 -38.062799999999996 2.9633000000000003 19.0968 -11.781 -11.781 -11.781 -38.062799999999996 3.9633000000000003 18.0968 -9.61266 -9.61266 -9.61266 -38.062799999999996 3.9633000000000003 19.0968 0.969985 0.969985 0.969985 -37.062799999999996 2.9633000000000003 20.0968 3.13507 3.13507 3.13507 -37.062799999999996 2.9633000000000003 21.0968 -1.45671 -1.45671 -1.45671 -37.062799999999996 3.9633000000000003 21.0968 -5.10519 -5.10519 -5.10519 -38.062799999999996 2.9633000000000003 20.0968 22.0309 22.0309 22.0309 -38.062799999999996 2.9633000000000003 21.0968 0.643761 0.643761 0.643761 -38.062799999999996 3.9633000000000003 21.0968 -7.77583 -7.77583 -7.77583 -37.062799999999996 4.9633 18.0968 -7.89644 -7.89644 -7.89644 -37.062799999999996 4.9633 19.0968 -2.73893 -2.73893 -2.73893 -37.062799999999996 5.9633 18.0968 15.8059 15.8059 15.8059 -37.062799999999996 5.9633 19.0968 -1.17629 -1.17629 -1.17629 -38.062799999999996 4.9633 18.0968 4.43003 4.43003 4.43003 -38.062799999999996 4.9633 19.0968 -8.32133 -8.32133 -8.32133 -38.062799999999996 5.9633 19.0968 5.76456 5.76456 5.76456 -37.062799999999996 5.9633 20.0968 -10.9133 -10.9133 -10.9133 -38.062799999999996 4.9633 20.0968 4.30033 4.30033 4.30033 -38.062799999999996 4.9633 21.0968 4.1503 4.1503 4.1503 -38.062799999999996 5.9633 20.0968 3.42334 3.42334 3.42334 -38.062799999999996 5.9633 21.0968 -4.1306 -4.1306 -4.1306 -39.062799999999996 2.9633000000000003 19.0968 12.3623 12.3623 12.3623 -39.062799999999996 3.9633000000000003 19.0968 -5.83968 -5.83968 -5.83968 -39.062799999999996 2.9633000000000003 20.0968 16.4526 16.4526 16.4526 -39.062799999999996 2.9633000000000003 21.0968 -20.43 -20.43 -20.43 -39.062799999999996 3.9633000000000003 20.0968 16.6272 16.6272 16.6272 -39.062799999999996 3.9633000000000003 21.0968 0.863431 0.863431 0.863431 -39.062799999999996 4.9633 19.0968 -10.4159 -10.4159 -10.4159 -39.062799999999996 4.9633 20.0968 -8.60507 -8.60507 -8.60507 -39.062799999999996 4.9633 21.0968 22.1912 22.1912 22.1912 -39.062799999999996 5.9633 20.0968 -11.3994 -11.3994 -11.3994 -39.062799999999996 5.9633 21.0968 10.4126 10.4126 10.4126 -37.062799999999996 8.9633 15.096800000000002 12.6835 12.6835 12.6835 -37.062799999999996 9.9633 14.096800000000002 5.53572 5.53572 5.53572 -37.062799999999996 9.9633 15.096800000000002 -170.79 -170.79 -170.79 -38.062799999999996 9.9633 15.096800000000002 125.364 125.364 125.364 -37.062799999999996 8.9633 16.0968 7.08754 7.08754 7.08754 -37.062799999999996 8.9633 17.0968 12.6069 12.6069 12.6069 -37.062799999999996 9.9633 16.0968 -54.4053 -54.4053 -54.4053 -37.062799999999996 9.9633 17.0968 37.0282 37.0282 37.0282 -38.062799999999996 8.9633 17.0968 15.4644 15.4644 15.4644 -38.062799999999996 9.9633 16.0968 56.3086 56.3086 56.3086 -38.062799999999996 9.9633 17.0968 159.124 159.124 159.124 -39.062799999999996 8.9633 17.0968 -5.66173 -5.66173 -5.66173 -39.062799999999996 9.9633 16.0968 -12.7756 -12.7756 -12.7756 -39.062799999999996 9.9633 17.0968 -55.1594 -55.1594 -55.1594 -40.062799999999996 8.9633 16.0968 -3.96454 -3.96454 -3.96454 -40.062799999999996 8.9633 17.0968 -48.3401 -48.3401 -48.3401 -40.062799999999996 9.9633 16.0968 31.1329 31.1329 31.1329 -40.062799999999996 9.9633 17.0968 38.0564 38.0564 38.0564 -37.062799999999996 6.9633 19.0968 -3.42244 -3.42244 -3.42244 -37.062799999999996 7.9633 18.0968 -3.26153 -3.26153 -3.26153 -37.062799999999996 7.9633 19.0968 -21.8901 -21.8901 -21.8901 -38.062799999999996 6.9633 19.0968 12.2156 12.2156 12.2156 -38.062799999999996 7.9633 18.0968 1.21544 1.21544 1.21544 -38.062799999999996 7.9633 19.0968 132.434 132.434 132.434 -37.062799999999996 6.9633 20.0968 5.56673 5.56673 5.56673 -38.062799999999996 6.9633 20.0968 -45.7913 -45.7913 -45.7913 -37.062799999999996 8.9633 18.0968 1.89031 1.89031 1.89031 -37.062799999999996 8.9633 19.0968 -25.3518 -25.3518 -25.3518 -37.062799999999996 9.9633 18.0968 14.8146 14.8146 14.8146 -37.062799999999996 9.9633 19.0968 20.1054 20.1054 20.1054 -38.062799999999996 8.9633 18.0968 9.19448 9.19448 9.19448 -37.062799999999996 8.9633 21.0968 64.7195 64.7195 64.7195 -37.062799999999996 9.9633 20.0968 -39.3746 -39.3746 -39.3746 -37.062799999999996 9.9633 21.0968 22.9217 22.9217 22.9217 -38.062799999999996 8.9633 21.0968 42.2184 42.2184 42.2184 -38.062799999999996 9.9633 20.0968 -28.372 -28.372 -28.372 -38.062799999999996 9.9633 21.0968 -26.5664 -26.5664 -26.5664 -39.062799999999996 6.9633 19.0968 -88.3055 -88.3055 -88.3055 -39.062799999999996 7.9633 18.0968 4.63388 4.63388 4.63388 -39.062799999999996 7.9633 19.0968 204.479 204.479 204.479 -40.062799999999996 7.9633 18.0968 -70.2456 -70.2456 -70.2456 -40.062799999999996 7.9633 19.0968 227.91 227.91 227.91 -39.062799999999996 6.9633 20.0968 -34.4784 -34.4784 -34.4784 -39.062799999999996 6.9633 21.0968 -282.909 -282.909 -282.909 -39.062799999999996 7.9633 20.0968 92.1764 92.1764 92.1764 -39.062799999999996 7.9633 21.0968 -47.348 -47.348 -47.348 -40.062799999999996 7.9633 20.0968 193.962 193.962 193.962 -40.062799999999996 7.9633 21.0968 -9.18439 -9.18439 -9.18439 -39.062799999999996 8.9633 18.0968 3.51671 3.51671 3.51671 -40.062799999999996 8.9633 18.0968 -76.1748 -76.1748 -76.1748 -40.062799999999996 8.9633 19.0968 -32.0704 -32.0704 -32.0704 -40.062799999999996 9.9633 19.0968 -27.5116 -27.5116 -27.5116 -39.062799999999996 8.9633 21.0968 -98.5396 -98.5396 -98.5396 -39.062799999999996 9.9633 20.0968 126.905 126.905 126.905 -39.062799999999996 9.9633 21.0968 -211.669 -211.669 -211.669 -40.062799999999996 8.9633 20.0968 33.4403 33.4403 33.4403 -40.062799999999996 8.9633 21.0968 -364.192 -364.192 -364.192 -40.062799999999996 9.9633 20.0968 9.00716 9.00716 9.00716 -40.062799999999996 9.9633 21.0968 -307.542 -307.542 -307.542 -41.062799999999996 8.9633 16.0968 5.14523 5.14523 5.14523 -41.062799999999996 8.9633 17.0968 -1.43929 -1.43929 -1.43929 -41.062799999999996 9.9633 16.0968 19.8742 19.8742 19.8742 -41.062799999999996 9.9633 17.0968 39.2042 39.2042 39.2042 -42.062799999999996 8.9633 17.0968 -34.3563 -34.3563 -34.3563 -42.062799999999996 9.9633 17.0968 80.5452 80.5452 80.5452 -41.062799999999996 8.9633 18.0968 10.3465 10.3465 10.3465 -41.062799999999996 8.9633 19.0968 59.5424 59.5424 59.5424 -41.062799999999996 9.9633 18.0968 141.114 141.114 141.114 -41.062799999999996 9.9633 19.0968 -37.9127 -37.9127 -37.9127 -42.062799999999996 8.9633 18.0968 -25.0233 -25.0233 -25.0233 -42.062799999999996 9.9633 18.0968 -47.39 -47.39 -47.39 -42.062799999999996 9.9633 19.0968 145.146 145.146 145.146 -41.062799999999996 9.9633 20.0968 307.012 307.012 307.012 -25.0628 -3.0366999999999997 23.0968 -45.5094 -45.5094 -45.5094 -25.0628 -2.0366999999999997 23.0968 -34.7098 -34.7098 -34.7098 -26.0628 -2.0366999999999997 23.0968 -35.1064 -35.1064 -35.1064 -25.0628 -3.0366999999999997 24.0968 -45.4693 -45.4693 -45.4693 -25.0628 -3.0366999999999997 25.0968 22.2958 22.2958 22.2958 -25.0628 -2.0366999999999997 24.0968 -27.0479 -27.0479 -27.0479 -25.0628 -2.0366999999999997 25.0968 41.6419 41.6419 41.6419 -26.0628 -2.0366999999999997 24.0968 47.3277 47.3277 47.3277 -27.0628 -2.0366999999999997 22.0968 6.70644 6.70644 6.70644 -27.0628 -2.0366999999999997 23.0968 -15.5834 -15.5834 -15.5834 -28.0628 -2.0366999999999997 22.0968 200.806 200.806 200.806 -27.0628 -2.0366999999999997 24.0968 35.2151 35.2151 35.2151 -25.0628 -1.0366999999999997 23.0968 13.9063 13.9063 13.9063 -25.0628 -0.03669999999999973 22.0968 -270.872 -270.872 -270.872 -25.0628 -0.03669999999999973 23.0968 68.9424 68.9424 68.9424 -26.0628 -1.0366999999999997 22.0968 -17.2397 -17.2397 -17.2397 -26.0628 -1.0366999999999997 23.0968 -16.5271 -16.5271 -16.5271 -26.0628 -0.03669999999999973 22.0968 -69.3327 -69.3327 -69.3327 -25.0628 -1.0366999999999997 24.0968 0.0256753 0.0256753 0.0256753 -25.0628 -1.0366999999999997 25.0968 8.68082 8.68082 8.68082 -25.0628 -0.03669999999999973 24.0968 20.6022 20.6022 20.6022 -25.0628 -0.03669999999999973 25.0968 -0.344557 -0.344557 -0.344557 -26.0628 -1.0366999999999997 24.0968 5.54935 5.54935 5.54935 -26.0628 -1.0366999999999997 25.0968 1.07736 1.07736 1.07736 -26.0628 -0.03669999999999973 24.0968 19.877 19.877 19.877 -26.0628 -0.03669999999999973 25.0968 10.2632 10.2632 10.2632 -25.0628 0.9633000000000003 22.0968 20.7112 20.7112 20.7112 -25.0628 0.9633000000000003 23.0968 -36.9433 -36.9433 -36.9433 -25.0628 1.9633000000000003 23.0968 -7.61867 -7.61867 -7.61867 -26.0628 0.9633000000000003 22.0968 33.4329 33.4329 33.4329 -26.0628 0.9633000000000003 23.0968 -35.1393 -35.1393 -35.1393 -26.0628 1.9633000000000003 23.0968 158.552 158.552 158.552 -25.0628 0.9633000000000003 24.0968 1.38979 1.38979 1.38979 -25.0628 1.9633000000000003 24.0968 -24.9052 -24.9052 -24.9052 -25.0628 1.9633000000000003 25.0968 -3.68759 -3.68759 -3.68759 -26.0628 0.9633000000000003 24.0968 16.4409 16.4409 16.4409 -26.0628 0.9633000000000003 25.0968 4.22926 4.22926 4.22926 -26.0628 1.9633000000000003 24.0968 -24.2026 -24.2026 -24.2026 -26.0628 1.9633000000000003 25.0968 3.69744 3.69744 3.69744 -27.0628 -1.0366999999999997 22.0968 -52.1612 -52.1612 -52.1612 -27.0628 -1.0366999999999997 23.0968 9.98872 9.98872 9.98872 -28.0628 -1.0366999999999997 22.0968 130.661 130.661 130.661 -28.0628 -1.0366999999999997 23.0968 3.04876 3.04876 3.04876 -27.0628 -1.0366999999999997 24.0968 37.1262 37.1262 37.1262 -27.0628 -1.0366999999999997 25.0968 0.834826 0.834826 0.834826 -27.0628 -0.03669999999999973 25.0968 2.7812 2.7812 2.7812 -28.0628 -1.0366999999999997 24.0968 62.1084 62.1084 62.1084 -28.0628 -1.0366999999999997 25.0968 -2.09819 -2.09819 -2.09819 -28.0628 -0.03669999999999973 24.0968 3.04939 3.04939 3.04939 -28.0628 -0.03669999999999973 25.0968 9.06665 9.06665 9.06665 -27.0628 1.9633000000000003 23.0968 1.43823 1.43823 1.43823 -28.0628 0.9633000000000003 23.0968 -1.21734 -1.21734 -1.21734 -28.0628 1.9633000000000003 22.0968 1.02636 1.02636 1.02636 -28.0628 1.9633000000000003 23.0968 -3.66884 -3.66884 -3.66884 -27.0628 0.9633000000000003 24.0968 8.57702 8.57702 8.57702 -27.0628 0.9633000000000003 25.0968 -8.76164 -8.76164 -8.76164 -27.0628 1.9633000000000003 24.0968 68.5672 68.5672 68.5672 -27.0628 1.9633000000000003 25.0968 -66.1442 -66.1442 -66.1442 -28.0628 0.9633000000000003 24.0968 6.48903 6.48903 6.48903 -28.0628 0.9633000000000003 25.0968 -0.327659 -0.327659 -0.327659 -28.0628 1.9633000000000003 24.0968 -23.0714 -23.0714 -23.0714 -28.0628 1.9633000000000003 25.0968 -72.8454 -72.8454 -72.8454 -25.0628 -0.03669999999999973 26.0968 -11.1579 -11.1579 -11.1579 -25.0628 -0.03669999999999973 27.0968 -9.18556 -9.18556 -9.18556 -26.0628 -0.03669999999999973 27.0968 -1.79056 -1.79056 -1.79056 -25.0628 -0.03669999999999973 28.0968 0.870502 0.870502 0.870502 -25.0628 -0.03669999999999973 29.0968 8.06234 8.06234 8.06234 -26.0628 -0.03669999999999973 28.0968 -0.888887 -0.888887 -0.888887 -25.0628 0.9633000000000003 26.0968 -4.11487 -4.11487 -4.11487 -25.0628 1.9633000000000003 26.0968 -1.13888 -1.13888 -1.13888 -25.0628 1.9633000000000003 27.0968 -0.83758 -0.83758 -0.83758 -26.0628 0.9633000000000003 26.0968 -7.08592 -7.08592 -7.08592 -26.0628 0.9633000000000003 27.0968 -0.445202 -0.445202 -0.445202 -26.0628 1.9633000000000003 26.0968 -3.40285 -3.40285 -3.40285 -26.0628 1.9633000000000003 27.0968 0.73994 0.73994 0.73994 -25.0628 0.9633000000000003 28.0968 2.03501 2.03501 2.03501 -25.0628 0.9633000000000003 29.0968 -2.00564 -2.00564 -2.00564 -25.0628 1.9633000000000003 28.0968 -0.532886 -0.532886 -0.532886 -25.0628 1.9633000000000003 29.0968 -0.334713 -0.334713 -0.334713 -26.0628 0.9633000000000003 28.0968 -2.07247 -2.07247 -2.07247 -26.0628 1.9633000000000003 28.0968 0.497409 0.497409 0.497409 -28.0628 -0.03669999999999973 29.0968 0.736323 0.736323 0.736323 -27.0628 1.9633000000000003 26.0968 -25.2673 -25.2673 -25.2673 -27.0628 1.9633000000000003 27.0968 -0.883307 -0.883307 -0.883307 -28.0628 1.9633000000000003 26.0968 6.87839 6.87839 6.87839 -28.0628 1.9633000000000003 27.0968 -2.11569 -2.11569 -2.11569 -27.0628 0.9633000000000003 29.0968 -0.130237 -0.130237 -0.130237 -27.0628 1.9633000000000003 29.0968 -2.51529 -2.51529 -2.51529 -28.0628 0.9633000000000003 28.0968 0.938601 0.938601 0.938601 -28.0628 0.9633000000000003 29.0968 4.92407 4.92407 4.92407 -28.0628 1.9633000000000003 28.0968 -5.04628 -5.04628 -5.04628 -28.0628 1.9633000000000003 29.0968 2.19116 2.19116 2.19116 -29.0628 -2.0366999999999997 22.0968 231.242 231.242 231.242 -29.0628 -1.0366999999999997 22.0968 -197.665 -197.665 -197.665 -29.0628 -1.0366999999999997 23.0968 -0.412812 -0.412812 -0.412812 -29.0628 -0.03669999999999973 22.0968 4.4737 4.4737 4.4737 -29.0628 -0.03669999999999973 23.0968 4.40742 4.40742 4.40742 -29.0628 -0.03669999999999973 24.0968 15.1195 15.1195 15.1195 -30.0628 -0.03669999999999973 25.0968 11.2869 11.2869 11.2869 -29.0628 0.9633000000000003 22.0968 2.52797 2.52797 2.52797 -29.0628 0.9633000000000003 23.0968 -1.3374 -1.3374 -1.3374 -29.0628 1.9633000000000003 22.0968 1.56146 1.56146 1.56146 -29.0628 1.9633000000000003 23.0968 -10.5609 -10.5609 -10.5609 -30.0628 1.9633000000000003 22.0968 -5.72821 -5.72821 -5.72821 -29.0628 0.9633000000000003 24.0968 -28.6267 -28.6267 -28.6267 -30.0628 0.9633000000000003 25.0968 -17.0407 -17.0407 -17.0407 -30.0628 1.9633000000000003 25.0968 7.55287 7.55287 7.55287 -31.0628 -1.0366999999999997 25.0968 -42.1711 -42.1711 -42.1711 -31.0628 -0.03669999999999973 24.0968 30.2385 30.2385 30.2385 -31.0628 -0.03669999999999973 25.0968 12.109 12.109 12.109 -32.062799999999996 -1.0366999999999997 25.0968 -3.88529 -3.88529 -3.88529 -32.062799999999996 -0.03669999999999973 24.0968 17.7669 17.7669 17.7669 -32.062799999999996 -0.03669999999999973 25.0968 -50.7866 -50.7866 -50.7866 -31.0628 0.9633000000000003 22.0968 -1.7367 -1.7367 -1.7367 -31.0628 0.9633000000000003 23.0968 -32.1001 -32.1001 -32.1001 -31.0628 1.9633000000000003 22.0968 -16.855 -16.855 -16.855 -31.0628 1.9633000000000003 23.0968 -6.64805 -6.64805 -6.64805 -32.062799999999996 0.9633000000000003 22.0968 12.7413 12.7413 12.7413 -32.062799999999996 0.9633000000000003 23.0968 -5.25034 -5.25034 -5.25034 -32.062799999999996 1.9633000000000003 23.0968 3.20788 3.20788 3.20788 -31.0628 0.9633000000000003 24.0968 -6.11828 -6.11828 -6.11828 -31.0628 0.9633000000000003 25.0968 19.649 19.649 19.649 -31.0628 1.9633000000000003 24.0968 0.067997 0.067997 0.067997 -31.0628 1.9633000000000003 25.0968 13.7675 13.7675 13.7675 -32.062799999999996 0.9633000000000003 24.0968 -2.94361 -2.94361 -2.94361 -32.062799999999996 1.9633000000000003 24.0968 7.32165 7.32165 7.32165 -32.062799999999996 1.9633000000000003 25.0968 -0.23413 -0.23413 -0.23413 -30.0628 -0.03669999999999973 26.0968 4.11695 4.11695 4.11695 -29.0628 -0.03669999999999973 29.0968 -2.77661 -2.77661 -2.77661 -29.0628 1.9633000000000003 26.0968 -25.9226 -25.9226 -25.9226 -29.0628 1.9633000000000003 27.0968 4.30465 4.30465 4.30465 -30.0628 0.9633000000000003 26.0968 -7.03524 -7.03524 -7.03524 -30.0628 1.9633000000000003 26.0968 -2.80008 -2.80008 -2.80008 -30.0628 1.9633000000000003 27.0968 2.49815 2.49815 2.49815 -29.0628 0.9633000000000003 28.0968 0.628168 0.628168 0.628168 -29.0628 0.9633000000000003 29.0968 0.323658 0.323658 0.323658 -29.0628 1.9633000000000003 28.0968 -5.83405 -5.83405 -5.83405 -30.0628 0.9633000000000003 29.0968 5.15383 5.15383 5.15383 -30.0628 1.9633000000000003 28.0968 -3.32199 -3.32199 -3.32199 -30.0628 1.9633000000000003 29.0968 -3.6662 -3.6662 -3.6662 -31.0628 -1.0366999999999997 26.0968 9.29805 9.29805 9.29805 -31.0628 -0.03669999999999973 26.0968 4.88796 4.88796 4.88796 -31.0628 -0.03669999999999973 27.0968 -6.47708 -6.47708 -6.47708 -32.062799999999996 -1.0366999999999997 26.0968 2.67312 2.67312 2.67312 -32.062799999999996 -0.03669999999999973 26.0968 -3.30851 -3.30851 -3.30851 -32.062799999999996 -0.03669999999999973 27.0968 -0.782457 -0.782457 -0.782457 -32.062799999999996 -0.03669999999999973 28.0968 -4.78363 -4.78363 -4.78363 -31.0628 0.9633000000000003 26.0968 -1.81869 -1.81869 -1.81869 -31.0628 0.9633000000000003 27.0968 -3.04901 -3.04901 -3.04901 -31.0628 1.9633000000000003 26.0968 -3.70693 -3.70693 -3.70693 -31.0628 1.9633000000000003 27.0968 -2.21755 -2.21755 -2.21755 -32.062799999999996 0.9633000000000003 27.0968 -6.79371 -6.79371 -6.79371 -31.0628 0.9633000000000003 28.0968 4.83745 4.83745 4.83745 -31.0628 1.9633000000000003 28.0968 1.61914 1.61914 1.61914 -32.062799999999996 0.9633000000000003 28.0968 -4.61769 -4.61769 -4.61769 -32.062799999999996 1.9633000000000003 28.0968 3.89749 3.89749 3.89749 -32.062799999999996 1.9633000000000003 29.0968 -1.26346 -1.26346 -1.26346 -26.0628 1.9633000000000003 31.0968 1.49268 1.49268 1.49268 -25.0628 1.9633000000000003 32.0968 -0.559283 -0.559283 -0.559283 -25.0628 1.9633000000000003 33.0968 -0.123273 -0.123273 -0.123273 -26.0628 1.9633000000000003 32.0968 0.716402 0.716402 0.716402 -26.0628 1.9633000000000003 33.0968 -13.2215 -13.2215 -13.2215 -28.0628 -0.03669999999999973 30.0968 1.75905 1.75905 1.75905 -28.0628 -0.03669999999999973 31.0968 -2.76123 -2.76123 -2.76123 -27.0628 0.9633000000000003 30.0968 1.72723 1.72723 1.72723 -27.0628 0.9633000000000003 31.0968 -0.719468 -0.719468 -0.719468 -27.0628 1.9633000000000003 30.0968 -2.40181 -2.40181 -2.40181 -27.0628 1.9633000000000003 31.0968 4.32783 4.32783 4.32783 -28.0628 0.9633000000000003 30.0968 1.59629 1.59629 1.59629 -28.0628 0.9633000000000003 31.0968 -1.83504 -1.83504 -1.83504 -28.0628 1.9633000000000003 31.0968 2.7001 2.7001 2.7001 -27.0628 1.9633000000000003 32.0968 4.09396 4.09396 4.09396 -27.0628 1.9633000000000003 33.0968 15.7189 15.7189 15.7189 -28.0628 0.9633000000000003 32.0968 -0.640789 -0.640789 -0.640789 -28.0628 1.9633000000000003 32.0968 -3.17909 -3.17909 -3.17909 -25.0628 1.9633000000000003 34.0968 -0.922543 -0.922543 -0.922543 -25.0628 1.9633000000000003 35.0968 -12.2172 -12.2172 -12.2172 -26.0628 1.9633000000000003 34.0968 -14.9141 -14.9141 -14.9141 -25.0628 1.9633000000000003 36.0968 -3.44326 -3.44326 -3.44326 -27.0628 1.9633000000000003 34.0968 8.78934 8.78934 8.78934 -29.0628 -0.03669999999999973 30.0968 -2.60681 -2.60681 -2.60681 -29.0628 -0.03669999999999973 31.0968 3.9978 3.9978 3.9978 -29.0628 0.9633000000000003 30.0968 -0.777003 -0.777003 -0.777003 -29.0628 0.9633000000000003 31.0968 -1.91664 -1.91664 -1.91664 -29.0628 1.9633000000000003 31.0968 -3.6443 -3.6443 -3.6443 -30.0628 0.9633000000000003 30.0968 1.22918 1.22918 1.22918 -30.0628 0.9633000000000003 31.0968 -0.107492 -0.107492 -0.107492 -30.0628 1.9633000000000003 30.0968 -6.05451 -6.05451 -6.05451 -30.0628 1.9633000000000003 31.0968 9.53397 9.53397 9.53397 -29.0628 0.9633000000000003 32.0968 0.353473 0.353473 0.353473 -29.0628 1.9633000000000003 32.0968 -6.23583 -6.23583 -6.23583 -30.0628 1.9633000000000003 32.0968 -0.557605 -0.557605 -0.557605 -31.0628 1.9633000000000003 30.0968 4.09558 4.09558 4.09558 -31.0628 1.9633000000000003 31.0968 -10.405 -10.405 -10.405 -32.062799999999996 1.9633000000000003 30.0968 -2.37694 -2.37694 -2.37694 -32.062799999999996 1.9633000000000003 31.0968 2.32309 2.32309 2.32309 -31.0628 1.9633000000000003 32.0968 -0.350248 -0.350248 -0.350248 -32.062799999999996 1.9633000000000003 32.0968 2.46669 2.46669 2.46669 -32.062799999999996 1.9633000000000003 33.0968 -1.65852 -1.65852 -1.65852 -25.0628 3.9633000000000003 22.0968 -114.307 -114.307 -114.307 -25.0628 3.9633000000000003 23.0968 -155.949 -155.949 -155.949 -26.0628 3.9633000000000003 22.0968 45.7165 45.7165 45.7165 -26.0628 3.9633000000000003 23.0968 -72.1753 -72.1753 -72.1753 -25.0628 2.9633000000000003 24.0968 -17.8249 -17.8249 -17.8249 -25.0628 2.9633000000000003 25.0968 -4.59586 -4.59586 -4.59586 -25.0628 3.9633000000000003 24.0968 22.5274 22.5274 22.5274 -25.0628 3.9633000000000003 25.0968 3.28952 3.28952 3.28952 -26.0628 2.9633000000000003 24.0968 -1.13048 -1.13048 -1.13048 -26.0628 2.9633000000000003 25.0968 3.71229 3.71229 3.71229 -26.0628 3.9633000000000003 24.0968 -4.07392 -4.07392 -4.07392 -25.0628 4.9633 22.0968 -5.57572 -5.57572 -5.57572 -25.0628 4.9633 23.0968 9.88186 9.88186 9.88186 -25.0628 5.9633 22.0968 7.77643 7.77643 7.77643 -25.0628 5.9633 23.0968 8.0972 8.0972 8.0972 -26.0628 4.9633 22.0968 -9.44809 -9.44809 -9.44809 -26.0628 4.9633 23.0968 -0.410612 -0.410612 -0.410612 -26.0628 5.9633 23.0968 -6.4229 -6.4229 -6.4229 -25.0628 4.9633 24.0968 8.59233 8.59233 8.59233 -25.0628 4.9633 25.0968 2.86376 2.86376 2.86376 -25.0628 5.9633 24.0968 -7.02965 -7.02965 -7.02965 -25.0628 5.9633 25.0968 1.75553 1.75553 1.75553 -26.0628 4.9633 24.0968 17.5242 17.5242 17.5242 -26.0628 4.9633 25.0968 -0.940136 -0.940136 -0.940136 -26.0628 5.9633 24.0968 -10.4283 -10.4283 -10.4283 -26.0628 5.9633 25.0968 1.61716 1.61716 1.61716 -27.0628 3.9633000000000003 22.0968 18.9587 18.9587 18.9587 -28.0628 2.9633000000000003 22.0968 -0.0129361 -0.0129361 -0.0129361 -28.0628 2.9633000000000003 23.0968 -22.275 -22.275 -22.275 -28.0628 3.9633000000000003 22.0968 -4.74658 -4.74658 -4.74658 -28.0628 3.9633000000000003 23.0968 -15.8355 -15.8355 -15.8355 -27.0628 2.9633000000000003 24.0968 36.5884 36.5884 36.5884 -27.0628 2.9633000000000003 25.0968 -26.2503 -26.2503 -26.2503 -27.0628 3.9633000000000003 24.0968 -20.857 -20.857 -20.857 -27.0628 3.9633000000000003 25.0968 -4.03731 -4.03731 -4.03731 -28.0628 2.9633000000000003 24.0968 63.7966 63.7966 63.7966 -28.0628 2.9633000000000003 25.0968 43.3143 43.3143 43.3143 -28.0628 3.9633000000000003 24.0968 -39.7028 -39.7028 -39.7028 -28.0628 3.9633000000000003 25.0968 12.5908 12.5908 12.5908 -27.0628 4.9633 22.0968 -5.97923 -5.97923 -5.97923 -27.0628 4.9633 23.0968 -9.50572 -9.50572 -9.50572 -27.0628 5.9633 23.0968 4.17361 4.17361 4.17361 -28.0628 4.9633 22.0968 -2.68789 -2.68789 -2.68789 -28.0628 4.9633 23.0968 -18.689 -18.689 -18.689 -28.0628 5.9633 22.0968 10.1036 10.1036 10.1036 -28.0628 5.9633 23.0968 5.01744 5.01744 5.01744 -27.0628 4.9633 24.0968 3.80296 3.80296 3.80296 -27.0628 4.9633 25.0968 1.78878 1.78878 1.78878 -27.0628 5.9633 24.0968 -0.321864 -0.321864 -0.321864 -28.0628 4.9633 24.0968 -5.50531 -5.50531 -5.50531 -28.0628 4.9633 25.0968 -5.0482 -5.0482 -5.0482 -28.0628 5.9633 24.0968 -2.52053 -2.52053 -2.52053 -25.0628 2.9633000000000003 26.0968 2.45996 2.45996 2.45996 -25.0628 2.9633000000000003 27.0968 -2.95417 -2.95417 -2.95417 -25.0628 3.9633000000000003 26.0968 -3.99371 -3.99371 -3.99371 -25.0628 3.9633000000000003 27.0968 -4.53567 -4.53567 -4.53567 -26.0628 2.9633000000000003 26.0968 4.52815 4.52815 4.52815 -26.0628 2.9633000000000003 27.0968 1.68951 1.68951 1.68951 -26.0628 3.9633000000000003 26.0968 3.63537 3.63537 3.63537 -26.0628 3.9633000000000003 27.0968 1.67356 1.67356 1.67356 -25.0628 2.9633000000000003 28.0968 0.245435 0.245435 0.245435 -25.0628 2.9633000000000003 29.0968 -0.838137 -0.838137 -0.838137 -25.0628 3.9633000000000003 29.0968 -3.14186 -3.14186 -3.14186 -26.0628 2.9633000000000003 28.0968 2.62863 2.62863 2.62863 -26.0628 2.9633000000000003 29.0968 -2.16714 -2.16714 -2.16714 -26.0628 3.9633000000000003 28.0968 -5.01665 -5.01665 -5.01665 -26.0628 3.9633000000000003 29.0968 5.96941 5.96941 5.96941 -25.0628 4.9633 26.0968 -0.803969 -0.803969 -0.803969 -25.0628 4.9633 27.0968 -4.32988 -4.32988 -4.32988 -25.0628 5.9633 26.0968 0.291504 0.291504 0.291504 -25.0628 5.9633 27.0968 3.94201 3.94201 3.94201 -26.0628 4.9633 26.0968 -4.36439 -4.36439 -4.36439 -26.0628 4.9633 27.0968 -0.52497 -0.52497 -0.52497 -25.0628 4.9633 28.0968 -11.5762 -11.5762 -11.5762 -25.0628 4.9633 29.0968 -4.07081 -4.07081 -4.07081 -25.0628 5.9633 28.0968 -8.6226 -8.6226 -8.6226 -26.0628 4.9633 29.0968 3.67347 3.67347 3.67347 -27.0628 2.9633000000000003 27.0968 7.09103 7.09103 7.09103 -28.0628 2.9633000000000003 27.0968 2.31199 2.31199 2.31199 -27.0628 2.9633000000000003 28.0968 0.735602 0.735602 0.735602 -27.0628 2.9633000000000003 29.0968 -0.964558 -0.964558 -0.964558 -27.0628 3.9633000000000003 28.0968 -1.13627 -1.13627 -1.13627 -27.0628 3.9633000000000003 29.0968 -1.47995 -1.47995 -1.47995 -28.0628 2.9633000000000003 28.0968 -1.85517 -1.85517 -1.85517 -28.0628 2.9633000000000003 29.0968 0.563311 0.563311 0.563311 -28.0628 3.9633000000000003 28.0968 -1.38759 -1.38759 -1.38759 -28.0628 3.9633000000000003 29.0968 1.80824 1.80824 1.80824 -28.0628 5.9633 27.0968 18.1832 18.1832 18.1832 -27.0628 4.9633 29.0968 -2.15709 -2.15709 -2.15709 -27.0628 5.9633 29.0968 7.05715 7.05715 7.05715 -28.0628 4.9633 28.0968 -2.50349 -2.50349 -2.50349 -28.0628 4.9633 29.0968 -0.379773 -0.379773 -0.379773 -28.0628 5.9633 28.0968 -1.94733 -1.94733 -1.94733 -28.0628 5.9633 29.0968 0.770412 0.770412 0.770412 -25.0628 6.9633 23.0968 -1.43479 -1.43479 -1.43479 -25.0628 7.9633 23.0968 -2.27458 -2.27458 -2.27458 -26.0628 6.9633 23.0968 -0.679021 -0.679021 -0.679021 -26.0628 7.9633 22.0968 4.85455 4.85455 4.85455 -26.0628 7.9633 23.0968 4.78652 4.78652 4.78652 -25.0628 6.9633 24.0968 -0.643231 -0.643231 -0.643231 -25.0628 6.9633 25.0968 -0.45774 -0.45774 -0.45774 -25.0628 7.9633 24.0968 0.0731986 0.0731986 0.0731986 -25.0628 7.9633 25.0968 0.0666986 0.0666986 0.0666986 -25.0628 8.9633 22.0968 -0.0202885 -0.0202885 -0.0202885 -25.0628 8.9633 23.0968 1.50628 1.50628 1.50628 -25.0628 9.9633 22.0968 -0.514089 -0.514089 -0.514089 -25.0628 9.9633 23.0968 0.630131 0.630131 0.630131 -26.0628 8.9633 22.0968 -1.95891 -1.95891 -1.95891 -26.0628 8.9633 23.0968 6.69749 6.69749 6.69749 -26.0628 9.9633 22.0968 -0.0942496 -0.0942496 -0.0942496 -26.0628 9.9633 23.0968 1.45849 1.45849 1.45849 -25.0628 8.9633 24.0968 -1.19067 -1.19067 -1.19067 -25.0628 8.9633 25.0968 -0.145726 -0.145726 -0.145726 -25.0628 9.9633 24.0968 -1.06215 -1.06215 -1.06215 -25.0628 9.9633 25.0968 2.74873 2.74873 2.74873 -26.0628 9.9633 25.0968 -0.359543 -0.359543 -0.359543 -27.0628 6.9633 23.0968 7.91396 7.91396 7.91396 -27.0628 7.9633 22.0968 6.60907 6.60907 6.60907 -27.0628 7.9633 23.0968 -9.55891 -9.55891 -9.55891 -28.0628 6.9633 22.0968 -5.81395 -5.81395 -5.81395 -28.0628 6.9633 23.0968 12.4447 12.4447 12.4447 -28.0628 7.9633 22.0968 -1.16256 -1.16256 -1.16256 -28.0628 7.9633 23.0968 1.93994 1.93994 1.93994 -27.0628 6.9633 24.0968 -2.94261 -2.94261 -2.94261 -27.0628 7.9633 25.0968 0.253239 0.253239 0.253239 -28.0628 6.9633 24.0968 6.75291 6.75291 6.75291 -28.0628 7.9633 24.0968 7.9389 7.9389 7.9389 -28.0628 7.9633 25.0968 -21.8849 -21.8849 -21.8849 -27.0628 8.9633 22.0968 -4.19938 -4.19938 -4.19938 -27.0628 8.9633 23.0968 -2.70373 -2.70373 -2.70373 -27.0628 9.9633 22.0968 4.14581 4.14581 4.14581 -27.0628 9.9633 23.0968 -2.83315 -2.83315 -2.83315 -28.0628 8.9633 22.0968 -4.10263 -4.10263 -4.10263 -28.0628 8.9633 23.0968 10.4146 10.4146 10.4146 -28.0628 9.9633 23.0968 5.33349 5.33349 5.33349 -27.0628 9.9633 24.0968 1.20945 1.20945 1.20945 -28.0628 8.9633 24.0968 -3.70387 -3.70387 -3.70387 -28.0628 8.9633 25.0968 -2.82875 -2.82875 -2.82875 -28.0628 9.9633 24.0968 2.71555 2.71555 2.71555 -28.0628 9.9633 25.0968 7.60973 7.60973 7.60973 -25.0628 6.9633 27.0968 0.421304 0.421304 0.421304 -25.0628 7.9633 26.0968 1.63701 1.63701 1.63701 -25.0628 7.9633 27.0968 0.0175693 0.0175693 0.0175693 -26.0628 6.9633 27.0968 -1.41009 -1.41009 -1.41009 -26.0628 7.9633 26.0968 -2.11655 -2.11655 -2.11655 -26.0628 7.9633 27.0968 -0.561851 -0.561851 -0.561851 -25.0628 7.9633 28.0968 0.918777 0.918777 0.918777 -26.0628 7.9633 28.0968 0.865713 0.865713 0.865713 -26.0628 7.9633 29.0968 -0.500539 -0.500539 -0.500539 -25.0628 8.9633 26.0968 0.731326 0.731326 0.731326 -25.0628 8.9633 27.0968 0.220445 0.220445 0.220445 -25.0628 9.9633 26.0968 -6.42513 -6.42513 -6.42513 -25.0628 9.9633 27.0968 1.83856 1.83856 1.83856 -26.0628 8.9633 26.0968 -0.711844 -0.711844 -0.711844 -26.0628 8.9633 27.0968 -12.0385 -12.0385 -12.0385 -26.0628 9.9633 26.0968 0.892652 0.892652 0.892652 -26.0628 9.9633 27.0968 -31.8256 -31.8256 -31.8256 -25.0628 8.9633 28.0968 1.49671 1.49671 1.49671 -25.0628 8.9633 29.0968 1.78361 1.78361 1.78361 -25.0628 9.9633 28.0968 0.0443406 0.0443406 0.0443406 -25.0628 9.9633 29.0968 -4.15245 -4.15245 -4.15245 -26.0628 8.9633 28.0968 90.1322 90.1322 90.1322 -26.0628 8.9633 29.0968 7.50017 7.50017 7.50017 -26.0628 9.9633 28.0968 -15.0032 -15.0032 -15.0032 -26.0628 9.9633 29.0968 4.59057 4.59057 4.59057 -27.0628 6.9633 27.0968 1.99703 1.99703 1.99703 -27.0628 7.9633 26.0968 -1.41741 -1.41741 -1.41741 -27.0628 7.9633 27.0968 2.55323 2.55323 2.55323 -28.0628 6.9633 26.0968 -41.0196 -41.0196 -41.0196 -28.0628 6.9633 27.0968 24.0585 24.0585 24.0585 -28.0628 7.9633 26.0968 7.88557 7.88557 7.88557 -28.0628 7.9633 27.0968 16.0234 16.0234 16.0234 -27.0628 7.9633 29.0968 1.12878 1.12878 1.12878 -28.0628 6.9633 28.0968 4.71989 4.71989 4.71989 -28.0628 6.9633 29.0968 -2.82418 -2.82418 -2.82418 -28.0628 7.9633 28.0968 -0.928516 -0.928516 -0.928516 -28.0628 7.9633 29.0968 3.5886 3.5886 3.5886 -27.0628 8.9633 27.0968 33.4924 33.4924 33.4924 -27.0628 9.9633 27.0968 36.8945 36.8945 36.8945 -28.0628 8.9633 26.0968 5.06145 5.06145 5.06145 -28.0628 8.9633 27.0968 -9.8459 -9.8459 -9.8459 -28.0628 9.9633 27.0968 -153.525 -153.525 -153.525 -27.0628 8.9633 28.0968 48.3924 48.3924 48.3924 -27.0628 8.9633 29.0968 24.0835 24.0835 24.0835 -27.0628 9.9633 28.0968 -16.4608 -16.4608 -16.4608 -27.0628 9.9633 29.0968 16.6596 16.6596 16.6596 -28.0628 8.9633 28.0968 34.8371 34.8371 34.8371 -28.0628 8.9633 29.0968 9.07177 9.07177 9.07177 -28.0628 9.9633 28.0968 13.9662 13.9662 13.9662 -28.0628 9.9633 29.0968 104.501 104.501 104.501 -29.0628 2.9633000000000003 22.0968 -1.16079 -1.16079 -1.16079 -29.0628 2.9633000000000003 23.0968 3.19216 3.19216 3.19216 -29.0628 3.9633000000000003 22.0968 2.8288 2.8288 2.8288 -29.0628 3.9633000000000003 23.0968 4.36613 4.36613 4.36613 -30.0628 2.9633000000000003 22.0968 -3.06299 -3.06299 -3.06299 -30.0628 2.9633000000000003 23.0968 -3.80204 -3.80204 -3.80204 -30.0628 3.9633000000000003 22.0968 -0.722847 -0.722847 -0.722847 -30.0628 3.9633000000000003 23.0968 -0.339838 -0.339838 -0.339838 -29.0628 2.9633000000000003 25.0968 9.71761 9.71761 9.71761 -29.0628 3.9633000000000003 24.0968 13.3362 13.3362 13.3362 -29.0628 3.9633000000000003 25.0968 54.1816 54.1816 54.1816 -30.0628 3.9633000000000003 24.0968 -24.0962 -24.0962 -24.0962 -29.0628 5.9633 22.0968 5.95538 5.95538 5.95538 -29.0628 5.9633 23.0968 -6.04974 -6.04974 -6.04974 -30.0628 5.9633 22.0968 -6.74477 -6.74477 -6.74477 -30.0628 5.9633 23.0968 5.23097 5.23097 5.23097 -29.0628 4.9633 24.0968 8.68084 8.68084 8.68084 -29.0628 4.9633 25.0968 13.784 13.784 13.784 -29.0628 5.9633 24.0968 13.0848 13.0848 13.0848 -30.0628 4.9633 24.0968 -29.8661 -29.8661 -29.8661 -30.0628 4.9633 25.0968 -27.3727 -27.3727 -27.3727 -30.0628 5.9633 24.0968 -7.27287 -7.27287 -7.27287 -30.0628 5.9633 25.0968 13.1663 13.1663 13.1663 -31.0628 2.9633000000000003 22.0968 -11.6356 -11.6356 -11.6356 -31.0628 2.9633000000000003 23.0968 1.60583 1.60583 1.60583 -31.0628 3.9633000000000003 22.0968 7.60966 7.60966 7.60966 -31.0628 3.9633000000000003 23.0968 -0.325062 -0.325062 -0.325062 -32.062799999999996 2.9633000000000003 23.0968 13.1198 13.1198 13.1198 -32.062799999999996 3.9633000000000003 22.0968 0.71814 0.71814 0.71814 -32.062799999999996 3.9633000000000003 23.0968 22.1269 22.1269 22.1269 -31.0628 2.9633000000000003 24.0968 6.12301 6.12301 6.12301 -31.0628 2.9633000000000003 25.0968 1.36508 1.36508 1.36508 -31.0628 3.9633000000000003 24.0968 2.17492 2.17492 2.17492 -31.0628 3.9633000000000003 25.0968 0.43164 0.43164 0.43164 -32.062799999999996 2.9633000000000003 24.0968 -0.466956 -0.466956 -0.466956 -32.062799999999996 2.9633000000000003 25.0968 -2.96434 -2.96434 -2.96434 -32.062799999999996 3.9633000000000003 24.0968 1.02376 1.02376 1.02376 -32.062799999999996 3.9633000000000003 25.0968 -19.9734 -19.9734 -19.9734 -31.0628 4.9633 22.0968 -1.26749 -1.26749 -1.26749 -31.0628 4.9633 23.0968 -7.50547 -7.50547 -7.50547 -31.0628 5.9633 22.0968 2.44901 2.44901 2.44901 -31.0628 5.9633 23.0968 -1.53534 -1.53534 -1.53534 -32.062799999999996 4.9633 22.0968 -5.20442 -5.20442 -5.20442 -32.062799999999996 4.9633 23.0968 10.5482 10.5482 10.5482 -32.062799999999996 5.9633 22.0968 4.21679 4.21679 4.21679 -32.062799999999996 5.9633 23.0968 2.31807 2.31807 2.31807 -31.0628 4.9633 24.0968 -17.0008 -17.0008 -17.0008 -32.062799999999996 4.9633 24.0968 10.4805 10.4805 10.4805 -32.062799999999996 4.9633 25.0968 -21.8642 -21.8642 -21.8642 -32.062799999999996 5.9633 24.0968 6.13235 6.13235 6.13235 -32.062799999999996 5.9633 25.0968 -5.25058 -5.25058 -5.25058 -29.0628 2.9633000000000003 26.0968 0.13171 0.13171 0.13171 -29.0628 2.9633000000000003 27.0968 7.51474 7.51474 7.51474 -29.0628 3.9633000000000003 26.0968 74.3472 74.3472 74.3472 -29.0628 3.9633000000000003 27.0968 1.24066 1.24066 1.24066 -30.0628 2.9633000000000003 26.0968 5.23802 5.23802 5.23802 -30.0628 2.9633000000000003 27.0968 -2.54155 -2.54155 -2.54155 -30.0628 3.9633000000000003 26.0968 5.41181 5.41181 5.41181 -30.0628 3.9633000000000003 27.0968 -1.53268 -1.53268 -1.53268 -29.0628 2.9633000000000003 28.0968 -1.49619 -1.49619 -1.49619 -29.0628 2.9633000000000003 29.0968 10.339 10.339 10.339 -29.0628 3.9633000000000003 28.0968 -2.84229 -2.84229 -2.84229 -30.0628 2.9633000000000003 28.0968 -3.67906 -3.67906 -3.67906 -30.0628 2.9633000000000003 29.0968 4.1458 4.1458 4.1458 -30.0628 3.9633000000000003 28.0968 -5.53536 -5.53536 -5.53536 -30.0628 3.9633000000000003 29.0968 12.6335 12.6335 12.6335 -29.0628 4.9633 26.0968 -12.4752 -12.4752 -12.4752 -29.0628 4.9633 27.0968 15.2601 15.2601 15.2601 -29.0628 5.9633 26.0968 -2.68888 -2.68888 -2.68888 -29.0628 5.9633 27.0968 39.0128 39.0128 39.0128 -30.0628 4.9633 26.0968 7.26697 7.26697 7.26697 -30.0628 5.9633 26.0968 -0.264811 -0.264811 -0.264811 -29.0628 4.9633 28.0968 -1.341 -1.341 -1.341 -29.0628 4.9633 29.0968 -23.3613 -23.3613 -23.3613 -29.0628 5.9633 28.0968 4.96571 4.96571 4.96571 -29.0628 5.9633 29.0968 -30.7979 -30.7979 -30.7979 -30.0628 4.9633 29.0968 28.1461 28.1461 28.1461 -30.0628 5.9633 28.0968 0.819611 0.819611 0.819611 -30.0628 5.9633 29.0968 -28.4938 -28.4938 -28.4938 -31.0628 2.9633000000000003 26.0968 -0.0755569 -0.0755569 -0.0755569 -31.0628 3.9633000000000003 26.0968 -3.05684 -3.05684 -3.05684 -31.0628 3.9633000000000003 27.0968 -3.14299 -3.14299 -3.14299 -32.062799999999996 3.9633000000000003 26.0968 -1.4944 -1.4944 -1.4944 -31.0628 2.9633000000000003 28.0968 -0.795785 -0.795785 -0.795785 -31.0628 2.9633000000000003 29.0968 0.50869 0.50869 0.50869 -31.0628 3.9633000000000003 28.0968 -6.35607 -6.35607 -6.35607 -31.0628 3.9633000000000003 29.0968 -6.81349 -6.81349 -6.81349 -32.062799999999996 2.9633000000000003 28.0968 -0.0792511 -0.0792511 -0.0792511 -32.062799999999996 2.9633000000000003 29.0968 1.75406 1.75406 1.75406 -32.062799999999996 3.9633000000000003 28.0968 -3.37105 -3.37105 -3.37105 -32.062799999999996 3.9633000000000003 29.0968 1.60673 1.60673 1.60673 -31.0628 4.9633 26.0968 -13.1179 -13.1179 -13.1179 -31.0628 4.9633 27.0968 -3.31743 -3.31743 -3.31743 -31.0628 5.9633 26.0968 -8.98659 -8.98659 -8.98659 -31.0628 5.9633 27.0968 -1.7075 -1.7075 -1.7075 -32.062799999999996 4.9633 26.0968 -1.48645 -1.48645 -1.48645 -32.062799999999996 4.9633 27.0968 3.52103 3.52103 3.52103 -32.062799999999996 5.9633 26.0968 -1.2883 -1.2883 -1.2883 -32.062799999999996 5.9633 27.0968 2.47621 2.47621 2.47621 -31.0628 4.9633 28.0968 -1.17841 -1.17841 -1.17841 -31.0628 4.9633 29.0968 -10.4541 -10.4541 -10.4541 -31.0628 5.9633 28.0968 0.49147 0.49147 0.49147 -31.0628 5.9633 29.0968 -29.3589 -29.3589 -29.3589 -32.062799999999996 4.9633 28.0968 -0.328807 -0.328807 -0.328807 -32.062799999999996 4.9633 29.0968 2.63576 2.63576 2.63576 -32.062799999999996 5.9633 28.0968 0.631048 0.631048 0.631048 -32.062799999999996 5.9633 29.0968 1.65235 1.65235 1.65235 -29.0628 6.9633 22.0968 -1.17765 -1.17765 -1.17765 -29.0628 6.9633 23.0968 -14.5266 -14.5266 -14.5266 -29.0628 7.9633 22.0968 -3.07138 -3.07138 -3.07138 -30.0628 6.9633 22.0968 -7.50183 -7.50183 -7.50183 -30.0628 6.9633 23.0968 5.47704 5.47704 5.47704 -30.0628 7.9633 22.0968 16.7582 16.7582 16.7582 -29.0628 6.9633 24.0968 5.03101 5.03101 5.03101 -29.0628 6.9633 25.0968 -6.45931 -6.45931 -6.45931 -29.0628 7.9633 24.0968 -1.66811 -1.66811 -1.66811 -29.0628 7.9633 25.0968 0.792395 0.792395 0.792395 -30.0628 6.9633 24.0968 6.46543 6.46543 6.46543 -30.0628 6.9633 25.0968 0.783728 0.783728 0.783728 -30.0628 7.9633 25.0968 20.1795 20.1795 20.1795 -29.0628 9.9633 23.0968 2.02564 2.02564 2.02564 -30.0628 8.9633 22.0968 3.78439 3.78439 3.78439 -30.0628 9.9633 23.0968 -7.37249 -7.37249 -7.37249 -29.0628 8.9633 24.0968 1.00503 1.00503 1.00503 -29.0628 8.9633 25.0968 -1.80492 -1.80492 -1.80492 -29.0628 9.9633 24.0968 1.75669 1.75669 1.75669 -29.0628 9.9633 25.0968 2.35478 2.35478 2.35478 -30.0628 8.9633 25.0968 9.50395 9.50395 9.50395 -30.0628 9.9633 24.0968 -42.1417 -42.1417 -42.1417 -30.0628 9.9633 25.0968 -0.708205 -0.708205 -0.708205 -31.0628 6.9633 22.0968 5.16363 5.16363 5.16363 -31.0628 6.9633 23.0968 3.05764 3.05764 3.05764 -31.0628 7.9633 22.0968 24.9099 24.9099 24.9099 -32.062799999999996 6.9633 22.0968 -4.36968 -4.36968 -4.36968 -32.062799999999996 6.9633 23.0968 1.16993 1.16993 1.16993 -32.062799999999996 7.9633 22.0968 -4.58075 -4.58075 -4.58075 -32.062799999999996 7.9633 23.0968 -28.0596 -28.0596 -28.0596 -31.0628 6.9633 24.0968 6.39014 6.39014 6.39014 -31.0628 6.9633 25.0968 -34.4624 -34.4624 -34.4624 -31.0628 7.9633 24.0968 -34.995 -34.995 -34.995 -31.0628 7.9633 25.0968 -27.7308 -27.7308 -27.7308 -32.062799999999996 6.9633 24.0968 -10.9984 -10.9984 -10.9984 -32.062799999999996 6.9633 25.0968 -8.79726 -8.79726 -8.79726 -32.062799999999996 7.9633 24.0968 23.2293 23.2293 23.2293 -32.062799999999996 7.9633 25.0968 20.5843 20.5843 20.5843 -31.0628 8.9633 22.0968 38.8557 38.8557 38.8557 -31.0628 9.9633 22.0968 -153.789 -153.789 -153.789 -31.0628 9.9633 23.0968 -167.648 -167.648 -167.648 -32.062799999999996 8.9633 22.0968 33.9931 33.9931 33.9931 -32.062799999999996 8.9633 23.0968 -2.27783 -2.27783 -2.27783 -32.062799999999996 9.9633 22.0968 -232.705 -232.705 -232.705 -32.062799999999996 9.9633 23.0968 -170.335 -170.335 -170.335 -31.0628 8.9633 25.0968 26.3009 26.3009 26.3009 -31.0628 9.9633 24.0968 -397.362 -397.362 -397.362 -31.0628 9.9633 25.0968 -6.48506 -6.48506 -6.48506 -32.062799999999996 8.9633 24.0968 -3.65757 -3.65757 -3.65757 -32.062799999999996 8.9633 25.0968 9.71623 9.71623 9.71623 -32.062799999999996 9.9633 24.0968 -342.994 -342.994 -342.994 -32.062799999999996 9.9633 25.0968 -7.19431 -7.19431 -7.19431 -29.0628 6.9633 26.0968 23.7395 23.7395 23.7395 -29.0628 6.9633 27.0968 13.5142 13.5142 13.5142 -29.0628 7.9633 26.0968 -27.7301 -27.7301 -27.7301 -29.0628 7.9633 27.0968 16.3013 16.3013 16.3013 -30.0628 6.9633 26.0968 -16.0836 -16.0836 -16.0836 -30.0628 6.9633 27.0968 -4.02188 -4.02188 -4.02188 -30.0628 7.9633 26.0968 -48.4707 -48.4707 -48.4707 -30.0628 7.9633 27.0968 -12.6845 -12.6845 -12.6845 -29.0628 6.9633 28.0968 2.52694 2.52694 2.52694 -29.0628 6.9633 29.0968 -2.49479 -2.49479 -2.49479 -29.0628 7.9633 28.0968 -1.48058 -1.48058 -1.48058 -29.0628 7.9633 29.0968 2.97228 2.97228 2.97228 -30.0628 6.9633 28.0968 4.99031 4.99031 4.99031 -30.0628 6.9633 29.0968 -20.0762 -20.0762 -20.0762 -30.0628 7.9633 28.0968 -12.2102 -12.2102 -12.2102 -29.0628 8.9633 26.0968 4.56171 4.56171 4.56171 -30.0628 8.9633 26.0968 -32.6251 -32.6251 -32.6251 -30.0628 8.9633 27.0968 -10.2363 -10.2363 -10.2363 -30.0628 9.9633 26.0968 -7.96099 -7.96099 -7.96099 -29.0628 8.9633 28.0968 5.36868 5.36868 5.36868 -29.0628 8.9633 29.0968 2.78389 2.78389 2.78389 -29.0628 9.9633 28.0968 6.03495 6.03495 6.03495 -29.0628 9.9633 29.0968 -3.40672 -3.40672 -3.40672 -30.0628 8.9633 29.0968 2.7569 2.7569 2.7569 -30.0628 9.9633 28.0968 -4.87265 -4.87265 -4.87265 -30.0628 9.9633 29.0968 9.17485 9.17485 9.17485 -31.0628 6.9633 26.0968 36.6034 36.6034 36.6034 -31.0628 6.9633 27.0968 -3.87055 -3.87055 -3.87055 -31.0628 7.9633 26.0968 34.9887 34.9887 34.9887 -31.0628 7.9633 27.0968 -3.60643 -3.60643 -3.60643 -32.062799999999996 6.9633 26.0968 10.9778 10.9778 10.9778 -32.062799999999996 7.9633 26.0968 42.0245 42.0245 42.0245 -31.0628 6.9633 29.0968 15.3016 15.3016 15.3016 -31.0628 8.9633 26.0968 -27.7132 -27.7132 -27.7132 -31.0628 8.9633 27.0968 5.30223 5.30223 5.30223 -31.0628 9.9633 26.0968 -8.61298 -8.61298 -8.61298 -31.0628 9.9633 27.0968 -4.43751 -4.43751 -4.43751 -32.062799999999996 8.9633 26.0968 8.58447 8.58447 8.58447 -32.062799999999996 8.9633 27.0968 9.86567 9.86567 9.86567 -32.062799999999996 9.9633 26.0968 -0.648181 -0.648181 -0.648181 -32.062799999999996 9.9633 27.0968 -14.0051 -14.0051 -14.0051 -31.0628 8.9633 28.0968 5.92571 5.92571 5.92571 -31.0628 8.9633 29.0968 1.73312 1.73312 1.73312 -31.0628 9.9633 28.0968 -5.34481 -5.34481 -5.34481 -31.0628 9.9633 29.0968 -0.866233 -0.866233 -0.866233 -32.062799999999996 8.9633 28.0968 -6.78244 -6.78244 -6.78244 -32.062799999999996 8.9633 29.0968 3.8007 3.8007 3.8007 -32.062799999999996 9.9633 28.0968 -13.0605 -13.0605 -13.0605 -32.062799999999996 9.9633 29.0968 1.61797 1.61797 1.61797 -25.0628 2.9633000000000003 30.0968 0.262702 0.262702 0.262702 -25.0628 2.9633000000000003 31.0968 0.149074 0.149074 0.149074 -25.0628 3.9633000000000003 30.0968 0.684803 0.684803 0.684803 -25.0628 3.9633000000000003 31.0968 -1.35577 -1.35577 -1.35577 -26.0628 2.9633000000000003 31.0968 0.62967 0.62967 0.62967 -26.0628 3.9633000000000003 31.0968 -2.96276 -2.96276 -2.96276 -25.0628 2.9633000000000003 32.0968 -0.5079 -0.5079 -0.5079 -25.0628 2.9633000000000003 33.0968 -2.53286 -2.53286 -2.53286 -25.0628 3.9633000000000003 32.0968 0.302455 0.302455 0.302455 -25.0628 4.9633 30.0968 -1.72002 -1.72002 -1.72002 -26.0628 4.9633 30.0968 3.78497 3.78497 3.78497 -26.0628 4.9633 31.0968 -3.66014 -3.66014 -3.66014 -26.0628 5.9633 30.0968 4.94864 4.94864 4.94864 -26.0628 5.9633 31.0968 0.572172 0.572172 0.572172 -26.0628 4.9633 32.0968 1.15695 1.15695 1.15695 -26.0628 4.9633 33.0968 1.54897 1.54897 1.54897 -26.0628 5.9633 32.0968 -2.27311 -2.27311 -2.27311 -26.0628 5.9633 33.0968 -2.4407 -2.4407 -2.4407 -27.0628 2.9633000000000003 30.0968 -3.49348 -3.49348 -3.49348 -27.0628 2.9633000000000003 31.0968 4.00955 4.00955 4.00955 -27.0628 3.9633000000000003 30.0968 -0.957852 -0.957852 -0.957852 -27.0628 3.9633000000000003 31.0968 -3.91058 -3.91058 -3.91058 -28.0628 2.9633000000000003 31.0968 5.5698 5.5698 5.5698 -28.0628 3.9633000000000003 31.0968 -2.41508 -2.41508 -2.41508 -27.0628 2.9633000000000003 32.0968 4.6695 4.6695 4.6695 -27.0628 2.9633000000000003 33.0968 -0.200822 -0.200822 -0.200822 -27.0628 3.9633000000000003 32.0968 0.269038 0.269038 0.269038 -27.0628 3.9633000000000003 33.0968 -0.137335 -0.137335 -0.137335 -28.0628 2.9633000000000003 32.0968 -1.12674 -1.12674 -1.12674 -28.0628 2.9633000000000003 33.0968 0.711296 0.711296 0.711296 -28.0628 3.9633000000000003 32.0968 -1.18991 -1.18991 -1.18991 -28.0628 3.9633000000000003 33.0968 -3.07139 -3.07139 -3.07139 -27.0628 4.9633 30.0968 -1.29654 -1.29654 -1.29654 -27.0628 4.9633 31.0968 -4.75313 -4.75313 -4.75313 -27.0628 5.9633 30.0968 3.7411 3.7411 3.7411 -27.0628 5.9633 31.0968 -1.78018 -1.78018 -1.78018 -28.0628 4.9633 30.0968 1.21697 1.21697 1.21697 -28.0628 4.9633 31.0968 5.83316 5.83316 5.83316 -28.0628 5.9633 30.0968 0.54763 0.54763 0.54763 -27.0628 4.9633 32.0968 2.31798 2.31798 2.31798 -27.0628 4.9633 33.0968 -0.478136 -0.478136 -0.478136 -27.0628 5.9633 32.0968 -2.47821 -2.47821 -2.47821 -28.0628 4.9633 32.0968 0.428327 0.428327 0.428327 -25.0628 2.9633000000000003 34.0968 6.4198 6.4198 6.4198 -25.0628 2.9633000000000003 35.0968 1.37072 1.37072 1.37072 -26.0628 2.9633000000000003 34.0968 1.00877 1.00877 1.00877 -26.0628 2.9633000000000003 35.0968 0.214504 0.214504 0.214504 -26.0628 3.9633000000000003 34.0968 -0.138822 -0.138822 -0.138822 -26.0628 3.9633000000000003 35.0968 1.05038 1.05038 1.05038 -25.0628 2.9633000000000003 36.0968 0.472006 0.472006 0.472006 -25.0628 3.9633000000000003 36.0968 0.0607129 0.0607129 0.0607129 -25.0628 3.9633000000000003 37.0968 0.279015 0.279015 0.279015 -26.0628 2.9633000000000003 36.0968 -0.0133897 -0.0133897 -0.0133897 -26.0628 3.9633000000000003 36.0968 0.257099 0.257099 0.257099 -25.0628 4.9633 34.0968 5.51227 5.51227 5.51227 -25.0628 4.9633 35.0968 8.16282 8.16282 8.16282 -25.0628 5.9633 34.0968 -1.19603 -1.19603 -1.19603 -25.0628 5.9633 35.0968 1.3982 1.3982 1.3982 -26.0628 4.9633 34.0968 -0.264413 -0.264413 -0.264413 -26.0628 4.9633 35.0968 0.733708 0.733708 0.733708 -26.0628 5.9633 34.0968 -1.09804 -1.09804 -1.09804 -25.0628 4.9633 36.0968 -0.524583 -0.524583 -0.524583 -25.0628 5.9633 36.0968 -1.84521 -1.84521 -1.84521 -26.0628 4.9633 36.0968 1.50737 1.50737 1.50737 -27.0628 2.9633000000000003 34.0968 -1.30736 -1.30736 -1.30736 -27.0628 3.9633000000000003 34.0968 2.34949 2.34949 2.34949 -28.0628 2.9633000000000003 34.0968 2.1097 2.1097 2.1097 -28.0628 3.9633000000000003 34.0968 1.20387 1.20387 1.20387 -27.0628 4.9633 34.0968 -0.429823 -0.429823 -0.429823 -25.0628 7.9633 30.0968 0.0169922 0.0169922 0.0169922 -25.0628 7.9633 31.0968 1.3479 1.3479 1.3479 -26.0628 6.9633 30.0968 1.92934 1.92934 1.92934 -26.0628 7.9633 30.0968 -0.228001 -0.228001 -0.228001 -26.0628 7.9633 31.0968 0.246359 0.246359 0.246359 -25.0628 6.9633 32.0968 -1.29806 -1.29806 -1.29806 -25.0628 6.9633 33.0968 2.83974 2.83974 2.83974 -25.0628 7.9633 32.0968 0.954363 0.954363 0.954363 -25.0628 7.9633 33.0968 1.22856 1.22856 1.22856 -26.0628 6.9633 32.0968 -2.36516 -2.36516 -2.36516 -26.0628 6.9633 33.0968 1.7687 1.7687 1.7687 -26.0628 7.9633 32.0968 1.41983 1.41983 1.41983 -26.0628 7.9633 33.0968 1.17575 1.17575 1.17575 -25.0628 8.9633 30.0968 -2.32628 -2.32628 -2.32628 -25.0628 8.9633 31.0968 3.50368 3.50368 3.50368 -25.0628 9.9633 30.0968 0.441316 0.441316 0.441316 -25.0628 9.9633 31.0968 -7.4133 -7.4133 -7.4133 -26.0628 8.9633 30.0968 0.0333497 0.0333497 0.0333497 -26.0628 8.9633 31.0968 -1.91782 -1.91782 -1.91782 -26.0628 9.9633 30.0968 -0.00338581 -0.00338581 -0.00338581 -26.0628 9.9633 31.0968 11.2084 11.2084 11.2084 -25.0628 8.9633 33.0968 1.04291 1.04291 1.04291 -25.0628 9.9633 32.0968 -39.9683 -39.9683 -39.9683 -25.0628 9.9633 33.0968 26.9682 26.9682 26.9682 -26.0628 8.9633 32.0968 -0.731877 -0.731877 -0.731877 -26.0628 8.9633 33.0968 1.63092 1.63092 1.63092 -26.0628 9.9633 32.0968 10.593 10.593 10.593 -26.0628 9.9633 33.0968 -22.0753 -22.0753 -22.0753 -27.0628 6.9633 30.0968 3.17693 3.17693 3.17693 -27.0628 6.9633 31.0968 2.52068 2.52068 2.52068 -27.0628 7.9633 30.0968 -4.49189 -4.49189 -4.49189 -27.0628 7.9633 31.0968 3.78012 3.78012 3.78012 -28.0628 6.9633 30.0968 -0.627727 -0.627727 -0.627727 -28.0628 6.9633 31.0968 2.60065 2.60065 2.60065 -28.0628 7.9633 30.0968 -3.5601 -3.5601 -3.5601 -28.0628 7.9633 31.0968 2.21966 2.21966 2.21966 -27.0628 6.9633 32.0968 -3.58847 -3.58847 -3.58847 -27.0628 7.9633 32.0968 0.477669 0.477669 0.477669 -28.0628 7.9633 32.0968 -1.25139 -1.25139 -1.25139 -28.0628 7.9633 33.0968 3.6841 3.6841 3.6841 -27.0628 8.9633 30.0968 6.48949 6.48949 6.48949 -27.0628 8.9633 31.0968 0.697105 0.697105 0.697105 -27.0628 9.9633 30.0968 2.60411 2.60411 2.60411 -27.0628 9.9633 31.0968 -0.41567 -0.41567 -0.41567 -28.0628 8.9633 30.0968 -9.13243 -9.13243 -9.13243 -28.0628 8.9633 31.0968 -3.38335 -3.38335 -3.38335 -28.0628 9.9633 30.0968 -10.0691 -10.0691 -10.0691 -28.0628 9.9633 31.0968 -0.223872 -0.223872 -0.223872 -27.0628 8.9633 32.0968 -0.225201 -0.225201 -0.225201 -27.0628 8.9633 33.0968 -2.24873 -2.24873 -2.24873 -27.0628 9.9633 32.0968 -0.463964 -0.463964 -0.463964 -27.0628 9.9633 33.0968 -0.826386 -0.826386 -0.826386 -28.0628 8.9633 32.0968 -2.23891 -2.23891 -2.23891 -28.0628 8.9633 33.0968 3.84869 3.84869 3.84869 -28.0628 9.9633 32.0968 2.52568 2.52568 2.52568 -28.0628 9.9633 33.0968 0.11846 0.11846 0.11846 -25.0628 6.9633 34.0968 1.16215 1.16215 1.16215 -25.0628 6.9633 35.0968 -0.342854 -0.342854 -0.342854 -25.0628 7.9633 34.0968 -0.448014 -0.448014 -0.448014 -25.0628 7.9633 35.0968 -1.24083 -1.24083 -1.24083 -26.0628 6.9633 34.0968 0.380309 0.380309 0.380309 -26.0628 7.9633 34.0968 -0.174467 -0.174467 -0.174467 -26.0628 7.9633 35.0968 -1.06994 -1.06994 -1.06994 -25.0628 7.9633 36.0968 22.5009 22.5009 22.5009 -25.0628 8.9633 34.0968 0.591418 0.591418 0.591418 -25.0628 8.9633 35.0968 -1.42734 -1.42734 -1.42734 -25.0628 9.9633 34.0968 -0.00409603 -0.00409603 -0.00409603 -25.0628 9.9633 35.0968 0.475571 0.475571 0.475571 -26.0628 8.9633 34.0968 4.0232 4.0232 4.0232 -26.0628 9.9633 34.0968 -0.697435 -0.697435 -0.697435 -26.0628 9.9633 35.0968 -2.00528 -2.00528 -2.00528 -27.0628 8.9633 34.0968 1.93636 1.93636 1.93636 -27.0628 9.9633 34.0968 -1.16422 -1.16422 -1.16422 -27.0628 9.9633 35.0968 -0.826512 -0.826512 -0.826512 -28.0628 9.9633 34.0968 2.96494 2.96494 2.96494 -28.0628 9.9633 35.0968 -2.00623 -2.00623 -2.00623 -29.0628 2.9633000000000003 31.0968 2.03593 2.03593 2.03593 -30.0628 2.9633000000000003 30.0968 2.38206 2.38206 2.38206 -30.0628 2.9633000000000003 31.0968 -5.46632 -5.46632 -5.46632 -29.0628 2.9633000000000003 32.0968 -2.85813 -2.85813 -2.85813 -29.0628 2.9633000000000003 33.0968 0.236496 0.236496 0.236496 -29.0628 3.9633000000000003 32.0968 -16.4233 -16.4233 -16.4233 -29.0628 3.9633000000000003 33.0968 8.68385 8.68385 8.68385 -30.0628 2.9633000000000003 32.0968 -0.900964 -0.900964 -0.900964 -30.0628 2.9633000000000003 33.0968 -0.211287 -0.211287 -0.211287 -30.0628 3.9633000000000003 33.0968 -13.0485 -13.0485 -13.0485 -29.0628 4.9633 30.0968 11.8516 11.8516 11.8516 -29.0628 4.9633 31.0968 71.7894 71.7894 71.7894 -29.0628 5.9633 30.0968 -39.9201 -39.9201 -39.9201 -29.0628 5.9633 31.0968 18.8425 18.8425 18.8425 -30.0628 4.9633 30.0968 10.8953 10.8953 10.8953 -30.0628 5.9633 30.0968 -5.26348 -5.26348 -5.26348 -30.0628 5.9633 31.0968 14.1701 14.1701 14.1701 -29.0628 4.9633 32.0968 -10.8586 -10.8586 -10.8586 -29.0628 4.9633 33.0968 -16.6356 -16.6356 -16.6356 -29.0628 5.9633 32.0968 20.2974 20.2974 20.2974 -30.0628 4.9633 32.0968 -4.91909 -4.91909 -4.91909 -30.0628 4.9633 33.0968 -7.33511 -7.33511 -7.33511 -30.0628 5.9633 32.0968 14.1907 14.1907 14.1907 -31.0628 2.9633000000000003 30.0968 4.46659 4.46659 4.46659 -32.062799999999996 2.9633000000000003 30.0968 0.973904 0.973904 0.973904 -32.062799999999996 3.9633000000000003 30.0968 0.059926 0.059926 0.059926 -31.0628 2.9633000000000003 32.0968 1.73731 1.73731 1.73731 -31.0628 2.9633000000000003 33.0968 -1.3904 -1.3904 -1.3904 -31.0628 3.9633000000000003 33.0968 1.3965 1.3965 1.3965 -32.062799999999996 2.9633000000000003 32.0968 0.778218 0.778218 0.778218 -32.062799999999996 2.9633000000000003 33.0968 0.106756 0.106756 0.106756 -32.062799999999996 3.9633000000000003 33.0968 3.08463 3.08463 3.08463 -31.0628 4.9633 30.0968 21.8411 21.8411 21.8411 -31.0628 4.9633 31.0968 25.9379 25.9379 25.9379 -31.0628 5.9633 30.0968 11.2235 11.2235 11.2235 -31.0628 5.9633 31.0968 5.72208 5.72208 5.72208 -32.062799999999996 4.9633 30.0968 -0.352134 -0.352134 -0.352134 -32.062799999999996 4.9633 31.0968 -3.50586 -3.50586 -3.50586 -32.062799999999996 5.9633 30.0968 1.1274 1.1274 1.1274 -32.062799999999996 5.9633 31.0968 -2.28564 -2.28564 -2.28564 -31.0628 4.9633 32.0968 322.751 322.751 322.751 -31.0628 4.9633 33.0968 187.085 187.085 187.085 -31.0628 5.9633 32.0968 -119.521 -119.521 -119.521 -31.0628 5.9633 33.0968 -178.722 -178.722 -178.722 -32.062799999999996 4.9633 33.0968 61.8113 61.8113 61.8113 -32.062799999999996 5.9633 33.0968 154.483 154.483 154.483 -32.062799999999996 3.9633000000000003 34.0968 0.473902 0.473902 0.473902 -32.062799999999996 4.9633 34.0968 54.7655 54.7655 54.7655 -32.062799999999996 5.9633 34.0968 64.8445 64.8445 64.8445 -29.0628 6.9633 30.0968 -6.95926 -6.95926 -6.95926 -29.0628 6.9633 31.0968 -8.32717 -8.32717 -8.32717 -29.0628 7.9633 30.0968 -2.59876 -2.59876 -2.59876 -29.0628 7.9633 31.0968 -98.6733 -98.6733 -98.6733 -30.0628 6.9633 30.0968 -14.151 -14.151 -14.151 -30.0628 6.9633 31.0968 -2.64545 -2.64545 -2.64545 -29.0628 6.9633 32.0968 0.502469 0.502469 0.502469 -29.0628 7.9633 32.0968 -79.5084 -79.5084 -79.5084 -29.0628 7.9633 33.0968 5.29054 5.29054 5.29054 -30.0628 6.9633 32.0968 0.274397 0.274397 0.274397 -30.0628 7.9633 32.0968 11.2692 11.2692 11.2692 -30.0628 7.9633 33.0968 -26.8164 -26.8164 -26.8164 -29.0628 9.9633 30.0968 3.72757 3.72757 3.72757 -30.0628 8.9633 31.0968 101.953 101.953 101.953 -30.0628 9.9633 30.0968 -8.3264 -8.3264 -8.3264 -30.0628 9.9633 31.0968 13.5399 13.5399 13.5399 -29.0628 8.9633 33.0968 19.4291 19.4291 19.4291 -29.0628 9.9633 33.0968 -9.71855 -9.71855 -9.71855 -30.0628 8.9633 32.0968 56.7095 56.7095 56.7095 -30.0628 8.9633 33.0968 12.3632 12.3632 12.3632 -30.0628 9.9633 32.0968 -12.6068 -12.6068 -12.6068 -30.0628 9.9633 33.0968 1.83655 1.83655 1.83655 -31.0628 6.9633 30.0968 2.14313 2.14313 2.14313 -32.062799999999996 6.9633 30.0968 -1.67416 -1.67416 -1.67416 -32.062799999999996 6.9633 31.0968 3.26886 3.26886 3.26886 -32.062799999999996 7.9633 30.0968 -1.32133 -1.32133 -1.32133 -32.062799999999996 7.9633 31.0968 -2.07914 -2.07914 -2.07914 -31.0628 6.9633 32.0968 189.795 189.795 189.795 -31.0628 6.9633 33.0968 9.48394 9.48394 9.48394 -31.0628 7.9633 32.0968 -50.911 -50.911 -50.911 -31.0628 7.9633 33.0968 -6.52832 -6.52832 -6.52832 -32.062799999999996 6.9633 32.0968 28.074 28.074 28.074 -32.062799999999996 6.9633 33.0968 -205.09 -205.09 -205.09 -32.062799999999996 7.9633 32.0968 23.1024 23.1024 23.1024 -31.0628 8.9633 30.0968 19.886 19.886 19.886 -31.0628 8.9633 31.0968 10.7088 10.7088 10.7088 -31.0628 9.9633 30.0968 6.23389 6.23389 6.23389 -31.0628 9.9633 31.0968 29.8343 29.8343 29.8343 -32.062799999999996 8.9633 30.0968 -1.87055 -1.87055 -1.87055 -32.062799999999996 8.9633 31.0968 -11.038 -11.038 -11.038 -32.062799999999996 9.9633 30.0968 -5.56597 -5.56597 -5.56597 -31.0628 8.9633 32.0968 10.9872 10.9872 10.9872 -32.062799999999996 8.9633 32.0968 22.9366 22.9366 22.9366 -33.062799999999996 -2.0366999999999997 27.0968 -3.81978 -3.81978 -3.81978 -34.062799999999996 -2.0366999999999997 27.0968 -25.1036 -25.1036 -25.1036 -33.062799999999996 -2.0366999999999997 28.0968 0.282032 0.282032 0.282032 -34.062799999999996 -2.0366999999999997 28.0968 8.11415 8.11415 8.11415 -34.062799999999996 -2.0366999999999997 29.0968 3.78167 3.78167 3.78167 -35.062799999999996 -2.0366999999999997 27.0968 -1.58872 -1.58872 -1.58872 -35.062799999999996 -2.0366999999999997 28.0968 8.53214 8.53214 8.53214 -35.062799999999996 -2.0366999999999997 29.0968 -7.27658 -7.27658 -7.27658 -33.062799999999996 -1.0366999999999997 25.0968 33.8016 33.8016 33.8016 -33.062799999999996 -0.03669999999999973 24.0968 29.512 29.512 29.512 -33.062799999999996 -0.03669999999999973 25.0968 -30.1254 -30.1254 -30.1254 -34.062799999999996 -0.03669999999999973 25.0968 0.393077 0.393077 0.393077 -33.062799999999996 0.9633000000000003 22.0968 -9.41861 -9.41861 -9.41861 -33.062799999999996 0.9633000000000003 23.0968 25.62 25.62 25.62 -33.062799999999996 1.9633000000000003 22.0968 -31.3959 -31.3959 -31.3959 -33.062799999999996 1.9633000000000003 23.0968 -16.838 -16.838 -16.838 -34.062799999999996 0.9633000000000003 22.0968 -15.1797 -15.1797 -15.1797 -34.062799999999996 0.9633000000000003 23.0968 -31.5781 -31.5781 -31.5781 -34.062799999999996 1.9633000000000003 22.0968 -7.20608 -7.20608 -7.20608 -34.062799999999996 1.9633000000000003 23.0968 1.44248 1.44248 1.44248 -33.062799999999996 0.9633000000000003 24.0968 5.53897 5.53897 5.53897 -33.062799999999996 0.9633000000000003 25.0968 -12.6252 -12.6252 -12.6252 -33.062799999999996 1.9633000000000003 24.0968 1.73667 1.73667 1.73667 -33.062799999999996 1.9633000000000003 25.0968 1.17062 1.17062 1.17062 -34.062799999999996 0.9633000000000003 24.0968 14.7282 14.7282 14.7282 -34.062799999999996 0.9633000000000003 25.0968 22.245 22.245 22.245 -34.062799999999996 1.9633000000000003 24.0968 5.16427 5.16427 5.16427 -34.062799999999996 1.9633000000000003 25.0968 3.99543 3.99543 3.99543 -35.062799999999996 -0.03669999999999973 25.0968 -4.12631 -4.12631 -4.12631 -36.062799999999996 -0.03669999999999973 25.0968 -0.0592341 -0.0592341 -0.0592341 -35.062799999999996 0.9633000000000003 22.0968 1.8957 1.8957 1.8957 -35.062799999999996 0.9633000000000003 23.0968 -0.190942 -0.190942 -0.190942 -35.062799999999996 1.9633000000000003 23.0968 3.05663 3.05663 3.05663 -36.062799999999996 0.9633000000000003 22.0968 -0.326646 -0.326646 -0.326646 -36.062799999999996 0.9633000000000003 23.0968 1.75597 1.75597 1.75597 -36.062799999999996 1.9633000000000003 22.0968 6.64986 6.64986 6.64986 -36.062799999999996 1.9633000000000003 23.0968 7.43963 7.43963 7.43963 -35.062799999999996 0.9633000000000003 24.0968 0.742554 0.742554 0.742554 -35.062799999999996 0.9633000000000003 25.0968 -0.290443 -0.290443 -0.290443 -35.062799999999996 1.9633000000000003 24.0968 1.94245 1.94245 1.94245 -35.062799999999996 1.9633000000000003 25.0968 0.0622354 0.0622354 0.0622354 -36.062799999999996 0.9633000000000003 24.0968 -0.338048 -0.338048 -0.338048 -36.062799999999996 0.9633000000000003 25.0968 0.0967107 0.0967107 0.0967107 -36.062799999999996 1.9633000000000003 24.0968 4.42084 4.42084 4.42084 -36.062799999999996 1.9633000000000003 25.0968 21.0285 21.0285 21.0285 -33.062799999999996 -1.0366999999999997 26.0968 9.85312 9.85312 9.85312 -33.062799999999996 -1.0366999999999997 27.0968 -4.41254 -4.41254 -4.41254 -33.062799999999996 -0.03669999999999973 26.0968 -10.0894 -10.0894 -10.0894 -33.062799999999996 -0.03669999999999973 27.0968 1.47334 1.47334 1.47334 -34.062799999999996 -1.0366999999999997 26.0968 -9.30147 -9.30147 -9.30147 -34.062799999999996 -1.0366999999999997 27.0968 21.0044 21.0044 21.0044 -34.062799999999996 -0.03669999999999973 26.0968 5.54991 5.54991 5.54991 -33.062799999999996 -1.0366999999999997 28.0968 1.91298 1.91298 1.91298 -33.062799999999996 -1.0366999999999997 29.0968 -0.756361 -0.756361 -0.756361 -33.062799999999996 -0.03669999999999973 28.0968 -0.32588 -0.32588 -0.32588 -33.062799999999996 -0.03669999999999973 29.0968 -3.64635 -3.64635 -3.64635 -34.062799999999996 -1.0366999999999997 28.0968 11.267 11.267 11.267 -34.062799999999996 -1.0366999999999997 29.0968 1.69609 1.69609 1.69609 -34.062799999999996 0.9633000000000003 26.0968 13.6683 13.6683 13.6683 -33.062799999999996 0.9633000000000003 28.0968 6.31344 6.31344 6.31344 -33.062799999999996 0.9633000000000003 29.0968 -2.02957 -2.02957 -2.02957 -33.062799999999996 1.9633000000000003 28.0968 -0.20631 -0.20631 -0.20631 -33.062799999999996 1.9633000000000003 29.0968 1.61169 1.61169 1.61169 -34.062799999999996 0.9633000000000003 28.0968 4.62018 4.62018 4.62018 -34.062799999999996 0.9633000000000003 29.0968 -0.982863 -0.982863 -0.982863 -34.062799999999996 1.9633000000000003 28.0968 11.4535 11.4535 11.4535 -34.062799999999996 1.9633000000000003 29.0968 -5.66657 -5.66657 -5.66657 -35.062799999999996 -1.0366999999999997 26.0968 6.84677 6.84677 6.84677 -35.062799999999996 -1.0366999999999997 27.0968 11.1382 11.1382 11.1382 -35.062799999999996 -0.03669999999999973 26.0968 -9.67571 -9.67571 -9.67571 -36.062799999999996 -1.0366999999999997 26.0968 -0.532516 -0.532516 -0.532516 -36.062799999999996 -1.0366999999999997 27.0968 -0.0805416 -0.0805416 -0.0805416 -36.062799999999996 -0.03669999999999973 26.0968 0.501301 0.501301 0.501301 -36.062799999999996 -0.03669999999999973 27.0968 2.19663 2.19663 2.19663 -35.062799999999996 -1.0366999999999997 28.0968 -5.53241 -5.53241 -5.53241 -35.062799999999996 -1.0366999999999997 29.0968 -0.262236 -0.262236 -0.262236 -35.062799999999996 -0.03669999999999973 29.0968 7.79806 7.79806 7.79806 -36.062799999999996 -1.0366999999999997 28.0968 0.0940665 0.0940665 0.0940665 -36.062799999999996 -1.0366999999999997 29.0968 0.47302 0.47302 0.47302 -36.062799999999996 -0.03669999999999973 28.0968 2.11388 2.11388 2.11388 -36.062799999999996 -0.03669999999999973 29.0968 0.0294899 0.0294899 0.0294899 -35.062799999999996 1.9633000000000003 26.0968 -2.45883 -2.45883 -2.45883 -36.062799999999996 0.9633000000000003 26.0968 3.06645 3.06645 3.06645 -36.062799999999996 1.9633000000000003 26.0968 -5.36812 -5.36812 -5.36812 -35.062799999999996 0.9633000000000003 28.0968 -9.00429 -9.00429 -9.00429 -35.062799999999996 0.9633000000000003 29.0968 -4.75755 -4.75755 -4.75755 -35.062799999999996 1.9633000000000003 28.0968 -3.93077 -3.93077 -3.93077 -35.062799999999996 1.9633000000000003 29.0968 -3.86545 -3.86545 -3.86545 -36.062799999999996 0.9633000000000003 29.0968 -1.14511 -1.14511 -1.14511 -36.062799999999996 1.9633000000000003 29.0968 -1.59765 -1.59765 -1.59765 -37.062799999999996 1.9633000000000003 22.0968 -16.6023 -16.6023 -16.6023 -37.062799999999996 1.9633000000000003 23.0968 3.41697 3.41697 3.41697 -37.062799999999996 1.9633000000000003 24.0968 -9.17381 -9.17381 -9.17381 -37.062799999999996 -1.0366999999999997 27.0968 -0.203672 -0.203672 -0.203672 -37.062799999999996 -0.03669999999999973 26.0968 -4.7876 -4.7876 -4.7876 -37.062799999999996 -0.03669999999999973 27.0968 0.694624 0.694624 0.694624 -38.062799999999996 -0.03669999999999973 26.0968 -0.505234 -0.505234 -0.505234 -38.062799999999996 -0.03669999999999973 27.0968 -0.576977 -0.576977 -0.576977 -37.062799999999996 -1.0366999999999997 28.0968 -1.06743 -1.06743 -1.06743 -37.062799999999996 -0.03669999999999973 28.0968 1.56606 1.56606 1.56606 -37.062799999999996 -0.03669999999999973 29.0968 -1.14546 -1.14546 -1.14546 -38.062799999999996 -0.03669999999999973 28.0968 1.03221 1.03221 1.03221 -38.062799999999996 -0.03669999999999973 29.0968 -0.992139 -0.992139 -0.992139 -37.062799999999996 0.9633000000000003 26.0968 0.393037 0.393037 0.393037 -37.062799999999996 1.9633000000000003 26.0968 -55.1498 -55.1498 -55.1498 -37.062799999999996 1.9633000000000003 27.0968 -10.2486 -10.2486 -10.2486 -38.062799999999996 0.9633000000000003 26.0968 -1.68184 -1.68184 -1.68184 -38.062799999999996 0.9633000000000003 27.0968 -0.775994 -0.775994 -0.775994 -38.062799999999996 1.9633000000000003 26.0968 57.2248 57.2248 57.2248 -38.062799999999996 1.9633000000000003 27.0968 -32.2941 -32.2941 -32.2941 -37.062799999999996 0.9633000000000003 29.0968 -1.56802 -1.56802 -1.56802 -37.062799999999996 1.9633000000000003 28.0968 -76.029 -76.029 -76.029 -37.062799999999996 1.9633000000000003 29.0968 -1.83388 -1.83388 -1.83388 -38.062799999999996 0.9633000000000003 28.0968 0.338565 0.338565 0.338565 -38.062799999999996 0.9633000000000003 29.0968 -0.007572 -0.007572 -0.007572 -38.062799999999996 1.9633000000000003 28.0968 18.1492 18.1492 18.1492 -38.062799999999996 1.9633000000000003 29.0968 -1.0025 -1.0025 -1.0025 -33.062799999999996 -1.0366999999999997 30.0968 5.07625 5.07625 5.07625 -33.062799999999996 -0.03669999999999973 30.0968 4.86826 4.86826 4.86826 -34.062799999999996 -1.0366999999999997 30.0968 -3.5352 -3.5352 -3.5352 -34.062799999999996 -0.03669999999999973 30.0968 0.100116 0.100116 0.100116 -33.062799999999996 0.9633000000000003 30.0968 -0.342981 -0.342981 -0.342981 -33.062799999999996 0.9633000000000003 31.0968 0.068206 0.068206 0.068206 -33.062799999999996 1.9633000000000003 30.0968 -3.03138 -3.03138 -3.03138 -33.062799999999996 1.9633000000000003 31.0968 3.22969 3.22969 3.22969 -34.062799999999996 0.9633000000000003 30.0968 -1.07101 -1.07101 -1.07101 -34.062799999999996 0.9633000000000003 31.0968 -0.321363 -0.321363 -0.321363 -34.062799999999996 1.9633000000000003 30.0968 -2.30772 -2.30772 -2.30772 -33.062799999999996 0.9633000000000003 32.0968 -0.702181 -0.702181 -0.702181 -33.062799999999996 0.9633000000000003 33.0968 -1.82126 -1.82126 -1.82126 -33.062799999999996 1.9633000000000003 32.0968 3.71875 3.71875 3.71875 -33.062799999999996 1.9633000000000003 33.0968 0.59692 0.59692 0.59692 -34.062799999999996 0.9633000000000003 32.0968 -0.361336 -0.361336 -0.361336 -34.062799999999996 0.9633000000000003 33.0968 -0.0797145 -0.0797145 -0.0797145 -34.062799999999996 1.9633000000000003 33.0968 -1.44737 -1.44737 -1.44737 -35.062799999999996 -1.0366999999999997 30.0968 -2.12944 -2.12944 -2.12944 -35.062799999999996 -0.03669999999999973 30.0968 -1.28623 -1.28623 -1.28623 -36.062799999999996 -0.03669999999999973 30.0968 0.58224 0.58224 0.58224 -35.062799999999996 0.9633000000000003 30.0968 -0.937018 -0.937018 -0.937018 -35.062799999999996 0.9633000000000003 31.0968 0.216707 0.216707 0.216707 -35.062799999999996 1.9633000000000003 30.0968 5.41308 5.41308 5.41308 -35.062799999999996 1.9633000000000003 31.0968 4.71434 4.71434 4.71434 -36.062799999999996 0.9633000000000003 30.0968 0.845905 0.845905 0.845905 -36.062799999999996 1.9633000000000003 30.0968 -2.3853 -2.3853 -2.3853 -36.062799999999996 1.9633000000000003 31.0968 3.82323 3.82323 3.82323 -35.062799999999996 0.9633000000000003 32.0968 -3.2852 -3.2852 -3.2852 -35.062799999999996 0.9633000000000003 33.0968 0.377704 0.377704 0.377704 -35.062799999999996 1.9633000000000003 32.0968 4.41479 4.41479 4.41479 -35.062799999999996 1.9633000000000003 33.0968 -0.365855 -0.365855 -0.365855 -36.062799999999996 1.9633000000000003 32.0968 0.461485 0.461485 0.461485 -36.062799999999996 1.9633000000000003 33.0968 2.12832 2.12832 2.12832 -37.062799999999996 -0.03669999999999973 30.0968 -1.25202 -1.25202 -1.25202 -37.062799999999996 0.9633000000000003 30.0968 -0.574921 -0.574921 -0.574921 -37.062799999999996 0.9633000000000003 31.0968 0.51278 0.51278 0.51278 -37.062799999999996 1.9633000000000003 30.0968 1.10427 1.10427 1.10427 -37.062799999999996 1.9633000000000003 31.0968 4.17846 4.17846 4.17846 -38.062799999999996 0.9633000000000003 30.0968 -1.04956 -1.04956 -1.04956 -38.062799999999996 0.9633000000000003 31.0968 1.05254 1.05254 1.05254 -38.062799999999996 1.9633000000000003 30.0968 -1.63889 -1.63889 -1.63889 -37.062799999999996 0.9633000000000003 32.0968 0.778981 0.778981 0.778981 -37.062799999999996 0.9633000000000003 33.0968 -0.177719 -0.177719 -0.177719 -37.062799999999996 1.9633000000000003 32.0968 0.170083 0.170083 0.170083 -37.062799999999996 1.9633000000000003 33.0968 0.118044 0.118044 0.118044 -38.062799999999996 0.9633000000000003 32.0968 0.628805 0.628805 0.628805 -38.062799999999996 0.9633000000000003 33.0968 -0.0267052 -0.0267052 -0.0267052 -38.062799999999996 1.9633000000000003 33.0968 -0.00189905 -0.00189905 -0.00189905 -39.062799999999996 0.9633000000000003 31.0968 -0.0471054 -0.0471054 -0.0471054 -39.062799999999996 1.9633000000000003 30.0968 0.49655 0.49655 0.49655 -39.062799999999996 1.9633000000000003 31.0968 0.120337 0.120337 0.120337 -39.062799999999996 0.9633000000000003 32.0968 0.692494 0.692494 0.692494 -39.062799999999996 1.9633000000000003 32.0968 0.655412 0.655412 0.655412 -39.062799999999996 1.9633000000000003 33.0968 -1.11722 -1.11722 -1.11722 -33.062799999999996 3.9633000000000003 22.0968 -2.39667 -2.39667 -2.39667 -34.062799999999996 3.9633000000000003 22.0968 -5.05808 -5.05808 -5.05808 -33.062799999999996 2.9633000000000003 24.0968 3.0438 3.0438 3.0438 -33.062799999999996 2.9633000000000003 25.0968 2.93825 2.93825 2.93825 -33.062799999999996 3.9633000000000003 25.0968 -1.60105 -1.60105 -1.60105 -34.062799999999996 2.9633000000000003 24.0968 7.75312 7.75312 7.75312 -34.062799999999996 2.9633000000000003 25.0968 5.07376 5.07376 5.07376 -34.062799999999996 3.9633000000000003 25.0968 1.96727 1.96727 1.96727 -33.062799999999996 4.9633 22.0968 8.17589 8.17589 8.17589 -33.062799999999996 4.9633 23.0968 0.594842 0.594842 0.594842 -33.062799999999996 5.9633 22.0968 0.197198 0.197198 0.197198 -33.062799999999996 5.9633 23.0968 0.638579 0.638579 0.638579 -34.062799999999996 4.9633 22.0968 1.80613 1.80613 1.80613 -34.062799999999996 4.9633 23.0968 0.892628 0.892628 0.892628 -34.062799999999996 5.9633 22.0968 -1.79146 -1.79146 -1.79146 -34.062799999999996 5.9633 23.0968 -3.81967 -3.81967 -3.81967 -33.062799999999996 4.9633 25.0968 -3.43694 -3.43694 -3.43694 -33.062799999999996 5.9633 24.0968 0.156385 0.156385 0.156385 -33.062799999999996 5.9633 25.0968 4.15261 4.15261 4.15261 -34.062799999999996 4.9633 25.0968 -1.13517 -1.13517 -1.13517 -34.062799999999996 5.9633 24.0968 -15.6836 -15.6836 -15.6836 -34.062799999999996 5.9633 25.0968 -0.111738 -0.111738 -0.111738 -35.062799999999996 3.9633000000000003 22.0968 -7.8053 -7.8053 -7.8053 -35.062799999999996 3.9633000000000003 23.0968 -1.10703 -1.10703 -1.10703 -36.062799999999996 2.9633000000000003 22.0968 8.17143 8.17143 8.17143 -36.062799999999996 3.9633000000000003 22.0968 -1.60367 -1.60367 -1.60367 -35.062799999999996 2.9633000000000003 24.0968 -1.59976 -1.59976 -1.59976 -35.062799999999996 2.9633000000000003 25.0968 1.29249 1.29249 1.29249 -35.062799999999996 3.9633000000000003 25.0968 0.404103 0.404103 0.404103 -36.062799999999996 2.9633000000000003 25.0968 17.686 17.686 17.686 -36.062799999999996 3.9633000000000003 25.0968 -1.37092 -1.37092 -1.37092 -35.062799999999996 4.9633 22.0968 -5.8437 -5.8437 -5.8437 -35.062799999999996 4.9633 23.0968 -8.00795 -8.00795 -8.00795 -35.062799999999996 5.9633 22.0968 0.127141 0.127141 0.127141 -35.062799999999996 5.9633 23.0968 5.0587 5.0587 5.0587 -36.062799999999996 4.9633 22.0968 -1.54517 -1.54517 -1.54517 -36.062799999999996 4.9633 23.0968 -0.0753456 -0.0753456 -0.0753456 -36.062799999999996 5.9633 22.0968 6.27962 6.27962 6.27962 -36.062799999999996 5.9633 23.0968 -26.0575 -26.0575 -26.0575 -35.062799999999996 4.9633 25.0968 2.66101 2.66101 2.66101 -35.062799999999996 5.9633 24.0968 11.0829 11.0829 11.0829 -35.062799999999996 5.9633 25.0968 3.59339 3.59339 3.59339 -36.062799999999996 4.9633 25.0968 -1.8427 -1.8427 -1.8427 -36.062799999999996 5.9633 24.0968 -3.52439 -3.52439 -3.52439 -36.062799999999996 5.9633 25.0968 -0.665178 -0.665178 -0.665178 -33.062799999999996 2.9633000000000003 26.0968 -2.59732 -2.59732 -2.59732 -33.062799999999996 2.9633000000000003 27.0968 -2.39688 -2.39688 -2.39688 -33.062799999999996 3.9633000000000003 26.0968 2.57244 2.57244 2.57244 -33.062799999999996 3.9633000000000003 27.0968 -0.639013 -0.639013 -0.639013 -34.062799999999996 2.9633000000000003 26.0968 1.80205 1.80205 1.80205 -34.062799999999996 3.9633000000000003 26.0968 4.39881 4.39881 4.39881 -34.062799999999996 3.9633000000000003 27.0968 -1.59655 -1.59655 -1.59655 -33.062799999999996 2.9633000000000003 28.0968 4.11555 4.11555 4.11555 -33.062799999999996 3.9633000000000003 28.0968 0.43571 0.43571 0.43571 -33.062799999999996 3.9633000000000003 29.0968 0.512121 0.512121 0.512121 -34.062799999999996 2.9633000000000003 28.0968 4.47931 4.47931 4.47931 -34.062799999999996 2.9633000000000003 29.0968 -1.46394 -1.46394 -1.46394 -34.062799999999996 3.9633000000000003 28.0968 -0.667545 -0.667545 -0.667545 -34.062799999999996 3.9633000000000003 29.0968 0.311925 0.311925 0.311925 -33.062799999999996 4.9633 26.0968 1.53477 1.53477 1.53477 -33.062799999999996 4.9633 27.0968 -1.11975 -1.11975 -1.11975 -33.062799999999996 5.9633 26.0968 1.3368 1.3368 1.3368 -33.062799999999996 5.9633 27.0968 -0.564543 -0.564543 -0.564543 -34.062799999999996 4.9633 26.0968 -2.42093 -2.42093 -2.42093 -34.062799999999996 5.9633 26.0968 2.02784 2.02784 2.02784 -33.062799999999996 4.9633 28.0968 -0.611363 -0.611363 -0.611363 -33.062799999999996 4.9633 29.0968 1.4914 1.4914 1.4914 -33.062799999999996 5.9633 28.0968 -0.275222 -0.275222 -0.275222 -33.062799999999996 5.9633 29.0968 -2.22052 -2.22052 -2.22052 -34.062799999999996 4.9633 28.0968 -2.19051 -2.19051 -2.19051 -34.062799999999996 4.9633 29.0968 0.870015 0.870015 0.870015 -34.062799999999996 5.9633 28.0968 -4.87584 -4.87584 -4.87584 -35.062799999999996 2.9633000000000003 26.0968 6.03953 6.03953 6.03953 -35.062799999999996 2.9633000000000003 27.0968 -4.51933 -4.51933 -4.51933 -35.062799999999996 3.9633000000000003 26.0968 1.65526 1.65526 1.65526 -35.062799999999996 3.9633000000000003 27.0968 2.00233 2.00233 2.00233 -36.062799999999996 2.9633000000000003 26.0968 14.357 14.357 14.357 -36.062799999999996 2.9633000000000003 27.0968 -6.49825 -6.49825 -6.49825 -36.062799999999996 3.9633000000000003 26.0968 20.9507 20.9507 20.9507 -36.062799999999996 3.9633000000000003 27.0968 -0.73517 -0.73517 -0.73517 -35.062799999999996 2.9633000000000003 28.0968 -1.57529 -1.57529 -1.57529 -35.062799999999996 2.9633000000000003 29.0968 -1.2583 -1.2583 -1.2583 -35.062799999999996 3.9633000000000003 28.0968 0.509721 0.509721 0.509721 -35.062799999999996 3.9633000000000003 29.0968 2.69394 2.69394 2.69394 -36.062799999999996 2.9633000000000003 28.0968 -0.285771 -0.285771 -0.285771 -36.062799999999996 2.9633000000000003 29.0968 -1.1254 -1.1254 -1.1254 -36.062799999999996 3.9633000000000003 28.0968 -7.44701 -7.44701 -7.44701 -36.062799999999996 3.9633000000000003 29.0968 -2.91441 -2.91441 -2.91441 -35.062799999999996 4.9633 26.0968 -18.1089 -18.1089 -18.1089 -35.062799999999996 4.9633 27.0968 -0.211366 -0.211366 -0.211366 -35.062799999999996 5.9633 26.0968 14.6686 14.6686 14.6686 -35.062799999999996 5.9633 27.0968 21.7847 21.7847 21.7847 -36.062799999999996 4.9633 26.0968 -10.1654 -10.1654 -10.1654 -36.062799999999996 4.9633 27.0968 -5.79399 -5.79399 -5.79399 -36.062799999999996 5.9633 26.0968 7.75602 7.75602 7.75602 -36.062799999999996 5.9633 27.0968 7.85249 7.85249 7.85249 -35.062799999999996 4.9633 28.0968 -23.452 -23.452 -23.452 -35.062799999999996 4.9633 29.0968 -0.0897504 -0.0897504 -0.0897504 -35.062799999999996 5.9633 28.0968 0.88307 0.88307 0.88307 -35.062799999999996 5.9633 29.0968 -4.50986 -4.50986 -4.50986 -36.062799999999996 5.9633 29.0968 -1.1695 -1.1695 -1.1695 -33.062799999999996 6.9633 22.0968 1.49162 1.49162 1.49162 -33.062799999999996 6.9633 23.0968 3.22227 3.22227 3.22227 -33.062799999999996 7.9633 22.0968 2.54502 2.54502 2.54502 -33.062799999999996 7.9633 23.0968 3.39059 3.39059 3.39059 -34.062799999999996 6.9633 22.0968 2.68526 2.68526 2.68526 -34.062799999999996 6.9633 23.0968 -3.05875 -3.05875 -3.05875 -34.062799999999996 7.9633 23.0968 12.7552 12.7552 12.7552 -33.062799999999996 6.9633 25.0968 -0.720842 -0.720842 -0.720842 -33.062799999999996 7.9633 24.0968 16.3759 16.3759 16.3759 -33.062799999999996 7.9633 25.0968 27.9962 27.9962 27.9962 -34.062799999999996 6.9633 24.0968 -19.5425 -19.5425 -19.5425 -34.062799999999996 6.9633 25.0968 -16.9703 -16.9703 -16.9703 -34.062799999999996 7.9633 24.0968 -4.82917 -4.82917 -4.82917 -34.062799999999996 7.9633 25.0968 -22.6291 -22.6291 -22.6291 -33.062799999999996 8.9633 22.0968 9.7557 9.7557 9.7557 -33.062799999999996 8.9633 23.0968 -2.65297 -2.65297 -2.65297 -33.062799999999996 9.9633 22.0968 283.099 283.099 283.099 -34.062799999999996 8.9633 22.0968 25.3042 25.3042 25.3042 -34.062799999999996 8.9633 23.0968 9.23798 9.23798 9.23798 -34.062799999999996 9.9633 22.0968 14.538 14.538 14.538 -33.062799999999996 8.9633 24.0968 1.75095 1.75095 1.75095 -33.062799999999996 8.9633 25.0968 -15.4207 -15.4207 -15.4207 -33.062799999999996 9.9633 25.0968 -12.3945 -12.3945 -12.3945 -34.062799999999996 8.9633 25.0968 -15.9015 -15.9015 -15.9015 -34.062799999999996 9.9633 25.0968 17.9654 17.9654 17.9654 -35.062799999999996 6.9633 23.0968 12.3975 12.3975 12.3975 -36.062799999999996 6.9633 23.0968 22.1169 22.1169 22.1169 -35.062799999999996 6.9633 24.0968 39.0203 39.0203 39.0203 -35.062799999999996 6.9633 25.0968 35.417 35.417 35.417 -35.062799999999996 7.9633 25.0968 -37.0236 -37.0236 -37.0236 -36.062799999999996 6.9633 24.0968 -6.54816 -6.54816 -6.54816 -36.062799999999996 6.9633 25.0968 -3.34362 -3.34362 -3.34362 -36.062799999999996 7.9633 25.0968 4.68439 4.68439 4.68439 -35.062799999999996 8.9633 22.0968 28.0026 28.0026 28.0026 -35.062799999999996 9.9633 22.0968 12.4933 12.4933 12.4933 -36.062799999999996 8.9633 22.0968 2.28037 2.28037 2.28037 -36.062799999999996 8.9633 23.0968 4.93096 4.93096 4.93096 -36.062799999999996 9.9633 22.0968 4.26509 4.26509 4.26509 -36.062799999999996 9.9633 23.0968 24.325 24.325 24.325 -36.062799999999996 8.9633 24.0968 -4.70227 -4.70227 -4.70227 -36.062799999999996 9.9633 24.0968 -2.28685 -2.28685 -2.28685 -33.062799999999996 6.9633 26.0968 -22.5097 -22.5097 -22.5097 -33.062799999999996 6.9633 27.0968 1.02023 1.02023 1.02023 -33.062799999999996 7.9633 26.0968 2.95973 2.95973 2.95973 -33.062799999999996 7.9633 27.0968 -3.09919 -3.09919 -3.09919 -34.062799999999996 6.9633 26.0968 -0.269613 -0.269613 -0.269613 -34.062799999999996 6.9633 27.0968 4.00496 4.00496 4.00496 -34.062799999999996 7.9633 26.0968 -1.64909 -1.64909 -1.64909 -34.062799999999996 7.9633 27.0968 1.26987 1.26987 1.26987 -33.062799999999996 6.9633 28.0968 -0.151504 -0.151504 -0.151504 -33.062799999999996 7.9633 28.0968 -5.16677 -5.16677 -5.16677 -34.062799999999996 6.9633 28.0968 0.11287 0.11287 0.11287 -34.062799999999996 7.9633 28.0968 3.70479 3.70479 3.70479 -33.062799999999996 8.9633 26.0968 -45.9602 -45.9602 -45.9602 -33.062799999999996 8.9633 27.0968 1.47808 1.47808 1.47808 -33.062799999999996 9.9633 27.0968 -12.5333 -12.5333 -12.5333 -34.062799999999996 8.9633 26.0968 -7.09619 -7.09619 -7.09619 -34.062799999999996 8.9633 27.0968 4.29701 4.29701 4.29701 -34.062799999999996 9.9633 26.0968 15.7645 15.7645 15.7645 -34.062799999999996 9.9633 27.0968 9.67684 9.67684 9.67684 -33.062799999999996 8.9633 28.0968 1.38655 1.38655 1.38655 -33.062799999999996 9.9633 28.0968 -9.44373 -9.44373 -9.44373 -34.062799999999996 8.9633 28.0968 0.515583 0.515583 0.515583 -34.062799999999996 9.9633 28.0968 -5.0926 -5.0926 -5.0926 -34.062799999999996 9.9633 29.0968 -6.57251 -6.57251 -6.57251 -35.062799999999996 6.9633 26.0968 4.63277 4.63277 4.63277 -35.062799999999996 6.9633 27.0968 2.00921 2.00921 2.00921 -35.062799999999996 7.9633 26.0968 3.78437 3.78437 3.78437 -35.062799999999996 7.9633 27.0968 3.64338 3.64338 3.64338 -36.062799999999996 6.9633 26.0968 -0.543231 -0.543231 -0.543231 -36.062799999999996 6.9633 27.0968 4.56316 4.56316 4.56316 -36.062799999999996 7.9633 26.0968 -5.69093 -5.69093 -5.69093 -36.062799999999996 7.9633 27.0968 -12.1851 -12.1851 -12.1851 -35.062799999999996 6.9633 28.0968 -1.42913 -1.42913 -1.42913 -35.062799999999996 6.9633 29.0968 0.530648 0.530648 0.530648 -35.062799999999996 7.9633 28.0968 0.170233 0.170233 0.170233 -35.062799999999996 7.9633 29.0968 -0.377261 -0.377261 -0.377261 -36.062799999999996 6.9633 28.0968 14.1098 14.1098 14.1098 -36.062799999999996 6.9633 29.0968 0.563829 0.563829 0.563829 -36.062799999999996 7.9633 28.0968 7.16157 7.16157 7.16157 -36.062799999999996 7.9633 29.0968 1.74331 1.74331 1.74331 -35.062799999999996 8.9633 27.0968 -8.01494 -8.01494 -8.01494 -35.062799999999996 9.9633 26.0968 -37.4002 -37.4002 -37.4002 -35.062799999999996 9.9633 27.0968 -1.02863 -1.02863 -1.02863 -36.062799999999996 8.9633 27.0968 -0.145376 -0.145376 -0.145376 -36.062799999999996 9.9633 27.0968 1.29788 1.29788 1.29788 -35.062799999999996 8.9633 28.0968 13.0034 13.0034 13.0034 -35.062799999999996 8.9633 29.0968 -25.1973 -25.1973 -25.1973 -35.062799999999996 9.9633 28.0968 -17.8561 -17.8561 -17.8561 -35.062799999999996 9.9633 29.0968 -25.2934 -25.2934 -25.2934 -36.062799999999996 8.9633 28.0968 -28.4405 -28.4405 -28.4405 -36.062799999999996 8.9633 29.0968 26.3683 26.3683 26.3683 -36.062799999999996 9.9633 28.0968 2.77884 2.77884 2.77884 -36.062799999999996 9.9633 29.0968 -17.4478 -17.4478 -17.4478 -37.062799999999996 2.9633000000000003 22.0968 -15.9058 -15.9058 -15.9058 -37.062799999999996 2.9633000000000003 23.0968 -6.79393 -6.79393 -6.79393 -37.062799999999996 3.9633000000000003 22.0968 3.16771 3.16771 3.16771 -37.062799999999996 3.9633000000000003 23.0968 8.8548 8.8548 8.8548 -38.062799999999996 2.9633000000000003 22.0968 6.41496 6.41496 6.41496 -38.062799999999996 3.9633000000000003 22.0968 -3.51012 -3.51012 -3.51012 -38.062799999999996 3.9633000000000003 23.0968 3.85061 3.85061 3.85061 -37.062799999999996 2.9633000000000003 24.0968 -7.53261 -7.53261 -7.53261 -37.062799999999996 2.9633000000000003 25.0968 -9.17812 -9.17812 -9.17812 -37.062799999999996 3.9633000000000003 24.0968 1.42529 1.42529 1.42529 -37.062799999999996 3.9633000000000003 25.0968 -4.3666 -4.3666 -4.3666 -38.062799999999996 2.9633000000000003 24.0968 -3.36615 -3.36615 -3.36615 -38.062799999999996 2.9633000000000003 25.0968 8.70589 8.70589 8.70589 -38.062799999999996 3.9633000000000003 24.0968 -19.6375 -19.6375 -19.6375 -38.062799999999996 3.9633000000000003 25.0968 -9.83091 -9.83091 -9.83091 -37.062799999999996 4.9633 22.0968 0.682919 0.682919 0.682919 -37.062799999999996 4.9633 23.0968 -6.69395 -6.69395 -6.69395 -37.062799999999996 5.9633 22.0968 -1.7619 -1.7619 -1.7619 -37.062799999999996 5.9633 23.0968 -4.06936 -4.06936 -4.06936 -38.062799999999996 4.9633 22.0968 3.25082 3.25082 3.25082 -38.062799999999996 4.9633 23.0968 -7.80142 -7.80142 -7.80142 -38.062799999999996 5.9633 22.0968 -4.79476 -4.79476 -4.79476 -38.062799999999996 5.9633 23.0968 1.51874 1.51874 1.51874 -37.062799999999996 5.9633 24.0968 8.51737 8.51737 8.51737 -37.062799999999996 5.9633 25.0968 -70.1605 -70.1605 -70.1605 -38.062799999999996 4.9633 24.0968 6.13308 6.13308 6.13308 -38.062799999999996 4.9633 25.0968 34.1893 34.1893 34.1893 -38.062799999999996 5.9633 24.0968 -55.5616 -55.5616 -55.5616 -38.062799999999996 5.9633 25.0968 43.2195 43.2195 43.2195 -39.062799999999996 3.9633000000000003 22.0968 30.9872 30.9872 30.9872 -39.062799999999996 4.9633 22.0968 1.77717 1.77717 1.77717 -39.062799999999996 5.9633 22.0968 4.20907 4.20907 4.20907 -37.062799999999996 2.9633000000000003 26.0968 -8.53115 -8.53115 -8.53115 -37.062799999999996 2.9633000000000003 27.0968 -3.4463 -3.4463 -3.4463 -37.062799999999996 3.9633000000000003 26.0968 9.67032 9.67032 9.67032 -37.062799999999996 3.9633000000000003 27.0968 22.8902 22.8902 22.8902 -38.062799999999996 3.9633000000000003 26.0968 -11.8413 -11.8413 -11.8413 -38.062799999999996 3.9633000000000003 27.0968 -6.69264 -6.69264 -6.69264 -37.062799999999996 2.9633000000000003 28.0968 70.8915 70.8915 70.8915 -37.062799999999996 2.9633000000000003 29.0968 -1.85519 -1.85519 -1.85519 -37.062799999999996 3.9633000000000003 28.0968 -91.6008 -91.6008 -91.6008 -37.062799999999996 3.9633000000000003 29.0968 -0.669268 -0.669268 -0.669268 -38.062799999999996 2.9633000000000003 28.0968 56.6125 56.6125 56.6125 -38.062799999999996 2.9633000000000003 29.0968 -0.645287 -0.645287 -0.645287 -38.062799999999996 3.9633000000000003 28.0968 22.5738 22.5738 22.5738 -38.062799999999996 3.9633000000000003 29.0968 -1.16175 -1.16175 -1.16175 -37.062799999999996 4.9633 26.0968 -50.8688 -50.8688 -50.8688 -37.062799999999996 4.9633 27.0968 -1.66779 -1.66779 -1.66779 -38.062799999999996 4.9633 26.0968 17.8127 17.8127 17.8127 -38.062799999999996 4.9633 27.0968 -0.268494 -0.268494 -0.268494 -38.062799999999996 5.9633 26.0968 26.5309 26.5309 26.5309 -38.062799999999996 5.9633 27.0968 -1.38644 -1.38644 -1.38644 -38.062799999999996 4.9633 28.0968 -5.55062 -5.55062 -5.55062 -38.062799999999996 4.9633 29.0968 3.73196 3.73196 3.73196 -38.062799999999996 5.9633 29.0968 2.44564 2.44564 2.44564 -39.062799999999996 4.9633 27.0968 -10.7491 -10.7491 -10.7491 -39.062799999999996 5.9633 27.0968 -0.310244 -0.310244 -0.310244 -39.062799999999996 4.9633 28.0968 2.00772 2.00772 2.00772 -39.062799999999996 5.9633 28.0968 -2.06087 -2.06087 -2.06087 -39.062799999999996 5.9633 29.0968 4.33559 4.33559 4.33559 -37.062799999999996 6.9633 23.0968 -3.60441 -3.60441 -3.60441 -37.062799999999996 7.9633 22.0968 27.9322 27.9322 27.9322 -37.062799999999996 7.9633 23.0968 17.8511 17.8511 17.8511 -38.062799999999996 6.9633 22.0968 -1.8059 -1.8059 -1.8059 -38.062799999999996 6.9633 23.0968 -1.24142 -1.24142 -1.24142 -38.062799999999996 7.9633 22.0968 -11.571 -11.571 -11.571 -38.062799999999996 7.9633 23.0968 5.91985 5.91985 5.91985 -37.062799999999996 6.9633 24.0968 14.347 14.347 14.347 -37.062799999999996 6.9633 25.0968 -22.6003 -22.6003 -22.6003 -37.062799999999996 7.9633 25.0968 -13.9333 -13.9333 -13.9333 -38.062799999999996 6.9633 24.0968 5.28886 5.28886 5.28886 -38.062799999999996 6.9633 25.0968 39.4472 39.4472 39.4472 -38.062799999999996 7.9633 24.0968 -34.1974 -34.1974 -34.1974 -38.062799999999996 7.9633 25.0968 3.37257 3.37257 3.37257 -37.062799999999996 8.9633 22.0968 70.6413 70.6413 70.6413 -37.062799999999996 8.9633 23.0968 57.723 57.723 57.723 -37.062799999999996 9.9633 22.0968 28.3633 28.3633 28.3633 -37.062799999999996 9.9633 23.0968 20.7997 20.7997 20.7997 -38.062799999999996 8.9633 22.0968 39.9225 39.9225 39.9225 -38.062799999999996 8.9633 23.0968 -10.0974 -10.0974 -10.0974 -37.062799999999996 8.9633 24.0968 1.18742 1.18742 1.18742 -37.062799999999996 8.9633 25.0968 -18.968 -18.968 -18.968 -37.062799999999996 9.9633 24.0968 24.3827 24.3827 24.3827 -38.062799999999996 8.9633 24.0968 -58.4049 -58.4049 -58.4049 -38.062799999999996 8.9633 25.0968 -4.81865 -4.81865 -4.81865 -38.062799999999996 9.9633 24.0968 -57.1518 -57.1518 -57.1518 -38.062799999999996 9.9633 25.0968 5.93124 5.93124 5.93124 -39.062799999999996 6.9633 22.0968 -1.17994 -1.17994 -1.17994 -39.062799999999996 6.9633 23.0968 -1.36866 -1.36866 -1.36866 -39.062799999999996 7.9633 22.0968 50.148 50.148 50.148 -39.062799999999996 7.9633 23.0968 -25.4154 -25.4154 -25.4154 -39.062799999999996 8.9633 22.0968 -77.0916 -77.0916 -77.0916 -37.062799999999996 7.9633 26.0968 7.03151 7.03151 7.03151 -37.062799999999996 7.9633 27.0968 -6.94433 -6.94433 -6.94433 -38.062799999999996 6.9633 26.0968 1.82167 1.82167 1.82167 -38.062799999999996 6.9633 27.0968 -14.9825 -14.9825 -14.9825 -38.062799999999996 7.9633 26.0968 -2.51039 -2.51039 -2.51039 -38.062799999999996 7.9633 27.0968 -1.90196 -1.90196 -1.90196 -37.062799999999996 6.9633 29.0968 0.747209 0.747209 0.747209 -37.062799999999996 7.9633 28.0968 18.4906 18.4906 18.4906 -37.062799999999996 7.9633 29.0968 19.197 19.197 19.197 -38.062799999999996 7.9633 28.0968 33.4522 33.4522 33.4522 -38.062799999999996 7.9633 29.0968 -2.99303 -2.99303 -2.99303 -37.062799999999996 8.9633 26.0968 -3.54396 -3.54396 -3.54396 -37.062799999999996 8.9633 27.0968 -68.6943 -68.6943 -68.6943 -37.062799999999996 9.9633 27.0968 -1.2324 -1.2324 -1.2324 -38.062799999999996 8.9633 26.0968 -21.7321 -21.7321 -21.7321 -38.062799999999996 8.9633 27.0968 83.3773 83.3773 83.3773 -38.062799999999996 9.9633 26.0968 -11.0194 -11.0194 -11.0194 -38.062799999999996 9.9633 27.0968 -33.9411 -33.9411 -33.9411 -37.062799999999996 9.9633 28.0968 54.7922 54.7922 54.7922 -37.062799999999996 9.9633 29.0968 -3.57699 -3.57699 -3.57699 -39.062799999999996 6.9633 27.0968 6.63581 6.63581 6.63581 -39.062799999999996 7.9633 27.0968 -2.57084 -2.57084 -2.57084 -39.062799999999996 6.9633 28.0968 12.954 12.954 12.954 -39.062799999999996 6.9633 29.0968 3.22638 3.22638 3.22638 -39.062799999999996 7.9633 28.0968 7.53382 7.53382 7.53382 -39.062799999999996 7.9633 29.0968 -24.4501 -24.4501 -24.4501 -33.062799999999996 2.9633000000000003 30.0968 4.52241 4.52241 4.52241 -33.062799999999996 2.9633000000000003 31.0968 7.83185 7.83185 7.83185 -33.062799999999996 3.9633000000000003 30.0968 -1.9527 -1.9527 -1.9527 -34.062799999999996 2.9633000000000003 30.0968 -8.19078 -8.19078 -8.19078 -34.062799999999996 3.9633000000000003 30.0968 4.45123 4.45123 4.45123 -33.062799999999996 2.9633000000000003 33.0968 0.269182 0.269182 0.269182 -33.062799999999996 3.9633000000000003 33.0968 0.286066 0.286066 0.286066 -34.062799999999996 2.9633000000000003 33.0968 0.187921 0.187921 0.187921 -34.062799999999996 3.9633000000000003 33.0968 -2.06456 -2.06456 -2.06456 -33.062799999999996 4.9633 30.0968 0.602613 0.602613 0.602613 -33.062799999999996 4.9633 31.0968 -0.919198 -0.919198 -0.919198 -33.062799999999996 5.9633 30.0968 4.05631 4.05631 4.05631 -33.062799999999996 5.9633 31.0968 -0.0705019 -0.0705019 -0.0705019 -34.062799999999996 4.9633 30.0968 2.06112 2.06112 2.06112 -34.062799999999996 5.9633 31.0968 0.444756 0.444756 0.444756 -33.062799999999996 4.9633 33.0968 394.133 394.133 394.133 -33.062799999999996 5.9633 33.0968 -537.422 -537.422 -537.422 -34.062799999999996 4.9633 32.0968 -0.512767 -0.512767 -0.512767 -34.062799999999996 4.9633 33.0968 -0.222613 -0.222613 -0.222613 -34.062799999999996 5.9633 32.0968 0.492045 0.492045 0.492045 -34.062799999999996 5.9633 33.0968 -2.92149 -2.92149 -2.92149 -35.062799999999996 2.9633000000000003 30.0968 -6.98867 -6.98867 -6.98867 -35.062799999999996 2.9633000000000003 32.0968 -1.17762 -1.17762 -1.17762 -35.062799999999996 2.9633000000000003 33.0968 -1.87452 -1.87452 -1.87452 -35.062799999999996 3.9633000000000003 32.0968 -8.17439 -8.17439 -8.17439 -35.062799999999996 3.9633000000000003 33.0968 -4.72236 -4.72236 -4.72236 -36.062799999999996 2.9633000000000003 32.0968 -1.0217 -1.0217 -1.0217 -36.062799999999996 2.9633000000000003 33.0968 1.23585 1.23585 1.23585 -36.062799999999996 3.9633000000000003 32.0968 0.640822 0.640822 0.640822 -36.062799999999996 3.9633000000000003 33.0968 0.930936 0.930936 0.930936 -35.062799999999996 4.9633 30.0968 0.749462 0.749462 0.749462 -35.062799999999996 5.9633 30.0968 -0.239839 -0.239839 -0.239839 -35.062799999999996 5.9633 31.0968 -0.124696 -0.124696 -0.124696 -36.062799999999996 4.9633 31.0968 -0.267251 -0.267251 -0.267251 -36.062799999999996 5.9633 30.0968 -0.605468 -0.605468 -0.605468 -36.062799999999996 5.9633 31.0968 -1.00371 -1.00371 -1.00371 -35.062799999999996 4.9633 32.0968 0.934955 0.934955 0.934955 -35.062799999999996 5.9633 32.0968 0.299355 0.299355 0.299355 -35.062799999999996 5.9633 33.0968 1.31579 1.31579 1.31579 -36.062799999999996 4.9633 32.0968 0.685968 0.685968 0.685968 -36.062799999999996 4.9633 33.0968 -0.693614 -0.693614 -0.693614 -36.062799999999996 5.9633 32.0968 -0.164868 -0.164868 -0.164868 -36.062799999999996 5.9633 33.0968 0.104725 0.104725 0.104725 -33.062799999999996 3.9633000000000003 34.0968 2.26701 2.26701 2.26701 -33.062799999999996 4.9633 34.0968 70.6996 70.6996 70.6996 -33.062799999999996 5.9633 34.0968 267.815 267.815 267.815 -33.062799999999996 6.9633 31.0968 -1.54688 -1.54688 -1.54688 -33.062799999999996 7.9633 31.0968 -4.1417 -4.1417 -4.1417 -34.062799999999996 6.9633 31.0968 0.590626 0.590626 0.590626 -33.062799999999996 6.9633 32.0968 -204.798 -204.798 -204.798 -33.062799999999996 6.9633 33.0968 -557.626 -557.626 -557.626 -33.062799999999996 7.9633 32.0968 2.33774 2.33774 2.33774 -33.062799999999996 7.9633 33.0968 -3.8293 -3.8293 -3.8293 -34.062799999999996 6.9633 32.0968 3.23896 3.23896 3.23896 -34.062799999999996 6.9633 33.0968 0.447835 0.447835 0.447835 -34.062799999999996 7.9633 33.0968 6.21763 6.21763 6.21763 -33.062799999999996 8.9633 31.0968 -0.806306 -0.806306 -0.806306 -33.062799999999996 9.9633 30.0968 0.102093 0.102093 0.102093 -33.062799999999996 9.9633 31.0968 1.38107 1.38107 1.38107 -34.062799999999996 8.9633 31.0968 13.4728 13.4728 13.4728 -34.062799999999996 9.9633 30.0968 -8.55822 -8.55822 -8.55822 -34.062799999999996 9.9633 31.0968 9.65923 9.65923 9.65923 -33.062799999999996 8.9633 32.0968 -13.2284 -13.2284 -13.2284 -33.062799999999996 8.9633 33.0968 -12.4804 -12.4804 -12.4804 -33.062799999999996 9.9633 32.0968 5.34118 5.34118 5.34118 -34.062799999999996 8.9633 32.0968 -8.69394 -8.69394 -8.69394 -34.062799999999996 8.9633 33.0968 -1.85633 -1.85633 -1.85633 -34.062799999999996 9.9633 32.0968 -8.89701 -8.89701 -8.89701 -34.062799999999996 9.9633 33.0968 3.86521 3.86521 3.86521 -35.062799999999996 6.9633 30.0968 -1.4295 -1.4295 -1.4295 -35.062799999999996 6.9633 31.0968 0.542979 0.542979 0.542979 -35.062799999999996 7.9633 30.0968 -24.2502 -24.2502 -24.2502 -36.062799999999996 6.9633 30.0968 1.44944 1.44944 1.44944 -36.062799999999996 6.9633 31.0968 -0.275018 -0.275018 -0.275018 -36.062799999999996 7.9633 30.0968 11.6744 11.6744 11.6744 -36.062799999999996 7.9633 31.0968 2.90951 2.90951 2.90951 -35.062799999999996 6.9633 32.0968 0.163832 0.163832 0.163832 -35.062799999999996 6.9633 33.0968 -0.646896 -0.646896 -0.646896 -35.062799999999996 7.9633 33.0968 -0.149898 -0.149898 -0.149898 -36.062799999999996 6.9633 33.0968 0.480596 0.480596 0.480596 -36.062799999999996 7.9633 33.0968 -1.52837 -1.52837 -1.52837 -36.062799999999996 8.9633 30.0968 40.0924 40.0924 40.0924 -36.062799999999996 8.9633 31.0968 16.8795 16.8795 16.8795 -36.062799999999996 9.9633 31.0968 -26.3054 -26.3054 -26.3054 -35.062799999999996 8.9633 32.0968 4.09288 4.09288 4.09288 -35.062799999999996 8.9633 33.0968 1.35954 1.35954 1.35954 -35.062799999999996 9.9633 32.0968 -3.65462 -3.65462 -3.65462 -35.062799999999996 9.9633 33.0968 -5.96802 -5.96802 -5.96802 -36.062799999999996 8.9633 32.0968 -1.31892 -1.31892 -1.31892 -36.062799999999996 8.9633 33.0968 1.92976 1.92976 1.92976 -36.062799999999996 9.9633 32.0968 -4.61446 -4.61446 -4.61446 -35.062799999999996 6.9633 34.0968 3.49205 3.49205 3.49205 -35.062799999999996 7.9633 34.0968 -0.458872 -0.458872 -0.458872 -36.062799999999996 6.9633 34.0968 2.83495 2.83495 2.83495 -36.062799999999996 7.9633 34.0968 -4.92607 -4.92607 -4.92607 -37.062799999999996 2.9633000000000003 30.0968 -3.0287 -3.0287 -3.0287 -38.062799999999996 2.9633000000000003 30.0968 -3.78331 -3.78331 -3.78331 -38.062799999999996 2.9633000000000003 31.0968 -0.0240257 -0.0240257 -0.0240257 -38.062799999999996 3.9633000000000003 30.0968 -0.300384 -0.300384 -0.300384 -38.062799999999996 3.9633000000000003 31.0968 0.777053 0.777053 0.777053 -37.062799999999996 2.9633000000000003 33.0968 0.266606 0.266606 0.266606 -37.062799999999996 3.9633000000000003 33.0968 0.892778 0.892778 0.892778 -38.062799999999996 2.9633000000000003 33.0968 0.30336 0.30336 0.30336 -38.062799999999996 3.9633000000000003 32.0968 0.135841 0.135841 0.135841 -38.062799999999996 3.9633000000000003 33.0968 0.907128 0.907128 0.907128 -37.062799999999996 4.9633 31.0968 0.0474622 0.0474622 0.0474622 -37.062799999999996 5.9633 30.0968 -1.42178 -1.42178 -1.42178 -37.062799999999996 5.9633 31.0968 -0.168183 -0.168183 -0.168183 -38.062799999999996 4.9633 30.0968 4.83324 4.83324 4.83324 -38.062799999999996 4.9633 31.0968 -1.0393 -1.0393 -1.0393 -38.062799999999996 5.9633 30.0968 -1.76253 -1.76253 -1.76253 -38.062799999999996 5.9633 31.0968 2.01244 2.01244 2.01244 -37.062799999999996 4.9633 32.0968 -0.848292 -0.848292 -0.848292 -37.062799999999996 4.9633 33.0968 0.00147629 0.00147629 0.00147629 -37.062799999999996 5.9633 32.0968 -0.578655 -0.578655 -0.578655 -37.062799999999996 5.9633 33.0968 -0.0915992 -0.0915992 -0.0915992 -38.062799999999996 4.9633 32.0968 -0.417651 -0.417651 -0.417651 -38.062799999999996 4.9633 33.0968 0.0567744 0.0567744 0.0567744 -39.062799999999996 2.9633000000000003 30.0968 0.250019 0.250019 0.250019 -39.062799999999996 2.9633000000000003 31.0968 0.11805 0.11805 0.11805 -39.062799999999996 3.9633000000000003 31.0968 -0.811542 -0.811542 -0.811542 -39.062799999999996 2.9633000000000003 32.0968 -0.0766486 -0.0766486 -0.0766486 -39.062799999999996 2.9633000000000003 33.0968 -0.0228686 -0.0228686 -0.0228686 -39.062799999999996 3.9633000000000003 32.0968 -0.230349 -0.230349 -0.230349 -39.062799999999996 4.9633 30.0968 -4.46039 -4.46039 -4.46039 -39.062799999999996 5.9633 30.0968 -0.860376 -0.860376 -0.860376 -37.062799999999996 6.9633 30.0968 0.133369 0.133369 0.133369 -37.062799999999996 6.9633 31.0968 -0.295683 -0.295683 -0.295683 -37.062799999999996 7.9633 30.0968 -14.6997 -14.6997 -14.6997 -37.062799999999996 7.9633 31.0968 -12.6823 -12.6823 -12.6823 -38.062799999999996 6.9633 30.0968 2.45921 2.45921 2.45921 -38.062799999999996 7.9633 30.0968 0.80428 0.80428 0.80428 -37.062799999999996 6.9633 32.0968 -0.0196525 -0.0196525 -0.0196525 -37.062799999999996 6.9633 33.0968 -0.126551 -0.126551 -0.126551 -37.062799999999996 7.9633 32.0968 0.921124 0.921124 0.921124 -37.062799999999996 7.9633 33.0968 0.727544 0.727544 0.727544 -37.062799999999996 8.9633 30.0968 -9.35045 -9.35045 -9.35045 -37.062799999999996 8.9633 31.0968 -11.5962 -11.5962 -11.5962 -37.062799999999996 9.9633 30.0968 -20.2404 -20.2404 -20.2404 -37.062799999999996 9.9633 31.0968 39.8936 39.8936 39.8936 -37.062799999999996 8.9633 32.0968 -9.42392 -9.42392 -9.42392 -37.062799999999996 8.9633 33.0968 3.31793 3.31793 3.31793 -39.062799999999996 6.9633 30.0968 1.42046 1.42046 1.42046 -39.062799999999996 7.9633 30.0968 13.761 13.761 13.761 -25.0628 10.9633 8.096800000000002 12.061 12.061 12.061 -25.0628 10.9633 9.096800000000002 23.835 23.835 23.835 -25.0628 11.9633 8.096800000000002 -53.1542 -53.1542 -53.1542 -25.0628 11.9633 9.096800000000002 -16.1596 -16.1596 -16.1596 -26.0628 10.9633 9.096800000000002 -0.318672 -0.318672 -0.318672 -26.0628 11.9633 9.096800000000002 -23.5086 -23.5086 -23.5086 -25.0628 12.9633 9.096800000000002 -6.54871 -6.54871 -6.54871 -26.0628 12.9633 9.096800000000002 -24.8262 -24.8262 -24.8262 -27.0628 10.9633 9.096800000000002 20.7072 20.7072 20.7072 -27.0628 11.9633 9.096800000000002 -3.29575 -3.29575 -3.29575 -25.0628 11.9633 10.096800000000002 3.31882 3.31882 3.31882 -25.0628 11.9633 11.096800000000002 -0.047513 -0.047513 -0.047513 -26.0628 10.9633 10.096800000000002 57.5688 57.5688 57.5688 -25.0628 10.9633 12.096800000000002 -2.964 -2.964 -2.964 -25.0628 10.9633 13.096800000000002 -3.04482 -3.04482 -3.04482 -26.0628 10.9633 13.096800000000002 -25.8132 -25.8132 -25.8132 -25.0628 12.9633 10.096800000000002 -0.587658 -0.587658 -0.587658 -25.0628 12.9633 11.096800000000002 -24.8509 -24.8509 -24.8509 -25.0628 13.9633 10.096800000000002 -1.73642 -1.73642 -1.73642 -25.0628 13.9633 11.096800000000002 -21.336 -21.336 -21.336 -26.0628 12.9633 10.096800000000002 2.31063 2.31063 2.31063 -26.0628 12.9633 11.096800000000002 -7.61557 -7.61557 -7.61557 -26.0628 13.9633 11.096800000000002 5.38108 5.38108 5.38108 -25.0628 13.9633 12.096800000000002 9.86733 9.86733 9.86733 -25.0628 13.9633 13.096800000000002 6.66701 6.66701 6.66701 -26.0628 13.9633 12.096800000000002 5.70444 5.70444 5.70444 -26.0628 13.9633 13.096800000000002 5.24942 5.24942 5.24942 -27.0628 10.9633 10.096800000000002 22.1203 22.1203 22.1203 -27.0628 10.9633 11.096800000000002 57.2697 57.2697 57.2697 -27.0628 11.9633 10.096800000000002 28.2819 28.2819 28.2819 -28.0628 10.9633 10.096800000000002 -2.9929 -2.9929 -2.9929 -28.0628 10.9633 11.096800000000002 61.7453 61.7453 61.7453 -28.0628 11.9633 10.096800000000002 12.6204 12.6204 12.6204 -28.0628 11.9633 11.096800000000002 -10.9218 -10.9218 -10.9218 -27.0628 10.9633 12.096800000000002 40.3136 40.3136 40.3136 -27.0628 10.9633 13.096800000000002 -17.4132 -17.4132 -17.4132 -28.0628 10.9633 12.096800000000002 -8.55795 -8.55795 -8.55795 -28.0628 10.9633 13.096800000000002 -20.5231 -20.5231 -20.5231 -28.0628 11.9633 12.096800000000002 -0.141361 -0.141361 -0.141361 -27.0628 12.9633 10.096800000000002 21.1759 21.1759 21.1759 -27.0628 12.9633 11.096800000000002 47.8935 47.8935 47.8935 -27.0628 13.9633 11.096800000000002 41.9582 41.9582 41.9582 -28.0628 12.9633 11.096800000000002 -79.4527 -79.4527 -79.4527 -28.0628 13.9633 11.096800000000002 -32.4863 -32.4863 -32.4863 -28.0628 13.9633 12.096800000000002 15.7496 15.7496 15.7496 -25.0628 14.9633 10.096800000000002 1.12609 1.12609 1.12609 -25.0628 14.9633 11.096800000000002 25.7959 25.7959 25.7959 -25.0628 15.9633 10.096800000000002 -0.127095 -0.127095 -0.127095 -25.0628 15.9633 11.096800000000002 2.33965 2.33965 2.33965 -26.0628 14.9633 11.096800000000002 -4.12402 -4.12402 -4.12402 -25.0628 14.9633 12.096800000000002 -16.4175 -16.4175 -16.4175 -25.0628 14.9633 13.096800000000002 -26.9671 -26.9671 -26.9671 -25.0628 15.9633 12.096800000000002 -14.6836 -14.6836 -14.6836 -25.0628 15.9633 13.096800000000002 -18.6519 -18.6519 -18.6519 -26.0628 14.9633 12.096800000000002 4.40626 4.40626 4.40626 -26.0628 14.9633 13.096800000000002 -11.895 -11.895 -11.895 -25.0628 17.9633 11.096800000000002 0.961159 0.961159 0.961159 -25.0628 16.9633 12.096800000000002 7.41712 7.41712 7.41712 -25.0628 16.9633 13.096800000000002 7.83248 7.83248 7.83248 -25.0628 17.9633 12.096800000000002 -18.976 -18.976 -18.976 -25.0628 17.9633 13.096800000000002 11.9745 11.9745 11.9745 -26.0628 16.9633 13.096800000000002 6.68607 6.68607 6.68607 -26.0628 17.9633 13.096800000000002 -8.23567 -8.23567 -8.23567 -27.0628 14.9633 11.096800000000002 9.00718 9.00718 9.00718 -28.0628 14.9633 11.096800000000002 -16.2497 -16.2497 -16.2497 -27.0628 14.9633 12.096800000000002 -3.97218 -3.97218 -3.97218 -27.0628 14.9633 13.096800000000002 -3.28203 -3.28203 -3.28203 -27.0628 15.9633 12.096800000000002 -12.7058 -12.7058 -12.7058 -27.0628 15.9633 13.096800000000002 1.28935 1.28935 1.28935 -28.0628 14.9633 12.096800000000002 0.0529637 0.0529637 0.0529637 -28.0628 14.9633 13.096800000000002 6.0705 6.0705 6.0705 -28.0628 15.9633 12.096800000000002 -2.44027 -2.44027 -2.44027 -28.0628 15.9633 13.096800000000002 -12.2489 -12.2489 -12.2489 -29.0628 11.9633 11.096800000000002 9.64344 9.64344 9.64344 -30.0628 10.9633 10.096800000000002 -10.8531 -10.8531 -10.8531 -30.0628 10.9633 11.096800000000002 -15.0224 -15.0224 -15.0224 -30.0628 11.9633 10.096800000000002 -1.35256 -1.35256 -1.35256 -30.0628 11.9633 11.096800000000002 4.97721 4.97721 4.97721 -29.0628 10.9633 12.096800000000002 0.545433 0.545433 0.545433 -29.0628 10.9633 13.096800000000002 3.84198 3.84198 3.84198 -29.0628 11.9633 12.096800000000002 19.8696 19.8696 19.8696 -30.0628 10.9633 12.096800000000002 -55.6044 -55.6044 -55.6044 -30.0628 10.9633 13.096800000000002 -52.3303 -52.3303 -52.3303 -30.0628 11.9633 12.096800000000002 -8.06574 -8.06574 -8.06574 -29.0628 12.9633 11.096800000000002 -4.78576 -4.78576 -4.78576 -30.0628 12.9633 11.096800000000002 109.822 109.822 109.822 -30.0628 13.9633 11.096800000000002 -5.07068 -5.07068 -5.07068 -29.0628 12.9633 12.096800000000002 -50.7991 -50.7991 -50.7991 -29.0628 13.9633 12.096800000000002 -2.08025 -2.08025 -2.08025 -29.0628 13.9633 13.096800000000002 3.63806 3.63806 3.63806 -30.0628 12.9633 12.096800000000002 -11.8787 -11.8787 -11.8787 -30.0628 13.9633 12.096800000000002 -15.9999 -15.9999 -15.9999 -30.0628 13.9633 13.096800000000002 -17.6173 -17.6173 -17.6173 -31.0628 10.9633 10.096800000000002 -11.1313 -11.1313 -11.1313 -31.0628 10.9633 11.096800000000002 -135.697 -135.697 -135.697 -31.0628 11.9633 10.096800000000002 19.8417 19.8417 19.8417 -31.0628 11.9633 11.096800000000002 -1.35257 -1.35257 -1.35257 -32.062799999999996 10.9633 10.096800000000002 -2.44424 -2.44424 -2.44424 -32.062799999999996 10.9633 11.096800000000002 -95.04 -95.04 -95.04 -32.062799999999996 11.9633 10.096800000000002 8.02025 8.02025 8.02025 -32.062799999999996 11.9633 11.096800000000002 -92.7566 -92.7566 -92.7566 -31.0628 10.9633 13.096800000000002 -76.4565 -76.4565 -76.4565 -31.0628 11.9633 13.096800000000002 50.8506 50.8506 50.8506 -32.062799999999996 10.9633 12.096800000000002 -17.2956 -17.2956 -17.2956 -32.062799999999996 10.9633 13.096800000000002 130.317 130.317 130.317 -32.062799999999996 11.9633 12.096800000000002 98.1445 98.1445 98.1445 -32.062799999999996 11.9633 13.096800000000002 16.5005 16.5005 16.5005 -31.0628 12.9633 10.096800000000002 24.2657 24.2657 24.2657 -31.0628 12.9633 11.096800000000002 -16.3671 -16.3671 -16.3671 -31.0628 13.9633 11.096800000000002 159.43 159.43 159.43 -32.062799999999996 12.9633 11.096800000000002 -210.255 -210.255 -210.255 -32.062799999999996 13.9633 11.096800000000002 -183.075 -183.075 -183.075 -31.0628 13.9633 12.096800000000002 -5.14419 -5.14419 -5.14419 -31.0628 13.9633 13.096800000000002 7.67663 7.67663 7.67663 -32.062799999999996 12.9633 12.096800000000002 66.8152 66.8152 66.8152 -32.062799999999996 12.9633 13.096800000000002 196.975 196.975 196.975 -32.062799999999996 13.9633 12.096800000000002 7.15101 7.15101 7.15101 -32.062799999999996 13.9633 13.096800000000002 3.71557 3.71557 3.71557 -29.0628 14.9633 12.096800000000002 -4.07563 -4.07563 -4.07563 -29.0628 14.9633 13.096800000000002 15.2305 15.2305 15.2305 -30.0628 14.9633 13.096800000000002 8.95847 8.95847 8.95847 -25.0628 10.9633 14.096800000000002 5.93077 5.93077 5.93077 -25.0628 10.9633 15.096800000000002 9.74425 9.74425 9.74425 -25.0628 11.9633 14.096800000000002 -3.34699 -3.34699 -3.34699 -26.0628 10.9633 14.096800000000002 -5.92147 -5.92147 -5.92147 -26.0628 10.9633 15.096800000000002 -7.03124 -7.03124 -7.03124 -26.0628 11.9633 14.096800000000002 -3.76557 -3.76557 -3.76557 -26.0628 11.9633 15.096800000000002 -1.95958 -1.95958 -1.95958 -25.0628 10.9633 16.0968 5.81409 5.81409 5.81409 -25.0628 10.9633 17.0968 0.935288 0.935288 0.935288 -25.0628 11.9633 16.0968 6.07614 6.07614 6.07614 -25.0628 11.9633 17.0968 -4.30054 -4.30054 -4.30054 -26.0628 10.9633 16.0968 -1.24036 -1.24036 -1.24036 -26.0628 10.9633 17.0968 -0.646292 -0.646292 -0.646292 -26.0628 11.9633 16.0968 88.035 88.035 88.035 -26.0628 11.9633 17.0968 31.2147 31.2147 31.2147 -25.0628 13.9633 15.096800000000002 -3.23153 -3.23153 -3.23153 -26.0628 12.9633 14.096800000000002 -12.9654 -12.9654 -12.9654 -26.0628 13.9633 14.096800000000002 -15.8493 -15.8493 -15.8493 -26.0628 13.9633 15.096800000000002 12.5579 12.5579 12.5579 -25.0628 12.9633 16.0968 4.08407 4.08407 4.08407 -25.0628 12.9633 17.0968 -1.05898 -1.05898 -1.05898 -25.0628 13.9633 16.0968 2.89266 2.89266 2.89266 -25.0628 13.9633 17.0968 -0.927103 -0.927103 -0.927103 -26.0628 12.9633 16.0968 61.3692 61.3692 61.3692 -26.0628 12.9633 17.0968 -111.087 -111.087 -111.087 -26.0628 13.9633 16.0968 51.2084 51.2084 51.2084 -27.0628 10.9633 14.096800000000002 -6.44715 -6.44715 -6.44715 -27.0628 10.9633 15.096800000000002 8.85815 8.85815 8.85815 -27.0628 11.9633 14.096800000000002 -1.41273 -1.41273 -1.41273 -27.0628 11.9633 15.096800000000002 -3.54583 -3.54583 -3.54583 -28.0628 10.9633 14.096800000000002 -0.719307 -0.719307 -0.719307 -28.0628 10.9633 15.096800000000002 1.38247 1.38247 1.38247 -28.0628 11.9633 14.096800000000002 8.63855 8.63855 8.63855 -28.0628 11.9633 15.096800000000002 -9.42418 -9.42418 -9.42418 -27.0628 10.9633 16.0968 9.4193 9.4193 9.4193 -27.0628 10.9633 17.0968 7.14403 7.14403 7.14403 -27.0628 11.9633 16.0968 -1.32409 -1.32409 -1.32409 -27.0628 11.9633 17.0968 -12.2629 -12.2629 -12.2629 -28.0628 10.9633 16.0968 -2.66199 -2.66199 -2.66199 -28.0628 10.9633 17.0968 -4.60563 -4.60563 -4.60563 -28.0628 11.9633 16.0968 -20.1998 -20.1998 -20.1998 -28.0628 11.9633 17.0968 82.081 82.081 82.081 -27.0628 12.9633 14.096800000000002 4.83117 4.83117 4.83117 -27.0628 12.9633 15.096800000000002 3.64108 3.64108 3.64108 -27.0628 13.9633 14.096800000000002 -2.98573 -2.98573 -2.98573 -27.0628 13.9633 15.096800000000002 9.96384 9.96384 9.96384 -28.0628 12.9633 14.096800000000002 -25.9456 -25.9456 -25.9456 -28.0628 12.9633 15.096800000000002 -7.40234 -7.40234 -7.40234 -28.0628 13.9633 14.096800000000002 -9.53124 -9.53124 -9.53124 -28.0628 13.9633 15.096800000000002 -2.45758 -2.45758 -2.45758 -27.0628 12.9633 16.0968 13.0673 13.0673 13.0673 -27.0628 12.9633 17.0968 -152.999 -152.999 -152.999 -27.0628 13.9633 16.0968 -35.4419 -35.4419 -35.4419 -27.0628 13.9633 17.0968 -106.835 -106.835 -106.835 -28.0628 12.9633 16.0968 52.7029 52.7029 52.7029 -28.0628 12.9633 17.0968 49.4144 49.4144 49.4144 -28.0628 13.9633 16.0968 59.9539 59.9539 59.9539 -28.0628 13.9633 17.0968 -79.8459 -79.8459 -79.8459 -25.0628 11.9633 18.0968 0.39814 0.39814 0.39814 -25.0628 11.9633 19.0968 -4.61872 -4.61872 -4.61872 -26.0628 11.9633 18.0968 -52.9081 -52.9081 -52.9081 -26.0628 11.9633 19.0968 -2.64814 -2.64814 -2.64814 -25.0628 11.9633 20.0968 2.80201 2.80201 2.80201 -25.0628 11.9633 21.0968 10.8187 10.8187 10.8187 -26.0628 10.9633 21.0968 6.23701 6.23701 6.23701 -26.0628 11.9633 20.0968 0.0248965 0.0248965 0.0248965 -26.0628 11.9633 21.0968 -3.55305 -3.55305 -3.55305 -25.0628 12.9633 18.0968 -2.10695 -2.10695 -2.10695 -25.0628 12.9633 19.0968 -5.02678 -5.02678 -5.02678 -25.0628 13.9633 18.0968 11.0274 11.0274 11.0274 -25.0628 13.9633 19.0968 -2.59342 -2.59342 -2.59342 -26.0628 12.9633 18.0968 -82.7535 -82.7535 -82.7535 -26.0628 12.9633 19.0968 -2.0332 -2.0332 -2.0332 -26.0628 13.9633 19.0968 -2.86694 -2.86694 -2.86694 -27.0628 10.9633 18.0968 5.56188 5.56188 5.56188 -27.0628 11.9633 18.0968 25.7299 25.7299 25.7299 -27.0628 11.9633 19.0968 5.39251 5.39251 5.39251 -28.0628 10.9633 18.0968 -6.36609 -6.36609 -6.36609 -28.0628 11.9633 18.0968 44.5653 44.5653 44.5653 -27.0628 10.9633 21.0968 11.6946 11.6946 11.6946 -27.0628 11.9633 20.0968 0.624016 0.624016 0.624016 -27.0628 11.9633 21.0968 -11.0653 -11.0653 -11.0653 -28.0628 10.9633 21.0968 3.62121 3.62121 3.62121 -28.0628 11.9633 21.0968 -9.41571 -9.41571 -9.41571 -27.0628 12.9633 18.0968 6.0944 6.0944 6.0944 -27.0628 12.9633 19.0968 -2.47367 -2.47367 -2.47367 -27.0628 13.9633 18.0968 -9.63633 -9.63633 -9.63633 -27.0628 13.9633 19.0968 -2.54192 -2.54192 -2.54192 -28.0628 12.9633 18.0968 32.4903 32.4903 32.4903 -28.0628 12.9633 19.0968 -6.14572 -6.14572 -6.14572 -28.0628 13.9633 18.0968 76.7159 76.7159 76.7159 -27.0628 12.9633 20.0968 -0.379035 -0.379035 -0.379035 -27.0628 12.9633 21.0968 6.8805 6.8805 6.8805 -28.0628 12.9633 20.0968 1.17668 1.17668 1.17668 -28.0628 12.9633 21.0968 -34.3632 -34.3632 -34.3632 -25.0628 14.9633 14.096800000000002 16.8568 16.8568 16.8568 -25.0628 14.9633 15.096800000000002 10.7309 10.7309 10.7309 -25.0628 15.9633 14.096800000000002 -30.3696 -30.3696 -30.3696 -25.0628 15.9633 15.096800000000002 -0.200481 -0.200481 -0.200481 -26.0628 14.9633 14.096800000000002 -1.67021 -1.67021 -1.67021 -26.0628 15.9633 14.096800000000002 10.0797 10.0797 10.0797 -26.0628 15.9633 15.096800000000002 2.07804 2.07804 2.07804 -25.0628 14.9633 16.0968 -4.13506 -4.13506 -4.13506 -25.0628 14.9633 17.0968 3.03773 3.03773 3.03773 -25.0628 15.9633 16.0968 2.11666 2.11666 2.11666 -25.0628 15.9633 17.0968 -8.529 -8.529 -8.529 -26.0628 14.9633 16.0968 -1.30673 -1.30673 -1.30673 -26.0628 14.9633 17.0968 5.68662 5.68662 5.68662 -26.0628 15.9633 16.0968 1.81928 1.81928 1.81928 -26.0628 15.9633 17.0968 1.68876 1.68876 1.68876 -25.0628 16.9633 14.096800000000002 -74.1575 -74.1575 -74.1575 -25.0628 16.9633 15.096800000000002 43.3481 43.3481 43.3481 -25.0628 17.9633 15.096800000000002 -26.844 -26.844 -26.844 -26.0628 16.9633 14.096800000000002 -7.55099 -7.55099 -7.55099 -26.0628 16.9633 15.096800000000002 28.3068 28.3068 28.3068 -26.0628 17.9633 14.096800000000002 3.98553 3.98553 3.98553 -26.0628 17.9633 15.096800000000002 -90.0348 -90.0348 -90.0348 -25.0628 16.9633 16.0968 108.135 108.135 108.135 -25.0628 16.9633 17.0968 -2.4292 -2.4292 -2.4292 -25.0628 17.9633 16.0968 53.5443 53.5443 53.5443 -26.0628 16.9633 16.0968 -39.9317 -39.9317 -39.9317 -26.0628 17.9633 16.0968 -5.16949 -5.16949 -5.16949 -27.0628 14.9633 14.096800000000002 -1.05976 -1.05976 -1.05976 -28.0628 14.9633 14.096800000000002 6.04229 6.04229 6.04229 -27.0628 14.9633 16.0968 -4.85302 -4.85302 -4.85302 -27.0628 14.9633 17.0968 -0.765678 -0.765678 -0.765678 -27.0628 15.9633 17.0968 0.846551 0.846551 0.846551 -25.0628 14.9633 18.0968 12.0618 12.0618 12.0618 -25.0628 14.9633 19.0968 0.55511 0.55511 0.55511 -25.0628 15.9633 18.0968 12.9465 12.9465 12.9465 -26.0628 14.9633 18.0968 15.4587 15.4587 15.4587 -26.0628 14.9633 19.0968 6.25765 6.25765 6.25765 -26.0628 15.9633 18.0968 -2.14038 -2.14038 -2.14038 -25.0628 16.9633 21.0968 -5.26236 -5.26236 -5.26236 -25.0628 17.9633 20.0968 -17.2372 -17.2372 -17.2372 -25.0628 17.9633 21.0968 -1.5681 -1.5681 -1.5681 -26.0628 17.9633 21.0968 15.466 15.466 15.466 -27.0628 14.9633 18.0968 -10.647 -10.647 -10.647 -27.0628 14.9633 19.0968 -0.731822 -0.731822 -0.731822 -27.0628 15.9633 18.0968 -12.9649 -12.9649 -12.9649 -29.0628 10.9633 14.096800000000002 2.0477 2.0477 2.0477 -29.0628 10.9633 15.096800000000002 -4.68102 -4.68102 -4.68102 -29.0628 11.9633 14.096800000000002 0.0988384 0.0988384 0.0988384 -29.0628 11.9633 15.096800000000002 -11.6707 -11.6707 -11.6707 -30.0628 10.9633 14.096800000000002 -16.0307 -16.0307 -16.0307 -30.0628 10.9633 15.096800000000002 12.0758 12.0758 12.0758 -29.0628 10.9633 16.0968 -3.95606 -3.95606 -3.95606 -29.0628 10.9633 17.0968 8.4551 8.4551 8.4551 -29.0628 11.9633 17.0968 0.323238 0.323238 0.323238 -30.0628 10.9633 16.0968 3.06332 3.06332 3.06332 -30.0628 10.9633 17.0968 -16.876 -16.876 -16.876 -29.0628 12.9633 14.096800000000002 -2.38079 -2.38079 -2.38079 -29.0628 13.9633 14.096800000000002 4.70013 4.70013 4.70013 -29.0628 13.9633 15.096800000000002 -4.33161 -4.33161 -4.33161 -30.0628 13.9633 14.096800000000002 -1.89291 -1.89291 -1.89291 -30.0628 13.9633 15.096800000000002 -7.17422 -7.17422 -7.17422 -29.0628 13.9633 16.0968 -5.39964 -5.39964 -5.39964 -29.0628 13.9633 17.0968 1.53005 1.53005 1.53005 -30.0628 13.9633 16.0968 -8.92757 -8.92757 -8.92757 -30.0628 13.9633 17.0968 -0.0329121 -0.0329121 -0.0329121 -31.0628 10.9633 14.096800000000002 -61.8301 -61.8301 -61.8301 -31.0628 10.9633 15.096800000000002 17.6825 17.6825 17.6825 -31.0628 11.9633 14.096800000000002 2.80971 2.80971 2.80971 -32.062799999999996 10.9633 14.096800000000002 40.556 40.556 40.556 -32.062799999999996 10.9633 15.096800000000002 -12.8803 -12.8803 -12.8803 -32.062799999999996 11.9633 14.096800000000002 -62.5625 -62.5625 -62.5625 -31.0628 10.9633 16.0968 9.51551 9.51551 9.51551 -31.0628 10.9633 17.0968 -2.07762 -2.07762 -2.07762 -31.0628 11.9633 16.0968 17.6527 17.6527 17.6527 -31.0628 11.9633 17.0968 8.35267 8.35267 8.35267 -32.062799999999996 10.9633 16.0968 23.21 23.21 23.21 -32.062799999999996 10.9633 17.0968 -12.6679 -12.6679 -12.6679 -32.062799999999996 11.9633 16.0968 41.7902 41.7902 41.7902 -32.062799999999996 11.9633 17.0968 1.8871 1.8871 1.8871 -31.0628 13.9633 14.096800000000002 -6.82847 -6.82847 -6.82847 -31.0628 13.9633 15.096800000000002 2.55009 2.55009 2.55009 -32.062799999999996 13.9633 14.096800000000002 -24.0436 -24.0436 -24.0436 -32.062799999999996 13.9633 15.096800000000002 -11.1606 -11.1606 -11.1606 -31.0628 12.9633 16.0968 17.7419 17.7419 17.7419 -31.0628 12.9633 17.0968 15.7981 15.7981 15.7981 -31.0628 13.9633 16.0968 8.1005 8.1005 8.1005 -31.0628 13.9633 17.0968 0.640093 0.640093 0.640093 -32.062799999999996 12.9633 16.0968 83.0882 83.0882 83.0882 -32.062799999999996 12.9633 17.0968 -8.72828 -8.72828 -8.72828 -32.062799999999996 13.9633 16.0968 40.4005 40.4005 40.4005 -29.0628 10.9633 18.0968 0.178726 0.178726 0.178726 -29.0628 10.9633 19.0968 -2.83783 -2.83783 -2.83783 -29.0628 11.9633 18.0968 -1.15334 -1.15334 -1.15334 -29.0628 11.9633 19.0968 2.22258 2.22258 2.22258 -30.0628 10.9633 18.0968 1.52306 1.52306 1.52306 -30.0628 10.9633 19.0968 9.80602 9.80602 9.80602 -30.0628 11.9633 18.0968 -3.45928 -3.45928 -3.45928 -30.0628 11.9633 19.0968 -19.9523 -19.9523 -19.9523 -29.0628 11.9633 21.0968 -16.8941 -16.8941 -16.8941 -30.0628 11.9633 21.0968 -14.6764 -14.6764 -14.6764 -29.0628 12.9633 18.0968 -7.99035 -7.99035 -7.99035 -29.0628 12.9633 19.0968 3.51566 3.51566 3.51566 -29.0628 13.9633 18.0968 -1.33613 -1.33613 -1.33613 -29.0628 13.9633 19.0968 -2.08311 -2.08311 -2.08311 -30.0628 12.9633 19.0968 -11.4641 -11.4641 -11.4641 -30.0628 13.9633 18.0968 -0.171408 -0.171408 -0.171408 -30.0628 13.9633 19.0968 11.8837 11.8837 11.8837 -29.0628 12.9633 20.0968 17.1123 17.1123 17.1123 -29.0628 12.9633 21.0968 -34.014 -34.014 -34.014 -30.0628 12.9633 20.0968 -38.3232 -38.3232 -38.3232 -30.0628 12.9633 21.0968 -28.1293 -28.1293 -28.1293 -31.0628 10.9633 18.0968 10.3956 10.3956 10.3956 -31.0628 10.9633 19.0968 -7.33536 -7.33536 -7.33536 -31.0628 11.9633 18.0968 2.94876 2.94876 2.94876 -31.0628 11.9633 19.0968 8.96941 8.96941 8.96941 -32.062799999999996 10.9633 18.0968 -11.4799 -11.4799 -11.4799 -32.062799999999996 10.9633 19.0968 -4.32928 -4.32928 -4.32928 -32.062799999999996 11.9633 18.0968 -0.938198 -0.938198 -0.938198 -32.062799999999996 11.9633 19.0968 23.3966 23.3966 23.3966 -31.0628 10.9633 20.0968 -13.7962 -13.7962 -13.7962 -31.0628 10.9633 21.0968 6.89775 6.89775 6.89775 -31.0628 11.9633 20.0968 4.98328 4.98328 4.98328 -31.0628 11.9633 21.0968 14.5793 14.5793 14.5793 -32.062799999999996 10.9633 20.0968 -10.2309 -10.2309 -10.2309 -32.062799999999996 10.9633 21.0968 -4.97092 -4.97092 -4.97092 -32.062799999999996 11.9633 20.0968 -3.7205 -3.7205 -3.7205 -32.062799999999996 11.9633 21.0968 40.9152 40.9152 40.9152 -31.0628 12.9633 18.0968 3.18956 3.18956 3.18956 -31.0628 12.9633 19.0968 14.0016 14.0016 14.0016 -31.0628 13.9633 18.0968 -2.993 -2.993 -2.993 -32.062799999999996 12.9633 18.0968 3.76522 3.76522 3.76522 -32.062799999999996 12.9633 19.0968 20.4289 20.4289 20.4289 -32.062799999999996 13.9633 19.0968 104.039 104.039 104.039 -31.0628 12.9633 20.0968 -46.7738 -46.7738 -46.7738 -31.0628 12.9633 21.0968 -50.8207 -50.8207 -50.8207 -32.062799999999996 12.9633 20.0968 -116.447 -116.447 -116.447 -32.062799999999996 12.9633 21.0968 -66.5735 -66.5735 -66.5735 -32.062799999999996 13.9633 20.0968 -42.1208 -42.1208 -42.1208 -32.062799999999996 13.9633 21.0968 -73.7141 -73.7141 -73.7141 -29.0628 14.9633 14.096800000000002 3.63504 3.63504 3.63504 -30.0628 14.9633 14.096800000000002 -3.84039 -3.84039 -3.84039 -29.0628 14.9633 16.0968 71.6829 71.6829 71.6829 -30.0628 14.9633 16.0968 -55.6088 -55.6088 -55.6088 -31.0628 14.9633 14.096800000000002 7.96091 7.96091 7.96091 -31.0628 14.9633 15.096800000000002 35.2249 35.2249 35.2249 -32.062799999999996 14.9633 14.096800000000002 -19.3547 -19.3547 -19.3547 -32.062799999999996 14.9633 15.096800000000002 -3.56342 -3.56342 -3.56342 -25.0628 18.9633 12.096800000000002 1.41442 1.41442 1.41442 -25.0628 18.9633 13.096800000000002 13.319 13.319 13.319 -25.0628 19.9633 13.096800000000002 -3.54343 -3.54343 -3.54343 -26.0628 18.9633 13.096800000000002 -10.2568 -10.2568 -10.2568 -26.0628 19.9633 13.096800000000002 -18.6157 -18.6157 -18.6157 -25.0628 20.9633 13.096800000000002 -3.42042 -3.42042 -3.42042 -25.0628 21.9633 13.096800000000002 -7.95385 -7.95385 -7.95385 -26.0628 20.9633 13.096800000000002 -8.16366 -8.16366 -8.16366 -25.0628 22.9633 13.096800000000002 -41.0457 -41.0457 -41.0457 -25.0628 23.9633 13.096800000000002 -45.9085 -45.9085 -45.9085 -25.0628 18.9633 14.096800000000002 -14.4838 -14.4838 -14.4838 -25.0628 18.9633 15.096800000000002 -47.7598 -47.7598 -47.7598 -25.0628 19.9633 15.096800000000002 -3.21168 -3.21168 -3.21168 -26.0628 18.9633 14.096800000000002 37.8728 37.8728 37.8728 -26.0628 18.9633 15.096800000000002 131.967 131.967 131.967 -26.0628 19.9633 14.096800000000002 0.232525 0.232525 0.232525 -26.0628 19.9633 15.096800000000002 -0.213571 -0.213571 -0.213571 -25.0628 18.9633 16.0968 -37.7551 -37.7551 -37.7551 -25.0628 19.9633 16.0968 10.3434 10.3434 10.3434 -25.0628 19.9633 17.0968 -4.83077 -4.83077 -4.83077 -26.0628 18.9633 16.0968 -28.1406 -28.1406 -28.1406 -25.0628 20.9633 14.096800000000002 -10.5483 -10.5483 -10.5483 -25.0628 20.9633 15.096800000000002 1.1214 1.1214 1.1214 -25.0628 21.9633 14.096800000000002 -4.81288 -4.81288 -4.81288 -25.0628 21.9633 15.096800000000002 -6.61238 -6.61238 -6.61238 -26.0628 20.9633 14.096800000000002 6.96087 6.96087 6.96087 -26.0628 20.9633 15.096800000000002 0.488575 0.488575 0.488575 -26.0628 21.9633 15.096800000000002 -3.16632 -3.16632 -3.16632 -25.0628 20.9633 16.0968 -4.26958 -4.26958 -4.26958 -25.0628 20.9633 17.0968 -12.2463 -12.2463 -12.2463 -25.0628 21.9633 16.0968 -1.30841 -1.30841 -1.30841 -25.0628 21.9633 17.0968 -14.0709 -14.0709 -14.0709 -26.0628 20.9633 16.0968 8.65467 8.65467 8.65467 -26.0628 21.9633 16.0968 1.58119 1.58119 1.58119 -25.0628 18.9633 19.0968 -3.33938 -3.33938 -3.33938 -25.0628 19.9633 19.0968 -3.19401 -3.19401 -3.19401 -26.0628 19.9633 19.0968 -1.02567 -1.02567 -1.02567 -25.0628 18.9633 20.0968 -0.301929 -0.301929 -0.301929 -25.0628 18.9633 21.0968 -51.9764 -51.9764 -51.9764 -25.0628 19.9633 20.0968 -3.54139 -3.54139 -3.54139 -26.0628 18.9633 20.0968 1.9625 1.9625 1.9625 -26.0628 18.9633 21.0968 -57.3391 -57.3391 -57.3391 -26.0628 19.9633 20.0968 -4.89649 -4.89649 -4.89649 -26.0628 19.9633 21.0968 -2.62295 -2.62295 -2.62295 -25.0628 20.9633 19.0968 0.116776 0.116776 0.116776 -25.0628 21.9633 19.0968 -3.00837 -3.00837 -3.00837 -26.0628 20.9633 19.0968 -1.35228 -1.35228 -1.35228 -25.0628 20.9633 20.0968 3.64159 3.64159 3.64159 -25.0628 21.9633 20.0968 9.19024 9.19024 9.19024 -25.0628 21.9633 21.0968 4.10714 4.10714 4.10714 -26.0628 20.9633 20.0968 -7.34645 -7.34645 -7.34645 -26.0628 20.9633 21.0968 6.66054 6.66054 6.66054 -26.0628 21.9633 20.0968 1.20511 1.20511 1.20511 -26.0628 21.9633 21.0968 -14.5098 -14.5098 -14.5098 -27.0628 20.9633 21.0968 -25.9235 -25.9235 -25.9235 -27.0628 21.9633 21.0968 27.608 27.608 27.608 -25.0628 22.9633 14.096800000000002 -18.7425 -18.7425 -18.7425 -25.0628 22.9633 15.096800000000002 5.40187 5.40187 5.40187 -25.0628 23.9633 14.096800000000002 15.2455 15.2455 15.2455 -25.0628 23.9633 15.096800000000002 -26.8627 -26.8627 -26.8627 -26.0628 22.9633 15.096800000000002 -4.45004 -4.45004 -4.45004 -25.0628 22.9633 16.0968 -2.6446 -2.6446 -2.6446 -25.0628 22.9633 17.0968 -4.31794 -4.31794 -4.31794 -25.0628 23.9633 16.0968 -1.25244 -1.25244 -1.25244 -25.0628 23.9633 17.0968 6.36484 6.36484 6.36484 -25.0628 24.9633 15.096800000000002 -28.7777 -28.7777 -28.7777 -25.0628 24.9633 16.0968 -13.6981 -13.6981 -13.6981 -25.0628 24.9633 17.0968 20.8166 20.8166 20.8166 -25.0628 22.9633 18.0968 12.0683 12.0683 12.0683 -25.0628 23.9633 18.0968 5.08001 5.08001 5.08001 -33.062799999999996 10.9633 11.096800000000002 19.68 19.68 19.68 -34.062799999999996 10.9633 11.096800000000002 -9.29929 -9.29929 -9.29929 -33.062799999999996 10.9633 12.096800000000002 44.5826 44.5826 44.5826 -33.062799999999996 10.9633 13.096800000000002 104.308 104.308 104.308 -33.062799999999996 11.9633 12.096800000000002 -134.592 -134.592 -134.592 -33.062799999999996 11.9633 13.096800000000002 12.1686 12.1686 12.1686 -34.062799999999996 10.9633 12.096800000000002 13.3184 13.3184 13.3184 -34.062799999999996 10.9633 13.096800000000002 30.909 30.909 30.909 -33.062799999999996 12.9633 12.096800000000002 -5.83478 -5.83478 -5.83478 -33.062799999999996 12.9633 13.096800000000002 -99.8228 -99.8228 -99.8228 -33.062799999999996 13.9633 13.096800000000002 12.4977 12.4977 12.4977 -35.062799999999996 10.9633 12.096800000000002 21.2049 21.2049 21.2049 -35.062799999999996 10.9633 13.096800000000002 -8.03621 -8.03621 -8.03621 -35.062799999999996 11.9633 13.096800000000002 22.6095 22.6095 22.6095 -36.062799999999996 11.9633 13.096800000000002 20.259 20.259 20.259 -35.062799999999996 12.9633 13.096800000000002 -12.4356 -12.4356 -12.4356 -36.062799999999996 12.9633 13.096800000000002 -2.03934 -2.03934 -2.03934 -33.062799999999996 10.9633 14.096800000000002 -20.3328 -20.3328 -20.3328 -33.062799999999996 10.9633 15.096800000000002 4.67957 4.67957 4.67957 -33.062799999999996 11.9633 14.096800000000002 -21.9389 -21.9389 -21.9389 -33.062799999999996 11.9633 15.096800000000002 2.39419 2.39419 2.39419 -34.062799999999996 10.9633 14.096800000000002 -21.0119 -21.0119 -21.0119 -34.062799999999996 10.9633 15.096800000000002 10.286 10.286 10.286 -34.062799999999996 11.9633 14.096800000000002 16.5658 16.5658 16.5658 -34.062799999999996 11.9633 15.096800000000002 9.41134 9.41134 9.41134 -33.062799999999996 10.9633 16.0968 41.6281 41.6281 41.6281 -33.062799999999996 10.9633 17.0968 -14.8214 -14.8214 -14.8214 -33.062799999999996 11.9633 16.0968 21.3869 21.3869 21.3869 -33.062799999999996 11.9633 17.0968 19.811 19.811 19.811 -34.062799999999996 10.9633 16.0968 11.6531 11.6531 11.6531 -34.062799999999996 11.9633 16.0968 16.8675 16.8675 16.8675 -34.062799999999996 11.9633 17.0968 -2.76263 -2.76263 -2.76263 -33.062799999999996 12.9633 14.096800000000002 -13.2633 -13.2633 -13.2633 -33.062799999999996 12.9633 15.096800000000002 -3.36862 -3.36862 -3.36862 -33.062799999999996 13.9633 14.096800000000002 0.596537 0.596537 0.596537 -33.062799999999996 13.9633 15.096800000000002 7.44842 7.44842 7.44842 -34.062799999999996 12.9633 14.096800000000002 -20.6336 -20.6336 -20.6336 -34.062799999999996 12.9633 15.096800000000002 -3.86008 -3.86008 -3.86008 -34.062799999999996 13.9633 14.096800000000002 10.5163 10.5163 10.5163 -34.062799999999996 13.9633 15.096800000000002 11.888 11.888 11.888 -33.062799999999996 12.9633 16.0968 4.14177 4.14177 4.14177 -33.062799999999996 12.9633 17.0968 -31.7792 -31.7792 -31.7792 -33.062799999999996 13.9633 16.0968 21.9318 21.9318 21.9318 -34.062799999999996 12.9633 16.0968 -32.3818 -32.3818 -32.3818 -34.062799999999996 12.9633 17.0968 13.6478 13.6478 13.6478 -34.062799999999996 13.9633 16.0968 -28.6264 -28.6264 -28.6264 -34.062799999999996 13.9633 17.0968 -1.57389 -1.57389 -1.57389 -35.062799999999996 10.9633 14.096800000000002 -27.8477 -27.8477 -27.8477 -35.062799999999996 10.9633 15.096800000000002 11.6724 11.6724 11.6724 -35.062799999999996 11.9633 14.096800000000002 5.98623 5.98623 5.98623 -36.062799999999996 10.9633 14.096800000000002 -17.403 -17.403 -17.403 -36.062799999999996 10.9633 15.096800000000002 -87.2825 -87.2825 -87.2825 -36.062799999999996 11.9633 14.096800000000002 15.4255 15.4255 15.4255 -36.062799999999996 11.9633 15.096800000000002 44.3822 44.3822 44.3822 -36.062799999999996 10.9633 17.0968 123.861 123.861 123.861 -36.062799999999996 11.9633 17.0968 190.129 190.129 190.129 -35.062799999999996 12.9633 14.096800000000002 -77.8159 -77.8159 -77.8159 -35.062799999999996 13.9633 14.096800000000002 -35.8661 -35.8661 -35.8661 -35.062799999999996 13.9633 15.096800000000002 -152.861 -152.861 -152.861 -36.062799999999996 12.9633 14.096800000000002 87.0367 87.0367 87.0367 -36.062799999999996 12.9633 15.096800000000002 213.617 213.617 213.617 -36.062799999999996 13.9633 14.096800000000002 7.26858 7.26858 7.26858 -36.062799999999996 13.9633 15.096800000000002 183.93 183.93 183.93 -35.062799999999996 12.9633 16.0968 -78.9071 -78.9071 -78.9071 -35.062799999999996 12.9633 17.0968 32.2735 32.2735 32.2735 -35.062799999999996 13.9633 16.0968 -25.0459 -25.0459 -25.0459 -35.062799999999996 13.9633 17.0968 -15.6582 -15.6582 -15.6582 -36.062799999999996 12.9633 16.0968 147.935 147.935 147.935 -36.062799999999996 12.9633 17.0968 64.7316 64.7316 64.7316 -36.062799999999996 13.9633 16.0968 -95.1606 -95.1606 -95.1606 -33.062799999999996 10.9633 18.0968 -2.20868 -2.20868 -2.20868 -33.062799999999996 11.9633 18.0968 -23.7181 -23.7181 -23.7181 -33.062799999999996 11.9633 19.0968 10.0416 10.0416 10.0416 -34.062799999999996 11.9633 18.0968 1.24597 1.24597 1.24597 -34.062799999999996 11.9633 19.0968 26.5674 26.5674 26.5674 -33.062799999999996 10.9633 21.0968 23.9049 23.9049 23.9049 -33.062799999999996 12.9633 18.0968 -30.09 -30.09 -30.09 -33.062799999999996 12.9633 19.0968 24.6846 24.6846 24.6846 -33.062799999999996 13.9633 19.0968 47.7578 47.7578 47.7578 -34.062799999999996 12.9633 18.0968 -19.3249 -19.3249 -19.3249 -34.062799999999996 12.9633 19.0968 -16.7593 -16.7593 -16.7593 -34.062799999999996 13.9633 19.0968 -32.7448 -32.7448 -32.7448 -33.062799999999996 13.9633 20.0968 23.8591 23.8591 23.8591 -33.062799999999996 13.9633 21.0968 53.4083 53.4083 53.4083 -34.062799999999996 12.9633 20.0968 17.225 17.225 17.225 -34.062799999999996 12.9633 21.0968 51.0926 51.0926 51.0926 -34.062799999999996 13.9633 20.0968 -13.3995 -13.3995 -13.3995 -34.062799999999996 13.9633 21.0968 69.2428 69.2428 69.2428 -35.062799999999996 10.9633 19.0968 20.659 20.659 20.659 -35.062799999999996 11.9633 18.0968 -4.06506 -4.06506 -4.06506 -35.062799999999996 11.9633 19.0968 -19.7451 -19.7451 -19.7451 -36.062799999999996 10.9633 18.0968 -49.7141 -49.7141 -49.7141 -36.062799999999996 10.9633 19.0968 -24.6626 -24.6626 -24.6626 -36.062799999999996 11.9633 18.0968 -56.0855 -56.0855 -56.0855 -36.062799999999996 11.9633 19.0968 12.8382 12.8382 12.8382 -35.062799999999996 10.9633 20.0968 83.2749 83.2749 83.2749 -35.062799999999996 10.9633 21.0968 -28.5332 -28.5332 -28.5332 -35.062799999999996 11.9633 20.0968 58.3681 58.3681 58.3681 -35.062799999999996 11.9633 21.0968 -7.70631 -7.70631 -7.70631 -36.062799999999996 10.9633 21.0968 12.2894 12.2894 12.2894 -36.062799999999996 11.9633 20.0968 47.9379 47.9379 47.9379 -36.062799999999996 11.9633 21.0968 192.648 192.648 192.648 -35.062799999999996 12.9633 18.0968 -72.3704 -72.3704 -72.3704 -35.062799999999996 12.9633 19.0968 -30.7329 -30.7329 -30.7329 -36.062799999999996 12.9633 18.0968 -72.4873 -72.4873 -72.4873 -35.062799999999996 12.9633 20.0968 -26.0691 -26.0691 -26.0691 -35.062799999999996 12.9633 21.0968 -105.485 -105.485 -105.485 -35.062799999999996 13.9633 21.0968 95.1794 95.1794 95.1794 -36.062799999999996 12.9633 21.0968 -107.551 -107.551 -107.551 -37.062799999999996 10.9633 14.096800000000002 18.2313 18.2313 18.2313 -37.062799999999996 10.9633 15.096800000000002 -24.625 -24.625 -24.625 -37.062799999999996 11.9633 14.096800000000002 7.22874 7.22874 7.22874 -37.062799999999996 11.9633 15.096800000000002 20.9593 20.9593 20.9593 -38.062799999999996 10.9633 15.096800000000002 -4.72809 -4.72809 -4.72809 -37.062799999999996 10.9633 16.0968 -50.6087 -50.6087 -50.6087 -37.062799999999996 10.9633 17.0968 -21.9057 -21.9057 -21.9057 -37.062799999999996 11.9633 16.0968 -62.4375 -62.4375 -62.4375 -37.062799999999996 11.9633 17.0968 -5.87732 -5.87732 -5.87732 -38.062799999999996 10.9633 16.0968 16.7322 16.7322 16.7322 -38.062799999999996 10.9633 17.0968 -52.3852 -52.3852 -52.3852 -38.062799999999996 11.9633 17.0968 -81.5598 -81.5598 -81.5598 -37.062799999999996 12.9633 14.096800000000002 -50.46 -50.46 -50.46 -37.062799999999996 12.9633 15.096800000000002 -16.6483 -16.6483 -16.6483 -37.062799999999996 12.9633 16.0968 -131.003 -131.003 -131.003 -39.062799999999996 10.9633 16.0968 46.7906 46.7906 46.7906 -39.062799999999996 10.9633 17.0968 -96.5843 -96.5843 -96.5843 -39.062799999999996 11.9633 16.0968 7.16901 7.16901 7.16901 -39.062799999999996 11.9633 17.0968 44.2735 44.2735 44.2735 -40.062799999999996 10.9633 16.0968 -178.637 -178.637 -178.637 -40.062799999999996 11.9633 16.0968 -40.037 -40.037 -40.037 -40.062799999999996 11.9633 17.0968 -28.4747 -28.4747 -28.4747 -37.062799999999996 10.9633 18.0968 -35.0091 -35.0091 -35.0091 -37.062799999999996 10.9633 19.0968 -7.64368 -7.64368 -7.64368 -38.062799999999996 10.9633 18.0968 101.474 101.474 101.474 -38.062799999999996 10.9633 19.0968 0.032115 0.032115 0.032115 -38.062799999999996 11.9633 18.0968 31.537 31.537 31.537 -38.062799999999996 11.9633 19.0968 17.454 17.454 17.454 -37.062799999999996 10.9633 21.0968 -49.4595 -49.4595 -49.4595 -38.062799999999996 10.9633 20.0968 21.4129 21.4129 21.4129 -37.062799999999996 13.9633 21.0968 -2.85762 -2.85762 -2.85762 -38.062799999999996 13.9633 21.0968 20.2873 20.2873 20.2873 -39.062799999999996 10.9633 19.0968 -9.22496 -9.22496 -9.22496 -39.062799999999996 11.9633 18.0968 14.6944 14.6944 14.6944 -39.062799999999996 11.9633 19.0968 -26.8014 -26.8014 -26.8014 -40.062799999999996 10.9633 19.0968 55.5219 55.5219 55.5219 -40.062799999999996 11.9633 18.0968 7.86238 7.86238 7.86238 -40.062799999999996 11.9633 19.0968 272.364 272.364 272.364 -39.062799999999996 10.9633 20.0968 107.915 107.915 107.915 -40.062799999999996 10.9633 20.0968 -67.4736 -67.4736 -67.4736 -40.062799999999996 11.9633 20.0968 -204.784 -204.784 -204.784 -39.062799999999996 13.9633 21.0968 -1.09518 -1.09518 -1.09518 -37.062799999999996 14.9633 21.0968 34.5394 34.5394 34.5394 -37.062799999999996 15.9633 21.0968 -18.6009 -18.6009 -18.6009 -38.062799999999996 14.9633 21.0968 67.2003 67.2003 67.2003 -38.062799999999996 15.9633 21.0968 42.0733 42.0733 42.0733 -39.062799999999996 14.9633 21.0968 15.326 15.326 15.326 -41.062799999999996 10.9633 16.0968 40.3142 40.3142 40.3142 -41.062799999999996 10.9633 17.0968 -68.0241 -68.0241 -68.0241 -41.062799999999996 11.9633 16.0968 34.6523 34.6523 34.6523 -41.062799999999996 11.9633 17.0968 -42.3539 -42.3539 -42.3539 -42.062799999999996 10.9633 17.0968 -54.0952 -54.0952 -54.0952 -41.062799999999996 10.9633 18.0968 79.5444 79.5444 79.5444 -41.062799999999996 10.9633 19.0968 -225.598 -225.598 -225.598 -41.062799999999996 11.9633 18.0968 -34.0196 -34.0196 -34.0196 -41.062799999999996 11.9633 19.0968 69.6263 69.6263 69.6263 -42.062799999999996 10.9633 18.0968 209.157 209.157 209.157 -42.062799999999996 10.9633 19.0968 -54.9563 -54.9563 -54.9563 -41.062799999999996 10.9633 20.0968 -28.8356 -28.8356 -28.8356 -41.062799999999996 11.9633 20.0968 -267.373 -267.373 -267.373 -25.0628 10.9633 22.0968 2.99497 2.99497 2.99497 -25.0628 10.9633 23.0968 0.377368 0.377368 0.377368 -25.0628 11.9633 22.0968 -1.65337 -1.65337 -1.65337 -26.0628 10.9633 22.0968 0.278795 0.278795 0.278795 -26.0628 10.9633 23.0968 -3.55547 -3.55547 -3.55547 -26.0628 11.9633 22.0968 -2.1582 -2.1582 -2.1582 -26.0628 11.9633 23.0968 -4.07477 -4.07477 -4.07477 -25.0628 10.9633 24.0968 5.64156 5.64156 5.64156 -25.0628 10.9633 25.0968 0.00414637 0.00414637 0.00414637 -25.0628 11.9633 24.0968 6.28683 6.28683 6.28683 -25.0628 11.9633 25.0968 5.5642 5.5642 5.5642 -26.0628 10.9633 24.0968 -0.291745 -0.291745 -0.291745 -26.0628 10.9633 25.0968 -0.735288 -0.735288 -0.735288 -26.0628 11.9633 24.0968 -6.82151 -6.82151 -6.82151 -26.0628 11.9633 25.0968 -3.2602 -3.2602 -3.2602 -25.0628 12.9633 24.0968 5.55603 5.55603 5.55603 -25.0628 12.9633 25.0968 129.746 129.746 129.746 -25.0628 13.9633 24.0968 17.3484 17.3484 17.3484 -25.0628 13.9633 25.0968 -87.3546 -87.3546 -87.3546 -26.0628 13.9633 24.0968 -881.615 -881.615 -881.615 -26.0628 13.9633 25.0968 1315.65 1315.65 1315.65 -27.0628 10.9633 22.0968 5.61397 5.61397 5.61397 -27.0628 10.9633 23.0968 -5.60388 -5.60388 -5.60388 -27.0628 11.9633 22.0968 8.13609 8.13609 8.13609 -28.0628 10.9633 22.0968 -2.39676 -2.39676 -2.39676 -28.0628 10.9633 23.0968 3.99916 3.99916 3.99916 -28.0628 11.9633 22.0968 10.3797 10.3797 10.3797 -27.0628 10.9633 24.0968 -0.121203 -0.121203 -0.121203 -27.0628 10.9633 25.0968 4.81506 4.81506 4.81506 -27.0628 11.9633 25.0968 12.5419 12.5419 12.5419 -28.0628 10.9633 25.0968 2.74606 2.74606 2.74606 -28.0628 11.9633 25.0968 357.995 357.995 357.995 -28.0628 12.9633 25.0968 390.298 390.298 390.298 -25.0628 10.9633 26.0968 41.1199 41.1199 41.1199 -25.0628 11.9633 26.0968 42.4612 42.4612 42.4612 -26.0628 10.9633 26.0968 -4.27615 -4.27615 -4.27615 -26.0628 11.9633 26.0968 10.4032 10.4032 10.4032 -26.0628 11.9633 27.0968 -70.587 -70.587 -70.587 -25.0628 10.9633 28.0968 -61.8561 -61.8561 -61.8561 -25.0628 10.9633 29.0968 -1.32142 -1.32142 -1.32142 -25.0628 11.9633 28.0968 -22.2495 -22.2495 -22.2495 -25.0628 11.9633 29.0968 0.331543 0.331543 0.331543 -26.0628 10.9633 29.0968 -10.1755 -10.1755 -10.1755 -26.0628 11.9633 28.0968 50.5514 50.5514 50.5514 -26.0628 11.9633 29.0968 -4.78246 -4.78246 -4.78246 -25.0628 12.9633 26.0968 -54.0891 -54.0891 -54.0891 -25.0628 12.9633 27.0968 28.678 28.678 28.678 -25.0628 13.9633 26.0968 4.31443 4.31443 4.31443 -25.0628 13.9633 27.0968 -2.56672 -2.56672 -2.56672 -26.0628 12.9633 26.0968 -10.9794 -10.9794 -10.9794 -26.0628 12.9633 27.0968 -2.36233 -2.36233 -2.36233 -26.0628 13.9633 26.0968 -69.7054 -69.7054 -69.7054 -26.0628 13.9633 27.0968 2.42255 2.42255 2.42255 -25.0628 12.9633 28.0968 40.1928 40.1928 40.1928 -25.0628 12.9633 29.0968 2.09457 2.09457 2.09457 -25.0628 13.9633 28.0968 -2.49306 -2.49306 -2.49306 -25.0628 13.9633 29.0968 3.21287 3.21287 3.21287 -26.0628 12.9633 28.0968 8.40752 8.40752 8.40752 -26.0628 12.9633 29.0968 10.0926 10.0926 10.0926 -26.0628 13.9633 28.0968 4.77066 4.77066 4.77066 -26.0628 13.9633 29.0968 4.30425 4.30425 4.30425 -27.0628 11.9633 26.0968 20.9414 20.9414 20.9414 -27.0628 11.9633 27.0968 -6.62362 -6.62362 -6.62362 -28.0628 11.9633 26.0968 745.215 745.215 745.215 -28.0628 11.9633 27.0968 -48.0403 -48.0403 -48.0403 -27.0628 10.9633 29.0968 -20.3116 -20.3116 -20.3116 -28.0628 10.9633 28.0968 -158.178 -158.178 -158.178 -28.0628 10.9633 29.0968 38.432 38.432 38.432 -28.0628 11.9633 29.0968 49.1919 49.1919 49.1919 -27.0628 12.9633 27.0968 1.73641 1.73641 1.73641 -27.0628 13.9633 27.0968 1.15712 1.15712 1.15712 -28.0628 12.9633 26.0968 1050.36 1050.36 1050.36 -28.0628 12.9633 27.0968 3.27418 3.27418 3.27418 -28.0628 13.9633 26.0968 167.551 167.551 167.551 -28.0628 13.9633 27.0968 0.768774 0.768774 0.768774 -27.0628 12.9633 29.0968 -17.036 -17.036 -17.036 -27.0628 13.9633 28.0968 -0.941718 -0.941718 -0.941718 -27.0628 13.9633 29.0968 -11.647 -11.647 -11.647 -28.0628 12.9633 28.0968 0.929005 0.929005 0.929005 -28.0628 12.9633 29.0968 0.770526 0.770526 0.770526 -28.0628 13.9633 28.0968 -6.89722 -6.89722 -6.89722 -28.0628 13.9633 29.0968 1.7287 1.7287 1.7287 -25.0628 14.9633 24.0968 146.033 146.033 146.033 -25.0628 15.9633 24.0968 2.03255 2.03255 2.03255 -25.0628 15.9633 25.0968 0.86996 0.86996 0.86996 -26.0628 14.9633 24.0968 -1123.38 -1123.38 -1123.38 -26.0628 14.9633 25.0968 317.534 317.534 317.534 -26.0628 15.9633 24.0968 380.039 380.039 380.039 -26.0628 15.9633 25.0968 240.717 240.717 240.717 -25.0628 16.9633 22.0968 20.6036 20.6036 20.6036 -25.0628 17.9633 22.0968 5.96352 5.96352 5.96352 -25.0628 17.9633 23.0968 -19.62 -19.62 -19.62 -26.0628 17.9633 22.0968 7.8739 7.8739 7.8739 -26.0628 17.9633 23.0968 -18.4627 -18.4627 -18.4627 -25.0628 16.9633 25.0968 49.9203 49.9203 49.9203 -25.0628 17.9633 24.0968 -14.1814 -14.1814 -14.1814 -25.0628 17.9633 25.0968 -10.7601 -10.7601 -10.7601 -26.0628 16.9633 24.0968 -4.64353 -4.64353 -4.64353 -26.0628 16.9633 25.0968 -49.3896 -49.3896 -49.3896 -26.0628 17.9633 24.0968 98.1609 98.1609 98.1609 -26.0628 17.9633 25.0968 35.5793 35.5793 35.5793 -27.0628 14.9633 25.0968 -1283.32 -1283.32 -1283.32 -27.0628 15.9633 25.0968 -635.294 -635.294 -635.294 -28.0628 15.9633 25.0968 482.739 482.739 482.739 -27.0628 16.9633 24.0968 -426.442 -426.442 -426.442 -27.0628 16.9633 25.0968 -18.5386 -18.5386 -18.5386 -27.0628 17.9633 24.0968 -18.8711 -18.8711 -18.8711 -27.0628 17.9633 25.0968 -157.368 -157.368 -157.368 -28.0628 16.9633 25.0968 -146.996 -146.996 -146.996 -28.0628 17.9633 25.0968 41.1481 41.1481 41.1481 -25.0628 14.9633 27.0968 4.43317 4.43317 4.43317 -25.0628 15.9633 26.0968 -4.53559 -4.53559 -4.53559 -25.0628 15.9633 27.0968 13.6499 13.6499 13.6499 -26.0628 14.9633 26.0968 -79.0693 -79.0693 -79.0693 -26.0628 14.9633 27.0968 0.372511 0.372511 0.372511 -26.0628 15.9633 26.0968 -48.3614 -48.3614 -48.3614 -26.0628 15.9633 27.0968 -4.06149 -4.06149 -4.06149 -25.0628 14.9633 28.0968 -2.1186 -2.1186 -2.1186 -25.0628 14.9633 29.0968 1.7281 1.7281 1.7281 -25.0628 15.9633 28.0968 11.3326 11.3326 11.3326 -25.0628 15.9633 29.0968 4.27972 4.27972 4.27972 -26.0628 14.9633 28.0968 11.7266 11.7266 11.7266 -26.0628 14.9633 29.0968 -1.95912 -1.95912 -1.95912 -26.0628 15.9633 28.0968 -2.22018 -2.22018 -2.22018 -25.0628 16.9633 26.0968 1.10788 1.10788 1.10788 -25.0628 16.9633 27.0968 7.3601 7.3601 7.3601 -25.0628 17.9633 26.0968 8.59803 8.59803 8.59803 -25.0628 17.9633 27.0968 1.60734 1.60734 1.60734 -26.0628 16.9633 27.0968 11.1066 11.1066 11.1066 -26.0628 17.9633 27.0968 1.17732 1.17732 1.17732 -25.0628 16.9633 28.0968 3.90707 3.90707 3.90707 -25.0628 17.9633 28.0968 0.843892 0.843892 0.843892 -25.0628 17.9633 29.0968 8.52482 8.52482 8.52482 -26.0628 16.9633 28.0968 -1.02385 -1.02385 -1.02385 -26.0628 17.9633 28.0968 25.0121 25.0121 25.0121 -26.0628 17.9633 29.0968 22.0517 22.0517 22.0517 -27.0628 14.9633 26.0968 103.534 103.534 103.534 -27.0628 15.9633 26.0968 41.8542 41.8542 41.8542 -27.0628 15.9633 27.0968 -6.6597 -6.6597 -6.6597 -28.0628 14.9633 26.0968 165.033 165.033 165.033 -28.0628 14.9633 27.0968 5.31687 5.31687 5.31687 -28.0628 15.9633 26.0968 44.5962 44.5962 44.5962 -28.0628 15.9633 27.0968 28.1245 28.1245 28.1245 -27.0628 14.9633 28.0968 -5.67355 -5.67355 -5.67355 -27.0628 14.9633 29.0968 -2.00068 -2.00068 -2.00068 -27.0628 15.9633 28.0968 -10.5766 -10.5766 -10.5766 -27.0628 15.9633 29.0968 -4.26927 -4.26927 -4.26927 -28.0628 14.9633 28.0968 -0.59649 -0.59649 -0.59649 -28.0628 14.9633 29.0968 0.73135 0.73135 0.73135 -28.0628 15.9633 28.0968 -1.58614 -1.58614 -1.58614 -28.0628 15.9633 29.0968 1.48109 1.48109 1.48109 -27.0628 16.9633 27.0968 -1.75576 -1.75576 -1.75576 -27.0628 17.9633 26.0968 52.7634 52.7634 52.7634 -27.0628 17.9633 27.0968 -16.2273 -16.2273 -16.2273 -28.0628 16.9633 26.0968 46.5302 46.5302 46.5302 -28.0628 16.9633 27.0968 -15.2873 -15.2873 -15.2873 -28.0628 17.9633 26.0968 118.886 118.886 118.886 -28.0628 17.9633 27.0968 -21.1121 -21.1121 -21.1121 -27.0628 16.9633 28.0968 -11.0037 -11.0037 -11.0037 -27.0628 16.9633 29.0968 -9.18606 -9.18606 -9.18606 -27.0628 17.9633 28.0968 -25.4529 -25.4529 -25.4529 -27.0628 17.9633 29.0968 3.08154 3.08154 3.08154 -28.0628 16.9633 29.0968 4.16698 4.16698 4.16698 -28.0628 17.9633 29.0968 -11.198 -11.198 -11.198 -29.0628 10.9633 22.0968 1.74398 1.74398 1.74398 -29.0628 10.9633 23.0968 2.47534 2.47534 2.47534 -29.0628 11.9633 22.0968 -12.2315 -12.2315 -12.2315 -29.0628 11.9633 23.0968 9.25372 9.25372 9.25372 -30.0628 10.9633 23.0968 2.41989 2.41989 2.41989 -30.0628 11.9633 22.0968 -27.4612 -27.4612 -27.4612 -30.0628 11.9633 23.0968 -21.8697 -21.8697 -21.8697 -29.0628 10.9633 24.0968 -1.57777 -1.57777 -1.57777 -29.0628 10.9633 25.0968 3.03976 3.03976 3.03976 -29.0628 11.9633 24.0968 -725.488 -725.488 -725.488 -29.0628 11.9633 25.0968 1012.93 1012.93 1012.93 -30.0628 10.9633 24.0968 2.09156 2.09156 2.09156 -30.0628 10.9633 25.0968 -8.36217 -8.36217 -8.36217 -30.0628 11.9633 24.0968 -1056.41 -1056.41 -1056.41 -30.0628 11.9633 25.0968 344.288 344.288 344.288 -29.0628 12.9633 22.0968 15.2552 15.2552 15.2552 -30.0628 12.9633 22.0968 -120.864 -120.864 -120.864 -30.0628 12.9633 23.0968 138.12 138.12 138.12 -29.0628 12.9633 24.0968 -753.548 -753.548 -753.548 -29.0628 12.9633 25.0968 -221.013 -221.013 -221.013 -29.0628 13.9633 25.0968 774.863 774.863 774.863 -30.0628 12.9633 24.0968 -2026.06 -2026.06 -2026.06 -30.0628 12.9633 25.0968 -675.44 -675.44 -675.44 -30.0628 13.9633 24.0968 914.429 914.429 914.429 -30.0628 13.9633 25.0968 -314.675 -314.675 -314.675 -31.0628 10.9633 22.0968 477.694 477.694 477.694 -31.0628 10.9633 23.0968 428.887 428.887 428.887 -31.0628 11.9633 22.0968 101.237 101.237 101.237 -31.0628 11.9633 23.0968 -206.2 -206.2 -206.2 -32.062799999999996 10.9633 22.0968 354.209 354.209 354.209 -32.062799999999996 10.9633 23.0968 78.0273 78.0273 78.0273 -32.062799999999996 11.9633 22.0968 91.5386 91.5386 91.5386 -32.062799999999996 11.9633 23.0968 152.509 152.509 152.509 -31.0628 10.9633 24.0968 -74.3621 -74.3621 -74.3621 -31.0628 10.9633 25.0968 -17.479 -17.479 -17.479 -32.062799999999996 10.9633 24.0968 -180.184 -180.184 -180.184 -32.062799999999996 10.9633 25.0968 -76.4339 -76.4339 -76.4339 -31.0628 12.9633 22.0968 -1.57069 -1.57069 -1.57069 -31.0628 12.9633 23.0968 39.8992 39.8992 39.8992 -31.0628 13.9633 23.0968 167.801 167.801 167.801 -32.062799999999996 12.9633 22.0968 -13.3225 -13.3225 -13.3225 -32.062799999999996 12.9633 23.0968 1.84306 1.84306 1.84306 -32.062799999999996 13.9633 22.0968 -24.3658 -24.3658 -24.3658 -32.062799999999996 13.9633 23.0968 67.2348 67.2348 67.2348 -31.0628 13.9633 24.0968 2.44142 2.44142 2.44142 -31.0628 13.9633 25.0968 39.1773 39.1773 39.1773 -32.062799999999996 13.9633 24.0968 14.0726 14.0726 14.0726 -32.062799999999996 13.9633 25.0968 -0.05718 -0.05718 -0.05718 -29.0628 11.9633 27.0968 -12.97 -12.97 -12.97 -30.0628 11.9633 27.0968 17.2877 17.2877 17.2877 -29.0628 10.9633 28.0968 -3.02161 -3.02161 -3.02161 -29.0628 10.9633 29.0968 4.17739 4.17739 4.17739 -29.0628 11.9633 28.0968 -9.03687 -9.03687 -9.03687 -29.0628 11.9633 29.0968 1.83436 1.83436 1.83436 -30.0628 10.9633 28.0968 -73.2029 -73.2029 -73.2029 -30.0628 10.9633 29.0968 3.92926 3.92926 3.92926 -30.0628 11.9633 28.0968 7.09947 7.09947 7.09947 -30.0628 11.9633 29.0968 -0.767167 -0.767167 -0.767167 -29.0628 12.9633 26.0968 -472.061 -472.061 -472.061 -29.0628 12.9633 27.0968 3.13302 3.13302 3.13302 -29.0628 13.9633 26.0968 473.9 473.9 473.9 -29.0628 13.9633 27.0968 7.39483 7.39483 7.39483 -30.0628 12.9633 26.0968 290.521 290.521 290.521 -30.0628 12.9633 27.0968 -7.60158 -7.60158 -7.60158 -30.0628 13.9633 26.0968 -327.864 -327.864 -327.864 -30.0628 13.9633 27.0968 -6.44199 -6.44199 -6.44199 -29.0628 12.9633 28.0968 0.476707 0.476707 0.476707 -29.0628 12.9633 29.0968 -5.52059 -5.52059 -5.52059 -29.0628 13.9633 28.0968 -5.98245 -5.98245 -5.98245 -29.0628 13.9633 29.0968 6.65651 6.65651 6.65651 -30.0628 12.9633 28.0968 7.01273 7.01273 7.01273 -30.0628 12.9633 29.0968 9.39639 9.39639 9.39639 -30.0628 13.9633 28.0968 1.82566 1.82566 1.82566 -30.0628 13.9633 29.0968 30.6985 30.6985 30.6985 -32.062799999999996 10.9633 26.0968 104.989 104.989 104.989 -32.062799999999996 10.9633 27.0968 -20.322 -20.322 -20.322 -31.0628 10.9633 28.0968 -44.3277 -44.3277 -44.3277 -31.0628 10.9633 29.0968 2.65394 2.65394 2.65394 -31.0628 11.9633 29.0968 -4.47548 -4.47548 -4.47548 -32.062799999999996 11.9633 29.0968 7.51604 7.51604 7.51604 -31.0628 12.9633 26.0968 88.666 88.666 88.666 -31.0628 12.9633 27.0968 29.6533 29.6533 29.6533 -31.0628 13.9633 26.0968 21.6811 21.6811 21.6811 -31.0628 13.9633 27.0968 14.5282 14.5282 14.5282 -32.062799999999996 12.9633 27.0968 2.51153 2.51153 2.51153 -32.062799999999996 13.9633 26.0968 -25.0141 -25.0141 -25.0141 -32.062799999999996 13.9633 27.0968 -1.8605 -1.8605 -1.8605 -31.0628 13.9633 28.0968 -1.58879 -1.58879 -1.58879 -32.062799999999996 12.9633 28.0968 -11.309 -11.309 -11.309 -32.062799999999996 13.9633 28.0968 0.257994 0.257994 0.257994 -29.0628 14.9633 25.0968 752.053 752.053 752.053 -29.0628 15.9633 25.0968 355.12 355.12 355.12 -30.0628 14.9633 25.0968 -77.1922 -77.1922 -77.1922 -30.0628 15.9633 25.0968 -78.7576 -78.7576 -78.7576 -29.0628 14.9633 26.0968 14.2512 14.2512 14.2512 -29.0628 15.9633 26.0968 -37.056 -37.056 -37.056 -29.0628 15.9633 27.0968 18.7225 18.7225 18.7225 -30.0628 14.9633 26.0968 50.7362 50.7362 50.7362 -30.0628 15.9633 26.0968 -46.6094 -46.6094 -46.6094 -30.0628 15.9633 27.0968 10.9875 10.9875 10.9875 -29.0628 14.9633 28.0968 -4.12425 -4.12425 -4.12425 -29.0628 14.9633 29.0968 -2.17859 -2.17859 -2.17859 -29.0628 15.9633 28.0968 -0.764236 -0.764236 -0.764236 -30.0628 14.9633 28.0968 -2.89712 -2.89712 -2.89712 -30.0628 14.9633 29.0968 -24.1822 -24.1822 -24.1822 -30.0628 15.9633 28.0968 3.63892 3.63892 3.63892 -30.0628 15.9633 29.0968 -23.1348 -23.1348 -23.1348 -29.0628 16.9633 26.0968 132.378 132.378 132.378 -29.0628 16.9633 27.0968 -6.51369 -6.51369 -6.51369 -30.0628 16.9633 26.0968 23.1355 23.1355 23.1355 -30.0628 16.9633 27.0968 -7.51299 -7.51299 -7.51299 -30.0628 16.9633 28.0968 8.48252 8.48252 8.48252 -30.0628 16.9633 29.0968 1.37375 1.37375 1.37375 -30.0628 17.9633 28.0968 -9.14827 -9.14827 -9.14827 -30.0628 17.9633 29.0968 -2.16832 -2.16832 -2.16832 -31.0628 14.9633 26.0968 -7.10637 -7.10637 -7.10637 -31.0628 14.9633 27.0968 26.614 26.614 26.614 -31.0628 15.9633 26.0968 -45.8459 -45.8459 -45.8459 -31.0628 15.9633 27.0968 4.73298 4.73298 4.73298 -32.062799999999996 14.9633 27.0968 -5.08394 -5.08394 -5.08394 -32.062799999999996 15.9633 27.0968 4.33821 4.33821 4.33821 -31.0628 14.9633 28.0968 -4.89385 -4.89385 -4.89385 -31.0628 15.9633 28.0968 7.67003 7.67003 7.67003 -31.0628 15.9633 29.0968 -5.97892 -5.97892 -5.97892 -32.062799999999996 14.9633 28.0968 12.5112 12.5112 12.5112 -31.0628 16.9633 27.0968 -14.1601 -14.1601 -14.1601 -31.0628 17.9633 27.0968 0.859089 0.859089 0.859089 -32.062799999999996 16.9633 27.0968 -12.7875 -12.7875 -12.7875 -32.062799999999996 17.9633 27.0968 2.19731 2.19731 2.19731 -31.0628 16.9633 28.0968 16.561 16.561 16.561 -31.0628 17.9633 28.0968 1.6182 1.6182 1.6182 -31.0628 17.9633 29.0968 3.21588 3.21588 3.21588 -32.062799999999996 17.9633 28.0968 -9.06869 -9.06869 -9.06869 -32.062799999999996 17.9633 29.0968 22.6568 22.6568 22.6568 -25.0628 11.9633 30.0968 -0.345897 -0.345897 -0.345897 -26.0628 10.9633 30.0968 1.5814 1.5814 1.5814 -26.0628 10.9633 31.0968 -3.6882 -3.6882 -3.6882 -26.0628 11.9633 30.0968 10.013 10.013 10.013 -26.0628 11.9633 31.0968 -3.09519 -3.09519 -3.09519 -26.0628 10.9633 32.0968 1.23101 1.23101 1.23101 -26.0628 11.9633 32.0968 46.0249 46.0249 46.0249 -26.0628 11.9633 33.0968 23.2401 23.2401 23.2401 -25.0628 12.9633 30.0968 -0.692176 -0.692176 -0.692176 -25.0628 12.9633 31.0968 -0.307759 -0.307759 -0.307759 -25.0628 13.9633 30.0968 -1.06022 -1.06022 -1.06022 -25.0628 13.9633 31.0968 -0.102426 -0.102426 -0.102426 -26.0628 12.9633 30.0968 2.00333 2.00333 2.00333 -26.0628 12.9633 31.0968 -0.356071 -0.356071 -0.356071 -26.0628 13.9633 30.0968 8.38051 8.38051 8.38051 -26.0628 13.9633 31.0968 -0.701133 -0.701133 -0.701133 -25.0628 12.9633 33.0968 -0.462619 -0.462619 -0.462619 -25.0628 13.9633 32.0968 0.222723 0.222723 0.222723 -25.0628 13.9633 33.0968 -0.562169 -0.562169 -0.562169 -26.0628 12.9633 32.0968 1.20544 1.20544 1.20544 -26.0628 12.9633 33.0968 0.468231 0.468231 0.468231 -26.0628 13.9633 32.0968 -0.455883 -0.455883 -0.455883 -26.0628 13.9633 33.0968 0.0380195 0.0380195 0.0380195 -27.0628 10.9633 30.0968 -3.17813 -3.17813 -3.17813 -27.0628 10.9633 31.0968 -1.54432 -1.54432 -1.54432 -27.0628 11.9633 30.0968 9.36319 9.36319 9.36319 -27.0628 11.9633 31.0968 -2.36115 -2.36115 -2.36115 -28.0628 10.9633 30.0968 4.50635 4.50635 4.50635 -28.0628 10.9633 31.0968 -0.463055 -0.463055 -0.463055 -28.0628 11.9633 30.0968 1.56552 1.56552 1.56552 -28.0628 11.9633 31.0968 -4.03179 -4.03179 -4.03179 -27.0628 10.9633 32.0968 0.0224451 0.0224451 0.0224451 -27.0628 11.9633 32.0968 -0.0058161 -0.0058161 -0.0058161 -28.0628 10.9633 32.0968 -2.32668 -2.32668 -2.32668 -28.0628 10.9633 33.0968 0.801457 0.801457 0.801457 -28.0628 11.9633 32.0968 1.17835 1.17835 1.17835 -28.0628 11.9633 33.0968 -2.10009 -2.10009 -2.10009 -27.0628 12.9633 30.0968 -6.81461 -6.81461 -6.81461 -27.0628 13.9633 30.0968 5.5296 5.5296 5.5296 -27.0628 13.9633 31.0968 2.08703 2.08703 2.08703 -28.0628 12.9633 30.0968 -8.29652 -8.29652 -8.29652 -28.0628 12.9633 31.0968 -10.5683 -10.5683 -10.5683 -28.0628 13.9633 30.0968 6.49177 6.49177 6.49177 -28.0628 13.9633 31.0968 -1.8708 -1.8708 -1.8708 -27.0628 12.9633 32.0968 -0.346332 -0.346332 -0.346332 -27.0628 12.9633 33.0968 0.0607346 0.0607346 0.0607346 -27.0628 13.9633 32.0968 -2.23502 -2.23502 -2.23502 -27.0628 13.9633 33.0968 0.532025 0.532025 0.532025 -28.0628 12.9633 32.0968 -0.0612053 -0.0612053 -0.0612053 -28.0628 13.9633 32.0968 -5.50239 -5.50239 -5.50239 -25.0628 10.9633 35.0968 -0.554007 -0.554007 -0.554007 -25.0628 11.9633 35.0968 1.4774 1.4774 1.4774 -26.0628 10.9633 35.0968 -0.901154 -0.901154 -0.901154 -26.0628 11.9633 34.0968 -0.826229 -0.826229 -0.826229 -26.0628 11.9633 35.0968 -0.164214 -0.164214 -0.164214 -25.0628 10.9633 36.0968 1.78567 1.78567 1.78567 -25.0628 11.9633 36.0968 -1.40279 -1.40279 -1.40279 -26.0628 11.9633 36.0968 -1.08857 -1.08857 -1.08857 -25.0628 12.9633 35.0968 0.83358 0.83358 0.83358 -25.0628 13.9633 34.0968 -0.195317 -0.195317 -0.195317 -25.0628 13.9633 35.0968 -0.133481 -0.133481 -0.133481 -26.0628 12.9633 34.0968 1.14843 1.14843 1.14843 -26.0628 12.9633 35.0968 0.129391 0.129391 0.129391 -26.0628 13.9633 34.0968 -0.404256 -0.404256 -0.404256 -25.0628 12.9633 36.0968 -0.495238 -0.495238 -0.495238 -25.0628 13.9633 36.0968 -0.405968 -0.405968 -0.405968 -26.0628 12.9633 36.0968 -1.05786 -1.05786 -1.05786 -26.0628 13.9633 36.0968 -1.36353 -1.36353 -1.36353 -26.0628 13.9633 37.0968 -0.87279 -0.87279 -0.87279 -27.0628 10.9633 35.0968 -3.45689 -3.45689 -3.45689 -27.0628 11.9633 34.0968 2.13133 2.13133 2.13133 -27.0628 11.9633 35.0968 1.07231 1.07231 1.07231 -28.0628 10.9633 34.0968 9.70427 9.70427 9.70427 -28.0628 10.9633 35.0968 5.27976 5.27976 5.27976 -28.0628 11.9633 34.0968 2.20238 2.20238 2.20238 -28.0628 11.9633 35.0968 1.47696 1.47696 1.47696 -27.0628 12.9633 34.0968 0.369264 0.369264 0.369264 -27.0628 12.9633 35.0968 -0.475773 -0.475773 -0.475773 -27.0628 13.9633 34.0968 -0.760354 -0.760354 -0.760354 -28.0628 12.9633 34.0968 -1.05525 -1.05525 -1.05525 -28.0628 12.9633 35.0968 1.0543 1.0543 1.0543 -28.0628 13.9633 34.0968 0.217937 0.217937 0.217937 -28.0628 13.9633 35.0968 -0.62143 -0.62143 -0.62143 -27.0628 12.9633 36.0968 1.17174 1.17174 1.17174 -27.0628 13.9633 36.0968 -0.388505 -0.388505 -0.388505 -27.0628 13.9633 37.0968 -1.95528 -1.95528 -1.95528 -28.0628 12.9633 36.0968 0.609814 0.609814 0.609814 -28.0628 13.9633 36.0968 2.80429 2.80429 2.80429 -25.0628 14.9633 30.0968 6.70411 6.70411 6.70411 -25.0628 14.9633 31.0968 0.973626 0.973626 0.973626 -25.0628 15.9633 30.0968 0.398539 0.398539 0.398539 -25.0628 15.9633 31.0968 -2.4709 -2.4709 -2.4709 -26.0628 14.9633 31.0968 -0.0318849 -0.0318849 -0.0318849 -26.0628 15.9633 31.0968 0.547286 0.547286 0.547286 -25.0628 14.9633 32.0968 -0.601668 -0.601668 -0.601668 -25.0628 14.9633 33.0968 2.05537 2.05537 2.05537 -25.0628 15.9633 32.0968 -8.99959 -8.99959 -8.99959 -25.0628 15.9633 33.0968 -1.15563 -1.15563 -1.15563 -26.0628 14.9633 33.0968 -0.577014 -0.577014 -0.577014 -26.0628 15.9633 33.0968 -0.734685 -0.734685 -0.734685 -25.0628 16.9633 31.0968 -3.89808 -3.89808 -3.89808 -25.0628 17.9633 30.0968 -0.237471 -0.237471 -0.237471 -25.0628 17.9633 31.0968 9.88086 9.88086 9.88086 -26.0628 16.9633 31.0968 2.2622 2.2622 2.2622 -26.0628 17.9633 30.0968 5.49616 5.49616 5.49616 -26.0628 17.9633 31.0968 15.6014 15.6014 15.6014 -25.0628 16.9633 32.0968 -3.59326 -3.59326 -3.59326 -25.0628 16.9633 33.0968 -0.462285 -0.462285 -0.462285 -26.0628 16.9633 32.0968 -12.0942 -12.0942 -12.0942 -26.0628 16.9633 33.0968 -3.03998 -3.03998 -3.03998 -28.0628 14.9633 30.0968 -0.247509 -0.247509 -0.247509 -28.0628 15.9633 30.0968 0.861485 0.861485 0.861485 -28.0628 15.9633 31.0968 1.02048 1.02048 1.02048 -28.0628 14.9633 32.0968 -3.44283 -3.44283 -3.44283 -28.0628 15.9633 32.0968 -0.486258 -0.486258 -0.486258 -27.0628 16.9633 30.0968 6.42005 6.42005 6.42005 -27.0628 16.9633 31.0968 4.83362 4.83362 4.83362 -27.0628 17.9633 30.0968 -10.3228 -10.3228 -10.3228 -27.0628 17.9633 31.0968 14.2882 14.2882 14.2882 -28.0628 16.9633 30.0968 -4.52134 -4.52134 -4.52134 -28.0628 16.9633 31.0968 -3.3311 -3.3311 -3.3311 -28.0628 17.9633 30.0968 -2.77829 -2.77829 -2.77829 -27.0628 16.9633 32.0968 -13.8073 -13.8073 -13.8073 -27.0628 16.9633 33.0968 -3.94321 -3.94321 -3.94321 -28.0628 16.9633 32.0968 -0.974631 -0.974631 -0.974631 -28.0628 16.9633 33.0968 0.92747 0.92747 0.92747 -25.0628 14.9633 34.0968 2.59164 2.59164 2.59164 -25.0628 14.9633 35.0968 0.0383125 0.0383125 0.0383125 -25.0628 15.9633 34.0968 2.24032 2.24032 2.24032 -25.0628 15.9633 35.0968 -0.172743 -0.172743 -0.172743 -26.0628 14.9633 34.0968 -0.355818 -0.355818 -0.355818 -26.0628 15.9633 34.0968 3.46508 3.46508 3.46508 -26.0628 15.9633 35.0968 1.51943 1.51943 1.51943 -25.0628 14.9633 36.0968 0.0580548 0.0580548 0.0580548 -25.0628 15.9633 36.0968 0.147222 0.147222 0.147222 -26.0628 14.9633 36.0968 0.581627 0.581627 0.581627 -26.0628 14.9633 37.0968 0.62909 0.62909 0.62909 -26.0628 15.9633 36.0968 1.06636 1.06636 1.06636 -26.0628 16.9633 34.0968 2.30226 2.30226 2.30226 -26.0628 16.9633 35.0968 2.11374 2.11374 2.11374 -26.0628 16.9633 36.0968 -4.9413 -4.9413 -4.9413 -28.0628 14.9633 35.0968 3.1505 3.1505 3.1505 -28.0628 15.9633 34.0968 4.44879 4.44879 4.44879 -28.0628 15.9633 35.0968 4.71069 4.71069 4.71069 -27.0628 14.9633 36.0968 -1.21068 -1.21068 -1.21068 -27.0628 14.9633 37.0968 -2.19796 -2.19796 -2.19796 -27.0628 15.9633 36.0968 -1.12125 -1.12125 -1.12125 -28.0628 14.9633 36.0968 1.88605 1.88605 1.88605 -28.0628 15.9633 36.0968 -3.02421 -3.02421 -3.02421 -27.0628 16.9633 34.0968 2.42348 2.42348 2.42348 -27.0628 16.9633 35.0968 -0.665545 -0.665545 -0.665545 -28.0628 16.9633 34.0968 -3.87668 -3.87668 -3.87668 -28.0628 16.9633 35.0968 2.33294 2.33294 2.33294 -27.0628 16.9633 36.0968 -0.55892 -0.55892 -0.55892 -28.0628 16.9633 36.0968 1.45456 1.45456 1.45456 -29.0628 10.9633 30.0968 -4.8711 -4.8711 -4.8711 -29.0628 10.9633 31.0968 8.46148 8.46148 8.46148 -29.0628 11.9633 30.0968 -2.88716 -2.88716 -2.88716 -30.0628 10.9633 30.0968 14.9125 14.9125 14.9125 -30.0628 10.9633 31.0968 -5.35643 -5.35643 -5.35643 -30.0628 11.9633 30.0968 10.3737 10.3737 10.3737 -29.0628 10.9633 32.0968 -15.4674 -15.4674 -15.4674 -29.0628 10.9633 33.0968 -8.95879 -8.95879 -8.95879 -29.0628 11.9633 32.0968 18.7998 18.7998 18.7998 -29.0628 11.9633 33.0968 2.22426 2.22426 2.22426 -30.0628 10.9633 32.0968 -0.11326 -0.11326 -0.11326 -30.0628 10.9633 33.0968 -20.4654 -20.4654 -20.4654 -30.0628 11.9633 32.0968 15.6409 15.6409 15.6409 -29.0628 12.9633 30.0968 -17.4351 -17.4351 -17.4351 -29.0628 12.9633 31.0968 -25.1139 -25.1139 -25.1139 -29.0628 13.9633 30.0968 2.04919 2.04919 2.04919 -29.0628 13.9633 31.0968 9.04323 9.04323 9.04323 -30.0628 12.9633 30.0968 -10.1193 -10.1193 -10.1193 -30.0628 13.9633 30.0968 -8.56279 -8.56279 -8.56279 -30.0628 13.9633 31.0968 -3.23421 -3.23421 -3.23421 -29.0628 12.9633 32.0968 7.35013 7.35013 7.35013 -29.0628 12.9633 33.0968 -4.17765 -4.17765 -4.17765 -29.0628 13.9633 32.0968 0.813472 0.813472 0.813472 -30.0628 12.9633 32.0968 15.2717 15.2717 15.2717 -30.0628 12.9633 33.0968 -8.26472 -8.26472 -8.26472 -30.0628 13.9633 32.0968 -2.54428 -2.54428 -2.54428 -30.0628 13.9633 33.0968 -4.10369 -4.10369 -4.10369 -31.0628 10.9633 30.0968 -7.3929 -7.3929 -7.3929 -31.0628 10.9633 31.0968 2.40258 2.40258 2.40258 -31.0628 11.9633 30.0968 -1.04925 -1.04925 -1.04925 -32.062799999999996 10.9633 30.0968 0.115903 0.115903 0.115903 -32.062799999999996 10.9633 31.0968 12.8725 12.8725 12.8725 -32.062799999999996 11.9633 30.0968 1.24613 1.24613 1.24613 -32.062799999999996 11.9633 31.0968 -11.0853 -11.0853 -11.0853 -31.0628 10.9633 32.0968 5.97926 5.97926 5.97926 -31.0628 11.9633 32.0968 4.36704 4.36704 4.36704 -32.062799999999996 11.9633 32.0968 0.525537 0.525537 0.525537 -31.0628 13.9633 31.0968 18.3198 18.3198 18.3198 -32.062799999999996 12.9633 31.0968 -26.6783 -26.6783 -26.6783 -32.062799999999996 13.9633 31.0968 16.9395 16.9395 16.9395 -31.0628 12.9633 32.0968 9.83913 9.83913 9.83913 -31.0628 12.9633 33.0968 3.22928 3.22928 3.22928 -31.0628 13.9633 32.0968 -8.80238 -8.80238 -8.80238 -32.062799999999996 12.9633 32.0968 -1.37766 -1.37766 -1.37766 -32.062799999999996 13.9633 32.0968 -5.39959 -5.39959 -5.39959 -29.0628 10.9633 34.0968 3.03314 3.03314 3.03314 -29.0628 11.9633 34.0968 0.308199 0.308199 0.308199 -29.0628 12.9633 34.0968 -8.19328 -8.19328 -8.19328 -29.0628 12.9633 35.0968 -2.7242 -2.7242 -2.7242 -29.0628 13.9633 34.0968 -1.09046 -1.09046 -1.09046 -29.0628 13.9633 35.0968 -4.78256 -4.78256 -4.78256 -30.0628 12.9633 34.0968 -0.730355 -0.730355 -0.730355 -30.0628 13.9633 34.0968 -0.966276 -0.966276 -0.966276 -29.0628 14.9633 30.0968 8.76442 8.76442 8.76442 -29.0628 14.9633 31.0968 -0.284511 -0.284511 -0.284511 -29.0628 15.9633 30.0968 1.54844 1.54844 1.54844 -29.0628 15.9633 31.0968 3.32524 3.32524 3.32524 -30.0628 14.9633 30.0968 -7.71199 -7.71199 -7.71199 -30.0628 14.9633 31.0968 28.4353 28.4353 28.4353 -30.0628 15.9633 30.0968 3.87384 3.87384 3.87384 -30.0628 15.9633 31.0968 1.27462 1.27462 1.27462 -29.0628 14.9633 32.0968 -4.70234 -4.70234 -4.70234 -29.0628 14.9633 33.0968 -9.37195 -9.37195 -9.37195 -29.0628 15.9633 32.0968 0.262354 0.262354 0.262354 -29.0628 15.9633 33.0968 1.0677 1.0677 1.0677 -30.0628 14.9633 32.0968 -4.93436 -4.93436 -4.93436 -30.0628 14.9633 33.0968 3.16312 3.16312 3.16312 -29.0628 16.9633 31.0968 -2.28049 -2.28049 -2.28049 -30.0628 16.9633 30.0968 10.6794 10.6794 10.6794 -30.0628 17.9633 30.0968 6.63474 6.63474 6.63474 -29.0628 16.9633 32.0968 -2.36491 -2.36491 -2.36491 -29.0628 16.9633 33.0968 2.21462 2.21462 2.21462 -31.0628 14.9633 31.0968 13.2341 13.2341 13.2341 -31.0628 15.9633 30.0968 -17.7444 -17.7444 -17.7444 -31.0628 15.9633 31.0968 -1.95821 -1.95821 -1.95821 -32.062799999999996 14.9633 31.0968 22.0847 22.0847 22.0847 -32.062799999999996 15.9633 30.0968 -16.5923 -16.5923 -16.5923 -32.062799999999996 15.9633 31.0968 -4.19808 -4.19808 -4.19808 -31.0628 16.9633 30.0968 0.377818 0.377818 0.377818 -31.0628 16.9633 31.0968 3.68271 3.68271 3.68271 -31.0628 17.9633 30.0968 -10.4444 -10.4444 -10.4444 -31.0628 17.9633 31.0968 -7.72094 -7.72094 -7.72094 -32.062799999999996 16.9633 30.0968 22.8914 22.8914 22.8914 -32.062799999999996 16.9633 31.0968 3.47198 3.47198 3.47198 -32.062799999999996 17.9633 30.0968 -1.32712 -1.32712 -1.32712 -32.062799999999996 17.9633 31.0968 -15.1634 -15.1634 -15.1634 -29.0628 14.9633 34.0968 -1.14478 -1.14478 -1.14478 -29.0628 14.9633 35.0968 3.42471 3.42471 3.42471 -29.0628 15.9633 34.0968 -3.78634 -3.78634 -3.78634 -29.0628 15.9633 35.0968 1.19892 1.19892 1.19892 -30.0628 14.9633 34.0968 5.91789 5.91789 5.91789 -29.0628 16.9633 34.0968 1.63979 1.63979 1.63979 -26.0628 18.9633 22.0968 18.0631 18.0631 18.0631 -26.0628 18.9633 23.0968 7.04224 7.04224 7.04224 -26.0628 19.9633 22.0968 1.2092 1.2092 1.2092 -26.0628 19.9633 23.0968 -7.22305 -7.22305 -7.22305 -25.0628 18.9633 24.0968 -79.6611 -79.6611 -79.6611 -25.0628 18.9633 25.0968 212.085 212.085 212.085 -25.0628 19.9633 24.0968 -186.577 -186.577 -186.577 -26.0628 18.9633 24.0968 -163.18 -163.18 -163.18 -26.0628 18.9633 25.0968 595.785 595.785 595.785 -26.0628 19.9633 24.0968 -426.59 -426.59 -426.59 -25.0628 20.9633 22.0968 -11.0734 -11.0734 -11.0734 -25.0628 20.9633 23.0968 18.1619 18.1619 18.1619 -25.0628 21.9633 22.0968 12.5963 12.5963 12.5963 -26.0628 20.9633 22.0968 1.94583 1.94583 1.94583 -26.0628 20.9633 23.0968 -13.1164 -13.1164 -13.1164 -26.0628 21.9633 22.0968 3.61261 3.61261 3.61261 -25.0628 20.9633 24.0968 0.80159 0.80159 0.80159 -26.0628 20.9633 24.0968 -480.6 -480.6 -480.6 -27.0628 18.9633 25.0968 -156.174 -156.174 -156.174 -25.0628 18.9633 26.0968 131.324 131.324 131.324 -26.0628 18.9633 26.0968 587.595 587.595 587.595 -26.0628 18.9633 27.0968 -6.80774 -6.80774 -6.80774 -25.0628 18.9633 28.0968 3.82669 3.82669 3.82669 -25.0628 18.9633 29.0968 2.45157 2.45157 2.45157 -25.0628 19.9633 28.0968 1.06785 1.06785 1.06785 -25.0628 19.9633 29.0968 2.01105 2.01105 2.01105 -26.0628 18.9633 29.0968 26.6212 26.6212 26.6212 -26.0628 19.9633 29.0968 2.06928 2.06928 2.06928 -27.0628 18.9633 26.0968 135.603 135.603 135.603 -27.0628 18.9633 27.0968 -6.10153 -6.10153 -6.10153 -27.0628 18.9633 29.0968 15.2525 15.2525 15.2525 -31.0628 18.9633 29.0968 -12.852 -12.852 -12.852 -32.062799999999996 18.9633 28.0968 6.99704 6.99704 6.99704 -32.062799999999996 18.9633 29.0968 -10.8545 -10.8545 -10.8545 -25.0628 18.9633 30.0968 -11.9945 -11.9945 -11.9945 -25.0628 18.9633 31.0968 -13.7984 -13.7984 -13.7984 -25.0628 19.9633 30.0968 -2.36422 -2.36422 -2.36422 -25.0628 19.9633 31.0968 -2.11555 -2.11555 -2.11555 -26.0628 18.9633 30.0968 -5.61014 -5.61014 -5.61014 -26.0628 18.9633 31.0968 -13.3667 -13.3667 -13.3667 -26.0628 19.9633 30.0968 -3.508 -3.508 -3.508 -26.0628 19.9633 31.0968 -4.43832 -4.43832 -4.43832 -27.0628 18.9633 30.0968 -1.3219 -1.3219 -1.3219 -27.0628 18.9633 31.0968 4.7546 4.7546 4.7546 -31.0628 18.9633 30.0968 5.80398 5.80398 5.80398 -32.062799999999996 18.9633 30.0968 20.5114 20.5114 20.5114 -33.062799999999996 10.9633 22.0968 14.0085 14.0085 14.0085 -33.062799999999996 10.9633 23.0968 -37.7927 -37.7927 -37.7927 -33.062799999999996 11.9633 22.0968 93.3508 93.3508 93.3508 -33.062799999999996 11.9633 23.0968 -17.1772 -17.1772 -17.1772 -34.062799999999996 11.9633 23.0968 -9.7581 -9.7581 -9.7581 -33.062799999999996 10.9633 24.0968 -90.6097 -90.6097 -90.6097 -33.062799999999996 10.9633 25.0968 -6.23191 -6.23191 -6.23191 -33.062799999999996 11.9633 24.0968 -20.1127 -20.1127 -20.1127 -33.062799999999996 11.9633 25.0968 -55.8113 -55.8113 -55.8113 -34.062799999999996 10.9633 24.0968 16.0991 16.0991 16.0991 -34.062799999999996 10.9633 25.0968 2.36547 2.36547 2.36547 -34.062799999999996 11.9633 24.0968 49.8893 49.8893 49.8893 -34.062799999999996 11.9633 25.0968 28.0714 28.0714 28.0714 -33.062799999999996 12.9633 22.0968 22.9766 22.9766 22.9766 -33.062799999999996 12.9633 23.0968 60.0624 60.0624 60.0624 -33.062799999999996 13.9633 22.0968 57.0905 57.0905 57.0905 -33.062799999999996 13.9633 23.0968 4.2994 4.2994 4.2994 -34.062799999999996 12.9633 22.0968 80.3602 80.3602 80.3602 -34.062799999999996 12.9633 23.0968 -45.9689 -45.9689 -45.9689 -34.062799999999996 13.9633 22.0968 99.3188 99.3188 99.3188 -34.062799999999996 13.9633 23.0968 22.9357 22.9357 22.9357 -33.062799999999996 12.9633 24.0968 61.9751 61.9751 61.9751 -33.062799999999996 13.9633 24.0968 -14.6317 -14.6317 -14.6317 -33.062799999999996 13.9633 25.0968 18.029 18.029 18.029 -34.062799999999996 12.9633 24.0968 -1.02102 -1.02102 -1.02102 -34.062799999999996 12.9633 25.0968 4.07596 4.07596 4.07596 -34.062799999999996 13.9633 24.0968 49.5158 49.5158 49.5158 -34.062799999999996 13.9633 25.0968 47.2193 47.2193 47.2193 -35.062799999999996 11.9633 23.0968 -155.761 -155.761 -155.761 -36.062799999999996 10.9633 22.0968 -13.7019 -13.7019 -13.7019 -36.062799999999996 10.9633 23.0968 29.5128 29.5128 29.5128 -36.062799999999996 11.9633 22.0968 -146.057 -146.057 -146.057 -36.062799999999996 11.9633 23.0968 58.5004 58.5004 58.5004 -35.062799999999996 10.9633 24.0968 40.3402 40.3402 40.3402 -35.062799999999996 10.9633 25.0968 9.99193 9.99193 9.99193 -35.062799999999996 11.9633 24.0968 32.4094 32.4094 32.4094 -35.062799999999996 11.9633 25.0968 94.917 94.917 94.917 -36.062799999999996 10.9633 24.0968 -6.07809 -6.07809 -6.07809 -36.062799999999996 10.9633 25.0968 -15.0208 -15.0208 -15.0208 -36.062799999999996 11.9633 24.0968 28.5988 28.5988 28.5988 -36.062799999999996 11.9633 25.0968 15.8642 15.8642 15.8642 -35.062799999999996 12.9633 22.0968 -333.922 -333.922 -333.922 -35.062799999999996 12.9633 23.0968 -247.062 -247.062 -247.062 -35.062799999999996 13.9633 22.0968 -29.0652 -29.0652 -29.0652 -35.062799999999996 13.9633 23.0968 179.719 179.719 179.719 -36.062799999999996 12.9633 22.0968 -70.6527 -70.6527 -70.6527 -36.062799999999996 12.9633 23.0968 69.8063 69.8063 69.8063 -36.062799999999996 13.9633 22.0968 20.8724 20.8724 20.8724 -36.062799999999996 13.9633 23.0968 -120.407 -120.407 -120.407 -35.062799999999996 12.9633 24.0968 -60.5966 -60.5966 -60.5966 -35.062799999999996 12.9633 25.0968 130.127 130.127 130.127 -35.062799999999996 13.9633 24.0968 -52.6878 -52.6878 -52.6878 -35.062799999999996 13.9633 25.0968 12.7139 12.7139 12.7139 -36.062799999999996 12.9633 24.0968 -51.8654 -51.8654 -51.8654 -36.062799999999996 12.9633 25.0968 4.89546 4.89546 4.89546 -36.062799999999996 13.9633 24.0968 -17.6125 -17.6125 -17.6125 -33.062799999999996 10.9633 26.0968 -106.885 -106.885 -106.885 -33.062799999999996 10.9633 27.0968 -18.6972 -18.6972 -18.6972 -33.062799999999996 11.9633 27.0968 4.89954 4.89954 4.89954 -34.062799999999996 10.9633 26.0968 32.0769 32.0769 32.0769 -34.062799999999996 10.9633 27.0968 6.34307 6.34307 6.34307 -34.062799999999996 11.9633 26.0968 21.1612 21.1612 21.1612 -34.062799999999996 11.9633 27.0968 7.16559 7.16559 7.16559 -33.062799999999996 10.9633 28.0968 -8.8196 -8.8196 -8.8196 -33.062799999999996 10.9633 29.0968 2.10587 2.10587 2.10587 -33.062799999999996 11.9633 28.0968 -2.55391 -2.55391 -2.55391 -33.062799999999996 11.9633 29.0968 -0.538286 -0.538286 -0.538286 -34.062799999999996 10.9633 28.0968 5.17156 5.17156 5.17156 -34.062799999999996 10.9633 29.0968 -8.02674 -8.02674 -8.02674 -34.062799999999996 11.9633 28.0968 4.10845 4.10845 4.10845 -34.062799999999996 11.9633 29.0968 -1.89213 -1.89213 -1.89213 -33.062799999999996 12.9633 27.0968 -8.93391 -8.93391 -8.93391 -33.062799999999996 13.9633 26.0968 -9.52256 -9.52256 -9.52256 -33.062799999999996 13.9633 27.0968 -1.49204 -1.49204 -1.49204 -34.062799999999996 12.9633 27.0968 3.87532 3.87532 3.87532 -34.062799999999996 13.9633 26.0968 -27.5823 -27.5823 -27.5823 -34.062799999999996 13.9633 27.0968 -1.02757 -1.02757 -1.02757 -33.062799999999996 12.9633 28.0968 2.0283 2.0283 2.0283 -33.062799999999996 12.9633 29.0968 -5.45635 -5.45635 -5.45635 -33.062799999999996 13.9633 28.0968 -2.9098 -2.9098 -2.9098 -33.062799999999996 13.9633 29.0968 -4.52574 -4.52574 -4.52574 -34.062799999999996 13.9633 28.0968 1.23713 1.23713 1.23713 -34.062799999999996 13.9633 29.0968 0.216041 0.216041 0.216041 -35.062799999999996 10.9633 26.0968 -4.61197 -4.61197 -4.61197 -35.062799999999996 10.9633 27.0968 32.7518 32.7518 32.7518 -35.062799999999996 11.9633 26.0968 -18.1223 -18.1223 -18.1223 -35.062799999999996 11.9633 27.0968 2.87508 2.87508 2.87508 -36.062799999999996 10.9633 26.0968 -20.5536 -20.5536 -20.5536 -36.062799999999996 10.9633 27.0968 10.1372 10.1372 10.1372 -36.062799999999996 11.9633 26.0968 16.7643 16.7643 16.7643 -36.062799999999996 11.9633 27.0968 1.44687 1.44687 1.44687 -35.062799999999996 10.9633 28.0968 7.719 7.719 7.719 -35.062799999999996 11.9633 28.0968 6.95271 6.95271 6.95271 -35.062799999999996 11.9633 29.0968 -0.986521 -0.986521 -0.986521 -36.062799999999996 10.9633 28.0968 8.54591 8.54591 8.54591 -36.062799999999996 11.9633 28.0968 4.93608 4.93608 4.93608 -36.062799999999996 11.9633 29.0968 6.30243 6.30243 6.30243 -35.062799999999996 12.9633 26.0968 -14.5064 -14.5064 -14.5064 -35.062799999999996 12.9633 27.0968 7.95535 7.95535 7.95535 -35.062799999999996 13.9633 26.0968 -2.58899 -2.58899 -2.58899 -35.062799999999996 13.9633 27.0968 1.70787 1.70787 1.70787 -36.062799999999996 12.9633 26.0968 10.6661 10.6661 10.6661 -36.062799999999996 12.9633 27.0968 8.76091 8.76091 8.76091 -36.062799999999996 13.9633 26.0968 -16.9062 -16.9062 -16.9062 -36.062799999999996 13.9633 27.0968 -31.57 -31.57 -31.57 -35.062799999999996 12.9633 28.0968 4.68949 4.68949 4.68949 -35.062799999999996 12.9633 29.0968 1.74327 1.74327 1.74327 -36.062799999999996 12.9633 28.0968 0.350642 0.350642 0.350642 -36.062799999999996 12.9633 29.0968 3.55449 3.55449 3.55449 -33.062799999999996 14.9633 25.0968 -65.6298 -65.6298 -65.6298 -34.062799999999996 14.9633 25.0968 18.0344 18.0344 18.0344 -35.062799999999996 14.9633 23.0968 204.209 204.209 204.209 -35.062799999999996 15.9633 23.0968 -145.925 -145.925 -145.925 -36.062799999999996 14.9633 22.0968 113.478 113.478 113.478 -36.062799999999996 14.9633 23.0968 -21.235 -21.235 -21.235 -36.062799999999996 15.9633 22.0968 11.8219 11.8219 11.8219 -36.062799999999996 15.9633 23.0968 4.90593 4.90593 4.90593 -35.062799999999996 14.9633 24.0968 212.879 212.879 212.879 -35.062799999999996 14.9633 25.0968 11.8823 11.8823 11.8823 -35.062799999999996 15.9633 24.0968 -178.977 -178.977 -178.977 -35.062799999999996 15.9633 25.0968 -99.5877 -99.5877 -99.5877 -36.062799999999996 15.9633 25.0968 58.9275 58.9275 58.9275 -35.062799999999996 16.9633 23.0968 -21.1277 -21.1277 -21.1277 -36.062799999999996 16.9633 22.0968 -3.5752 -3.5752 -3.5752 -36.062799999999996 16.9633 23.0968 19.7924 19.7924 19.7924 -36.062799999999996 17.9633 22.0968 -7.22483 -7.22483 -7.22483 -36.062799999999996 17.9633 23.0968 32.1943 32.1943 32.1943 -35.062799999999996 16.9633 24.0968 92.0209 92.0209 92.0209 -35.062799999999996 16.9633 25.0968 33.7766 33.7766 33.7766 -35.062799999999996 17.9633 24.0968 4.74503 4.74503 4.74503 -35.062799999999996 17.9633 25.0968 14.8837 14.8837 14.8837 -36.062799999999996 16.9633 25.0968 -31.9746 -31.9746 -31.9746 -36.062799999999996 17.9633 24.0968 78.5929 78.5929 78.5929 -36.062799999999996 17.9633 25.0968 25.876 25.876 25.876 -33.062799999999996 14.9633 26.0968 10.1975 10.1975 10.1975 -33.062799999999996 14.9633 27.0968 -2.93949 -2.93949 -2.93949 -33.062799999999996 15.9633 27.0968 -5.07987 -5.07987 -5.07987 -34.062799999999996 14.9633 26.0968 12.305 12.305 12.305 -34.062799999999996 14.9633 27.0968 -0.0576856 -0.0576856 -0.0576856 -34.062799999999996 15.9633 27.0968 -16.5824 -16.5824 -16.5824 -33.062799999999996 15.9633 28.0968 -7.27407 -7.27407 -7.27407 -33.062799999999996 15.9633 29.0968 -0.0520892 -0.0520892 -0.0520892 -34.062799999999996 14.9633 28.0968 0.0019412 0.0019412 0.0019412 -34.062799999999996 14.9633 29.0968 -3.74245 -3.74245 -3.74245 -34.062799999999996 15.9633 28.0968 -2.4258 -2.4258 -2.4258 -34.062799999999996 15.9633 29.0968 -4.75823 -4.75823 -4.75823 -33.062799999999996 16.9633 27.0968 5.8696 5.8696 5.8696 -33.062799999999996 17.9633 27.0968 0.726401 0.726401 0.726401 -33.062799999999996 16.9633 28.0968 4.4377 4.4377 4.4377 -33.062799999999996 16.9633 29.0968 -2.85997 -2.85997 -2.85997 -33.062799999999996 17.9633 28.0968 1.25383 1.25383 1.25383 -33.062799999999996 17.9633 29.0968 7.34282 7.34282 7.34282 -34.062799999999996 16.9633 28.0968 3.04457 3.04457 3.04457 -34.062799999999996 16.9633 29.0968 -1.07804 -1.07804 -1.07804 -34.062799999999996 17.9633 28.0968 4.4286 4.4286 4.4286 -34.062799999999996 17.9633 29.0968 -5.89855 -5.89855 -5.89855 -35.062799999999996 14.9633 26.0968 -3.52832 -3.52832 -3.52832 -35.062799999999996 14.9633 27.0968 7.85991 7.85991 7.85991 -35.062799999999996 15.9633 26.0968 -14.3546 -14.3546 -14.3546 -35.062799999999996 15.9633 27.0968 -8.21618 -8.21618 -8.21618 -36.062799999999996 14.9633 27.0968 -9.61038 -9.61038 -9.61038 -36.062799999999996 15.9633 26.0968 -4.56103 -4.56103 -4.56103 -36.062799999999996 15.9633 27.0968 -7.95748 -7.95748 -7.95748 -35.062799999999996 14.9633 28.0968 1.61246 1.61246 1.61246 -35.062799999999996 14.9633 29.0968 -12.4669 -12.4669 -12.4669 -35.062799999999996 15.9633 28.0968 -33.5988 -33.5988 -33.5988 -36.062799999999996 16.9633 26.0968 -0.294107 -0.294107 -0.294107 -37.062799999999996 10.9633 22.0968 -153.091 -153.091 -153.091 -37.062799999999996 10.9633 23.0968 -133.845 -133.845 -133.845 -37.062799999999996 11.9633 22.0968 -49.6442 -49.6442 -49.6442 -37.062799999999996 11.9633 23.0968 -1.23713 -1.23713 -1.23713 -38.062799999999996 11.9633 22.0968 200.804 200.804 200.804 -38.062799999999996 11.9633 23.0968 -104.393 -104.393 -104.393 -37.062799999999996 10.9633 24.0968 -11.956 -11.956 -11.956 -37.062799999999996 10.9633 25.0968 -43.1004 -43.1004 -43.1004 -37.062799999999996 11.9633 24.0968 -14.7499 -14.7499 -14.7499 -37.062799999999996 11.9633 25.0968 -23.12 -23.12 -23.12 -38.062799999999996 10.9633 24.0968 -4.46749 -4.46749 -4.46749 -38.062799999999996 10.9633 25.0968 2.90236 2.90236 2.90236 -38.062799999999996 11.9633 24.0968 -29.176 -29.176 -29.176 -38.062799999999996 11.9633 25.0968 -17.5087 -17.5087 -17.5087 -37.062799999999996 12.9633 22.0968 75.6875 75.6875 75.6875 -37.062799999999996 12.9633 23.0968 30.928 30.928 30.928 -37.062799999999996 13.9633 22.0968 47.7596 47.7596 47.7596 -38.062799999999996 12.9633 22.0968 -18.8042 -18.8042 -18.8042 -38.062799999999996 12.9633 23.0968 114.655 114.655 114.655 -38.062799999999996 13.9633 22.0968 -21.9455 -21.9455 -21.9455 -37.062799999999996 12.9633 24.0968 -21.0905 -21.0905 -21.0905 -38.062799999999996 12.9633 24.0968 -13.4346 -13.4346 -13.4346 -38.062799999999996 13.9633 24.0968 3.98863 3.98863 3.98863 -38.062799999999996 13.9633 25.0968 -10.4089 -10.4089 -10.4089 -39.062799999999996 11.9633 23.0968 -124.966 -124.966 -124.966 -39.062799999999996 10.9633 25.0968 -310.525 -310.525 -310.525 -39.062799999999996 11.9633 24.0968 4.13554 4.13554 4.13554 -39.062799999999996 11.9633 25.0968 39.0756 39.0756 39.0756 -40.062799999999996 11.9633 25.0968 379.71 379.71 379.71 -39.062799999999996 12.9633 22.0968 -43.3807 -43.3807 -43.3807 -39.062799999999996 12.9633 23.0968 147.44 147.44 147.44 -39.062799999999996 13.9633 22.0968 -38.5882 -38.5882 -38.5882 -39.062799999999996 13.9633 23.0968 -2.18413 -2.18413 -2.18413 -39.062799999999996 12.9633 24.0968 -5.08877 -5.08877 -5.08877 -39.062799999999996 12.9633 25.0968 46.2631 46.2631 46.2631 -39.062799999999996 13.9633 24.0968 -11.516 -11.516 -11.516 -39.062799999999996 13.9633 25.0968 -3.34676 -3.34676 -3.34676 -40.062799999999996 12.9633 25.0968 -18.6877 -18.6877 -18.6877 -40.062799999999996 13.9633 25.0968 -21.9712 -21.9712 -21.9712 -37.062799999999996 10.9633 26.0968 -11.1411 -11.1411 -11.1411 -37.062799999999996 10.9633 27.0968 -14.8654 -14.8654 -14.8654 -37.062799999999996 11.9633 26.0968 -7.37531 -7.37531 -7.37531 -37.062799999999996 11.9633 27.0968 -7.14924 -7.14924 -7.14924 -38.062799999999996 10.9633 26.0968 7.74704 7.74704 7.74704 -38.062799999999996 10.9633 27.0968 -6.61842 -6.61842 -6.61842 -38.062799999999996 11.9633 26.0968 -11.4923 -11.4923 -11.4923 -38.062799999999996 11.9633 27.0968 -18.9469 -18.9469 -18.9469 -37.062799999999996 10.9633 28.0968 62.5981 62.5981 62.5981 -37.062799999999996 10.9633 29.0968 1.78918 1.78918 1.78918 -37.062799999999996 11.9633 28.0968 -10.0696 -10.0696 -10.0696 -37.062799999999996 11.9633 29.0968 19.3002 19.3002 19.3002 -38.062799999999996 11.9633 28.0968 -30.2811 -30.2811 -30.2811 -37.062799999999996 12.9633 27.0968 8.27159 8.27159 8.27159 -37.062799999999996 13.9633 27.0968 -87.7048 -87.7048 -87.7048 -38.062799999999996 12.9633 27.0968 0.716639 0.716639 0.716639 -37.062799999999996 12.9633 28.0968 -8.93935 -8.93935 -8.93935 -37.062799999999996 13.9633 28.0968 0.270949 0.270949 0.270949 -38.062799999999996 12.9633 28.0968 -17.4522 -17.4522 -17.4522 -38.062799999999996 12.9633 29.0968 -3.48066 -3.48066 -3.48066 -38.062799999999996 13.9633 28.0968 4.18121 4.18121 4.18121 -38.062799999999996 13.9633 29.0968 6.87354 6.87354 6.87354 -39.062799999999996 10.9633 26.0968 -51.0177 -51.0177 -51.0177 -39.062799999999996 10.9633 27.0968 202.884 202.884 202.884 -39.062799999999996 11.9633 26.0968 -259.827 -259.827 -259.827 -39.062799999999996 11.9633 27.0968 380.863 380.863 380.863 -40.062799999999996 11.9633 26.0968 131.183 131.183 131.183 -40.062799999999996 11.9633 27.0968 -226.256 -226.256 -226.256 -39.062799999999996 11.9633 28.0968 11.967 11.967 11.967 -39.062799999999996 11.9633 29.0968 -37.5697 -37.5697 -37.5697 -40.062799999999996 11.9633 28.0968 -12.0222 -12.0222 -12.0222 -40.062799999999996 11.9633 29.0968 12.2069 12.2069 12.2069 -39.062799999999996 13.9633 26.0968 -2.011 -2.011 -2.011 -40.062799999999996 12.9633 26.0968 35.3165 35.3165 35.3165 -40.062799999999996 13.9633 26.0968 40.8997 40.8997 40.8997 -39.062799999999996 12.9633 28.0968 -2.41165 -2.41165 -2.41165 -39.062799999999996 12.9633 29.0968 -6.07775 -6.07775 -6.07775 -39.062799999999996 13.9633 29.0968 0.7309 0.7309 0.7309 -40.062799999999996 12.9633 29.0968 -2.16657 -2.16657 -2.16657 -37.062799999999996 14.9633 22.0968 -8.96156 -8.96156 -8.96156 -37.062799999999996 15.9633 22.0968 -13.7859 -13.7859 -13.7859 -38.062799999999996 14.9633 22.0968 2.19623 2.19623 2.19623 -38.062799999999996 14.9633 23.0968 -22.678 -22.678 -22.678 -38.062799999999996 15.9633 22.0968 -14.5947 -14.5947 -14.5947 -38.062799999999996 15.9633 23.0968 2.11038 2.11038 2.11038 -37.062799999999996 15.9633 25.0968 -8.01878 -8.01878 -8.01878 -38.062799999999996 14.9633 24.0968 21.4224 21.4224 21.4224 -38.062799999999996 14.9633 25.0968 -40.9767 -40.9767 -40.9767 -38.062799999999996 15.9633 24.0968 10.6711 10.6711 10.6711 -38.062799999999996 15.9633 25.0968 42.3725 42.3725 42.3725 -37.062799999999996 16.9633 22.0968 14.5236 14.5236 14.5236 -37.062799999999996 17.9633 22.0968 4.46311 4.46311 4.46311 -37.062799999999996 17.9633 23.0968 11.9334 11.9334 11.9334 -38.062799999999996 16.9633 22.0968 14.2745 14.2745 14.2745 -38.062799999999996 16.9633 23.0968 5.75417 5.75417 5.75417 -38.062799999999996 17.9633 22.0968 2.1391 2.1391 2.1391 -38.062799999999996 17.9633 23.0968 1.17408 1.17408 1.17408 -37.062799999999996 16.9633 24.0968 -52.7132 -52.7132 -52.7132 -37.062799999999996 16.9633 25.0968 -16.7797 -16.7797 -16.7797 -37.062799999999996 17.9633 24.0968 27.4618 27.4618 27.4618 -37.062799999999996 17.9633 25.0968 -10.9706 -10.9706 -10.9706 -38.062799999999996 16.9633 24.0968 -37.2141 -37.2141 -37.2141 -38.062799999999996 16.9633 25.0968 -39.8653 -39.8653 -39.8653 -38.062799999999996 17.9633 24.0968 1.59417 1.59417 1.59417 -39.062799999999996 14.9633 22.0968 11.2758 11.2758 11.2758 -39.062799999999996 14.9633 23.0968 -38.8245 -38.8245 -38.8245 -39.062799999999996 15.9633 22.0968 27.9934 27.9934 27.9934 -39.062799999999996 14.9633 24.0968 -31.8194 -31.8194 -31.8194 -39.062799999999996 14.9633 25.0968 8.24094 8.24094 8.24094 -40.062799999999996 14.9633 25.0968 0.558957 0.558957 0.558957 -40.062799999999996 15.9633 25.0968 -20.1475 -20.1475 -20.1475 -37.062799999999996 14.9633 26.0968 -19.7768 -19.7768 -19.7768 -37.062799999999996 14.9633 27.0968 -0.114686 -0.114686 -0.114686 -37.062799999999996 15.9633 26.0968 24.3635 24.3635 24.3635 -37.062799999999996 15.9633 27.0968 16.085 16.085 16.085 -38.062799999999996 14.9633 26.0968 -0.822562 -0.822562 -0.822562 -38.062799999999996 14.9633 27.0968 43.826 43.826 43.826 -38.062799999999996 15.9633 26.0968 -18.0575 -18.0575 -18.0575 -37.062799999999996 14.9633 28.0968 50.6533 50.6533 50.6533 -38.062799999999996 14.9633 28.0968 -3.27807 -3.27807 -3.27807 -38.062799999999996 14.9633 29.0968 -4.74795 -4.74795 -4.74795 -37.062799999999996 16.9633 26.0968 -23.2994 -23.2994 -23.2994 -39.062799999999996 14.9633 26.0968 -14.6737 -14.6737 -14.6737 -39.062799999999996 14.9633 27.0968 -8.4219 -8.4219 -8.4219 -40.062799999999996 14.9633 26.0968 13.6313 13.6313 13.6313 -40.062799999999996 14.9633 27.0968 -11.2229 -11.2229 -11.2229 -40.062799999999996 15.9633 26.0968 15.8311 15.8311 15.8311 -40.062799999999996 15.9633 27.0968 47.2508 47.2508 47.2508 -39.062799999999996 14.9633 28.0968 -3.42672 -3.42672 -3.42672 -39.062799999999996 14.9633 29.0968 -0.436365 -0.436365 -0.436365 -39.062799999999996 15.9633 28.0968 8.37138 8.37138 8.37138 -39.062799999999996 15.9633 29.0968 -2.50071 -2.50071 -2.50071 -40.062799999999996 14.9633 28.0968 10.9136 10.9136 10.9136 -40.062799999999996 15.9633 28.0968 -21.1678 -21.1678 -21.1678 -40.062799999999996 15.9633 29.0968 5.54227 5.54227 5.54227 -33.062799999999996 10.9633 30.0968 -3.15469 -3.15469 -3.15469 -33.062799999999996 10.9633 31.0968 -0.740345 -0.740345 -0.740345 -33.062799999999996 11.9633 30.0968 1.60532 1.60532 1.60532 -33.062799999999996 11.9633 31.0968 0.823128 0.823128 0.823128 -34.062799999999996 10.9633 30.0968 -1.19025 -1.19025 -1.19025 -34.062799999999996 11.9633 30.0968 -0.0476578 -0.0476578 -0.0476578 -33.062799999999996 10.9633 32.0968 -1.56493 -1.56493 -1.56493 -33.062799999999996 10.9633 33.0968 3.67541 3.67541 3.67541 -33.062799999999996 11.9633 32.0968 -1.59565 -1.59565 -1.59565 -33.062799999999996 11.9633 33.0968 2.21048 2.21048 2.21048 -34.062799999999996 10.9633 32.0968 -3.59603 -3.59603 -3.59603 -34.062799999999996 10.9633 33.0968 3.68786 3.68786 3.68786 -34.062799999999996 11.9633 32.0968 0.177812 0.177812 0.177812 -34.062799999999996 11.9633 33.0968 -19.1992 -19.1992 -19.1992 -33.062799999999996 12.9633 30.0968 -3.31836 -3.31836 -3.31836 -33.062799999999996 12.9633 31.0968 -0.151551 -0.151551 -0.151551 -33.062799999999996 13.9633 30.0968 -14.6603 -14.6603 -14.6603 -33.062799999999996 13.9633 31.0968 -73.6198 -73.6198 -73.6198 -34.062799999999996 12.9633 30.0968 2.54332 2.54332 2.54332 -34.062799999999996 12.9633 31.0968 15.5961 15.5961 15.5961 -34.062799999999996 13.9633 30.0968 -57.8626 -57.8626 -57.8626 -33.062799999999996 12.9633 32.0968 -2.49847 -2.49847 -2.49847 -34.062799999999996 12.9633 32.0968 14.4054 14.4054 14.4054 -35.062799999999996 11.9633 30.0968 -1.29482 -1.29482 -1.29482 -35.062799999999996 11.9633 31.0968 -4.18313 -4.18313 -4.18313 -36.062799999999996 10.9633 30.0968 -24.9058 -24.9058 -24.9058 -36.062799999999996 10.9633 31.0968 0.986846 0.986846 0.986846 -36.062799999999996 11.9633 30.0968 -7.662 -7.662 -7.662 -36.062799999999996 11.9633 31.0968 -0.22955 -0.22955 -0.22955 -35.062799999999996 10.9633 32.0968 -2.8212 -2.8212 -2.8212 -35.062799999999996 10.9633 33.0968 3.65261 3.65261 3.65261 -35.062799999999996 11.9633 32.0968 -14.5902 -14.5902 -14.5902 -35.062799999999996 11.9633 33.0968 -15.1951 -15.1951 -15.1951 -36.062799999999996 10.9633 32.0968 2.62518 2.62518 2.62518 -36.062799999999996 11.9633 32.0968 -1.68426 -1.68426 -1.68426 -35.062799999999996 12.9633 30.0968 -4.9453 -4.9453 -4.9453 -35.062799999999996 12.9633 31.0968 4.72571 4.72571 4.72571 -35.062799999999996 12.9633 32.0968 24.0944 24.0944 24.0944 -33.062799999999996 14.9633 30.0968 54.9872 54.9872 54.9872 -33.062799999999996 14.9633 31.0968 14.4206 14.4206 14.4206 -33.062799999999996 15.9633 30.0968 2.05105 2.05105 2.05105 -33.062799999999996 15.9633 31.0968 21.5528 21.5528 21.5528 -34.062799999999996 14.9633 30.0968 21.2115 21.2115 21.2115 -34.062799999999996 15.9633 30.0968 48.3039 48.3039 48.3039 -33.062799999999996 16.9633 30.0968 -10.0697 -10.0697 -10.0697 -33.062799999999996 17.9633 30.0968 -4.71842 -4.71842 -4.71842 -37.062799999999996 10.9633 30.0968 -12.4789 -12.4789 -12.4789 -37.062799999999996 10.9633 31.0968 17.1242 17.1242 17.1242 -37.062799999999996 11.9633 30.0968 -11.8156 -11.8156 -11.8156 -39.062799999999996 12.9633 30.0968 7.5488 7.5488 7.5488 -39.062799999999996 13.9633 30.0968 -23.932 -23.932 -23.932 -39.062799999999996 13.9633 31.0968 0.794568 0.794568 0.794568 -40.062799999999996 12.9633 30.0968 -4.0321 -4.0321 -4.0321 -40.062799999999996 12.9633 31.0968 10.4911 10.4911 10.4911 -40.062799999999996 13.9633 30.0968 0.779902 0.779902 0.779902 -40.062799999999996 13.9633 31.0968 -6.68971 -6.68971 -6.68971 -38.062799999999996 14.9633 30.0968 0.921096 0.921096 0.921096 -39.062799999999996 14.9633 30.0968 0.799778 0.799778 0.799778 -39.062799999999996 15.9633 30.0968 3.65272 3.65272 3.65272 -40.062799999999996 14.9633 30.0968 2.46219 2.46219 2.46219 -40.062799999999996 14.9633 31.0968 0.741158 0.741158 0.741158 -40.062799999999996 15.9633 30.0968 -1.47383 -1.47383 -1.47383 -33.062799999999996 18.9633 28.0968 0.289164 0.289164 0.289164 -33.062799999999996 18.9633 29.0968 -3.55862 -3.55862 -3.55862 -41.062799999999996 12.9633 25.0968 27.9497 27.9497 27.9497 -41.062799999999996 13.9633 25.0968 56.0338 56.0338 56.0338 -42.062799999999996 12.9633 25.0968 -7.63304 -7.63304 -7.63304 -42.062799999999996 13.9633 25.0968 -32.7281 -32.7281 -32.7281 -41.062799999999996 11.9633 26.0968 -180.467 -180.467 -180.467 -41.062799999999996 11.9633 27.0968 -49.7125 -49.7125 -49.7125 -42.062799999999996 11.9633 26.0968 6.79462 6.79462 6.79462 -42.062799999999996 11.9633 27.0968 -34.5247 -34.5247 -34.5247 -41.062799999999996 11.9633 28.0968 25.2934 25.2934 25.2934 -41.062799999999996 11.9633 29.0968 31.1306 31.1306 31.1306 -42.062799999999996 11.9633 28.0968 56.183 56.183 56.183 -41.062799999999996 12.9633 26.0968 57.7102 57.7102 57.7102 -42.062799999999996 12.9633 26.0968 -39.8111 -39.8111 -39.8111 -42.062799999999996 12.9633 27.0968 62.7611 62.7611 62.7611 -42.062799999999996 13.9633 26.0968 -29.8338 -29.8338 -29.8338 -41.062799999999996 12.9633 28.0968 13.7253 13.7253 13.7253 -41.062799999999996 12.9633 29.0968 16.1852 16.1852 16.1852 -42.062799999999996 12.9633 28.0968 32.5122 32.5122 32.5122 -42.062799999999996 12.9633 29.0968 10.8563 10.8563 10.8563 -42.062799999999996 13.9633 28.0968 -13.0743 -13.0743 -13.0743 -42.062799999999996 13.9633 29.0968 -3.08632 -3.08632 -3.08632 -43.062799999999996 12.9633 26.0968 50.4117 50.4117 50.4117 -43.062799999999996 12.9633 27.0968 -99.2885 -99.2885 -99.2885 -43.062799999999996 13.9633 26.0968 -10.6205 -10.6205 -10.6205 -43.062799999999996 13.9633 27.0968 16.8975 16.8975 16.8975 -43.062799999999996 12.9633 28.0968 -29.7339 -29.7339 -29.7339 -43.062799999999996 13.9633 28.0968 -22.8006 -22.8006 -22.8006 -41.062799999999996 14.9633 25.0968 32.058 32.058 32.058 -41.062799999999996 15.9633 25.0968 -13.4896 -13.4896 -13.4896 -42.062799999999996 14.9633 25.0968 -41.029 -41.029 -41.029 -42.062799999999996 15.9633 25.0968 14.0455 14.0455 14.0455 -41.062799999999996 15.9633 26.0968 -8.97992 -8.97992 -8.97992 -41.062799999999996 15.9633 27.0968 7.39895 7.39895 7.39895 -42.062799999999996 14.9633 26.0968 -11.7878 -11.7878 -11.7878 -42.062799999999996 14.9633 27.0968 -16.8966 -16.8966 -16.8966 -42.062799999999996 15.9633 26.0968 -14.6556 -14.6556 -14.6556 -42.062799999999996 15.9633 27.0968 -0.597285 -0.597285 -0.597285 -41.062799999999996 14.9633 28.0968 16.7682 16.7682 16.7682 -41.062799999999996 14.9633 29.0968 8.50829 8.50829 8.50829 -41.062799999999996 15.9633 28.0968 -25.1759 -25.1759 -25.1759 -41.062799999999996 15.9633 29.0968 -1.45028 -1.45028 -1.45028 -42.062799999999996 14.9633 28.0968 6.97799 6.97799 6.97799 -42.062799999999996 14.9633 29.0968 1.71396 1.71396 1.71396 -42.062799999999996 15.9633 28.0968 -10.9196 -10.9196 -10.9196 -41.062799999999996 16.9633 26.0968 25.0724 25.0724 25.0724 -41.062799999999996 16.9633 27.0968 -19.2615 -19.2615 -19.2615 -43.062799999999996 14.9633 26.0968 6.56232 6.56232 6.56232 -43.062799999999996 14.9633 27.0968 -44.2052 -44.2052 -44.2052 -43.062799999999996 15.9633 26.0968 -0.895131 -0.895131 -0.895131 -43.062799999999996 15.9633 27.0968 7.43538 7.43538 7.43538 -43.062799999999996 14.9633 28.0968 5.57276 5.57276 5.57276 -41.062799999999996 12.9633 30.0968 16.187 16.187 16.187 -41.062799999999996 13.9633 30.0968 12.3494 12.3494 12.3494 -41.062799999999996 13.9633 31.0968 -10.0713 -10.0713 -10.0713 -42.062799999999996 13.9633 30.0968 -0.322562 -0.322562 -0.322562 -41.062799999999996 14.9633 30.0968 -0.805727 -0.805727 -0.805727 -41.062799999999996 14.9633 31.0968 8.02745 8.02745 8.02745 -41.062799999999996 15.9633 30.0968 0.0276089 0.0276089 0.0276089 -42.062799999999996 14.9633 30.0968 -10.3382 -10.3382 -10.3382 diff --git a/tensorflow/script/ocnn_lrp_results/heatmap_0.ply b/tensorflow/script/ocnn_lrp_results/heatmap_0.ply deleted file mode 100644 index 6753f83..0000000 --- a/tensorflow/script/ocnn_lrp_results/heatmap_0.ply +++ /dev/null @@ -1,5506 +0,0 @@ -ply -format ascii 1.0 -element vertex 5493 -property float x -property float y -property float z -property float nx -property float ny -property float nz -element face 0 -property list uchar int vertex_indices -end_header --0.453125 -0.328125 -0.078125 -9.92836 -9.92836 -9.92836 --0.453125 -0.328125 -0.046875 -253.114 -253.114 -253.114 --0.453125 -0.328125 -0.015625 101.743 101.743 101.743 --0.453125 -0.296875 -0.078125 14.7938 14.7938 14.7938 --0.453125 -0.265625 -0.078125 12.984 12.984 12.984 --0.453125 -0.296875 -0.046875 133.906 133.906 133.906 --0.453125 -0.296875 -0.015625 68.2286 68.2286 68.2286 --0.453125 -0.265625 -0.046875 285.609 285.609 285.609 --0.453125 -0.265625 -0.015625 -371.142 -371.142 -371.142 --0.421875 -0.328125 -0.078125 1487.43 1487.43 1487.43 --0.390625 -0.328125 -0.078125 3654.32 3654.32 3654.32 --0.421875 -0.328125 -0.046875 617.815 617.815 617.815 --0.421875 -0.328125 -0.015625 -19.2983 -19.2983 -19.2983 --0.390625 -0.359375 -0.046875 0.516032 0.516032 0.516032 --0.390625 -0.359375 -0.015625 1.07441 1.07441 1.07441 --0.390625 -0.328125 -0.046875 203.335 203.335 203.335 --0.390625 -0.328125 -0.015625 10.0427 10.0427 10.0427 --0.421875 -0.296875 -0.078125 1089.9 1089.9 1089.9 --0.421875 -0.265625 -0.078125 1375.51 1375.51 1375.51 --0.390625 -0.296875 -0.078125 -2183.16 -2183.16 -2183.16 --0.390625 -0.265625 -0.078125 528.065 528.065 528.065 --0.421875 -0.296875 -0.015625 -0.331589 -0.331589 -0.331589 --0.421875 -0.265625 -0.015625 -23.3431 -23.3431 -23.3431 --0.359375 -0.390625 -0.046875 2.99828 2.99828 2.99828 --0.359375 -0.390625 -0.015625 -10.8188 -10.8188 -10.8188 --0.328125 -0.390625 -0.046875 -3.75321 -3.75321 -3.75321 --0.328125 -0.390625 -0.015625 3.22731 3.22731 3.22731 --0.296875 -0.390625 -0.078125 2.74893 2.74893 2.74893 --0.265625 -0.390625 -0.078125 4.18329 4.18329 4.18329 --0.296875 -0.390625 -0.046875 1.65414 1.65414 1.65414 --0.296875 -0.390625 -0.015625 -14.2988 -14.2988 -14.2988 --0.265625 -0.390625 -0.046875 2.25967 2.25967 2.25967 --0.265625 -0.390625 -0.015625 23.9757 23.9757 23.9757 --0.359375 -0.265625 -0.234375 20.0887 20.0887 20.0887 --0.359375 -0.265625 -0.203125 -14.4285 -14.4285 -14.4285 --0.328125 -0.265625 -0.234375 -23.6471 -23.6471 -23.6471 --0.328125 -0.265625 -0.203125 -16.1699 -16.1699 -16.1699 --0.328125 -0.265625 -0.140625 105.592 105.592 105.592 --0.296875 -0.265625 -0.140625 -151.773 -151.773 -151.773 --0.359375 -0.359375 -0.078125 0.0271316 0.0271316 0.0271316 --0.359375 -0.328125 -0.078125 -1304.09 -1304.09 -1304.09 --0.328125 -0.359375 -0.078125 -1.73993 -1.73993 -1.73993 --0.328125 -0.328125 -0.078125 3.01115 3.01115 3.01115 --0.359375 -0.359375 -0.046875 13.4009 13.4009 13.4009 --0.359375 -0.359375 -0.015625 7.42316 7.42316 7.42316 --0.359375 -0.328125 -0.046875 -59.4555 -59.4555 -59.4555 --0.359375 -0.328125 -0.015625 6.27528 6.27528 6.27528 --0.328125 -0.359375 -0.046875 -18.9602 -18.9602 -18.9602 --0.328125 -0.359375 -0.015625 -3.56015 -3.56015 -3.56015 --0.359375 -0.296875 -0.078125 -2031.58 -2031.58 -2031.58 --0.359375 -0.265625 -0.078125 -1102.43 -1102.43 -1102.43 --0.328125 -0.296875 -0.078125 34.79 34.79 34.79 --0.328125 -0.265625 -0.109375 -53.5151 -53.5151 -53.5151 --0.328125 -0.265625 -0.078125 -15.8764 -15.8764 -15.8764 --0.359375 -0.296875 -0.046875 -257.529 -257.529 -257.529 --0.359375 -0.265625 -0.046875 -1930.27 -1930.27 -1930.27 --0.359375 -0.265625 -0.015625 -48.9575 -48.9575 -48.9575 --0.328125 -0.296875 -0.046875 47.3844 47.3844 47.3844 --0.328125 -0.265625 -0.046875 12.4486 12.4486 12.4486 --0.328125 -0.265625 -0.015625 -1325.25 -1325.25 -1325.25 --0.296875 -0.359375 -0.078125 -3.99568 -3.99568 -3.99568 --0.296875 -0.328125 -0.078125 -2.52942 -2.52942 -2.52942 --0.265625 -0.359375 -0.078125 -4.43326 -4.43326 -4.43326 --0.265625 -0.328125 -0.078125 8.57578 8.57578 8.57578 --0.296875 -0.359375 -0.046875 -8.58892 -8.58892 -8.58892 --0.296875 -0.359375 -0.015625 -7.43571 -7.43571 -7.43571 --0.265625 -0.359375 -0.046875 2.15291 2.15291 2.15291 --0.296875 -0.296875 -0.078125 4.57187 4.57187 4.57187 --0.296875 -0.265625 -0.109375 -118.575 -118.575 -118.575 --0.296875 -0.265625 -0.078125 -6.24742 -6.24742 -6.24742 --0.265625 -0.296875 -0.078125 16.005 16.005 16.005 --0.265625 -0.265625 -0.109375 -85.4865 -85.4865 -85.4865 --0.265625 -0.265625 -0.078125 -27.7731 -27.7731 -27.7731 --0.296875 -0.296875 -0.046875 -1.4693 -1.4693 -1.4693 --0.296875 -0.296875 -0.015625 -1240.01 -1240.01 -1240.01 --0.296875 -0.265625 -0.046875 18.0112 18.0112 18.0112 --0.296875 -0.265625 -0.015625 -330.977 -330.977 -330.977 --0.265625 -0.296875 -0.046875 -15.1486 -15.1486 -15.1486 --0.265625 -0.296875 -0.015625 1593.68 1593.68 1593.68 --0.265625 -0.265625 -0.046875 -36.0196 -36.0196 -36.0196 --0.265625 -0.265625 -0.015625 105.9 105.9 105.9 --0.328125 -0.203125 -0.328125 -184.84 -184.84 -184.84 --0.359375 -0.234375 -0.265625 14.9319 14.9319 14.9319 --0.359375 -0.203125 -0.265625 -181.522 -181.522 -181.522 --0.328125 -0.234375 -0.265625 12.9996 12.9996 12.9996 --0.328125 -0.203125 -0.296875 24.2407 24.2407 24.2407 --0.328125 -0.203125 -0.265625 -214.559 -214.559 -214.559 --0.359375 -0.171875 -0.328125 151.121 151.121 151.121 --0.359375 -0.140625 -0.328125 -127.975 -127.975 -127.975 --0.328125 -0.171875 -0.359375 -5.45925 -5.45925 -5.45925 --0.328125 -0.171875 -0.328125 -150.903 -150.903 -150.903 --0.328125 -0.140625 -0.359375 -658.402 -658.402 -658.402 --0.328125 -0.140625 -0.328125 760.012 760.012 760.012 --0.359375 -0.171875 -0.296875 73.4934 73.4934 73.4934 --0.359375 -0.171875 -0.265625 -54.5183 -54.5183 -54.5183 --0.359375 -0.140625 -0.296875 5.09429 5.09429 5.09429 --0.359375 -0.140625 -0.265625 137.108 137.108 137.108 --0.328125 -0.171875 -0.296875 152.163 152.163 152.163 --0.328125 -0.171875 -0.265625 55.9303 55.9303 55.9303 --0.328125 -0.140625 -0.265625 108.357 108.357 108.357 --0.296875 -0.203125 -0.328125 72.8248 72.8248 72.8248 --0.265625 -0.203125 -0.359375 73.9476 73.9476 73.9476 --0.265625 -0.203125 -0.328125 76.9889 76.9889 76.9889 --0.296875 -0.234375 -0.265625 67.2191 67.2191 67.2191 --0.296875 -0.203125 -0.296875 57.1486 57.1486 57.1486 --0.296875 -0.203125 -0.265625 9.61958 9.61958 9.61958 --0.265625 -0.203125 -0.296875 85.2391 85.2391 85.2391 --0.265625 -0.203125 -0.265625 -103.566 -103.566 -103.566 --0.296875 -0.171875 -0.359375 59.2449 59.2449 59.2449 --0.296875 -0.171875 -0.328125 154.054 154.054 154.054 --0.296875 -0.140625 -0.359375 60.6916 60.6916 60.6916 --0.296875 -0.140625 -0.328125 77.0714 77.0714 77.0714 --0.265625 -0.171875 -0.359375 36.6851 36.6851 36.6851 --0.265625 -0.171875 -0.328125 123.418 123.418 123.418 --0.265625 -0.140625 -0.359375 147.054 147.054 147.054 --0.265625 -0.140625 -0.328125 118.051 118.051 118.051 --0.296875 -0.171875 -0.296875 61.9755 61.9755 61.9755 --0.296875 -0.171875 -0.265625 -30.0835 -30.0835 -30.0835 --0.359375 -0.109375 -0.328125 -35.1198 -35.1198 -35.1198 --0.328125 -0.109375 -0.359375 -1100.71 -1100.71 -1100.71 --0.328125 -0.109375 -0.328125 -3.24072 -3.24072 -3.24072 --0.359375 -0.109375 -0.296875 361.469 361.469 361.469 --0.359375 -0.109375 -0.265625 -290.531 -290.531 -290.531 --0.328125 -0.109375 -0.296875 385.605 385.605 385.605 --0.328125 -0.109375 -0.265625 112.713 112.713 112.713 --0.296875 -0.109375 -0.359375 150.11 150.11 150.11 --0.296875 -0.109375 -0.328125 120.416 120.416 120.416 --0.265625 -0.109375 -0.359375 201.982 201.982 201.982 --0.265625 -0.109375 -0.328125 -131.945 -131.945 -131.945 --0.265625 -0.078125 -0.328125 -13.7595 -13.7595 -13.7595 --0.296875 -0.109375 -0.296875 263.42 263.42 263.42 --0.296875 -0.109375 -0.265625 -80.3092 -80.3092 -80.3092 --0.296875 -0.078125 -0.296875 -208.616 -208.616 -208.616 --0.296875 -0.078125 -0.265625 -483.332 -483.332 -483.332 --0.265625 -0.109375 -0.265625 705.586 705.586 705.586 --0.265625 -0.078125 -0.296875 -53.2076 -53.2076 -53.2076 --0.265625 -0.078125 -0.265625 -316.448 -316.448 -316.448 --0.296875 -0.046875 -0.296875 -265.966 -265.966 -265.966 --0.296875 -0.046875 -0.265625 -250.593 -250.593 -250.593 --0.296875 -0.015625 -0.296875 1500.67 1500.67 1500.67 --0.296875 -0.015625 -0.265625 347.159 347.159 347.159 --0.265625 -0.046875 -0.296875 -23.142 -23.142 -23.142 --0.265625 -0.046875 -0.265625 -405.587 -405.587 -405.587 --0.265625 -0.015625 -0.296875 498.591 498.591 498.591 --0.453125 -0.203125 -0.171875 -42.4382 -42.4382 -42.4382 --0.453125 -0.171875 -0.171875 -46.2435 -46.2435 -46.2435 --0.453125 -0.171875 -0.140625 -54.9248 -54.9248 -54.9248 --0.421875 -0.234375 -0.203125 -7.58007 -7.58007 -7.58007 --0.421875 -0.203125 -0.203125 -1476.25 -1476.25 -1476.25 --0.390625 -0.234375 -0.234375 25.5817 25.5817 25.5817 --0.390625 -0.234375 -0.203125 -9.57959 -9.57959 -9.57959 --0.390625 -0.203125 -0.234375 -2096.16 -2096.16 -2096.16 --0.390625 -0.203125 -0.203125 -175.413 -175.413 -175.413 --0.421875 -0.234375 -0.171875 18.4153 18.4153 18.4153 --0.421875 -0.234375 -0.140625 -46.0013 -46.0013 -46.0013 --0.421875 -0.203125 -0.171875 -3531.67 -3531.67 -3531.67 --0.421875 -0.203125 -0.140625 -23.4814 -23.4814 -23.4814 --0.390625 -0.234375 -0.171875 -11.6984 -11.6984 -11.6984 --0.390625 -0.234375 -0.140625 -40.4182 -40.4182 -40.4182 --0.390625 -0.203125 -0.140625 -38.7154 -38.7154 -38.7154 --0.421875 -0.171875 -0.203125 970.637 970.637 970.637 --0.421875 -0.140625 -0.203125 -2422.61 -2422.61 -2422.61 --0.390625 -0.171875 -0.234375 1251.49 1251.49 1251.49 --0.390625 -0.171875 -0.203125 848.268 848.268 848.268 --0.390625 -0.140625 -0.203125 2317.31 2317.31 2317.31 --0.421875 -0.171875 -0.171875 -49.4947 -49.4947 -49.4947 --0.421875 -0.171875 -0.140625 16.7186 16.7186 16.7186 --0.421875 -0.140625 -0.171875 58.9967 58.9967 58.9967 --0.421875 -0.140625 -0.140625 -34.8774 -34.8774 -34.8774 --0.390625 -0.140625 -0.171875 1086.91 1086.91 1086.91 --0.390625 -0.140625 -0.140625 43.7496 43.7496 43.7496 --0.453125 -0.234375 -0.078125 -6.71841 -6.71841 -6.71841 --0.453125 -0.234375 -0.046875 -1.29061 -1.29061 -1.29061 --0.453125 -0.234375 -0.015625 19.1089 19.1089 19.1089 --0.453125 -0.203125 -0.015625 -1504.48 -1504.48 -1504.48 --0.453125 -0.171875 -0.015625 -1038.91 -1038.91 -1038.91 --0.421875 -0.234375 -0.078125 -30.3345 -30.3345 -30.3345 --0.421875 -0.203125 -0.109375 39.9424 39.9424 39.9424 --0.390625 -0.234375 -0.078125 -17.0854 -17.0854 -17.0854 --0.390625 -0.203125 -0.109375 -69.8866 -69.8866 -69.8866 --0.421875 -0.234375 -0.046875 -45.8981 -45.8981 -45.8981 --0.421875 -0.234375 -0.015625 -13.5968 -13.5968 -13.5968 --0.421875 -0.203125 -0.046875 -237.718 -237.718 -237.718 --0.421875 -0.203125 -0.015625 545.436 545.436 545.436 --0.390625 -0.234375 -0.046875 52.6765 52.6765 52.6765 --0.390625 -0.234375 -0.015625 6.51601 6.51601 6.51601 --0.390625 -0.203125 -0.046875 2.08737 2.08737 2.08737 --0.390625 -0.203125 -0.015625 25.9359 25.9359 25.9359 --0.421875 -0.171875 -0.109375 39.2475 39.2475 39.2475 --0.421875 -0.140625 -0.109375 -28.3561 -28.3561 -28.3561 --0.390625 -0.171875 -0.109375 -27.7798 -27.7798 -27.7798 --0.390625 -0.171875 -0.078125 239.684 239.684 239.684 --0.390625 -0.140625 -0.109375 14.6847 14.6847 14.6847 --0.390625 -0.140625 -0.078125 -4.8669 -4.8669 -4.8669 --0.421875 -0.171875 -0.015625 -1192.04 -1192.04 -1192.04 --0.390625 -0.171875 -0.046875 -101.366 -101.366 -101.366 --0.390625 -0.171875 -0.015625 -233 -233 -233 --0.390625 -0.140625 -0.046875 25.1869 25.1869 25.1869 --0.390625 -0.140625 -0.015625 30.8776 30.8776 30.8776 --0.453125 -0.046875 -0.203125 38.9536 38.9536 38.9536 --0.453125 -0.015625 -0.203125 229.182 229.182 229.182 --0.453125 -0.046875 -0.171875 82.9616 82.9616 82.9616 --0.453125 -0.046875 -0.140625 -91.114 -91.114 -91.114 --0.453125 -0.015625 -0.171875 90.8965 90.8965 90.8965 --0.453125 -0.015625 -0.140625 -77.2125 -77.2125 -77.2125 --0.390625 -0.109375 -0.203125 67.6525 67.6525 67.6525 --0.390625 -0.109375 -0.171875 -282.358 -282.358 -282.358 --0.390625 -0.109375 -0.140625 86.9234 86.9234 86.9234 --0.390625 -0.078125 -0.171875 91.2895 91.2895 91.2895 --0.390625 -0.078125 -0.140625 90.4296 90.4296 90.4296 --0.421875 -0.046875 -0.203125 -440.108 -440.108 -440.108 --0.421875 -0.015625 -0.234375 -43.5276 -43.5276 -43.5276 --0.421875 -0.015625 -0.203125 -46.186 -46.186 -46.186 --0.390625 -0.046875 -0.203125 -543.933 -543.933 -543.933 --0.390625 -0.015625 -0.234375 70.136 70.136 70.136 --0.390625 -0.015625 -0.203125 20.9092 20.9092 20.9092 --0.421875 -0.046875 -0.171875 -111.049 -111.049 -111.049 --0.421875 -0.046875 -0.140625 25.4261 25.4261 25.4261 --0.421875 -0.015625 -0.140625 17.375 17.375 17.375 --0.390625 -0.046875 -0.171875 153.554 153.554 153.554 --0.390625 -0.046875 -0.140625 -15.1599 -15.1599 -15.1599 --0.453125 -0.046875 -0.109375 -776.822 -776.822 -776.822 --0.453125 -0.046875 -0.078125 -1288.85 -1288.85 -1288.85 --0.453125 -0.015625 -0.109375 1296.27 1296.27 1296.27 --0.453125 -0.015625 -0.078125 1112.62 1112.62 1112.62 --0.453125 -0.046875 -0.046875 -772.328 -772.328 -772.328 --0.453125 -0.015625 -0.046875 365.606 365.606 365.606 --0.421875 -0.078125 -0.109375 1109.19 1109.19 1109.19 --0.421875 -0.078125 -0.078125 -328.729 -328.729 -328.729 --0.390625 -0.109375 -0.109375 64.9445 64.9445 64.9445 --0.390625 -0.109375 -0.078125 99.6304 99.6304 99.6304 --0.390625 -0.078125 -0.109375 151.64 151.64 151.64 --0.390625 -0.078125 -0.078125 37.2138 37.2138 37.2138 --0.390625 -0.109375 -0.046875 -20.6014 -20.6014 -20.6014 --0.390625 -0.109375 -0.015625 177.733 177.733 177.733 --0.390625 -0.078125 -0.015625 -11.6798 -11.6798 -11.6798 --0.421875 -0.046875 -0.109375 -630.398 -630.398 -630.398 --0.421875 -0.046875 -0.078125 -172.034 -172.034 -172.034 --0.390625 -0.046875 -0.109375 149.142 149.142 149.142 --0.390625 -0.046875 -0.078125 -34.9579 -34.9579 -34.9579 --0.421875 -0.046875 -0.046875 -4.21242 -4.21242 -4.21242 --0.421875 -0.015625 -0.046875 -505.195 -505.195 -505.195 --0.421875 -0.015625 -0.015625 -25.1921 -25.1921 -25.1921 --0.390625 -0.046875 -0.046875 -98.5448 -98.5448 -98.5448 --0.390625 -0.015625 -0.046875 -96.1 -96.1 -96.1 --0.390625 -0.015625 -0.015625 -105.051 -105.051 -105.051 --0.359375 -0.234375 -0.234375 14.1158 14.1158 14.1158 --0.359375 -0.234375 -0.203125 -12.482 -12.482 -12.482 --0.359375 -0.203125 -0.234375 1793.57 1793.57 1793.57 --0.359375 -0.203125 -0.203125 222.888 222.888 222.888 --0.328125 -0.234375 -0.234375 1.47808 1.47808 1.47808 --0.328125 -0.234375 -0.203125 -41.6301 -41.6301 -41.6301 --0.359375 -0.234375 -0.171875 24.2283 24.2283 24.2283 --0.359375 -0.234375 -0.140625 -17.41 -17.41 -17.41 --0.359375 -0.203125 -0.171875 -2423.54 -2423.54 -2423.54 --0.359375 -0.203125 -0.140625 4.90051 4.90051 4.90051 --0.328125 -0.234375 -0.171875 49.0275 49.0275 49.0275 --0.328125 -0.234375 -0.140625 7.99977 7.99977 7.99977 --0.328125 -0.203125 -0.171875 96.0322 96.0322 96.0322 --0.359375 -0.171875 -0.234375 777.35 777.35 777.35 --0.359375 -0.171875 -0.203125 778.123 778.123 778.123 --0.359375 -0.140625 -0.234375 699.782 699.782 699.782 --0.359375 -0.140625 -0.203125 1351.52 1351.52 1351.52 --0.328125 -0.140625 -0.234375 168.003 168.003 168.003 --0.296875 -0.234375 -0.234375 42.9218 42.9218 42.9218 --0.296875 -0.234375 -0.203125 43.3484 43.3484 43.3484 --0.296875 -0.203125 -0.234375 114.168 114.168 114.168 --0.296875 -0.203125 -0.203125 -124.759 -124.759 -124.759 --0.265625 -0.203125 -0.234375 -98.9686 -98.9686 -98.9686 --0.265625 -0.203125 -0.203125 33.7905 33.7905 33.7905 --0.296875 -0.234375 -0.171875 94.0549 94.0549 94.0549 --0.296875 -0.234375 -0.140625 -14.2127 -14.2127 -14.2127 --0.296875 -0.203125 -0.171875 106.191 106.191 106.191 --0.265625 -0.234375 -0.171875 49.1226 49.1226 49.1226 --0.265625 -0.234375 -0.140625 -65.2499 -65.2499 -65.2499 --0.265625 -0.203125 -0.171875 55.5694 55.5694 55.5694 --0.265625 -0.203125 -0.140625 54.9757 54.9757 54.9757 --0.265625 -0.171875 -0.203125 -11.3951 -11.3951 -11.3951 --0.265625 -0.140625 -0.203125 -20.1639 -20.1639 -20.1639 --0.296875 -0.171875 -0.171875 24.1194 24.1194 24.1194 --0.296875 -0.171875 -0.140625 44.6852 44.6852 44.6852 --0.296875 -0.140625 -0.171875 -88.9901 -88.9901 -88.9901 --0.296875 -0.140625 -0.140625 31.8792 31.8792 31.8792 --0.265625 -0.171875 -0.171875 -40.4245 -40.4245 -40.4245 --0.265625 -0.171875 -0.140625 92.3891 92.3891 92.3891 --0.265625 -0.140625 -0.171875 6.60701 6.60701 6.60701 --0.265625 -0.140625 -0.140625 -108.19 -108.19 -108.19 --0.359375 -0.234375 -0.109375 -13.1727 -13.1727 -13.1727 --0.359375 -0.234375 -0.078125 -4.39133 -4.39133 -4.39133 --0.359375 -0.203125 -0.109375 26.952 26.952 26.952 --0.359375 -0.203125 -0.078125 65.3818 65.3818 65.3818 --0.328125 -0.234375 -0.109375 -62.7004 -62.7004 -62.7004 --0.328125 -0.234375 -0.078125 -48.1163 -48.1163 -48.1163 --0.328125 -0.203125 -0.078125 -39.3114 -39.3114 -39.3114 --0.359375 -0.234375 -0.046875 12.6779 12.6779 12.6779 --0.359375 -0.234375 -0.015625 4.8723 4.8723 4.8723 --0.359375 -0.203125 -0.015625 23.6779 23.6779 23.6779 --0.328125 -0.234375 -0.046875 -25.8386 -25.8386 -25.8386 --0.328125 -0.234375 -0.015625 694.797 694.797 694.797 --0.328125 -0.203125 -0.046875 -7.61469 -7.61469 -7.61469 --0.359375 -0.171875 -0.109375 9.51796 9.51796 9.51796 --0.359375 -0.171875 -0.078125 87.0344 87.0344 87.0344 --0.328125 -0.171875 -0.078125 -10.368 -10.368 -10.368 --0.359375 -0.171875 -0.046875 -22.7792 -22.7792 -22.7792 --0.359375 -0.171875 -0.015625 21.0179 21.0179 21.0179 --0.359375 -0.140625 -0.046875 4.2591 4.2591 4.2591 --0.359375 -0.140625 -0.015625 15.8739 15.8739 15.8739 --0.328125 -0.171875 -0.046875 -48.7457 -48.7457 -48.7457 --0.328125 -0.171875 -0.015625 -12.3674 -12.3674 -12.3674 --0.328125 -0.140625 -0.046875 -8.25151 -8.25151 -8.25151 --0.328125 -0.140625 -0.015625 -15.9008 -15.9008 -15.9008 --0.296875 -0.234375 -0.109375 -82.24 -82.24 -82.24 --0.296875 -0.234375 -0.078125 -4.74924 -4.74924 -4.74924 --0.265625 -0.234375 -0.109375 2.4616 2.4616 2.4616 --0.265625 -0.234375 -0.078125 -46.6253 -46.6253 -46.6253 --0.265625 -0.203125 -0.109375 22.7153 22.7153 22.7153 --0.296875 -0.234375 -0.046875 5.94091 5.94091 5.94091 --0.296875 -0.234375 -0.015625 2146.34 2146.34 2146.34 --0.296875 -0.203125 -0.046875 2.64258 2.64258 2.64258 --0.296875 -0.203125 -0.015625 -5.30075 -5.30075 -5.30075 --0.265625 -0.234375 -0.046875 -33.9139 -33.9139 -33.9139 --0.265625 -0.234375 -0.015625 1519.36 1519.36 1519.36 --0.265625 -0.203125 -0.046875 -37.0598 -37.0598 -37.0598 --0.265625 -0.203125 -0.015625 -5.6526 -5.6526 -5.6526 --0.296875 -0.171875 -0.078125 -15.1167 -15.1167 -15.1167 --0.296875 -0.140625 -0.109375 -38.0066 -38.0066 -38.0066 --0.296875 -0.140625 -0.078125 2.01473 2.01473 2.01473 --0.265625 -0.171875 -0.109375 17.3213 17.3213 17.3213 --0.265625 -0.171875 -0.078125 -4.14306 -4.14306 -4.14306 --0.265625 -0.140625 -0.109375 -32.2989 -32.2989 -32.2989 --0.265625 -0.140625 -0.078125 -10.0713 -10.0713 -10.0713 --0.296875 -0.171875 -0.046875 10.2517 10.2517 10.2517 --0.296875 -0.140625 -0.046875 -22.2917 -22.2917 -22.2917 --0.296875 -0.140625 -0.015625 -9.63008 -9.63008 -9.63008 --0.265625 -0.171875 -0.046875 -26.6685 -26.6685 -26.6685 --0.265625 -0.171875 -0.015625 -7.79024 -7.79024 -7.79024 --0.265625 -0.140625 -0.015625 -19.1966 -19.1966 -19.1966 --0.359375 -0.109375 -0.234375 -610.044 -610.044 -610.044 --0.359375 -0.109375 -0.203125 -265.986 -265.986 -265.986 --0.359375 -0.078125 -0.203125 344.462 344.462 344.462 --0.328125 -0.109375 -0.234375 182.559 182.559 182.559 --0.328125 -0.109375 -0.203125 543.297 543.297 543.297 --0.328125 -0.078125 -0.234375 475.191 475.191 475.191 --0.328125 -0.078125 -0.203125 419.273 419.273 419.273 --0.359375 -0.109375 -0.171875 -1543.48 -1543.48 -1543.48 --0.359375 -0.109375 -0.140625 -130.668 -130.668 -130.668 --0.359375 -0.078125 -0.171875 -65.6412 -65.6412 -65.6412 --0.359375 -0.078125 -0.140625 89.9195 89.9195 89.9195 --0.328125 -0.109375 -0.171875 -1445.43 -1445.43 -1445.43 --0.328125 -0.109375 -0.140625 -63.2562 -63.2562 -63.2562 --0.328125 -0.078125 -0.171875 -497.535 -497.535 -497.535 --0.328125 -0.078125 -0.140625 -151.737 -151.737 -151.737 --0.359375 -0.046875 -0.203125 406.122 406.122 406.122 --0.359375 -0.015625 -0.203125 81.2837 81.2837 81.2837 --0.328125 -0.046875 -0.234375 822.061 822.061 822.061 --0.328125 -0.046875 -0.203125 334.244 334.244 334.244 --0.328125 -0.015625 -0.234375 131.267 131.267 131.267 --0.328125 -0.015625 -0.203125 204.295 204.295 204.295 --0.359375 -0.046875 -0.171875 458.791 458.791 458.791 --0.359375 -0.046875 -0.140625 321.559 321.559 321.559 --0.328125 -0.046875 -0.140625 -278.702 -278.702 -278.702 --0.296875 -0.109375 -0.234375 6.95966 6.95966 6.95966 --0.296875 -0.078125 -0.234375 624.091 624.091 624.091 --0.265625 -0.109375 -0.234375 -108.005 -108.005 -108.005 --0.265625 -0.109375 -0.203125 382.123 382.123 382.123 --0.265625 -0.078125 -0.234375 -97.2424 -97.2424 -97.2424 --0.265625 -0.078125 -0.203125 69.4692 69.4692 69.4692 --0.296875 -0.109375 -0.171875 -412.465 -412.465 -412.465 --0.296875 -0.109375 -0.140625 -35.1063 -35.1063 -35.1063 --0.296875 -0.078125 -0.140625 138.76 138.76 138.76 --0.265625 -0.109375 -0.171875 137.156 137.156 137.156 --0.265625 -0.109375 -0.140625 -5.8636 -5.8636 -5.8636 --0.265625 -0.078125 -0.171875 -55.3818 -55.3818 -55.3818 --0.265625 -0.078125 -0.140625 -109.037 -109.037 -109.037 --0.296875 -0.046875 -0.234375 370.635 370.635 370.635 --0.296875 -0.015625 -0.234375 670.826 670.826 670.826 --0.265625 -0.046875 -0.234375 -63.6915 -63.6915 -63.6915 --0.265625 -0.046875 -0.203125 -24.576 -24.576 -24.576 --0.296875 -0.046875 -0.140625 -86.713 -86.713 -86.713 --0.296875 -0.015625 -0.140625 -666.853 -666.853 -666.853 --0.265625 -0.046875 -0.171875 66.156 66.156 66.156 --0.265625 -0.046875 -0.140625 46.1944 46.1944 46.1944 --0.265625 -0.015625 -0.140625 17.6872 17.6872 17.6872 --0.359375 -0.109375 -0.109375 -57.5946 -57.5946 -57.5946 --0.359375 -0.109375 -0.078125 120.968 120.968 120.968 --0.359375 -0.078125 -0.109375 3.3651 3.3651 3.3651 --0.359375 -0.078125 -0.078125 -33.4198 -33.4198 -33.4198 --0.328125 -0.109375 -0.109375 -29.1529 -29.1529 -29.1529 --0.328125 -0.109375 -0.078125 93.6944 93.6944 93.6944 --0.328125 -0.078125 -0.109375 -168.794 -168.794 -168.794 --0.328125 -0.078125 -0.078125 29.2009 29.2009 29.2009 --0.359375 -0.109375 -0.046875 -3.0573 -3.0573 -3.0573 --0.359375 -0.109375 -0.015625 25.2309 25.2309 25.2309 --0.359375 -0.078125 -0.046875 42.9496 42.9496 42.9496 --0.359375 -0.078125 -0.015625 15.7145 15.7145 15.7145 --0.328125 -0.109375 -0.046875 59.0868 59.0868 59.0868 --0.328125 -0.109375 -0.015625 38.3448 38.3448 38.3448 --0.328125 -0.078125 -0.046875 -10.5951 -10.5951 -10.5951 --0.328125 -0.078125 -0.015625 58.2061 58.2061 58.2061 --0.359375 -0.046875 -0.109375 5.09714 5.09714 5.09714 --0.359375 -0.046875 -0.078125 28.8555 28.8555 28.8555 --0.328125 -0.046875 -0.109375 -166.321 -166.321 -166.321 --0.328125 -0.046875 -0.078125 -5.18324 -5.18324 -5.18324 --0.328125 -0.015625 -0.109375 -44.565 -44.565 -44.565 --0.359375 -0.046875 -0.046875 -8.8362 -8.8362 -8.8362 --0.359375 -0.046875 -0.015625 20.947 20.947 20.947 --0.359375 -0.015625 -0.046875 44.1134 44.1134 44.1134 --0.359375 -0.015625 -0.015625 21.0537 21.0537 21.0537 --0.328125 -0.046875 -0.046875 9.56309 9.56309 9.56309 --0.328125 -0.046875 -0.015625 33.5126 33.5126 33.5126 --0.328125 -0.015625 -0.015625 18.3011 18.3011 18.3011 --0.296875 -0.109375 -0.109375 28.4998 28.4998 28.4998 --0.296875 -0.109375 -0.078125 62.7521 62.7521 62.7521 --0.265625 -0.109375 -0.109375 -127.499 -127.499 -127.499 --0.265625 -0.109375 -0.078125 -62.3855 -62.3855 -62.3855 --0.265625 -0.078125 -0.109375 -23.5139 -23.5139 -23.5139 --0.265625 -0.078125 -0.078125 -32.1589 -32.1589 -32.1589 --0.296875 -0.109375 -0.046875 55.4095 55.4095 55.4095 --0.296875 -0.109375 -0.015625 3.3526 3.3526 3.3526 --0.296875 -0.078125 -0.046875 -35.8275 -35.8275 -35.8275 --0.296875 -0.078125 -0.015625 1.88606 1.88606 1.88606 --0.265625 -0.109375 -0.046875 -12.704 -12.704 -12.704 --0.265625 -0.109375 -0.015625 -12.0893 -12.0893 -12.0893 --0.265625 -0.078125 -0.046875 -76.5767 -76.5767 -76.5767 --0.265625 -0.078125 -0.015625 -36.9838 -36.9838 -36.9838 --0.296875 -0.046875 -0.109375 -16.284 -16.284 -16.284 --0.296875 -0.046875 -0.078125 3.00576 3.00576 3.00576 --0.296875 -0.015625 -0.109375 188.795 188.795 188.795 --0.296875 -0.015625 -0.078125 -74.2724 -74.2724 -74.2724 --0.265625 -0.046875 -0.109375 106.877 106.877 106.877 --0.265625 -0.046875 -0.078125 95.5244 95.5244 95.5244 --0.265625 -0.015625 -0.078125 5.08187 5.08187 5.08187 --0.296875 -0.046875 -0.046875 24.0486 24.0486 24.0486 --0.296875 -0.046875 -0.015625 49.3866 49.3866 49.3866 --0.296875 -0.015625 -0.046875 -29.7879 -29.7879 -29.7879 --0.296875 -0.015625 -0.015625 25.7218 25.7218 25.7218 --0.265625 -0.046875 -0.046875 80.9342 80.9342 80.9342 --0.265625 -0.015625 -0.046875 45.6286 45.6286 45.6286 --0.265625 -0.015625 -0.015625 34.6448 34.6448 34.6448 --0.203125 -0.265625 -0.265625 -397.409 -397.409 -397.409 --0.015625 -0.265625 -0.265625 -22.3265 -22.3265 -22.3265 --0.234375 -0.390625 -0.046875 -0.393601 -0.393601 -0.393601 --0.234375 -0.390625 -0.015625 -34.5717 -34.5717 -34.5717 --0.203125 -0.390625 -0.046875 379.802 379.802 379.802 --0.203125 -0.390625 -0.015625 251.01 251.01 251.01 --0.171875 -0.390625 -0.046875 -508.394 -508.394 -508.394 --0.171875 -0.390625 -0.015625 -95.1801 -95.1801 -95.1801 --0.234375 -0.265625 -0.234375 186.685 186.685 186.685 --0.203125 -0.265625 -0.234375 -739.409 -739.409 -739.409 --0.203125 -0.265625 -0.203125 136.085 136.085 136.085 --0.203125 -0.296875 -0.171875 84.449 84.449 84.449 --0.203125 -0.296875 -0.140625 126.794 126.794 126.794 --0.203125 -0.265625 -0.171875 16.3666 16.3666 16.3666 --0.203125 -0.265625 -0.140625 146.524 146.524 146.524 --0.171875 -0.265625 -0.234375 -130.491 -130.491 -130.491 --0.171875 -0.265625 -0.203125 575.164 575.164 575.164 --0.140625 -0.265625 -0.234375 41.8672 41.8672 41.8672 --0.140625 -0.265625 -0.203125 3.72131 3.72131 3.72131 --0.171875 -0.296875 -0.171875 -49.9451 -49.9451 -49.9451 --0.171875 -0.296875 -0.140625 6.01954 6.01954 6.01954 --0.171875 -0.265625 -0.171875 -109.133 -109.133 -109.133 --0.140625 -0.296875 -0.171875 -3.03231 -3.03231 -3.03231 --0.140625 -0.296875 -0.140625 -43.7237 -43.7237 -43.7237 --0.140625 -0.265625 -0.171875 -11.3185 -11.3185 -11.3185 --0.140625 -0.265625 -0.140625 38.2735 38.2735 38.2735 --0.234375 -0.359375 -0.078125 -6.23076 -6.23076 -6.23076 --0.234375 -0.328125 -0.078125 -25.4898 -25.4898 -25.4898 --0.234375 -0.359375 -0.046875 3.56033 3.56033 3.56033 --0.234375 -0.328125 -0.046875 -13.3682 -13.3682 -13.3682 --0.203125 -0.359375 -0.046875 -1.39031 -1.39031 -1.39031 --0.203125 -0.328125 -0.046875 6.13039 6.13039 6.13039 --0.234375 -0.296875 -0.078125 1.66654 1.66654 1.66654 --0.203125 -0.296875 -0.109375 105.332 105.332 105.332 --0.203125 -0.265625 -0.109375 -11.3382 -11.3382 -11.3382 --0.203125 -0.265625 -0.078125 12.8435 12.8435 12.8435 --0.234375 -0.296875 -0.046875 -0.675797 -0.675797 -0.675797 --0.234375 -0.296875 -0.015625 -2.2368 -2.2368 -2.2368 --0.234375 -0.265625 -0.046875 -15.8875 -15.8875 -15.8875 --0.234375 -0.265625 -0.015625 -16.0002 -16.0002 -16.0002 --0.203125 -0.296875 -0.046875 24.1803 24.1803 24.1803 --0.203125 -0.296875 -0.015625 37.0804 37.0804 37.0804 --0.203125 -0.265625 -0.046875 24.3288 24.3288 24.3288 --0.203125 -0.265625 -0.015625 -29.11 -29.11 -29.11 --0.171875 -0.359375 -0.046875 -13.9489 -13.9489 -13.9489 --0.171875 -0.359375 -0.015625 -10.1881 -10.1881 -10.1881 --0.171875 -0.328125 -0.046875 35.1029 35.1029 35.1029 --0.171875 -0.328125 -0.015625 24.4849 24.4849 24.4849 --0.171875 -0.296875 -0.109375 72.566 72.566 72.566 --0.171875 -0.296875 -0.078125 22.4118 22.4118 22.4118 --0.171875 -0.265625 -0.109375 25.239 25.239 25.239 --0.171875 -0.265625 -0.078125 104.104 104.104 104.104 --0.140625 -0.296875 -0.109375 57.2343 57.2343 57.2343 --0.140625 -0.296875 -0.078125 20.666 20.666 20.666 --0.140625 -0.265625 -0.109375 28.9818 28.9818 28.9818 --0.140625 -0.265625 -0.078125 -37.4425 -37.4425 -37.4425 --0.171875 -0.296875 -0.046875 27.2123 27.2123 27.2123 --0.171875 -0.296875 -0.015625 -4.10041 -4.10041 -4.10041 --0.171875 -0.265625 -0.046875 -42.4017 -42.4017 -42.4017 --0.171875 -0.265625 -0.015625 -33.6917 -33.6917 -33.6917 --0.140625 -0.265625 -0.015625 71.0366 71.0366 71.0366 --0.109375 -0.265625 -0.234375 -14.261 -14.261 -14.261 --0.109375 -0.265625 -0.203125 254.794 254.794 254.794 --0.078125 -0.265625 -0.203125 118.939 118.939 118.939 --0.109375 -0.296875 -0.140625 -169.177 -169.177 -169.177 --0.109375 -0.265625 -0.171875 43.5854 43.5854 43.5854 --0.109375 -0.265625 -0.140625 3.12595 3.12595 3.12595 --0.078125 -0.265625 -0.171875 -86.5957 -86.5957 -86.5957 --0.015625 -0.265625 -0.234375 222.851 222.851 222.851 --0.109375 -0.265625 -0.109375 119.724 119.724 119.724 --0.234375 -0.203125 -0.359375 83.8145 83.8145 83.8145 --0.234375 -0.203125 -0.328125 -6.61059 -6.61059 -6.61059 --0.203125 -0.203125 -0.359375 8.3392 8.3392 8.3392 --0.203125 -0.203125 -0.328125 -45.0939 -45.0939 -45.0939 --0.234375 -0.234375 -0.265625 240.587 240.587 240.587 --0.234375 -0.203125 -0.296875 181.886 181.886 181.886 --0.234375 -0.203125 -0.265625 -1.66438 -1.66438 -1.66438 --0.203125 -0.234375 -0.265625 -182.649 -182.649 -182.649 --0.203125 -0.203125 -0.296875 -41.4058 -41.4058 -41.4058 --0.203125 -0.203125 -0.265625 -38.2136 -38.2136 -38.2136 --0.234375 -0.171875 -0.359375 -63.9437 -63.9437 -63.9437 --0.234375 -0.140625 -0.359375 -1427.17 -1427.17 -1427.17 --0.203125 -0.171875 -0.359375 -632.105 -632.105 -632.105 --0.203125 -0.171875 -0.328125 392.484 392.484 392.484 --0.203125 -0.140625 -0.359375 695.392 695.392 695.392 --0.203125 -0.140625 -0.328125 2778.64 2778.64 2778.64 --0.234375 -0.171875 -0.265625 10.1404 10.1404 10.1404 --0.234375 -0.140625 -0.265625 13.1721 13.1721 13.1721 --0.203125 -0.171875 -0.296875 -1271.64 -1271.64 -1271.64 --0.203125 -0.171875 -0.265625 1.1453 1.1453 1.1453 --0.203125 -0.140625 -0.296875 1625.27 1625.27 1625.27 --0.203125 -0.140625 -0.265625 -17.4336 -17.4336 -17.4336 --0.171875 -0.234375 -0.328125 39.3483 39.3483 39.3483 --0.171875 -0.203125 -0.328125 -115.571 -115.571 -115.571 --0.140625 -0.234375 -0.328125 29.6557 29.6557 29.6557 --0.140625 -0.203125 -0.328125 -18.4686 -18.4686 -18.4686 --0.171875 -0.234375 -0.296875 42.1496 42.1496 42.1496 --0.171875 -0.234375 -0.265625 -14.3205 -14.3205 -14.3205 --0.171875 -0.203125 -0.296875 -48.6347 -48.6347 -48.6347 --0.171875 -0.203125 -0.265625 22.9301 22.9301 22.9301 --0.140625 -0.234375 -0.296875 62.2386 62.2386 62.2386 --0.140625 -0.234375 -0.265625 39.4468 39.4468 39.4468 --0.171875 -0.171875 -0.328125 1309.7 1309.7 1309.7 --0.171875 -0.140625 -0.328125 419.176 419.176 419.176 --0.140625 -0.171875 -0.328125 11.7995 11.7995 11.7995 --0.140625 -0.140625 -0.359375 93.5458 93.5458 93.5458 --0.140625 -0.140625 -0.328125 -10.4346 -10.4346 -10.4346 --0.171875 -0.171875 -0.296875 449.216 449.216 449.216 --0.171875 -0.171875 -0.265625 -8.02889 -8.02889 -8.02889 --0.171875 -0.140625 -0.296875 -2087.89 -2087.89 -2087.89 --0.171875 -0.140625 -0.265625 -456.561 -456.561 -456.561 --0.140625 -0.171875 -0.296875 -62.5803 -62.5803 -62.5803 --0.140625 -0.140625 -0.296875 -107.11 -107.11 -107.11 --0.140625 -0.140625 -0.265625 -295.052 -295.052 -295.052 --0.140625 -0.109375 -0.390625 30.0256 30.0256 30.0256 --0.140625 -0.078125 -0.390625 -5.66289 -5.66289 -5.66289 --0.234375 -0.109375 -0.359375 -197.3 -197.3 -197.3 --0.234375 -0.109375 -0.328125 -2424.72 -2424.72 -2424.72 --0.203125 -0.109375 -0.359375 103.892 103.892 103.892 --0.203125 -0.109375 -0.328125 1552.85 1552.85 1552.85 --0.234375 -0.109375 -0.296875 -1169.92 -1169.92 -1169.92 --0.234375 -0.109375 -0.265625 5.61738 5.61738 5.61738 --0.234375 -0.078125 -0.296875 -16.2251 -16.2251 -16.2251 --0.234375 -0.078125 -0.265625 91.4028 91.4028 91.4028 --0.203125 -0.109375 -0.296875 82.9765 82.9765 82.9765 --0.203125 -0.109375 -0.265625 104.366 104.366 104.366 --0.203125 -0.078125 -0.265625 89.6398 89.6398 89.6398 --0.234375 -0.015625 -0.328125 -170.267 -170.267 -170.267 --0.203125 -0.046875 -0.328125 -33.5763 -33.5763 -33.5763 --0.203125 -0.015625 -0.328125 -15.2317 -15.2317 -15.2317 --0.234375 -0.046875 -0.296875 56.4426 56.4426 56.4426 --0.234375 -0.046875 -0.265625 152.217 152.217 152.217 --0.234375 -0.015625 -0.296875 -26.6271 -26.6271 -26.6271 --0.234375 -0.015625 -0.265625 574.566 574.566 574.566 --0.203125 -0.046875 -0.296875 -7.83425 -7.83425 -7.83425 --0.203125 -0.046875 -0.265625 8.91925 8.91925 8.91925 --0.203125 -0.015625 -0.296875 23.7946 23.7946 23.7946 --0.203125 -0.015625 -0.265625 419.506 419.506 419.506 --0.171875 -0.109375 -0.359375 -1129.19 -1129.19 -1129.19 --0.171875 -0.109375 -0.328125 1001.24 1001.24 1001.24 --0.171875 -0.078125 -0.359375 -109.003 -109.003 -109.003 --0.171875 -0.078125 -0.328125 -9.50784 -9.50784 -9.50784 --0.140625 -0.109375 -0.359375 45.6604 45.6604 45.6604 --0.140625 -0.109375 -0.328125 -272.931 -272.931 -272.931 --0.140625 -0.078125 -0.359375 0.707342 0.707342 0.707342 --0.171875 -0.109375 -0.296875 428.273 428.273 428.273 --0.171875 -0.109375 -0.265625 -145.444 -145.444 -145.444 --0.171875 -0.078125 -0.296875 558.154 558.154 558.154 --0.171875 -0.078125 -0.265625 3.08313 3.08313 3.08313 --0.140625 -0.109375 -0.296875 -524.651 -524.651 -524.651 --0.140625 -0.109375 -0.265625 -354.767 -354.767 -354.767 --0.140625 -0.078125 -0.296875 188.854 188.854 188.854 --0.140625 -0.078125 -0.265625 -45.5613 -45.5613 -45.5613 --0.171875 -0.046875 -0.359375 46.067 46.067 46.067 --0.171875 -0.046875 -0.328125 -39.3721 -39.3721 -39.3721 --0.171875 -0.015625 -0.328125 -14.1837 -14.1837 -14.1837 --0.140625 -0.046875 -0.359375 11.7885 11.7885 11.7885 --0.140625 -0.046875 -0.328125 -10.8735 -10.8735 -10.8735 --0.140625 -0.015625 -0.328125 -4.4679 -4.4679 -4.4679 --0.171875 -0.046875 -0.296875 -16.4586 -16.4586 -16.4586 --0.171875 -0.046875 -0.265625 -116.879 -116.879 -116.879 --0.171875 -0.015625 -0.296875 -16.1898 -16.1898 -16.1898 --0.171875 -0.015625 -0.265625 46.0983 46.0983 46.0983 --0.140625 -0.046875 -0.296875 -9.07126 -9.07126 -9.07126 --0.140625 -0.046875 -0.265625 1.63489 1.63489 1.63489 --0.140625 -0.015625 -0.296875 5.18622 5.18622 5.18622 --0.140625 -0.015625 -0.265625 4.80799 4.80799 4.80799 --0.109375 -0.234375 -0.328125 11.8641 11.8641 11.8641 --0.109375 -0.203125 -0.328125 -15.8139 -15.8139 -15.8139 --0.078125 -0.203125 -0.328125 -77.9682 -77.9682 -77.9682 --0.109375 -0.234375 -0.296875 -6.15915 -6.15915 -6.15915 --0.109375 -0.234375 -0.265625 -70.2543 -70.2543 -70.2543 --0.078125 -0.234375 -0.296875 31.623 31.623 31.623 --0.078125 -0.234375 -0.265625 42.4358 42.4358 42.4358 --0.078125 -0.203125 -0.296875 -57.0204 -57.0204 -57.0204 --0.078125 -0.203125 -0.265625 -103.531 -103.531 -103.531 --0.109375 -0.171875 -0.328125 71.6479 71.6479 71.6479 --0.109375 -0.140625 -0.359375 173.484 173.484 173.484 --0.109375 -0.140625 -0.328125 -76.4148 -76.4148 -76.4148 --0.078125 -0.171875 -0.328125 163.461 163.461 163.461 --0.078125 -0.140625 -0.359375 147.148 147.148 147.148 --0.078125 -0.140625 -0.328125 83.9477 83.9477 83.9477 --0.109375 -0.171875 -0.296875 4.82956 4.82956 4.82956 --0.109375 -0.140625 -0.296875 65.2862 65.2862 65.2862 --0.109375 -0.140625 -0.265625 -39.1577 -39.1577 -39.1577 --0.078125 -0.171875 -0.296875 6.56841 6.56841 6.56841 --0.046875 -0.234375 -0.328125 111.058 111.058 111.058 --0.046875 -0.203125 -0.328125 -126.378 -126.378 -126.378 --0.015625 -0.234375 -0.328125 5963.93 5963.93 5963.93 --0.015625 -0.203125 -0.359375 -6334.4 -6334.4 -6334.4 --0.015625 -0.203125 -0.328125 535.62 535.62 535.62 --0.046875 -0.234375 -0.296875 46.4178 46.4178 46.4178 --0.046875 -0.203125 -0.296875 -69.467 -69.467 -69.467 --0.046875 -0.203125 -0.265625 -94.4659 -94.4659 -94.4659 --0.015625 -0.234375 -0.296875 4.10117 4.10117 4.10117 --0.015625 -0.234375 -0.265625 -104.97 -104.97 -104.97 --0.015625 -0.203125 -0.265625 -36.7565 -36.7565 -36.7565 --0.046875 -0.171875 -0.328125 16.2021 16.2021 16.2021 --0.046875 -0.140625 -0.328125 1.35767 1.35767 1.35767 --0.015625 -0.171875 -0.328125 -676.171 -676.171 -676.171 --0.015625 -0.140625 -0.328125 0.184445 0.184445 0.184445 --0.046875 -0.171875 -0.296875 -149.307 -149.307 -149.307 --0.046875 -0.171875 -0.265625 -27.2317 -27.2317 -27.2317 --0.015625 -0.140625 -0.296875 274.734 274.734 274.734 --0.109375 -0.109375 -0.390625 19.023 19.023 19.023 --0.109375 -0.078125 -0.390625 16.1646 16.1646 16.1646 --0.078125 -0.015625 -0.390625 -70.5369 -70.5369 -70.5369 --0.046875 -0.046875 -0.390625 -12.493 -12.493 -12.493 --0.046875 -0.015625 -0.421875 -13.1244 -13.1244 -13.1244 --0.046875 -0.015625 -0.390625 -28.3369 -28.3369 -28.3369 --0.015625 -0.046875 -0.390625 55.8923 55.8923 55.8923 --0.015625 -0.015625 -0.421875 -122.482 -122.482 -122.482 --0.015625 -0.015625 -0.390625 171.368 171.368 171.368 --0.109375 -0.109375 -0.359375 192.621 192.621 192.621 --0.109375 -0.078125 -0.359375 -60.2928 -60.2928 -60.2928 --0.078125 -0.109375 -0.359375 226.807 226.807 226.807 --0.078125 -0.109375 -0.328125 35.2945 35.2945 35.2945 --0.078125 -0.078125 -0.359375 -38.1209 -38.1209 -38.1209 --0.078125 -0.078125 -0.328125 22.7351 22.7351 22.7351 --0.109375 -0.109375 -0.296875 -158.649 -158.649 -158.649 --0.109375 -0.109375 -0.265625 -26.5519 -26.5519 -26.5519 --0.109375 -0.078125 -0.265625 -17.3578 -17.3578 -17.3578 --0.078125 -0.109375 -0.265625 -383.594 -383.594 -383.594 --0.078125 -0.078125 -0.265625 54.6134 54.6134 54.6134 --0.109375 -0.046875 -0.359375 24.9024 24.9024 24.9024 --0.109375 -0.046875 -0.328125 -6.46374 -6.46374 -6.46374 --0.109375 -0.015625 -0.359375 -18.3232 -18.3232 -18.3232 --0.109375 -0.015625 -0.328125 -23.7195 -23.7195 -23.7195 --0.078125 -0.046875 -0.359375 13.9549 13.9549 13.9549 --0.078125 -0.046875 -0.328125 21.0416 21.0416 21.0416 --0.078125 -0.015625 -0.359375 -4.30216 -4.30216 -4.30216 --0.078125 -0.015625 -0.328125 -78.8142 -78.8142 -78.8142 --0.109375 -0.046875 -0.296875 14.8488 14.8488 14.8488 --0.109375 -0.046875 -0.265625 -8.52445 -8.52445 -8.52445 --0.109375 -0.015625 -0.296875 4.48847 4.48847 4.48847 --0.109375 -0.015625 -0.265625 4.55144 4.55144 4.55144 --0.078125 -0.046875 -0.296875 -32.1048 -32.1048 -32.1048 --0.078125 -0.046875 -0.265625 -22.5633 -22.5633 -22.5633 --0.078125 -0.015625 -0.296875 48.0319 48.0319 48.0319 --0.078125 -0.015625 -0.265625 13.2596 13.2596 13.2596 --0.046875 -0.109375 -0.359375 71.5716 71.5716 71.5716 --0.046875 -0.109375 -0.328125 13.4448 13.4448 13.4448 --0.046875 -0.078125 -0.359375 27.3218 27.3218 27.3218 --0.046875 -0.078125 -0.328125 -66.1523 -66.1523 -66.1523 --0.015625 -0.109375 -0.328125 402.215 402.215 402.215 --0.015625 -0.078125 -0.328125 8.39152 8.39152 8.39152 --0.046875 -0.109375 -0.265625 -20.4085 -20.4085 -20.4085 --0.046875 -0.078125 -0.265625 -63.3417 -63.3417 -63.3417 --0.015625 -0.109375 -0.296875 383.861 383.861 383.861 --0.015625 -0.109375 -0.265625 71.5005 71.5005 71.5005 --0.015625 -0.078125 -0.296875 58.5118 58.5118 58.5118 --0.015625 -0.078125 -0.265625 64.0941 64.0941 64.0941 --0.046875 -0.046875 -0.359375 -23.211 -23.211 -23.211 --0.046875 -0.046875 -0.328125 -36.5868 -36.5868 -36.5868 --0.046875 -0.015625 -0.359375 42.5948 42.5948 42.5948 --0.046875 -0.015625 -0.328125 24.7625 24.7625 24.7625 --0.015625 -0.046875 -0.359375 -7.9055 -7.9055 -7.9055 --0.015625 -0.046875 -0.328125 -16.6353 -16.6353 -16.6353 --0.015625 -0.015625 -0.328125 6.47911 6.47911 6.47911 --0.046875 -0.046875 -0.296875 23.9586 23.9586 23.9586 --0.046875 -0.046875 -0.265625 -4.07757 -4.07757 -4.07757 --0.046875 -0.015625 -0.296875 -82.6935 -82.6935 -82.6935 --0.046875 -0.015625 -0.265625 20.3242 20.3242 20.3242 --0.015625 -0.046875 -0.296875 -44.3275 -44.3275 -44.3275 --0.015625 -0.015625 -0.296875 -6.84848 -6.84848 -6.84848 --0.015625 -0.015625 -0.265625 14.876 14.876 14.876 --0.234375 -0.234375 -0.234375 16.3325 16.3325 16.3325 --0.234375 -0.234375 -0.203125 -61.4013 -61.4013 -61.4013 --0.234375 -0.203125 -0.234375 -55.129 -55.129 -55.129 --0.234375 -0.203125 -0.203125 -3.18633 -3.18633 -3.18633 --0.203125 -0.234375 -0.234375 -138.361 -138.361 -138.361 --0.203125 -0.234375 -0.203125 -217.669 -217.669 -217.669 --0.203125 -0.203125 -0.203125 28.6627 28.6627 28.6627 --0.234375 -0.203125 -0.171875 -4.89507 -4.89507 -4.89507 --0.203125 -0.234375 -0.171875 31.6744 31.6744 31.6744 --0.203125 -0.234375 -0.140625 -55.7337 -55.7337 -55.7337 --0.203125 -0.203125 -0.171875 -7.4945 -7.4945 -7.4945 --0.203125 -0.203125 -0.140625 19.6898 19.6898 19.6898 --0.234375 -0.171875 -0.203125 43.9182 43.9182 43.9182 --0.234375 -0.140625 -0.203125 70.7455 70.7455 70.7455 --0.203125 -0.140625 -0.203125 -27.0154 -27.0154 -27.0154 --0.234375 -0.171875 -0.171875 3.64323 3.64323 3.64323 --0.234375 -0.140625 -0.171875 -7.85325 -7.85325 -7.85325 --0.234375 -0.140625 -0.140625 -274.369 -274.369 -274.369 --0.203125 -0.171875 -0.171875 9.48597 9.48597 9.48597 --0.203125 -0.171875 -0.140625 11.904 11.904 11.904 --0.203125 -0.140625 -0.171875 1.58375 1.58375 1.58375 --0.203125 -0.140625 -0.140625 7.28368 7.28368 7.28368 --0.171875 -0.234375 -0.234375 108.514 108.514 108.514 --0.171875 -0.234375 -0.203125 -12.5403 -12.5403 -12.5403 --0.140625 -0.234375 -0.234375 89.2196 89.2196 89.2196 --0.171875 -0.234375 -0.171875 -103.924 -103.924 -103.924 --0.171875 -0.203125 -0.171875 -23.7171 -23.7171 -23.7171 --0.171875 -0.140625 -0.234375 -77.7294 -77.7294 -77.7294 --0.171875 -0.140625 -0.203125 3.01412 3.01412 3.01412 --0.140625 -0.140625 -0.234375 -23.3449 -23.3449 -23.3449 --0.140625 -0.140625 -0.203125 -12.3343 -12.3343 -12.3343 --0.171875 -0.171875 -0.171875 -4.1291 -4.1291 -4.1291 --0.171875 -0.171875 -0.140625 41.9091 41.9091 41.9091 --0.171875 -0.140625 -0.171875 2.05713 2.05713 2.05713 --0.171875 -0.140625 -0.140625 -15.2328 -15.2328 -15.2328 --0.140625 -0.171875 -0.171875 -12.1348 -12.1348 -12.1348 --0.140625 -0.171875 -0.140625 118.157 118.157 118.157 --0.140625 -0.140625 -0.171875 -1.51725 -1.51725 -1.51725 --0.140625 -0.140625 -0.140625 152.179 152.179 152.179 --0.234375 -0.234375 -0.109375 -124.874 -124.874 -124.874 --0.234375 -0.234375 -0.078125 -11.2747 -11.2747 -11.2747 --0.234375 -0.203125 -0.109375 -14.2273 -14.2273 -14.2273 --0.234375 -0.203125 -0.078125 -12.7794 -12.7794 -12.7794 --0.203125 -0.234375 -0.109375 40.6627 40.6627 40.6627 --0.203125 -0.234375 -0.078125 -16.6269 -16.6269 -16.6269 --0.203125 -0.203125 -0.109375 -10.1217 -10.1217 -10.1217 --0.203125 -0.203125 -0.078125 -13.5965 -13.5965 -13.5965 --0.234375 -0.234375 -0.046875 -15.9385 -15.9385 -15.9385 --0.234375 -0.234375 -0.015625 10.4192 10.4192 10.4192 --0.234375 -0.203125 -0.046875 -19.6466 -19.6466 -19.6466 --0.234375 -0.203125 -0.015625 12.4713 12.4713 12.4713 --0.203125 -0.234375 -0.046875 -21.8425 -21.8425 -21.8425 --0.203125 -0.203125 -0.046875 -2.57159 -2.57159 -2.57159 --0.203125 -0.203125 -0.015625 2.88887 2.88887 2.88887 --0.234375 -0.171875 -0.109375 -14.4752 -14.4752 -14.4752 --0.234375 -0.171875 -0.078125 -7.98569 -7.98569 -7.98569 --0.234375 -0.140625 -0.109375 29.4725 29.4725 29.4725 --0.234375 -0.140625 -0.078125 -36.4333 -36.4333 -36.4333 --0.203125 -0.171875 -0.109375 0.167607 0.167607 0.167607 --0.203125 -0.171875 -0.078125 -0.731066 -0.731066 -0.731066 --0.203125 -0.140625 -0.109375 -19.1292 -19.1292 -19.1292 --0.203125 -0.140625 -0.078125 4.60219 4.60219 4.60219 --0.234375 -0.171875 -0.046875 -16.8781 -16.8781 -16.8781 --0.234375 -0.171875 -0.015625 -11.1198 -11.1198 -11.1198 --0.234375 -0.140625 -0.046875 -8.51219 -8.51219 -8.51219 --0.234375 -0.140625 -0.015625 7.86822 7.86822 7.86822 --0.203125 -0.171875 -0.046875 1.48878 1.48878 1.48878 --0.203125 -0.171875 -0.015625 35.2673 35.2673 35.2673 --0.203125 -0.140625 -0.046875 5.55841 5.55841 5.55841 --0.203125 -0.140625 -0.015625 -12.0315 -12.0315 -12.0315 --0.171875 -0.234375 -0.109375 -2.41988 -2.41988 -2.41988 --0.171875 -0.234375 -0.078125 -50.1698 -50.1698 -50.1698 --0.171875 -0.203125 -0.109375 40.0297 40.0297 40.0297 --0.171875 -0.203125 -0.078125 50.5888 50.5888 50.5888 --0.140625 -0.234375 -0.109375 -0.934752 -0.934752 -0.934752 --0.140625 -0.234375 -0.078125 -87.1043 -87.1043 -87.1043 --0.140625 -0.203125 -0.109375 -11.1218 -11.1218 -11.1218 --0.140625 -0.203125 -0.078125 -22.8334 -22.8334 -22.8334 --0.171875 -0.234375 -0.046875 -73.4944 -73.4944 -73.4944 --0.171875 -0.234375 -0.015625 -2.62165 -2.62165 -2.62165 --0.171875 -0.203125 -0.015625 -46.8957 -46.8957 -46.8957 --0.140625 -0.234375 -0.046875 343.106 343.106 343.106 --0.140625 -0.234375 -0.015625 174.214 174.214 174.214 --0.140625 -0.203125 -0.015625 214.529 214.529 214.529 --0.171875 -0.171875 -0.109375 27.9868 27.9868 27.9868 --0.171875 -0.171875 -0.078125 87.6025 87.6025 87.6025 --0.171875 -0.140625 -0.109375 9.92021 9.92021 9.92021 --0.171875 -0.140625 -0.078125 159.937 159.937 159.937 --0.140625 -0.171875 -0.109375 -83.2559 -83.2559 -83.2559 --0.140625 -0.171875 -0.078125 -52.7776 -52.7776 -52.7776 --0.140625 -0.140625 -0.078125 56.3025 56.3025 56.3025 --0.171875 -0.171875 -0.046875 80.0692 80.0692 80.0692 --0.171875 -0.171875 -0.015625 -493.359 -493.359 -493.359 --0.171875 -0.140625 -0.046875 169.228 169.228 169.228 --0.171875 -0.140625 -0.015625 -145.761 -145.761 -145.761 --0.140625 -0.171875 -0.046875 135.383 135.383 135.383 --0.140625 -0.171875 -0.015625 108.834 108.834 108.834 --0.140625 -0.140625 -0.046875 202.367 202.367 202.367 --0.140625 -0.140625 -0.015625 131.391 131.391 131.391 --0.234375 -0.109375 -0.234375 -86.3974 -86.3974 -86.3974 --0.234375 -0.109375 -0.203125 216.324 216.324 216.324 --0.234375 -0.078125 -0.234375 109.305 109.305 109.305 --0.234375 -0.078125 -0.203125 170.243 170.243 170.243 --0.203125 -0.078125 -0.234375 -16.9444 -16.9444 -16.9444 --0.203125 -0.078125 -0.203125 134.345 134.345 134.345 --0.234375 -0.109375 -0.171875 -240.969 -240.969 -240.969 --0.234375 -0.109375 -0.140625 -719.788 -719.788 -719.788 --0.234375 -0.078125 -0.171875 -72.6298 -72.6298 -72.6298 --0.234375 -0.078125 -0.140625 -647.605 -647.605 -647.605 --0.203125 -0.109375 -0.171875 230.669 230.669 230.669 --0.203125 -0.109375 -0.140625 -439.946 -439.946 -439.946 --0.203125 -0.078125 -0.171875 576.946 576.946 576.946 --0.203125 -0.078125 -0.140625 390.878 390.878 390.878 --0.234375 -0.046875 -0.234375 67.1289 67.1289 67.1289 --0.203125 -0.046875 -0.234375 -41.7784 -41.7784 -41.7784 --0.203125 -0.046875 -0.203125 -144.385 -144.385 -144.385 --0.203125 -0.015625 -0.234375 -76.1035 -76.1035 -76.1035 --0.203125 -0.015625 -0.203125 -157.22 -157.22 -157.22 --0.234375 -0.046875 -0.140625 -284.71 -284.71 -284.71 --0.234375 -0.015625 -0.140625 -100.996 -100.996 -100.996 --0.171875 -0.109375 -0.234375 164.114 164.114 164.114 --0.171875 -0.109375 -0.203125 198.05 198.05 198.05 --0.171875 -0.078125 -0.234375 -118.759 -118.759 -118.759 --0.171875 -0.078125 -0.203125 268.894 268.894 268.894 --0.140625 -0.109375 -0.234375 93.5342 93.5342 93.5342 --0.140625 -0.109375 -0.203125 -11.4151 -11.4151 -11.4151 --0.140625 -0.078125 -0.234375 -62.4127 -62.4127 -62.4127 --0.140625 -0.078125 -0.203125 -0.587937 -0.587937 -0.587937 --0.171875 -0.109375 -0.171875 341.584 341.584 341.584 --0.171875 -0.109375 -0.140625 -73.3797 -73.3797 -73.3797 --0.171875 -0.078125 -0.171875 297.679 297.679 297.679 --0.140625 -0.109375 -0.171875 -7.87959 -7.87959 -7.87959 --0.140625 -0.109375 -0.140625 -46.2369 -46.2369 -46.2369 --0.140625 -0.078125 -0.171875 2.77593 2.77593 2.77593 --0.171875 -0.046875 -0.234375 -48.5284 -48.5284 -48.5284 --0.171875 -0.046875 -0.203125 162.676 162.676 162.676 --0.171875 -0.015625 -0.234375 -82.6687 -82.6687 -82.6687 --0.171875 -0.015625 -0.203125 5.91308 5.91308 5.91308 --0.140625 -0.046875 -0.234375 -4.78002 -4.78002 -4.78002 --0.140625 -0.046875 -0.203125 1.27314 1.27314 1.27314 --0.140625 -0.015625 -0.234375 -12.132 -12.132 -12.132 --0.140625 -0.015625 -0.203125 -5.48083 -5.48083 -5.48083 --0.140625 -0.015625 -0.171875 -3.26154 -3.26154 -3.26154 --0.140625 -0.015625 -0.140625 1.73239 1.73239 1.73239 --0.234375 -0.109375 -0.078125 48.867 48.867 48.867 --0.234375 -0.078125 -0.078125 -5.33855 -5.33855 -5.33855 --0.203125 -0.109375 -0.078125 -27.5304 -27.5304 -27.5304 --0.203125 -0.078125 -0.078125 -7.50874 -7.50874 -7.50874 --0.234375 -0.109375 -0.046875 -48.9518 -48.9518 -48.9518 --0.234375 -0.109375 -0.015625 38.0003 38.0003 38.0003 --0.234375 -0.078125 -0.046875 -16.5523 -16.5523 -16.5523 --0.203125 -0.109375 -0.046875 -25.7864 -25.7864 -25.7864 --0.203125 -0.109375 -0.015625 -11.2034 -11.2034 -11.2034 --0.203125 -0.078125 -0.046875 -12.8641 -12.8641 -12.8641 --0.234375 -0.046875 -0.109375 -41.7862 -41.7862 -41.7862 --0.234375 -0.046875 -0.078125 11.8568 11.8568 11.8568 --0.234375 -0.015625 -0.109375 -100.836 -100.836 -100.836 --0.203125 -0.046875 -0.109375 -11.8422 -11.8422 -11.8422 --0.203125 -0.046875 -0.078125 -2.22228 -2.22228 -2.22228 --0.203125 -0.015625 -0.109375 -15.7794 -15.7794 -15.7794 --0.203125 -0.015625 -0.078125 17.1763 17.1763 17.1763 --0.234375 -0.046875 -0.046875 83.1067 83.1067 83.1067 --0.234375 -0.015625 -0.046875 25.3473 25.3473 25.3473 --0.203125 -0.046875 -0.046875 26.9672 26.9672 26.9672 --0.203125 -0.046875 -0.015625 69.9271 69.9271 69.9271 --0.203125 -0.015625 -0.046875 -29.2999 -29.2999 -29.2999 --0.171875 -0.109375 -0.078125 -4.28663 -4.28663 -4.28663 --0.140625 -0.109375 -0.078125 -47.1126 -47.1126 -47.1126 --0.140625 -0.078125 -0.109375 -38.6596 -38.6596 -38.6596 --0.140625 -0.078125 -0.078125 -65.0247 -65.0247 -65.0247 --0.171875 -0.109375 -0.046875 68.7501 68.7501 68.7501 --0.171875 -0.109375 -0.015625 -690.084 -690.084 -690.084 --0.171875 -0.078125 -0.046875 -39.9507 -39.9507 -39.9507 --0.140625 -0.109375 -0.046875 29.8605 29.8605 29.8605 --0.140625 -0.109375 -0.015625 316.229 316.229 316.229 --0.140625 -0.078125 -0.046875 53.3556 53.3556 53.3556 --0.140625 -0.078125 -0.015625 -271.553 -271.553 -271.553 --0.171875 -0.046875 -0.109375 -2.41937 -2.41937 -2.41937 --0.171875 -0.046875 -0.078125 -4.43404 -4.43404 -4.43404 --0.171875 -0.015625 -0.109375 6.06441 6.06441 6.06441 --0.171875 -0.015625 -0.078125 20.1125 20.1125 20.1125 --0.140625 -0.046875 -0.109375 7.67954 7.67954 7.67954 --0.140625 -0.046875 -0.078125 -3.25537 -3.25537 -3.25537 --0.140625 -0.015625 -0.109375 -9.51673 -9.51673 -9.51673 --0.140625 -0.015625 -0.078125 2.70535 2.70535 2.70535 --0.171875 -0.046875 -0.046875 -14.2898 -14.2898 -14.2898 --0.171875 -0.046875 -0.015625 2095.58 2095.58 2095.58 --0.171875 -0.015625 -0.046875 37.3965 37.3965 37.3965 --0.171875 -0.015625 -0.015625 -12.4186 -12.4186 -12.4186 --0.140625 -0.046875 -0.046875 -43.574 -43.574 -43.574 --0.140625 -0.046875 -0.015625 1194.72 1194.72 1194.72 --0.140625 -0.015625 -0.046875 -0.0564418 -0.0564418 -0.0564418 --0.140625 -0.015625 -0.015625 1.27628 1.27628 1.27628 --0.109375 -0.234375 -0.234375 -8.60778 -8.60778 -8.60778 --0.109375 -0.234375 -0.203125 129.459 129.459 129.459 --0.109375 -0.203125 -0.234375 -0.161047 -0.161047 -0.161047 --0.109375 -0.203125 -0.203125 2.78576 2.78576 2.78576 --0.078125 -0.234375 -0.234375 50.1329 50.1329 50.1329 --0.078125 -0.234375 -0.203125 77.7466 77.7466 77.7466 --0.078125 -0.203125 -0.234375 15.8278 15.8278 15.8278 --0.078125 -0.203125 -0.203125 -149.116 -149.116 -149.116 --0.109375 -0.234375 -0.171875 -25.762 -25.762 -25.762 --0.109375 -0.234375 -0.140625 55.2955 55.2955 55.2955 --0.109375 -0.203125 -0.171875 -3.04637 -3.04637 -3.04637 --0.109375 -0.203125 -0.140625 3.44176 3.44176 3.44176 --0.078125 -0.234375 -0.171875 -2.19941 -2.19941 -2.19941 --0.078125 -0.203125 -0.171875 -392.612 -392.612 -392.612 --0.109375 -0.171875 -0.203125 5.17852 5.17852 5.17852 --0.109375 -0.140625 -0.203125 -9.46588 -9.46588 -9.46588 --0.078125 -0.171875 -0.234375 -30.4958 -30.4958 -30.4958 --0.078125 -0.171875 -0.203125 -23.4365 -23.4365 -23.4365 --0.078125 -0.140625 -0.203125 -88.0346 -88.0346 -88.0346 --0.109375 -0.171875 -0.171875 -2.76234 -2.76234 -2.76234 --0.109375 -0.171875 -0.140625 -110.268 -110.268 -110.268 --0.109375 -0.140625 -0.171875 -0.808205 -0.808205 -0.808205 --0.109375 -0.140625 -0.140625 334.72 334.72 334.72 --0.078125 -0.140625 -0.171875 -31.5095 -31.5095 -31.5095 --0.046875 -0.203125 -0.234375 -18.5306 -18.5306 -18.5306 --0.015625 -0.234375 -0.234375 54.2935 54.2935 54.2935 --0.015625 -0.203125 -0.234375 225.713 225.713 225.713 --0.015625 -0.203125 -0.140625 625.649 625.649 625.649 --0.046875 -0.171875 -0.234375 5.02154 5.02154 5.02154 --0.046875 -0.171875 -0.203125 -32.6847 -32.6847 -32.6847 --0.046875 -0.140625 -0.234375 -5.9186 -5.9186 -5.9186 --0.046875 -0.140625 -0.203125 193.997 193.997 193.997 --0.015625 -0.171875 -0.234375 -62.7527 -62.7527 -62.7527 --0.015625 -0.171875 -0.203125 -266.066 -266.066 -266.066 --0.015625 -0.140625 -0.203125 107.741 107.741 107.741 --0.046875 -0.171875 -0.140625 95.3782 95.3782 95.3782 --0.046875 -0.140625 -0.171875 159.903 159.903 159.903 --0.046875 -0.140625 -0.140625 -55.1311 -55.1311 -55.1311 --0.015625 -0.171875 -0.171875 -4.6712 -4.6712 -4.6712 --0.015625 -0.171875 -0.140625 1004.89 1004.89 1004.89 --0.015625 -0.140625 -0.171875 -252.395 -252.395 -252.395 --0.015625 -0.140625 -0.140625 -323.43 -323.43 -323.43 --0.109375 -0.234375 -0.109375 84.4472 84.4472 84.4472 --0.109375 -0.234375 -0.078125 -18.4942 -18.4942 -18.4942 --0.109375 -0.203125 -0.109375 -138.522 -138.522 -138.522 --0.109375 -0.203125 -0.078125 202.669 202.669 202.669 --0.109375 -0.234375 -0.046875 -125.549 -125.549 -125.549 --0.109375 -0.234375 -0.015625 -240.99 -240.99 -240.99 --0.109375 -0.203125 -0.046875 150.64 150.64 150.64 --0.109375 -0.203125 -0.015625 -77.236 -77.236 -77.236 --0.078125 -0.203125 -0.046875 178.447 178.447 178.447 --0.078125 -0.203125 -0.015625 646.53 646.53 646.53 --0.109375 -0.171875 -0.109375 -407.992 -407.992 -407.992 --0.109375 -0.171875 -0.078125 217.935 217.935 217.935 --0.109375 -0.140625 -0.109375 -403.852 -403.852 -403.852 --0.109375 -0.140625 -0.078125 0.180597 0.180597 0.180597 --0.078125 -0.171875 -0.078125 -102.467 -102.467 -102.467 --0.078125 -0.140625 -0.078125 -189.853 -189.853 -189.853 --0.109375 -0.171875 -0.046875 431.789 431.789 431.789 --0.109375 -0.171875 -0.015625 -65.1741 -65.1741 -65.1741 --0.109375 -0.140625 -0.046875 202.995 202.995 202.995 --0.109375 -0.140625 -0.015625 277.003 277.003 277.003 --0.078125 -0.171875 -0.046875 -5529.36 -5529.36 -5529.36 --0.015625 -0.203125 -0.109375 357.738 357.738 357.738 --0.015625 -0.203125 -0.078125 -18.2991 -18.2991 -18.2991 --0.046875 -0.203125 -0.046875 -154.556 -154.556 -154.556 --0.046875 -0.203125 -0.015625 1487.07 1487.07 1487.07 --0.046875 -0.171875 -0.109375 -146.239 -146.239 -146.239 --0.046875 -0.171875 -0.078125 82.3685 82.3685 82.3685 --0.046875 -0.140625 -0.109375 420.011 420.011 420.011 --0.046875 -0.140625 -0.078125 -215.531 -215.531 -215.531 --0.015625 -0.171875 -0.109375 1269.13 1269.13 1269.13 --0.015625 -0.171875 -0.078125 275.963 275.963 275.963 --0.015625 -0.140625 -0.078125 284.688 284.688 284.688 --0.046875 -0.171875 -0.046875 113.403 113.403 113.403 --0.046875 -0.171875 -0.015625 -1268.37 -1268.37 -1268.37 --0.046875 -0.140625 -0.046875 7263.69 7263.69 7263.69 --0.015625 -0.171875 -0.046875 -2679.94 -2679.94 -2679.94 --0.015625 -0.171875 -0.015625 1998.06 1998.06 1998.06 --0.015625 -0.140625 -0.046875 6675.95 6675.95 6675.95 --0.109375 -0.109375 -0.234375 11.7204 11.7204 11.7204 --0.109375 -0.109375 -0.203125 -15.2628 -15.2628 -15.2628 --0.109375 -0.078125 -0.234375 4.85757 4.85757 4.85757 --0.078125 -0.109375 -0.234375 149.337 149.337 149.337 --0.078125 -0.109375 -0.203125 81.0152 81.0152 81.0152 --0.078125 -0.078125 -0.234375 147.137 147.137 147.137 --0.109375 -0.109375 -0.171875 -0.515644 -0.515644 -0.515644 --0.109375 -0.109375 -0.140625 -153.173 -153.173 -153.173 --0.109375 -0.078125 -0.171875 0.841544 0.841544 0.841544 --0.109375 -0.078125 -0.140625 -114.181 -114.181 -114.181 --0.078125 -0.109375 -0.171875 13.5306 13.5306 13.5306 --0.078125 -0.109375 -0.140625 132.143 132.143 132.143 --0.078125 -0.078125 -0.140625 28.7223 28.7223 28.7223 --0.109375 -0.046875 -0.234375 -11.1273 -11.1273 -11.1273 --0.109375 -0.046875 -0.203125 3.72172 3.72172 3.72172 --0.109375 -0.015625 -0.234375 75.1323 75.1323 75.1323 --0.109375 -0.015625 -0.203125 91.1807 91.1807 91.1807 --0.078125 -0.046875 -0.234375 6.70767 6.70767 6.70767 --0.078125 -0.046875 -0.203125 3.23372 3.23372 3.23372 --0.078125 -0.015625 -0.234375 50.6228 50.6228 50.6228 --0.078125 -0.015625 -0.203125 -3.94283 -3.94283 -3.94283 --0.109375 -0.015625 -0.171875 203.758 203.758 203.758 --0.109375 -0.015625 -0.140625 -45.7815 -45.7815 -45.7815 --0.078125 -0.015625 -0.140625 152.301 152.301 152.301 --0.046875 -0.109375 -0.234375 27.9587 27.9587 27.9587 --0.046875 -0.109375 -0.203125 181.471 181.471 181.471 --0.046875 -0.078125 -0.234375 -1.49801 -1.49801 -1.49801 --0.046875 -0.078125 -0.203125 -20.7415 -20.7415 -20.7415 --0.015625 -0.109375 -0.203125 81.1673 81.1673 81.1673 --0.015625 -0.078125 -0.234375 108.76 108.76 108.76 --0.015625 -0.078125 -0.203125 -32.1033 -32.1033 -32.1033 --0.046875 -0.109375 -0.171875 65.7298 65.7298 65.7298 --0.046875 -0.109375 -0.140625 26.0741 26.0741 26.0741 --0.046875 -0.078125 -0.171875 -33.256 -33.256 -33.256 --0.046875 -0.078125 -0.140625 -30.0686 -30.0686 -30.0686 --0.015625 -0.109375 -0.171875 -135.729 -135.729 -135.729 --0.015625 -0.109375 -0.140625 -54.16 -54.16 -54.16 --0.015625 -0.078125 -0.140625 9.72105 9.72105 9.72105 --0.046875 -0.046875 -0.234375 -23.7249 -23.7249 -23.7249 --0.046875 -0.046875 -0.203125 22.8581 22.8581 22.8581 --0.046875 -0.015625 -0.234375 -37.7276 -37.7276 -37.7276 --0.015625 -0.046875 -0.234375 36.7921 36.7921 36.7921 --0.015625 -0.046875 -0.203125 3.62084 3.62084 3.62084 --0.015625 -0.015625 -0.234375 15.9088 15.9088 15.9088 --0.015625 -0.015625 -0.203125 2.29147 2.29147 2.29147 --0.015625 -0.015625 -0.171875 6.28875 6.28875 6.28875 --0.015625 -0.015625 -0.140625 -146.189 -146.189 -146.189 --0.109375 -0.109375 -0.109375 -168.713 -168.713 -168.713 --0.109375 -0.109375 -0.078125 49.089 49.089 49.089 --0.109375 -0.078125 -0.109375 -75.4589 -75.4589 -75.4589 --0.109375 -0.078125 -0.078125 -2.12152 -2.12152 -2.12152 --0.078125 -0.109375 -0.078125 -237.711 -237.711 -237.711 --0.078125 -0.078125 -0.109375 -63.4242 -63.4242 -63.4242 --0.078125 -0.078125 -0.078125 -43.2571 -43.2571 -43.2571 --0.109375 -0.109375 -0.046875 -75.7152 -75.7152 -75.7152 --0.109375 -0.109375 -0.015625 2032.3 2032.3 2032.3 --0.109375 -0.078125 -0.046875 -14.0245 -14.0245 -14.0245 --0.109375 -0.078125 -0.015625 -585.066 -585.066 -585.066 --0.078125 -0.078125 -0.015625 -20.3124 -20.3124 -20.3124 --0.109375 -0.046875 -0.109375 -14.2581 -14.2581 -14.2581 --0.109375 -0.046875 -0.078125 18.1121 18.1121 18.1121 --0.109375 -0.015625 -0.109375 8.02403 8.02403 8.02403 --0.109375 -0.015625 -0.078125 -0.916672 -0.916672 -0.916672 --0.078125 -0.046875 -0.109375 -2.86536 -2.86536 -2.86536 --0.078125 -0.046875 -0.078125 12.6782 12.6782 12.6782 --0.078125 -0.015625 -0.109375 62.2817 62.2817 62.2817 --0.078125 -0.015625 -0.078125 -222.676 -222.676 -222.676 --0.109375 -0.046875 -0.046875 -11.4339 -11.4339 -11.4339 --0.109375 -0.046875 -0.015625 370.238 370.238 370.238 --0.109375 -0.015625 -0.046875 7.00327 7.00327 7.00327 --0.109375 -0.015625 -0.015625 7.24343 7.24343 7.24343 --0.078125 -0.046875 -0.015625 -12.9592 -12.9592 -12.9592 --0.078125 -0.015625 -0.015625 -11.7369 -11.7369 -11.7369 --0.046875 -0.109375 -0.109375 -85.2972 -85.2972 -85.2972 --0.046875 -0.109375 -0.078125 76.5757 76.5757 76.5757 --0.046875 -0.078125 -0.109375 -64.1431 -64.1431 -64.1431 --0.046875 -0.078125 -0.078125 117.261 117.261 117.261 --0.015625 -0.109375 -0.109375 58.5544 58.5544 58.5544 --0.015625 -0.109375 -0.078125 -103.47 -103.47 -103.47 --0.015625 -0.078125 -0.109375 -95.2033 -95.2033 -95.2033 --0.015625 -0.078125 -0.078125 -62.0317 -62.0317 -62.0317 --0.046875 -0.109375 -0.046875 -2500.7 -2500.7 -2500.7 --0.015625 -0.109375 -0.046875 7754.52 7754.52 7754.52 --0.015625 -0.078125 -0.046875 60.4171 60.4171 60.4171 --0.046875 -0.046875 -0.109375 43.5414 43.5414 43.5414 --0.046875 -0.046875 -0.078125 54.2639 54.2639 54.2639 --0.046875 -0.015625 -0.109375 163.67 163.67 163.67 --0.046875 -0.015625 -0.078125 2.3557 2.3557 2.3557 --0.015625 -0.046875 -0.109375 -15.1235 -15.1235 -15.1235 --0.015625 -0.046875 -0.078125 -86.116 -86.116 -86.116 --0.015625 -0.015625 -0.109375 117.605 117.605 117.605 --0.015625 -0.015625 -0.078125 112.016 112.016 112.016 --0.046875 -0.015625 -0.046875 -20.102 -20.102 -20.102 --0.046875 -0.015625 -0.015625 -79.0648 -79.0648 -79.0648 --0.453125 -0.296875 0.015625 296.184 296.184 296.184 --0.453125 -0.296875 0.046875 42.8715 42.8715 42.8715 --0.453125 -0.265625 0.015625 -231.086 -231.086 -231.086 --0.453125 -0.265625 0.046875 -73.9767 -73.9767 -73.9767 --0.453125 -0.265625 0.078125 -119.398 -119.398 -119.398 --0.421875 -0.328125 0.015625 -14.842 -14.842 -14.842 --0.421875 -0.328125 0.046875 -21.6119 -21.6119 -21.6119 --0.390625 -0.359375 0.015625 1.63369 1.63369 1.63369 --0.390625 -0.328125 0.015625 8.27309 8.27309 8.27309 --0.390625 -0.328125 0.046875 -57.2486 -57.2486 -57.2486 --0.390625 -0.359375 0.078125 -0.258072 -0.258072 -0.258072 --0.390625 -0.359375 0.109375 0.219377 0.219377 0.219377 --0.390625 -0.328125 0.078125 28.8316 28.8316 28.8316 --0.390625 -0.328125 0.109375 -8.16708 -8.16708 -8.16708 --0.421875 -0.296875 0.015625 12.6057 12.6057 12.6057 --0.421875 -0.296875 0.046875 9.78849 9.78849 9.78849 --0.421875 -0.265625 0.046875 -20.3756 -20.3756 -20.3756 --0.390625 -0.296875 0.046875 -10.5728 -10.5728 -10.5728 --0.421875 -0.296875 0.078125 -19.9103 -19.9103 -19.9103 --0.421875 -0.265625 0.078125 -8.13003 -8.13003 -8.13003 --0.390625 -0.296875 0.078125 -3.76405 -3.76405 -3.76405 --0.390625 -0.296875 0.109375 4.96731 4.96731 4.96731 --0.390625 -0.265625 0.078125 -11.1831 -11.1831 -11.1831 --0.359375 -0.421875 0.109375 -0.844033 -0.844033 -0.844033 --0.359375 -0.390625 0.078125 5.68548 5.68548 5.68548 --0.359375 -0.390625 0.109375 -0.852915 -0.852915 -0.852915 --0.328125 -0.421875 0.078125 0.84849 0.84849 0.84849 --0.328125 -0.421875 0.109375 0.256198 0.256198 0.256198 --0.328125 -0.390625 0.078125 0.79283 0.79283 0.79283 --0.328125 -0.390625 0.109375 -0.89399 -0.89399 -0.89399 --0.296875 -0.390625 0.015625 -12.4793 -12.4793 -12.4793 --0.296875 -0.390625 0.046875 -8.4931 -8.4931 -8.4931 --0.265625 -0.390625 0.015625 -3.32873 -3.32873 -3.32873 --0.265625 -0.390625 0.046875 8.58392 8.58392 8.58392 --0.296875 -0.421875 0.078125 0.746076 0.746076 0.746076 --0.296875 -0.421875 0.109375 0.414926 0.414926 0.414926 --0.296875 -0.390625 0.078125 0.585582 0.585582 0.585582 --0.265625 -0.421875 0.078125 -6.23291 -6.23291 -6.23291 --0.265625 -0.421875 0.109375 2.70349 2.70349 2.70349 --0.265625 -0.390625 0.078125 6.51344 6.51344 6.51344 --0.265625 -0.390625 0.109375 1.55379 1.55379 1.55379 --0.359375 -0.421875 0.140625 -0.212236 -0.212236 -0.212236 --0.359375 -0.390625 0.140625 0.373778 0.373778 0.373778 --0.328125 -0.421875 0.140625 -3.56573 -3.56573 -3.56573 --0.328125 -0.421875 0.171875 -2.05094 -2.05094 -2.05094 --0.328125 -0.390625 0.140625 -0.301319 -0.301319 -0.301319 --0.328125 -0.390625 0.171875 5.29484 5.29484 5.29484 --0.296875 -0.421875 0.140625 -5.89854 -5.89854 -5.89854 --0.296875 -0.421875 0.171875 4.76045 4.76045 4.76045 --0.296875 -0.390625 0.140625 -0.154804 -0.154804 -0.154804 --0.296875 -0.390625 0.171875 -10.2815 -10.2815 -10.2815 --0.265625 -0.421875 0.140625 2.69124 2.69124 2.69124 --0.265625 -0.390625 0.140625 2.42367 2.42367 2.42367 --0.265625 -0.390625 0.171875 2.48993 2.48993 2.48993 --0.359375 -0.359375 0.015625 5.99953 5.99953 5.99953 --0.359375 -0.359375 0.046875 0.0974616 0.0974616 0.0974616 --0.359375 -0.328125 0.015625 -4.5655 -4.5655 -4.5655 --0.359375 -0.328125 0.046875 43.4105 43.4105 43.4105 --0.328125 -0.359375 0.015625 7.31196 7.31196 7.31196 --0.328125 -0.359375 0.046875 -9.42191 -9.42191 -9.42191 --0.328125 -0.328125 0.015625 36.8954 36.8954 36.8954 --0.328125 -0.328125 0.046875 68.5926 68.5926 68.5926 --0.359375 -0.359375 0.078125 4.11949 4.11949 4.11949 --0.359375 -0.359375 0.109375 5.27711 5.27711 5.27711 --0.359375 -0.328125 0.078125 4.60235 4.60235 4.60235 --0.359375 -0.328125 0.109375 -9.30497 -9.30497 -9.30497 --0.328125 -0.359375 0.078125 -7.57491 -7.57491 -7.57491 --0.359375 -0.296875 0.046875 19.2579 19.2579 19.2579 --0.359375 -0.265625 0.015625 -36.8444 -36.8444 -36.8444 --0.359375 -0.265625 0.046875 -84.8912 -84.8912 -84.8912 --0.328125 -0.296875 0.046875 -1137.04 -1137.04 -1137.04 --0.328125 -0.265625 0.015625 -851.182 -851.182 -851.182 --0.328125 -0.265625 0.046875 2602.56 2602.56 2602.56 --0.359375 -0.296875 0.078125 6.63444 6.63444 6.63444 --0.359375 -0.296875 0.109375 4.93765 4.93765 4.93765 --0.359375 -0.265625 0.078125 15.7125 15.7125 15.7125 --0.359375 -0.265625 0.109375 -1.67592 -1.67592 -1.67592 --0.328125 -0.296875 0.078125 8.76851 8.76851 8.76851 --0.328125 -0.296875 0.109375 -4.81593 -4.81593 -4.81593 --0.328125 -0.265625 0.078125 -2.9896 -2.9896 -2.9896 --0.328125 -0.265625 0.109375 -7.89037 -7.89037 -7.89037 --0.296875 -0.359375 0.015625 -4.08914 -4.08914 -4.08914 --0.296875 -0.359375 0.046875 1.37871 1.37871 1.37871 --0.296875 -0.328125 0.015625 -3.83674 -3.83674 -3.83674 --0.296875 -0.328125 0.046875 -4.12867 -4.12867 -4.12867 --0.265625 -0.359375 0.046875 -2.6658 -2.6658 -2.6658 --0.265625 -0.328125 0.046875 -2.64093 -2.64093 -2.64093 --0.296875 -0.359375 0.078125 3.03482 3.03482 3.03482 --0.296875 -0.328125 0.078125 15.3484 15.3484 15.3484 --0.265625 -0.359375 0.078125 12.0816 12.0816 12.0816 --0.265625 -0.359375 0.109375 4.11826 4.11826 4.11826 --0.265625 -0.328125 0.078125 -3.86323 -3.86323 -3.86323 --0.296875 -0.296875 0.015625 -571.414 -571.414 -571.414 --0.296875 -0.296875 0.046875 -1590.77 -1590.77 -1590.77 --0.296875 -0.265625 0.015625 -1494.2 -1494.2 -1494.2 --0.296875 -0.265625 0.046875 439.162 439.162 439.162 --0.265625 -0.296875 0.015625 -2948.77 -2948.77 -2948.77 --0.265625 -0.296875 0.046875 -2320.37 -2320.37 -2320.37 --0.265625 -0.265625 0.015625 1472.74 1472.74 1472.74 --0.265625 -0.265625 0.046875 2014.02 2014.02 2014.02 --0.296875 -0.296875 0.078125 -0.217476 -0.217476 -0.217476 --0.296875 -0.296875 0.109375 2.58796 2.58796 2.58796 --0.296875 -0.265625 0.078125 -1.62416 -1.62416 -1.62416 --0.296875 -0.265625 0.109375 2.66975 2.66975 2.66975 --0.265625 -0.296875 0.078125 6.17219 6.17219 6.17219 --0.265625 -0.265625 0.078125 -4.54731 -4.54731 -4.54731 --0.359375 -0.359375 0.140625 -16.947 -16.947 -16.947 --0.359375 -0.328125 0.140625 -0.204638 -0.204638 -0.204638 --0.359375 -0.328125 0.171875 -39.7589 -39.7589 -39.7589 --0.328125 -0.359375 0.140625 22.4377 22.4377 22.4377 --0.328125 -0.359375 0.171875 -1.61133 -1.61133 -1.61133 --0.328125 -0.328125 0.140625 27.9952 27.9952 27.9952 --0.328125 -0.328125 0.171875 14.3388 14.3388 14.3388 --0.359375 -0.328125 0.203125 -79.7815 -79.7815 -79.7815 --0.328125 -0.359375 0.203125 -48.9692 -48.9692 -48.9692 --0.328125 -0.328125 0.203125 -30.3883 -30.3883 -30.3883 --0.328125 -0.328125 0.234375 -23.8421 -23.8421 -23.8421 --0.359375 -0.296875 0.140625 24.1673 24.1673 24.1673 --0.359375 -0.296875 0.171875 55.012 55.012 55.012 --0.359375 -0.265625 0.171875 52.3531 52.3531 52.3531 --0.328125 -0.296875 0.140625 -15.6068 -15.6068 -15.6068 --0.328125 -0.296875 0.171875 22.1127 22.1127 22.1127 --0.328125 -0.265625 0.140625 -0.0708728 -0.0708728 -0.0708728 --0.328125 -0.265625 0.171875 19.8675 19.8675 19.8675 --0.359375 -0.296875 0.203125 45.9382 45.9382 45.9382 --0.359375 -0.265625 0.203125 160.757 160.757 160.757 --0.328125 -0.296875 0.203125 110.189 110.189 110.189 --0.328125 -0.296875 0.234375 -48.13 -48.13 -48.13 --0.328125 -0.265625 0.203125 76.8266 76.8266 76.8266 --0.328125 -0.265625 0.234375 -62.2762 -62.2762 -62.2762 --0.296875 -0.359375 0.171875 10.0728 10.0728 10.0728 --0.265625 -0.359375 0.140625 11.5673 11.5673 11.5673 --0.265625 -0.359375 0.171875 7.93973 7.93973 7.93973 --0.296875 -0.359375 0.203125 -0.61431 -0.61431 -0.61431 --0.296875 -0.328125 0.203125 10.8046 10.8046 10.8046 --0.296875 -0.328125 0.234375 40.8566 40.8566 40.8566 --0.265625 -0.359375 0.203125 -5.13478 -5.13478 -5.13478 --0.265625 -0.328125 0.203125 -38.6487 -38.6487 -38.6487 --0.265625 -0.328125 0.234375 -15.6167 -15.6167 -15.6167 --0.296875 -0.296875 0.140625 0.325627 0.325627 0.325627 --0.296875 -0.265625 0.140625 22.1451 22.1451 22.1451 --0.296875 -0.265625 0.171875 33.9668 33.9668 33.9668 --0.265625 -0.265625 0.140625 23.2962 23.2962 23.2962 --0.265625 -0.265625 0.171875 57.6103 57.6103 57.6103 --0.296875 -0.296875 0.234375 55.269 55.269 55.269 --0.296875 -0.265625 0.203125 -70.854 -70.854 -70.854 --0.296875 -0.265625 0.234375 -66.1937 -66.1937 -66.1937 --0.265625 -0.296875 0.203125 -42.7921 -42.7921 -42.7921 --0.265625 -0.296875 0.234375 -39.9838 -39.9838 -39.9838 --0.265625 -0.265625 0.203125 -33.5067 -33.5067 -33.5067 --0.265625 -0.265625 0.234375 -76.0367 -76.0367 -76.0367 --0.453125 -0.234375 0.015625 -99.4653 -99.4653 -99.4653 --0.453125 -0.234375 0.046875 -1.82417 -1.82417 -1.82417 --0.453125 -0.203125 0.015625 2435.52 2435.52 2435.52 --0.453125 -0.203125 0.046875 65.0713 65.0713 65.0713 --0.453125 -0.171875 0.015625 491.096 491.096 491.096 --0.453125 -0.171875 0.046875 19.5535 19.5535 19.5535 --0.421875 -0.234375 0.046875 -13.8171 -13.8171 -13.8171 --0.421875 -0.203125 0.046875 -12.7036 -12.7036 -12.7036 --0.390625 -0.203125 0.015625 37.3031 37.3031 37.3031 --0.390625 -0.203125 0.046875 36.1792 36.1792 36.1792 --0.421875 -0.234375 0.078125 -26.114 -26.114 -26.114 --0.421875 -0.203125 0.078125 -15.8439 -15.8439 -15.8439 --0.421875 -0.203125 0.109375 -19.6347 -19.6347 -19.6347 --0.390625 -0.234375 0.078125 -16.6146 -16.6146 -16.6146 --0.390625 -0.203125 0.078125 42.6084 42.6084 42.6084 --0.390625 -0.203125 0.109375 102.923 102.923 102.923 --0.421875 -0.171875 0.015625 335.531 335.531 335.531 --0.421875 -0.171875 0.046875 57.93 57.93 57.93 --0.421875 -0.140625 0.046875 3.94878 3.94878 3.94878 --0.390625 -0.171875 0.015625 25.8415 25.8415 25.8415 --0.390625 -0.171875 0.046875 -21.7637 -21.7637 -21.7637 --0.390625 -0.140625 0.015625 59.608 59.608 59.608 --0.390625 -0.140625 0.046875 -75.366 -75.366 -75.366 --0.421875 -0.171875 0.078125 -79.5461 -79.5461 -79.5461 --0.421875 -0.171875 0.109375 -160.409 -160.409 -160.409 --0.421875 -0.140625 0.078125 29.7036 29.7036 29.7036 --0.421875 -0.140625 0.109375 -308.627 -308.627 -308.627 --0.390625 -0.171875 0.078125 -12.7531 -12.7531 -12.7531 --0.390625 -0.171875 0.109375 -325.099 -325.099 -325.099 --0.390625 -0.140625 0.078125 31.7932 31.7932 31.7932 --0.390625 -0.203125 0.140625 74.0252 74.0252 74.0252 --0.421875 -0.171875 0.140625 -42.5826 -42.5826 -42.5826 --0.421875 -0.140625 0.140625 -386.971 -386.971 -386.971 --0.390625 -0.171875 0.140625 -70.4333 -70.4333 -70.4333 --0.390625 -0.140625 0.140625 -744.334 -744.334 -744.334 --0.390625 -0.140625 0.171875 109.125 109.125 109.125 --0.390625 -0.140625 0.203125 -504.307 -504.307 -504.307 --0.421875 -0.109375 0.046875 -7.20418 -7.20418 -7.20418 --0.421875 -0.078125 0.046875 567.376 567.376 567.376 --0.390625 -0.109375 0.015625 6.09789 6.09789 6.09789 --0.390625 -0.109375 0.046875 -34.8529 -34.8529 -34.8529 --0.390625 -0.078125 0.015625 526.272 526.272 526.272 --0.390625 -0.078125 0.046875 736.15 736.15 736.15 --0.421875 -0.109375 0.078125 18.3532 18.3532 18.3532 --0.421875 -0.109375 0.109375 665.374 665.374 665.374 --0.421875 -0.078125 0.078125 -229.543 -229.543 -229.543 --0.421875 -0.078125 0.109375 -416.553 -416.553 -416.553 --0.390625 -0.109375 0.078125 -40.1082 -40.1082 -40.1082 --0.390625 -0.109375 0.109375 871.593 871.593 871.593 --0.390625 -0.078125 0.109375 -126.567 -126.567 -126.567 --0.421875 -0.046875 0.015625 1505.69 1505.69 1505.69 --0.421875 -0.046875 0.046875 -1371.7 -1371.7 -1371.7 --0.421875 -0.015625 0.015625 -2864.96 -2864.96 -2864.96 --0.421875 -0.015625 0.046875 -1085.99 -1085.99 -1085.99 --0.390625 -0.046875 0.015625 1867.58 1867.58 1867.58 --0.390625 -0.046875 0.046875 586.625 586.625 586.625 --0.390625 -0.015625 0.015625 -495.131 -495.131 -495.131 --0.421875 -0.046875 0.078125 -2102.74 -2102.74 -2102.74 --0.421875 -0.046875 0.109375 -493.937 -493.937 -493.937 --0.421875 -0.015625 0.078125 116.604 116.604 116.604 --0.421875 -0.015625 0.109375 -502.807 -502.807 -502.807 --0.390625 -0.046875 0.109375 936.11 936.11 936.11 --0.390625 -0.015625 0.109375 -335.374 -335.374 -335.374 --0.390625 -0.109375 0.140625 -683.341 -683.341 -683.341 --0.390625 -0.109375 0.171875 718.452 718.452 718.452 --0.390625 -0.078125 0.140625 -728.618 -728.618 -728.618 --0.390625 -0.078125 0.171875 -1690.27 -1690.27 -1690.27 --0.390625 -0.109375 0.203125 -832.229 -832.229 -832.229 --0.390625 -0.078125 0.203125 148.882 148.882 148.882 --0.390625 -0.046875 0.140625 -1099.31 -1099.31 -1099.31 --0.359375 -0.234375 0.015625 -12.3903 -12.3903 -12.3903 --0.359375 -0.234375 0.046875 -31.0649 -31.0649 -31.0649 --0.359375 -0.203125 0.015625 -15.0283 -15.0283 -15.0283 --0.359375 -0.203125 0.046875 2.3394 2.3394 2.3394 --0.328125 -0.234375 0.015625 -470.838 -470.838 -470.838 --0.328125 -0.203125 0.046875 -2.47335 -2.47335 -2.47335 --0.359375 -0.234375 0.078125 -7.55224 -7.55224 -7.55224 --0.359375 -0.203125 0.078125 11.2082 11.2082 11.2082 --0.359375 -0.203125 0.109375 -5.47815 -5.47815 -5.47815 --0.328125 -0.234375 0.078125 -10.4034 -10.4034 -10.4034 --0.328125 -0.234375 0.109375 -25.0815 -25.0815 -25.0815 --0.328125 -0.203125 0.078125 -7.59881 -7.59881 -7.59881 --0.328125 -0.203125 0.109375 -46.2393 -46.2393 -46.2393 --0.359375 -0.171875 0.015625 49.8813 49.8813 49.8813 --0.359375 -0.171875 0.046875 8.10197 8.10197 8.10197 --0.359375 -0.140625 0.015625 60.6487 60.6487 60.6487 --0.359375 -0.140625 0.046875 -30.4366 -30.4366 -30.4366 --0.328125 -0.171875 0.015625 22.657 22.657 22.657 --0.328125 -0.171875 0.046875 5.37369 5.37369 5.37369 --0.328125 -0.140625 0.015625 0.900467 0.900467 0.900467 --0.328125 -0.140625 0.046875 12.8298 12.8298 12.8298 --0.328125 -0.171875 0.078125 5.24034 5.24034 5.24034 --0.328125 -0.171875 0.109375 10.7518 10.7518 10.7518 --0.296875 -0.234375 0.015625 950.29 950.29 950.29 --0.296875 -0.234375 0.046875 678.027 678.027 678.027 --0.296875 -0.203125 0.015625 61.6497 61.6497 61.6497 --0.296875 -0.203125 0.046875 23.1132 23.1132 23.1132 --0.265625 -0.234375 0.015625 -803.347 -803.347 -803.347 --0.265625 -0.234375 0.046875 854.917 854.917 854.917 --0.265625 -0.203125 0.015625 21.458 21.458 21.458 --0.265625 -0.203125 0.046875 0.382541 0.382541 0.382541 --0.296875 -0.234375 0.078125 -6.33669 -6.33669 -6.33669 --0.296875 -0.234375 0.109375 -3.44045 -3.44045 -3.44045 --0.296875 -0.203125 0.078125 -14.56 -14.56 -14.56 --0.265625 -0.234375 0.078125 -16.401 -16.401 -16.401 --0.265625 -0.234375 0.109375 -38.2619 -38.2619 -38.2619 --0.265625 -0.203125 0.078125 -14.2714 -14.2714 -14.2714 --0.265625 -0.203125 0.109375 5.20892 5.20892 5.20892 --0.296875 -0.171875 0.046875 18.4519 18.4519 18.4519 --0.296875 -0.140625 0.015625 2.61481 2.61481 2.61481 --0.296875 -0.140625 0.046875 21.6914 21.6914 21.6914 --0.265625 -0.171875 0.015625 -6.83866 -6.83866 -6.83866 --0.265625 -0.171875 0.046875 -14.4791 -14.4791 -14.4791 --0.265625 -0.140625 0.015625 -24.591 -24.591 -24.591 --0.296875 -0.171875 0.078125 14.746 14.746 14.746 --0.296875 -0.171875 0.109375 10.6603 10.6603 10.6603 --0.296875 -0.140625 0.078125 39.8862 39.8862 39.8862 --0.296875 -0.140625 0.109375 -1910.88 -1910.88 -1910.88 --0.265625 -0.171875 0.078125 8.25781 8.25781 8.25781 --0.265625 -0.171875 0.109375 -0.0204653 -0.0204653 -0.0204653 --0.265625 -0.140625 0.078125 4.56216 4.56216 4.56216 --0.265625 -0.140625 0.109375 -12.3944 -12.3944 -12.3944 --0.359375 -0.203125 0.140625 8.1005 8.1005 8.1005 --0.328125 -0.234375 0.140625 -25.3563 -25.3563 -25.3563 --0.328125 -0.234375 0.171875 -34.7436 -34.7436 -34.7436 --0.328125 -0.203125 0.140625 -37.5186 -37.5186 -37.5186 --0.328125 -0.234375 0.203125 -43.5583 -43.5583 -43.5583 --0.359375 -0.171875 0.140625 43.7469 43.7469 43.7469 --0.359375 -0.171875 0.171875 -27.4267 -27.4267 -27.4267 --0.359375 -0.140625 0.140625 163.545 163.545 163.545 --0.359375 -0.140625 0.171875 -1494.97 -1494.97 -1494.97 --0.328125 -0.171875 0.140625 13.574 13.574 13.574 --0.328125 -0.171875 0.171875 17.357 17.357 17.357 --0.328125 -0.140625 0.171875 274.746 274.746 274.746 --0.359375 -0.140625 0.203125 527.88 527.88 527.88 --0.328125 -0.140625 0.203125 -382.544 -382.544 -382.544 --0.296875 -0.234375 0.140625 8.27071 8.27071 8.27071 --0.296875 -0.234375 0.171875 116.529 116.529 116.529 --0.265625 -0.234375 0.140625 12.1337 12.1337 12.1337 --0.265625 -0.234375 0.171875 69.9916 69.9916 69.9916 --0.265625 -0.203125 0.171875 34.3313 34.3313 34.3313 --0.296875 -0.234375 0.203125 7.23156 7.23156 7.23156 --0.296875 -0.203125 0.203125 112.744 112.744 112.744 --0.296875 -0.203125 0.234375 21.7525 21.7525 21.7525 --0.265625 -0.234375 0.203125 39.9266 39.9266 39.9266 --0.265625 -0.234375 0.234375 11.6925 11.6925 11.6925 --0.265625 -0.203125 0.203125 68.7172 68.7172 68.7172 --0.265625 -0.203125 0.234375 -49.0084 -49.0084 -49.0084 --0.296875 -0.171875 0.140625 -11.3702 -11.3702 -11.3702 --0.296875 -0.171875 0.171875 -41.5491 -41.5491 -41.5491 --0.296875 -0.140625 0.140625 -205.232 -205.232 -205.232 --0.296875 -0.140625 0.171875 974.056 974.056 974.056 --0.265625 -0.171875 0.140625 0.507464 0.507464 0.507464 --0.265625 -0.171875 0.171875 -40.9697 -40.9697 -40.9697 --0.265625 -0.140625 0.140625 6.14357 6.14357 6.14357 --0.265625 -0.140625 0.171875 -56.2556 -56.2556 -56.2556 --0.296875 -0.171875 0.203125 24.6617 24.6617 24.6617 --0.296875 -0.171875 0.234375 66.4779 66.4779 66.4779 --0.296875 -0.140625 0.203125 -51.2155 -51.2155 -51.2155 --0.296875 -0.140625 0.234375 110.657 110.657 110.657 --0.265625 -0.171875 0.234375 115.334 115.334 115.334 --0.359375 -0.078125 0.015625 30.362 30.362 30.362 --0.328125 -0.078125 0.015625 -94.4997 -94.4997 -94.4997 --0.359375 -0.109375 0.109375 248.304 248.304 248.304 --0.328125 -0.078125 0.109375 555.504 555.504 555.504 --0.359375 -0.046875 0.015625 48.0065 48.0065 48.0065 --0.359375 -0.015625 0.015625 17.8956 17.8956 17.8956 --0.328125 -0.046875 0.015625 13.5512 13.5512 13.5512 --0.328125 -0.046875 0.046875 22.9906 22.9906 22.9906 --0.328125 -0.015625 0.015625 5.89141 5.89141 5.89141 --0.328125 -0.015625 0.046875 14.1221 14.1221 14.1221 --0.359375 -0.046875 0.109375 2215.79 2215.79 2215.79 --0.359375 -0.015625 0.109375 2056.71 2056.71 2056.71 --0.328125 -0.046875 0.078125 1.75312 1.75312 1.75312 --0.328125 -0.046875 0.109375 408.096 408.096 408.096 --0.328125 -0.015625 0.078125 -97.2297 -97.2297 -97.2297 --0.328125 -0.015625 0.109375 467.098 467.098 467.098 --0.296875 -0.109375 0.015625 -3.83669 -3.83669 -3.83669 --0.296875 -0.109375 0.046875 4.55592 4.55592 4.55592 --0.296875 -0.078125 0.015625 -90.0091 -90.0091 -90.0091 --0.296875 -0.078125 0.046875 -28.5559 -28.5559 -28.5559 --0.265625 -0.109375 0.015625 -31.6069 -31.6069 -31.6069 --0.265625 -0.109375 0.046875 -31.4579 -31.4579 -31.4579 --0.265625 -0.078125 0.015625 32.8637 32.8637 32.8637 --0.265625 -0.078125 0.046875 -12.314 -12.314 -12.314 --0.296875 -0.109375 0.078125 -0.233153 -0.233153 -0.233153 --0.296875 -0.078125 0.078125 -24.3933 -24.3933 -24.3933 --0.296875 -0.078125 0.109375 -1070.13 -1070.13 -1070.13 --0.265625 -0.109375 0.078125 12.7851 12.7851 12.7851 --0.265625 -0.078125 0.078125 6.89009 6.89009 6.89009 --0.265625 -0.078125 0.109375 -31.0252 -31.0252 -31.0252 --0.296875 -0.046875 0.015625 -38.9666 -38.9666 -38.9666 --0.296875 -0.046875 0.046875 30.6885 30.6885 30.6885 --0.296875 -0.015625 0.015625 20.321 20.321 20.321 --0.296875 -0.015625 0.046875 0.977631 0.977631 0.977631 --0.265625 -0.046875 0.046875 30.4745 30.4745 30.4745 --0.265625 -0.015625 0.015625 -44.32 -44.32 -44.32 --0.265625 -0.015625 0.046875 -23.6728 -23.6728 -23.6728 --0.296875 -0.046875 0.078125 58.577 58.577 58.577 --0.296875 -0.046875 0.109375 85.0568 85.0568 85.0568 --0.296875 -0.015625 0.078125 -115.9 -115.9 -115.9 --0.296875 -0.015625 0.109375 428.894 428.894 428.894 --0.265625 -0.046875 0.109375 -5.14347 -5.14347 -5.14347 --0.265625 -0.015625 0.078125 19.603 19.603 19.603 --0.265625 -0.015625 0.109375 -7.59368 -7.59368 -7.59368 --0.359375 -0.109375 0.140625 2143.2 2143.2 2143.2 --0.359375 -0.078125 0.140625 1782.15 1782.15 1782.15 --0.359375 -0.078125 0.171875 1674.98 1674.98 1674.98 --0.328125 -0.078125 0.140625 -88.8614 -88.8614 -88.8614 --0.328125 -0.078125 0.171875 -15.6841 -15.6841 -15.6841 --0.359375 -0.109375 0.203125 -180.703 -180.703 -180.703 --0.359375 -0.078125 0.203125 -727.253 -727.253 -727.253 --0.328125 -0.109375 0.203125 -449.282 -449.282 -449.282 --0.328125 -0.078125 0.203125 36.0347 36.0347 36.0347 --0.359375 -0.046875 0.140625 2380.88 2380.88 2380.88 --0.328125 -0.046875 0.140625 298.682 298.682 298.682 --0.328125 -0.015625 0.171875 861.962 861.962 861.962 --0.328125 -0.046875 0.203125 285.098 285.098 285.098 --0.328125 -0.015625 0.203125 1127.67 1127.67 1127.67 --0.328125 -0.015625 0.234375 -484.57 -484.57 -484.57 --0.296875 -0.109375 0.171875 1719.87 1719.87 1719.87 --0.296875 -0.078125 0.140625 -1647.7 -1647.7 -1647.7 --0.296875 -0.078125 0.171875 -789.759 -789.759 -789.759 --0.296875 -0.109375 0.203125 -547.355 -547.355 -547.355 --0.296875 -0.109375 0.234375 132.505 132.505 132.505 --0.296875 -0.078125 0.203125 -1243.85 -1243.85 -1243.85 --0.296875 -0.078125 0.234375 -1049.94 -1049.94 -1049.94 --0.265625 -0.109375 0.234375 25.8512 25.8512 25.8512 --0.265625 -0.078125 0.234375 -26.76 -26.76 -26.76 --0.296875 -0.046875 0.140625 -92.4814 -92.4814 -92.4814 --0.296875 -0.046875 0.171875 -655.176 -655.176 -655.176 --0.296875 -0.015625 0.140625 -223.134 -223.134 -223.134 --0.296875 -0.015625 0.171875 107.436 107.436 107.436 --0.265625 -0.046875 0.140625 -10.7136 -10.7136 -10.7136 --0.265625 -0.015625 0.140625 -25.0338 -25.0338 -25.0338 --0.296875 -0.046875 0.203125 -220.082 -220.082 -220.082 --0.296875 -0.046875 0.234375 39.7952 39.7952 39.7952 --0.296875 -0.015625 0.203125 1032.05 1032.05 1032.05 --0.296875 -0.015625 0.234375 560.808 560.808 560.808 --0.265625 -0.046875 0.203125 -33.1786 -33.1786 -33.1786 --0.265625 -0.046875 0.234375 -1.39606 -1.39606 -1.39606 --0.265625 -0.015625 0.234375 1.62767 1.62767 1.62767 --0.265625 -0.234375 0.265625 -430.164 -430.164 -430.164 --0.265625 -0.203125 0.265625 -21.9693 -21.9693 -21.9693 --0.265625 -0.203125 0.296875 321.673 321.673 321.673 --0.296875 -0.171875 0.265625 192.291 192.291 192.291 --0.296875 -0.140625 0.265625 -130.838 -130.838 -130.838 --0.265625 -0.171875 0.265625 -72.0854 -72.0854 -72.0854 --0.265625 -0.171875 0.296875 -18.6395 -18.6395 -18.6395 --0.265625 -0.140625 0.265625 145.223 145.223 145.223 --0.265625 -0.109375 0.265625 13.4622 13.4622 13.4622 --0.265625 -0.109375 0.296875 9.92653 9.92653 9.92653 --0.265625 -0.078125 0.265625 19.3656 19.3656 19.3656 --0.265625 -0.078125 0.296875 -1.1326 -1.1326 -1.1326 --0.265625 -0.046875 0.265625 29.8377 29.8377 29.8377 --0.265625 -0.015625 0.265625 55.7817 55.7817 55.7817 --0.234375 -0.390625 0.015625 24.65 24.65 24.65 --0.234375 -0.390625 0.046875 32.0446 32.0446 32.0446 --0.203125 -0.390625 0.015625 -10.1768 -10.1768 -10.1768 --0.203125 -0.390625 0.046875 -1.5824 -1.5824 -1.5824 --0.171875 -0.390625 0.015625 20.0185 20.0185 20.0185 --0.171875 -0.390625 0.046875 -6.54352 -6.54352 -6.54352 --0.234375 -0.359375 0.046875 12.1375 12.1375 12.1375 --0.234375 -0.328125 0.046875 -0.15778 -0.15778 -0.15778 --0.203125 -0.359375 0.046875 -0.0747216 -0.0747216 -0.0747216 --0.203125 -0.328125 0.046875 0.65521 0.65521 0.65521 --0.234375 -0.359375 0.078125 9.61476 9.61476 9.61476 --0.234375 -0.359375 0.109375 15.6578 15.6578 15.6578 --0.234375 -0.328125 0.078125 1.19737 1.19737 1.19737 --0.234375 -0.328125 0.109375 -17.6322 -17.6322 -17.6322 --0.203125 -0.359375 0.078125 -18.3843 -18.3843 -18.3843 --0.203125 -0.359375 0.109375 8.4377 8.4377 8.4377 --0.203125 -0.328125 0.078125 -14.9491 -14.9491 -14.9491 --0.203125 -0.328125 0.109375 -19.9605 -19.9605 -19.9605 --0.234375 -0.296875 0.015625 1.95963 1.95963 1.95963 --0.234375 -0.296875 0.046875 10.6016 10.6016 10.6016 --0.234375 -0.265625 0.015625 -14.0997 -14.0997 -14.0997 --0.234375 -0.265625 0.046875 -10.7487 -10.7487 -10.7487 --0.203125 -0.296875 0.015625 7.52705 7.52705 7.52705 --0.203125 -0.296875 0.046875 8.08604 8.08604 8.08604 --0.203125 -0.265625 0.046875 -19.633 -19.633 -19.633 --0.234375 -0.296875 0.078125 9.19276 9.19276 9.19276 --0.203125 -0.296875 0.109375 5.46696 5.46696 5.46696 --0.203125 -0.265625 0.109375 20.1686 20.1686 20.1686 --0.171875 -0.359375 0.015625 -0.611415 -0.611415 -0.611415 --0.171875 -0.359375 0.046875 1.3871 1.3871 1.3871 --0.171875 -0.328125 0.015625 -21.6216 -21.6216 -21.6216 --0.171875 -0.328125 0.046875 -60.8174 -60.8174 -60.8174 --0.171875 -0.359375 0.078125 -11.1131 -11.1131 -11.1131 --0.171875 -0.328125 0.078125 15.9813 15.9813 15.9813 --0.171875 -0.328125 0.109375 -31.2517 -31.2517 -31.2517 --0.171875 -0.296875 0.015625 -50.488 -50.488 -50.488 --0.171875 -0.296875 0.046875 -28.8403 -28.8403 -28.8403 --0.171875 -0.265625 0.015625 -14.2818 -14.2818 -14.2818 --0.171875 -0.265625 0.046875 -65.6828 -65.6828 -65.6828 --0.140625 -0.296875 0.046875 -89.4223 -89.4223 -89.4223 --0.140625 -0.265625 0.015625 -30.28 -30.28 -30.28 --0.140625 -0.265625 0.046875 4.84036 4.84036 4.84036 --0.171875 -0.296875 0.078125 33.1216 33.1216 33.1216 --0.171875 -0.296875 0.109375 22.8565 22.8565 22.8565 --0.171875 -0.265625 0.078125 -14.8576 -14.8576 -14.8576 --0.171875 -0.265625 0.109375 6.36177 6.36177 6.36177 --0.140625 -0.296875 0.078125 98.8045 98.8045 98.8045 --0.140625 -0.296875 0.109375 -92.9258 -92.9258 -92.9258 --0.140625 -0.265625 0.078125 74.7957 74.7957 74.7957 --0.140625 -0.265625 0.109375 21.5964 21.5964 21.5964 --0.234375 -0.359375 0.140625 0.136158 0.136158 0.136158 --0.234375 -0.359375 0.171875 -17.0553 -17.0553 -17.0553 --0.203125 -0.359375 0.140625 6.35601 6.35601 6.35601 --0.203125 -0.359375 0.171875 38.7588 38.7588 38.7588 --0.203125 -0.328125 0.140625 18.4307 18.4307 18.4307 --0.203125 -0.328125 0.171875 -1.54594 -1.54594 -1.54594 --0.234375 -0.359375 0.203125 3.09834 3.09834 3.09834 --0.234375 -0.328125 0.203125 -25.1177 -25.1177 -25.1177 --0.234375 -0.328125 0.234375 -42.2537 -42.2537 -42.2537 --0.203125 -0.359375 0.203125 9.02864 9.02864 9.02864 --0.203125 -0.328125 0.203125 6.45586 6.45586 6.45586 --0.203125 -0.328125 0.234375 -4.1805 -4.1805 -4.1805 --0.234375 -0.265625 0.140625 -1.73895 -1.73895 -1.73895 --0.234375 -0.265625 0.171875 41.6663 41.6663 41.6663 --0.203125 -0.296875 0.140625 3.72293 3.72293 3.72293 --0.203125 -0.265625 0.140625 -25.4393 -25.4393 -25.4393 --0.203125 -0.265625 0.171875 1.7682 1.7682 1.7682 --0.234375 -0.296875 0.234375 -87.9229 -87.9229 -87.9229 --0.234375 -0.265625 0.203125 35.373 35.373 35.373 --0.234375 -0.265625 0.234375 -34.745 -34.745 -34.745 --0.203125 -0.296875 0.234375 1.36291 1.36291 1.36291 --0.203125 -0.265625 0.203125 -6.88067 -6.88067 -6.88067 --0.203125 -0.265625 0.234375 -2.76254 -2.76254 -2.76254 --0.171875 -0.328125 0.140625 28.7329 28.7329 28.7329 --0.171875 -0.328125 0.171875 35.5251 35.5251 35.5251 --0.171875 -0.328125 0.203125 8.7844 8.7844 8.7844 --0.171875 -0.296875 0.140625 64.5481 64.5481 64.5481 --0.171875 -0.296875 0.171875 64.8049 64.8049 64.8049 --0.171875 -0.265625 0.140625 64.1795 64.1795 64.1795 --0.171875 -0.265625 0.171875 58.2239 58.2239 58.2239 --0.171875 -0.296875 0.203125 -48.731 -48.731 -48.731 --0.171875 -0.296875 0.234375 5.11939 5.11939 5.11939 --0.171875 -0.265625 0.203125 -89.9981 -89.9981 -89.9981 --0.171875 -0.265625 0.234375 7.97054 7.97054 7.97054 --0.109375 -0.296875 0.046875 -4.65845 -4.65845 -4.65845 --0.109375 -0.265625 0.015625 74.2726 74.2726 74.2726 --0.109375 -0.265625 0.046875 7.80877 7.80877 7.80877 --0.078125 -0.296875 0.046875 82.8105 82.8105 82.8105 --0.078125 -0.265625 0.015625 -345.353 -345.353 -345.353 --0.078125 -0.265625 0.046875 -21.2985 -21.2985 -21.2985 --0.109375 -0.296875 0.078125 0.1609 0.1609 0.1609 --0.109375 -0.265625 0.078125 47.1502 47.1502 47.1502 --0.109375 -0.265625 0.109375 -132.636 -132.636 -132.636 --0.078125 -0.296875 0.078125 17.8038 17.8038 17.8038 --0.078125 -0.265625 0.078125 -53.1878 -53.1878 -53.1878 --0.078125 -0.265625 0.109375 28.2646 28.2646 28.2646 --0.046875 -0.265625 0.015625 68.8941 68.8941 68.8941 --0.046875 -0.265625 0.046875 -82.7089 -82.7089 -82.7089 --0.046875 -0.265625 0.078125 -32.0213 -32.0213 -32.0213 --0.046875 -0.265625 0.109375 52.7595 52.7595 52.7595 --0.015625 -0.265625 0.109375 -6.79277 -6.79277 -6.79277 --0.046875 -0.265625 0.140625 104.952 104.952 104.952 --0.046875 -0.265625 0.171875 -123.175 -123.175 -123.175 --0.015625 -0.265625 0.140625 210.631 210.631 210.631 --0.015625 -0.265625 0.171875 5.47041 5.47041 5.47041 --0.046875 -0.265625 0.203125 69.5411 69.5411 69.5411 --0.015625 -0.265625 0.203125 142.719 142.719 142.719 --0.203125 -0.234375 0.046875 2.176 2.176 2.176 --0.203125 -0.203125 0.015625 18.7428 18.7428 18.7428 --0.203125 -0.203125 0.046875 2.16139 2.16139 2.16139 --0.234375 -0.234375 0.109375 -4.52193 -4.52193 -4.52193 --0.234375 -0.203125 0.109375 1.10905 1.10905 1.10905 --0.203125 -0.234375 0.109375 28.5944 28.5944 28.5944 --0.203125 -0.203125 0.109375 23.8155 23.8155 23.8155 --0.234375 -0.171875 0.015625 -27.329 -27.329 -27.329 --0.234375 -0.171875 0.046875 -13.2824 -13.2824 -13.2824 --0.234375 -0.140625 0.015625 48.348 48.348 48.348 --0.234375 -0.140625 0.046875 -13.622 -13.622 -13.622 --0.203125 -0.171875 0.015625 -3.56278 -3.56278 -3.56278 --0.203125 -0.171875 0.046875 24.4509 24.4509 24.4509 --0.203125 -0.140625 0.015625 -8.26814 -8.26814 -8.26814 --0.203125 -0.140625 0.046875 -7.76572 -7.76572 -7.76572 --0.234375 -0.171875 0.078125 -11.512 -11.512 -11.512 --0.234375 -0.171875 0.109375 -2.16198 -2.16198 -2.16198 --0.234375 -0.140625 0.078125 7.21419 7.21419 7.21419 --0.171875 -0.234375 0.046875 -40.1498 -40.1498 -40.1498 --0.171875 -0.203125 0.015625 18.9613 18.9613 18.9613 --0.171875 -0.203125 0.046875 -59.5018 -59.5018 -59.5018 --0.140625 -0.234375 0.015625 -78.4345 -78.4345 -78.4345 --0.140625 -0.234375 0.046875 -3.94266 -3.94266 -3.94266 --0.140625 -0.203125 0.015625 120.993 120.993 120.993 --0.140625 -0.203125 0.046875 13.7065 13.7065 13.7065 --0.171875 -0.234375 0.109375 28.2597 28.2597 28.2597 --0.171875 -0.203125 0.109375 -29.683 -29.683 -29.683 --0.140625 -0.234375 0.078125 -0.159509 -0.159509 -0.159509 --0.140625 -0.234375 0.109375 -8.63475 -8.63475 -8.63475 --0.140625 -0.203125 0.078125 -44.3961 -44.3961 -44.3961 --0.140625 -0.203125 0.109375 -193.558 -193.558 -193.558 --0.171875 -0.171875 0.015625 -169.718 -169.718 -169.718 --0.171875 -0.171875 0.046875 -35.1807 -35.1807 -35.1807 --0.171875 -0.140625 0.015625 32.3976 32.3976 32.3976 --0.171875 -0.140625 0.046875 -310.285 -310.285 -310.285 --0.140625 -0.171875 0.015625 126.364 126.364 126.364 --0.140625 -0.171875 0.046875 -46.5496 -46.5496 -46.5496 --0.140625 -0.140625 0.015625 -220.189 -220.189 -220.189 --0.140625 -0.140625 0.046875 156.599 156.599 156.599 --0.171875 -0.140625 0.078125 -73.5801 -73.5801 -73.5801 --0.140625 -0.171875 0.078125 27.4949 27.4949 27.4949 --0.140625 -0.140625 0.078125 30.0835 30.0835 30.0835 --0.234375 -0.234375 0.140625 -5.56079 -5.56079 -5.56079 --0.234375 -0.234375 0.171875 -1.72616 -1.72616 -1.72616 --0.234375 -0.203125 0.140625 -2.58609 -2.58609 -2.58609 --0.234375 -0.203125 0.171875 -53.2224 -53.2224 -53.2224 --0.203125 -0.234375 0.140625 6.98863 6.98863 6.98863 --0.203125 -0.234375 0.171875 2.52198 2.52198 2.52198 --0.203125 -0.203125 0.140625 -0.700727 -0.700727 -0.700727 --0.203125 -0.203125 0.171875 11.8699 11.8699 11.8699 --0.234375 -0.234375 0.203125 -5.14983 -5.14983 -5.14983 --0.234375 -0.234375 0.234375 34.3375 34.3375 34.3375 --0.234375 -0.203125 0.203125 14.7755 14.7755 14.7755 --0.203125 -0.234375 0.203125 2.57815 2.57815 2.57815 --0.203125 -0.234375 0.234375 -0.731178 -0.731178 -0.731178 --0.203125 -0.203125 0.203125 1.4978 1.4978 1.4978 --0.203125 -0.203125 0.234375 14.779 14.779 14.779 --0.234375 -0.171875 0.140625 7.05314 7.05314 7.05314 --0.234375 -0.171875 0.171875 -78.4672 -78.4672 -78.4672 --0.234375 -0.140625 0.140625 -16.1631 -16.1631 -16.1631 --0.234375 -0.140625 0.171875 -57.1492 -57.1492 -57.1492 --0.203125 -0.171875 0.140625 37.367 37.367 37.367 --0.203125 -0.171875 0.171875 -14.9321 -14.9321 -14.9321 --0.203125 -0.140625 0.140625 -29.3346 -29.3346 -29.3346 --0.203125 -0.140625 0.171875 -89.7836 -89.7836 -89.7836 --0.203125 -0.171875 0.203125 5.01562 5.01562 5.01562 --0.203125 -0.140625 0.203125 -27.8837 -27.8837 -27.8837 --0.203125 -0.140625 0.234375 66.6092 66.6092 66.6092 --0.171875 -0.234375 0.140625 33.9177 33.9177 33.9177 --0.171875 -0.203125 0.140625 30.4764 30.4764 30.4764 --0.171875 -0.203125 0.171875 9.93741 9.93741 9.93741 --0.140625 -0.234375 0.140625 -22.3335 -22.3335 -22.3335 --0.140625 -0.234375 0.171875 14.2719 14.2719 14.2719 --0.140625 -0.203125 0.171875 68.7625 68.7625 68.7625 --0.171875 -0.234375 0.234375 -3.95577 -3.95577 -3.95577 --0.171875 -0.203125 0.203125 -2.36933 -2.36933 -2.36933 --0.171875 -0.203125 0.234375 10.3879 10.3879 10.3879 --0.140625 -0.203125 0.203125 100.615 100.615 100.615 --0.171875 -0.171875 0.140625 -9.11082 -9.11082 -9.11082 --0.171875 -0.171875 0.171875 15.0029 15.0029 15.0029 --0.171875 -0.140625 0.140625 -57.1957 -57.1957 -57.1957 --0.171875 -0.140625 0.171875 -29.041 -29.041 -29.041 --0.140625 -0.171875 0.171875 36.2311 36.2311 36.2311 --0.140625 -0.140625 0.171875 41.6316 41.6316 41.6316 --0.171875 -0.171875 0.203125 -13.3928 -13.3928 -13.3928 --0.171875 -0.171875 0.234375 16.493 16.493 16.493 --0.171875 -0.140625 0.203125 1.35261 1.35261 1.35261 --0.171875 -0.140625 0.234375 29.1439 29.1439 29.1439 --0.140625 -0.171875 0.203125 10.1172 10.1172 10.1172 --0.140625 -0.140625 0.203125 25.5103 25.5103 25.5103 --0.234375 -0.109375 0.046875 -24.4042 -24.4042 -24.4042 --0.234375 -0.078125 0.046875 -27.2295 -27.2295 -27.2295 --0.203125 -0.109375 0.046875 77.2624 77.2624 77.2624 --0.203125 -0.078125 0.046875 4.91533 4.91533 4.91533 --0.234375 -0.109375 0.078125 -35.5821 -35.5821 -35.5821 --0.234375 -0.109375 0.109375 -38.8835 -38.8835 -38.8835 --0.234375 -0.078125 0.078125 -29.4357 -29.4357 -29.4357 --0.234375 -0.078125 0.109375 -16.6808 -16.6808 -16.6808 --0.203125 -0.109375 0.078125 -26.0312 -26.0312 -26.0312 --0.203125 -0.109375 0.109375 -33.1027 -33.1027 -33.1027 --0.203125 -0.078125 0.078125 -44.753 -44.753 -44.753 --0.203125 -0.078125 0.109375 -54.6054 -54.6054 -54.6054 --0.234375 -0.046875 0.046875 -26.9785 -26.9785 -26.9785 --0.234375 -0.015625 0.046875 -49.5396 -49.5396 -49.5396 --0.203125 -0.046875 0.046875 -85.2896 -85.2896 -85.2896 --0.203125 -0.015625 0.046875 -32.9017 -32.9017 -32.9017 --0.234375 -0.046875 0.109375 12.276 12.276 12.276 --0.234375 -0.015625 0.078125 -10.4256 -10.4256 -10.4256 --0.234375 -0.015625 0.109375 -5.58636 -5.58636 -5.58636 --0.203125 -0.046875 0.078125 -9.64995 -9.64995 -9.64995 --0.203125 -0.046875 0.109375 46.268 46.268 46.268 --0.203125 -0.015625 0.078125 10.8682 10.8682 10.8682 --0.203125 -0.015625 0.109375 1.34998 1.34998 1.34998 --0.171875 -0.109375 0.046875 495.186 495.186 495.186 --0.171875 -0.078125 0.046875 2431.52 2431.52 2431.52 --0.140625 -0.109375 0.015625 -1350.7 -1350.7 -1350.7 --0.140625 -0.109375 0.046875 28.3768 28.3768 28.3768 --0.140625 -0.078125 0.015625 -2322.14 -2322.14 -2322.14 --0.140625 -0.078125 0.046875 -2168.64 -2168.64 -2168.64 --0.171875 -0.109375 0.078125 49.6371 49.6371 49.6371 --0.171875 -0.109375 0.109375 -56.8762 -56.8762 -56.8762 --0.171875 -0.078125 0.078125 -8.70928 -8.70928 -8.70928 --0.171875 -0.078125 0.109375 -104.05 -104.05 -104.05 --0.140625 -0.109375 0.078125 -77.3198 -77.3198 -77.3198 --0.140625 -0.078125 0.078125 -39.9101 -39.9101 -39.9101 --0.140625 -0.078125 0.109375 -182.024 -182.024 -182.024 --0.171875 -0.046875 0.046875 1484.1 1484.1 1484.1 --0.140625 -0.046875 0.046875 2651.07 2651.07 2651.07 --0.140625 -0.015625 0.046875 21.9706 21.9706 21.9706 --0.171875 -0.046875 0.078125 -82.4529 -82.4529 -82.4529 --0.171875 -0.046875 0.109375 -99.8965 -99.8965 -99.8965 --0.171875 -0.015625 0.078125 19.0279 19.0279 19.0279 --0.171875 -0.015625 0.109375 -10.323 -10.323 -10.323 --0.140625 -0.046875 0.078125 9.27351 9.27351 9.27351 --0.140625 -0.046875 0.109375 58.7341 58.7341 58.7341 --0.140625 -0.015625 0.078125 21.7408 21.7408 21.7408 --0.234375 -0.109375 0.140625 17.1505 17.1505 17.1505 --0.234375 -0.078125 0.140625 24.2169 24.2169 24.2169 --0.203125 -0.109375 0.140625 110.542 110.542 110.542 --0.203125 -0.109375 0.171875 -102.738 -102.738 -102.738 --0.203125 -0.078125 0.140625 72.1411 72.1411 72.1411 --0.203125 -0.078125 0.171875 -31.7119 -31.7119 -31.7119 --0.203125 -0.078125 0.203125 45.6773 45.6773 45.6773 --0.234375 -0.015625 0.140625 7.17233 7.17233 7.17233 --0.203125 -0.046875 0.171875 33.5624 33.5624 33.5624 --0.203125 -0.015625 0.171875 -5.58556 -5.58556 -5.58556 --0.234375 -0.046875 0.203125 -27.998 -27.998 -27.998 --0.234375 -0.046875 0.234375 -64.0951 -64.0951 -64.0951 --0.234375 -0.015625 0.203125 21.8544 21.8544 21.8544 --0.234375 -0.015625 0.234375 37.5337 37.5337 37.5337 --0.203125 -0.046875 0.203125 -140.154 -140.154 -140.154 --0.203125 -0.046875 0.234375 67.0985 67.0985 67.0985 --0.203125 -0.015625 0.203125 6.48818 6.48818 6.48818 --0.171875 -0.109375 0.140625 93.0112 93.0112 93.0112 --0.171875 -0.109375 0.171875 -7.38679 -7.38679 -7.38679 --0.171875 -0.078125 0.140625 -45.4581 -45.4581 -45.4581 --0.171875 -0.078125 0.171875 -83.4347 -83.4347 -83.4347 --0.140625 -0.109375 0.171875 246.766 246.766 246.766 --0.140625 -0.078125 0.140625 -53.0141 -53.0141 -53.0141 --0.140625 -0.078125 0.171875 -254.304 -254.304 -254.304 --0.171875 -0.109375 0.203125 68.4698 68.4698 68.4698 --0.171875 -0.109375 0.234375 37.7443 37.7443 37.7443 --0.171875 -0.078125 0.203125 -0.703889 -0.703889 -0.703889 --0.171875 -0.078125 0.234375 1.86427 1.86427 1.86427 --0.140625 -0.109375 0.203125 273.841 273.841 273.841 --0.140625 -0.109375 0.234375 -22.2893 -22.2893 -22.2893 --0.140625 -0.078125 0.203125 149.082 149.082 149.082 --0.140625 -0.078125 0.234375 -98.6293 -98.6293 -98.6293 --0.171875 -0.046875 0.140625 80.5688 80.5688 80.5688 --0.171875 -0.046875 0.171875 31.6621 31.6621 31.6621 --0.171875 -0.015625 0.171875 -0.756663 -0.756663 -0.756663 --0.140625 -0.046875 0.140625 3.15498 3.15498 3.15498 --0.140625 -0.046875 0.171875 -46.3437 -46.3437 -46.3437 --0.140625 -0.015625 0.171875 11.762 11.762 11.762 --0.171875 -0.046875 0.203125 24.9533 24.9533 24.9533 --0.171875 -0.046875 0.234375 -25.9395 -25.9395 -25.9395 --0.171875 -0.015625 0.203125 0.169075 0.169075 0.169075 --0.171875 -0.015625 0.234375 91.1255 91.1255 91.1255 --0.140625 -0.046875 0.234375 112.561 112.561 112.561 --0.140625 -0.015625 0.203125 20.3864 20.3864 20.3864 --0.140625 -0.015625 0.234375 3.30099 3.30099 3.30099 --0.109375 -0.234375 0.015625 -258.761 -258.761 -258.761 --0.109375 -0.203125 0.015625 -138.785 -138.785 -138.785 --0.109375 -0.203125 0.046875 89.8104 89.8104 89.8104 --0.078125 -0.234375 0.015625 -458.668 -458.668 -458.668 --0.078125 -0.203125 0.015625 -524.049 -524.049 -524.049 --0.078125 -0.203125 0.046875 -69.3691 -69.3691 -69.3691 --0.109375 -0.234375 0.078125 1.8677 1.8677 1.8677 --0.109375 -0.234375 0.109375 146.866 146.866 146.866 --0.109375 -0.203125 0.078125 5.07842 5.07842 5.07842 --0.109375 -0.203125 0.109375 -96.176 -96.176 -96.176 --0.078125 -0.234375 0.078125 -99.772 -99.772 -99.772 --0.078125 -0.234375 0.109375 50.4009 50.4009 50.4009 --0.078125 -0.203125 0.078125 -42.5535 -42.5535 -42.5535 --0.078125 -0.203125 0.109375 -95.4687 -95.4687 -95.4687 --0.109375 -0.171875 0.015625 34.3964 34.3964 34.3964 --0.109375 -0.171875 0.046875 1.6634 1.6634 1.6634 --0.109375 -0.140625 0.015625 21.0833 21.0833 21.0833 --0.109375 -0.140625 0.046875 -18.6122 -18.6122 -18.6122 --0.078125 -0.171875 0.015625 -2109.26 -2109.26 -2109.26 --0.078125 -0.140625 0.015625 -154.359 -154.359 -154.359 --0.078125 -0.140625 0.046875 220.611 220.611 220.611 --0.109375 -0.171875 0.078125 173.959 173.959 173.959 --0.109375 -0.171875 0.109375 -99.2861 -99.2861 -99.2861 --0.109375 -0.140625 0.078125 193.854 193.854 193.854 --0.078125 -0.171875 0.078125 -30.1434 -30.1434 -30.1434 --0.078125 -0.171875 0.109375 -34.0025 -34.0025 -34.0025 --0.078125 -0.140625 0.078125 -137.796 -137.796 -137.796 --0.078125 -0.140625 0.109375 -241.032 -241.032 -241.032 --0.046875 -0.234375 0.015625 164.503 164.503 164.503 --0.046875 -0.234375 0.046875 -97.9857 -97.9857 -97.9857 --0.046875 -0.203125 0.015625 606.172 606.172 606.172 --0.046875 -0.203125 0.046875 7.75708 7.75708 7.75708 --0.046875 -0.234375 0.078125 -107.28 -107.28 -107.28 --0.046875 -0.234375 0.109375 40.6188 40.6188 40.6188 --0.046875 -0.203125 0.078125 38.3358 38.3358 38.3358 --0.046875 -0.203125 0.109375 221.875 221.875 221.875 --0.015625 -0.234375 0.078125 -55.1277 -55.1277 -55.1277 --0.015625 -0.234375 0.109375 -38.714 -38.714 -38.714 --0.015625 -0.203125 0.078125 36.5614 36.5614 36.5614 --0.015625 -0.203125 0.109375 181.051 181.051 181.051 --0.046875 -0.171875 0.015625 -5082.09 -5082.09 -5082.09 --0.046875 -0.171875 0.046875 -75.5505 -75.5505 -75.5505 --0.046875 -0.140625 0.015625 -1777.44 -1777.44 -1777.44 --0.046875 -0.140625 0.046875 365.679 365.679 365.679 --0.015625 -0.171875 0.015625 1069.31 1069.31 1069.31 --0.015625 -0.171875 0.046875 94.5569 94.5569 94.5569 --0.015625 -0.140625 0.046875 -114.657 -114.657 -114.657 --0.046875 -0.171875 0.078125 -16.2801 -16.2801 -16.2801 --0.046875 -0.171875 0.109375 -122.642 -122.642 -122.642 --0.046875 -0.140625 0.078125 -58.3224 -58.3224 -58.3224 --0.046875 -0.140625 0.109375 -171.941 -171.941 -171.941 --0.015625 -0.171875 0.078125 22.4268 22.4268 22.4268 --0.015625 -0.171875 0.109375 -142.479 -142.479 -142.479 --0.015625 -0.140625 0.109375 26.2547 26.2547 26.2547 --0.109375 -0.234375 0.140625 162.227 162.227 162.227 --0.109375 -0.234375 0.171875 -51.4225 -51.4225 -51.4225 --0.109375 -0.203125 0.171875 207.265 207.265 207.265 --0.078125 -0.234375 0.140625 -78.5093 -78.5093 -78.5093 --0.078125 -0.234375 0.171875 116.944 116.944 116.944 --0.078125 -0.203125 0.140625 -185.288 -185.288 -185.288 --0.078125 -0.203125 0.171875 -3.30893 -3.30893 -3.30893 --0.109375 -0.203125 0.203125 20.5165 20.5165 20.5165 --0.078125 -0.234375 0.203125 -65.0773 -65.0773 -65.0773 --0.078125 -0.203125 0.203125 44.2361 44.2361 44.2361 --0.109375 -0.171875 0.171875 -121.154 -121.154 -121.154 --0.109375 -0.140625 0.140625 176.866 176.866 176.866 --0.109375 -0.140625 0.171875 -364.68 -364.68 -364.68 --0.078125 -0.171875 0.140625 -164.887 -164.887 -164.887 --0.078125 -0.171875 0.171875 -199.029 -199.029 -199.029 --0.078125 -0.140625 0.140625 -13.7136 -13.7136 -13.7136 --0.078125 -0.140625 0.171875 236.946 236.946 236.946 --0.109375 -0.171875 0.203125 39.0843 39.0843 39.0843 --0.109375 -0.140625 0.203125 -18.1917 -18.1917 -18.1917 --0.109375 -0.140625 0.234375 4.06058 4.06058 4.06058 --0.078125 -0.140625 0.234375 53.3395 53.3395 53.3395 --0.046875 -0.234375 0.140625 8.19244 8.19244 8.19244 --0.046875 -0.234375 0.171875 98.2815 98.2815 98.2815 --0.046875 -0.203125 0.140625 -139.77 -139.77 -139.77 --0.046875 -0.203125 0.171875 130.228 130.228 130.228 --0.046875 -0.234375 0.203125 3.72476 3.72476 3.72476 --0.046875 -0.234375 0.234375 85.4449 85.4449 85.4449 --0.046875 -0.203125 0.203125 43.9767 43.9767 43.9767 --0.046875 -0.203125 0.234375 -15.834 -15.834 -15.834 --0.015625 -0.234375 0.203125 182.091 182.091 182.091 --0.015625 -0.234375 0.234375 -114.616 -114.616 -114.616 --0.015625 -0.203125 0.234375 -243.318 -243.318 -243.318 --0.046875 -0.171875 0.140625 -14.037 -14.037 -14.037 --0.046875 -0.171875 0.171875 3.90495 3.90495 3.90495 --0.046875 -0.140625 0.140625 -33.2738 -33.2738 -33.2738 --0.046875 -0.140625 0.171875 -120.928 -120.928 -120.928 --0.015625 -0.171875 0.140625 -72.2628 -72.2628 -72.2628 --0.015625 -0.171875 0.171875 -253.102 -253.102 -253.102 --0.015625 -0.140625 0.140625 -204.95 -204.95 -204.95 --0.015625 -0.140625 0.171875 -194.619 -194.619 -194.619 --0.046875 -0.171875 0.203125 57.788 57.788 57.788 --0.046875 -0.171875 0.234375 18.4655 18.4655 18.4655 --0.046875 -0.140625 0.203125 59.9832 59.9832 59.9832 --0.046875 -0.140625 0.234375 -14.0354 -14.0354 -14.0354 --0.015625 -0.140625 0.203125 14.0276 14.0276 14.0276 --0.109375 -0.109375 0.015625 -3641.41 -3641.41 -3641.41 --0.109375 -0.078125 0.015625 964.992 964.992 964.992 --0.109375 -0.078125 0.046875 -1689.41 -1689.41 -1689.41 --0.078125 -0.109375 0.015625 -5010.84 -5010.84 -5010.84 --0.078125 -0.109375 0.046875 78.1648 78.1648 78.1648 --0.078125 -0.078125 0.015625 -16.692 -16.692 -16.692 --0.109375 -0.109375 0.078125 211.607 211.607 211.607 --0.109375 -0.078125 0.078125 -90.6055 -90.6055 -90.6055 --0.078125 -0.109375 0.078125 -255.402 -255.402 -255.402 --0.078125 -0.078125 0.078125 51.2325 51.2325 51.2325 --0.078125 -0.078125 0.109375 162.758 162.758 162.758 --0.109375 -0.046875 0.015625 716.918 716.918 716.918 --0.109375 -0.046875 0.046875 -1713.58 -1713.58 -1713.58 --0.109375 -0.015625 0.015625 -18.2459 -18.2459 -18.2459 --0.109375 -0.015625 0.046875 13.4356 13.4356 13.4356 --0.078125 -0.046875 0.015625 -1.23552 -1.23552 -1.23552 --0.078125 -0.046875 0.046875 -74.4695 -74.4695 -74.4695 --0.078125 -0.015625 0.015625 -12.4196 -12.4196 -12.4196 --0.078125 -0.015625 0.046875 2.0986 2.0986 2.0986 --0.109375 -0.046875 0.078125 109.904 109.904 109.904 --0.078125 -0.046875 0.078125 9.03086 9.03086 9.03086 --0.078125 -0.046875 0.109375 24.1727 24.1727 24.1727 --0.078125 -0.015625 0.109375 -6.01065 -6.01065 -6.01065 --0.046875 -0.109375 0.015625 -552.486 -552.486 -552.486 --0.046875 -0.109375 0.046875 -122.751 -122.751 -122.751 --0.046875 -0.078125 0.015625 -75.6638 -75.6638 -75.6638 --0.046875 -0.078125 0.046875 69.8781 69.8781 69.8781 --0.015625 -0.109375 0.046875 -12.8017 -12.8017 -12.8017 --0.015625 -0.078125 0.046875 -166.42 -166.42 -166.42 --0.046875 -0.109375 0.078125 253.597 253.597 253.597 --0.046875 -0.109375 0.109375 -83.1336 -83.1336 -83.1336 --0.046875 -0.078125 0.078125 -18.7671 -18.7671 -18.7671 --0.046875 -0.078125 0.109375 19.4811 19.4811 19.4811 --0.015625 -0.109375 0.078125 41.0988 41.0988 41.0988 --0.015625 -0.109375 0.109375 -7.40465 -7.40465 -7.40465 --0.015625 -0.078125 0.078125 -119.929 -119.929 -119.929 --0.015625 -0.078125 0.109375 3.26931 3.26931 3.26931 --0.046875 -0.046875 0.015625 -118.308 -118.308 -118.308 --0.046875 -0.046875 0.046875 33.5059 33.5059 33.5059 --0.046875 -0.015625 0.015625 4.01815 4.01815 4.01815 --0.046875 -0.015625 0.046875 -17.1346 -17.1346 -17.1346 --0.015625 -0.046875 0.015625 -8.8939 -8.8939 -8.8939 --0.015625 -0.046875 0.046875 -14.0135 -14.0135 -14.0135 --0.046875 -0.046875 0.078125 88.226 88.226 88.226 --0.046875 -0.046875 0.109375 -35.0312 -35.0312 -35.0312 --0.046875 -0.015625 0.078125 8.34242 8.34242 8.34242 --0.046875 -0.015625 0.109375 4.60695 4.60695 4.60695 --0.015625 -0.046875 0.078125 -48.4158 -48.4158 -48.4158 --0.015625 -0.046875 0.109375 -45.7826 -45.7826 -45.7826 --0.015625 -0.015625 0.109375 -87.1053 -87.1053 -87.1053 --0.109375 -0.109375 0.171875 227.99 227.99 227.99 --0.109375 -0.078125 0.171875 -228.255 -228.255 -228.255 --0.078125 -0.109375 0.171875 46.5544 46.5544 46.5544 --0.078125 -0.078125 0.171875 -147.108 -147.108 -147.108 --0.109375 -0.109375 0.203125 12.0695 12.0695 12.0695 --0.109375 -0.109375 0.234375 50.6468 50.6468 50.6468 --0.109375 -0.078125 0.203125 -26.399 -26.399 -26.399 --0.109375 -0.078125 0.234375 -24.807 -24.807 -24.807 --0.078125 -0.109375 0.203125 -32.269 -32.269 -32.269 --0.078125 -0.109375 0.234375 -62.7013 -62.7013 -62.7013 --0.078125 -0.015625 0.140625 6.12067 6.12067 6.12067 --0.078125 -0.015625 0.171875 4.53292 4.53292 4.53292 --0.109375 -0.046875 0.234375 -127.799 -127.799 -127.799 --0.109375 -0.015625 0.203125 30.7291 30.7291 30.7291 --0.109375 -0.015625 0.234375 -67.9879 -67.9879 -67.9879 --0.078125 -0.015625 0.203125 -9.31416 -9.31416 -9.31416 --0.078125 -0.015625 0.234375 59.6197 59.6197 59.6197 --0.046875 -0.109375 0.140625 135.03 135.03 135.03 --0.046875 -0.109375 0.171875 -62.7181 -62.7181 -62.7181 --0.046875 -0.078125 0.140625 90.6027 90.6027 90.6027 --0.046875 -0.078125 0.171875 -206.191 -206.191 -206.191 --0.015625 -0.109375 0.140625 -63.7133 -63.7133 -63.7133 --0.015625 -0.109375 0.171875 171.05 171.05 171.05 --0.015625 -0.078125 0.140625 5.2953 5.2953 5.2953 --0.015625 -0.078125 0.171875 70.9296 70.9296 70.9296 --0.046875 -0.109375 0.203125 47.3491 47.3491 47.3491 --0.046875 -0.109375 0.234375 -102.665 -102.665 -102.665 --0.046875 -0.078125 0.203125 95.6089 95.6089 95.6089 --0.046875 -0.078125 0.234375 28.6501 28.6501 28.6501 --0.015625 -0.109375 0.203125 -106.39 -106.39 -106.39 --0.015625 -0.109375 0.234375 -19.2753 -19.2753 -19.2753 --0.015625 -0.078125 0.203125 160.57 160.57 160.57 --0.015625 -0.078125 0.234375 -24.3474 -24.3474 -24.3474 --0.046875 -0.046875 0.140625 -172.724 -172.724 -172.724 --0.046875 -0.046875 0.171875 -55.9014 -55.9014 -55.9014 --0.046875 -0.015625 0.140625 -51.1332 -51.1332 -51.1332 --0.046875 -0.015625 0.171875 -20.6501 -20.6501 -20.6501 --0.015625 -0.046875 0.140625 -84.6972 -84.6972 -84.6972 --0.015625 -0.046875 0.171875 -175.852 -175.852 -175.852 --0.015625 -0.015625 0.140625 -19.6134 -19.6134 -19.6134 --0.015625 -0.015625 0.171875 19.0256 19.0256 19.0256 --0.046875 -0.046875 0.234375 2.06818 2.06818 2.06818 --0.046875 -0.015625 0.234375 -10.3421 -10.3421 -10.3421 --0.015625 -0.046875 0.203125 14.3964 14.3964 14.3964 --0.015625 -0.046875 0.234375 90.6318 90.6318 90.6318 --0.015625 -0.015625 0.203125 2.82935 2.82935 2.82935 --0.015625 -0.015625 0.234375 148.237 148.237 148.237 --0.234375 -0.234375 0.265625 6.39798 6.39798 6.39798 --0.234375 -0.203125 0.265625 -0.637583 -0.637583 -0.637583 --0.234375 -0.203125 0.296875 -41.5694 -41.5694 -41.5694 --0.203125 -0.234375 0.265625 -2.30339 -2.30339 -2.30339 --0.203125 -0.203125 0.265625 1.45593 1.45593 1.45593 --0.203125 -0.203125 0.296875 -1.37142 -1.37142 -1.37142 --0.234375 -0.171875 0.265625 -71.3286 -71.3286 -71.3286 --0.234375 -0.171875 0.296875 -19.5388 -19.5388 -19.5388 --0.234375 -0.140625 0.265625 92.5762 92.5762 92.5762 --0.234375 -0.140625 0.296875 5.7351 5.7351 5.7351 --0.203125 -0.171875 0.265625 13.0344 13.0344 13.0344 --0.203125 -0.171875 0.296875 -3.37663 -3.37663 -3.37663 --0.203125 -0.140625 0.265625 28.5487 28.5487 28.5487 --0.171875 -0.203125 0.265625 -15.115 -15.115 -15.115 --0.171875 -0.171875 0.265625 11.8424 11.8424 11.8424 --0.171875 -0.140625 0.265625 2.29811 2.29811 2.29811 --0.234375 -0.109375 0.265625 -128.074 -128.074 -128.074 --0.234375 -0.109375 0.296875 2.52058 2.52058 2.52058 --0.234375 -0.078125 0.265625 -6.75182 -6.75182 -6.75182 --0.234375 -0.078125 0.296875 -38.523 -38.523 -38.523 --0.203125 -0.109375 0.265625 -1.44038 -1.44038 -1.44038 --0.203125 -0.109375 0.296875 -0.803649 -0.803649 -0.803649 --0.203125 -0.078125 0.265625 60.7496 60.7496 60.7496 --0.203125 -0.078125 0.296875 63.5521 63.5521 63.5521 --0.234375 -0.046875 0.265625 54.5848 54.5848 54.5848 --0.234375 -0.046875 0.296875 76.6734 76.6734 76.6734 --0.234375 -0.015625 0.265625 -48.3885 -48.3885 -48.3885 --0.203125 -0.046875 0.265625 74.252 74.252 74.252 --0.203125 -0.046875 0.296875 -64.0141 -64.0141 -64.0141 --0.171875 -0.109375 0.265625 81.8444 81.8444 81.8444 --0.171875 -0.109375 0.296875 -81.3584 -81.3584 -81.3584 --0.171875 -0.078125 0.265625 -20.4175 -20.4175 -20.4175 --0.171875 -0.078125 0.296875 119.8 119.8 119.8 --0.140625 -0.109375 0.265625 29.4149 29.4149 29.4149 --0.140625 -0.078125 0.265625 -443.488 -443.488 -443.488 --0.171875 -0.046875 0.265625 -198.303 -198.303 -198.303 --0.109375 -0.140625 0.265625 42.2283 42.2283 42.2283 --0.078125 -0.140625 0.265625 5.86095 5.86095 5.86095 --0.046875 -0.203125 0.265625 -131.27 -131.27 -131.27 --0.015625 -0.203125 0.265625 -97.5666 -97.5666 -97.5666 --0.015625 -0.203125 0.296875 195.877 195.877 195.877 --0.046875 -0.171875 0.265625 -54.9949 -54.9949 -54.9949 --0.046875 -0.171875 0.296875 -17.6601 -17.6601 -17.6601 --0.046875 -0.140625 0.265625 -60.4487 -60.4487 -60.4487 --0.046875 -0.140625 0.296875 124.43 124.43 124.43 --0.015625 -0.171875 0.265625 -27.4329 -27.4329 -27.4329 --0.015625 -0.171875 0.296875 1.17762 1.17762 1.17762 --0.015625 -0.140625 0.265625 -15.0393 -15.0393 -15.0393 --0.015625 -0.140625 0.296875 154.006 154.006 154.006 --0.046875 -0.140625 0.328125 36.1948 36.1948 36.1948 --0.046875 -0.140625 0.359375 -47.1958 -47.1958 -47.1958 --0.015625 -0.171875 0.328125 -414.255 -414.255 -414.255 --0.015625 -0.140625 0.328125 442.968 442.968 442.968 --0.015625 -0.140625 0.359375 -38.4686 -38.4686 -38.4686 --0.109375 -0.109375 0.265625 57.6369 57.6369 57.6369 --0.109375 -0.109375 0.296875 17.2145 17.2145 17.2145 --0.109375 -0.078125 0.265625 -260.564 -260.564 -260.564 --0.109375 -0.078125 0.296875 202.41 202.41 202.41 --0.078125 -0.109375 0.265625 69.8545 69.8545 69.8545 --0.078125 -0.109375 0.296875 19.7982 19.7982 19.7982 --0.078125 -0.078125 0.296875 213.275 213.275 213.275 --0.078125 -0.109375 0.328125 -8.48235 -8.48235 -8.48235 --0.078125 -0.078125 0.328125 -145.41 -145.41 -145.41 --0.109375 -0.046875 0.265625 148.986 148.986 148.986 --0.109375 -0.046875 0.296875 51.6805 51.6805 51.6805 --0.109375 -0.015625 0.265625 857.448 857.448 857.448 --0.078125 -0.046875 0.265625 -175.063 -175.063 -175.063 --0.078125 -0.046875 0.296875 86.4118 86.4118 86.4118 --0.078125 -0.015625 0.265625 170.404 170.404 170.404 --0.046875 -0.109375 0.265625 -12.2424 -12.2424 -12.2424 --0.046875 -0.109375 0.296875 91.9929 91.9929 91.9929 --0.046875 -0.078125 0.265625 -78.0866 -78.0866 -78.0866 --0.015625 -0.109375 0.265625 -76.6908 -76.6908 -76.6908 --0.015625 -0.078125 0.265625 -200.543 -200.543 -200.543 --0.046875 -0.109375 0.328125 37.76 37.76 37.76 --0.046875 -0.109375 0.359375 6.23528 6.23528 6.23528 --0.046875 -0.078125 0.328125 -8.33258 -8.33258 -8.33258 --0.046875 -0.078125 0.359375 86.8298 86.8298 86.8298 --0.015625 -0.109375 0.359375 -6.5555 -6.5555 -6.5555 --0.015625 -0.078125 0.359375 -73.9704 -73.9704 -73.9704 --0.046875 -0.046875 0.265625 -0.0943651 -0.0943651 -0.0943651 --0.046875 -0.046875 0.296875 11.7713 11.7713 11.7713 --0.046875 -0.015625 0.265625 138.748 138.748 138.748 --0.046875 -0.015625 0.296875 969.27 969.27 969.27 --0.015625 -0.046875 0.265625 129.226 129.226 129.226 --0.015625 -0.046875 0.296875 -206.091 -206.091 -206.091 --0.015625 -0.015625 0.265625 11.2485 11.2485 11.2485 --0.015625 -0.015625 0.296875 -125.269 -125.269 -125.269 --0.046875 -0.046875 0.328125 38.3094 38.3094 38.3094 --0.046875 -0.046875 0.359375 43.2727 43.2727 43.2727 --0.015625 -0.046875 0.328125 109.468 109.468 109.468 --0.015625 -0.046875 0.359375 269.931 269.931 269.931 --0.296875 0.015625 -0.296875 -636.573 -636.573 -636.573 --0.296875 0.015625 -0.265625 -2674.72 -2674.72 -2674.72 --0.296875 0.046875 -0.265625 -2245.97 -2245.97 -2245.97 --0.265625 0.015625 -0.296875 3303.54 3303.54 3303.54 --0.265625 0.046875 -0.296875 3727.32 3727.32 3727.32 --0.265625 0.046875 -0.265625 -191.974 -191.974 -191.974 --0.265625 0.078125 -0.296875 -665.804 -665.804 -665.804 --0.265625 0.078125 -0.265625 2865.07 2865.07 2865.07 --0.265625 0.109375 -0.296875 -1631.75 -1631.75 -1631.75 --0.265625 0.109375 -0.265625 -921.723 -921.723 -921.723 --0.453125 0.015625 -0.203125 61.3058 61.3058 61.3058 --0.453125 0.046875 -0.203125 103.074 103.074 103.074 --0.453125 0.015625 -0.171875 182.248 182.248 182.248 --0.453125 0.015625 -0.140625 5.81481 5.81481 5.81481 --0.453125 0.046875 -0.171875 373.33 373.33 373.33 --0.453125 0.046875 -0.140625 -495.264 -495.264 -495.264 --0.453125 0.078125 -0.203125 -5.4849 -5.4849 -5.4849 --0.453125 0.078125 -0.171875 77.3501 77.3501 77.3501 --0.421875 0.015625 -0.234375 -19.2116 -19.2116 -19.2116 --0.421875 0.015625 -0.203125 -176.904 -176.904 -176.904 --0.421875 0.046875 -0.234375 -144.133 -144.133 -144.133 --0.421875 0.046875 -0.203125 207.713 207.713 207.713 --0.390625 0.015625 -0.234375 26.4935 26.4935 26.4935 --0.390625 0.015625 -0.203125 -90.1596 -90.1596 -90.1596 --0.390625 0.046875 -0.234375 -30.3361 -30.3361 -30.3361 --0.390625 0.046875 -0.203125 27.0118 27.0118 27.0118 --0.421875 0.015625 -0.140625 29.5533 29.5533 29.5533 --0.421875 0.046875 -0.140625 115.927 115.927 115.927 --0.390625 0.046875 -0.140625 -146.59 -146.59 -146.59 --0.421875 0.078125 -0.234375 -24.9401 -24.9401 -24.9401 --0.421875 0.078125 -0.203125 108.271 108.271 108.271 --0.390625 0.078125 -0.234375 -165.948 -165.948 -165.948 --0.390625 0.078125 -0.203125 147.984 147.984 147.984 --0.421875 0.078125 -0.171875 450.67 450.67 450.67 --0.421875 0.078125 -0.140625 -132.335 -132.335 -132.335 --0.390625 0.078125 -0.171875 50.9409 50.9409 50.9409 --0.390625 0.078125 -0.140625 -193.993 -193.993 -193.993 --0.453125 0.015625 -0.109375 -164.466 -164.466 -164.466 --0.453125 0.015625 -0.078125 -35.0734 -35.0734 -35.0734 --0.453125 0.046875 -0.078125 28.082 28.082 28.082 --0.453125 0.015625 -0.046875 -96.8517 -96.8517 -96.8517 --0.421875 0.015625 -0.109375 21.9948 21.9948 21.9948 --0.421875 0.015625 -0.078125 51.7504 51.7504 51.7504 --0.421875 0.046875 -0.109375 32.7034 32.7034 32.7034 --0.421875 0.046875 -0.078125 83.6705 83.6705 83.6705 --0.390625 0.046875 -0.109375 43.2833 43.2833 43.2833 --0.390625 0.046875 -0.078125 -57.1796 -57.1796 -57.1796 --0.421875 0.015625 -0.046875 -64.2593 -64.2593 -64.2593 --0.421875 0.015625 -0.015625 -267.374 -267.374 -267.374 --0.421875 0.046875 -0.046875 76.9518 76.9518 76.9518 --0.390625 0.015625 -0.046875 -70.2267 -70.2267 -70.2267 --0.390625 0.046875 -0.046875 52.6814 52.6814 52.6814 --0.359375 0.015625 -0.203125 53.912 53.912 53.912 --0.359375 0.046875 -0.203125 -93.6121 -93.6121 -93.6121 --0.328125 0.015625 -0.234375 -297.546 -297.546 -297.546 --0.328125 0.015625 -0.203125 143.406 143.406 143.406 --0.328125 0.046875 -0.203125 20.3169 20.3169 20.3169 --0.359375 0.015625 -0.171875 465.543 465.543 465.543 --0.359375 0.046875 -0.171875 -186.34 -186.34 -186.34 --0.359375 0.046875 -0.140625 35.9489 35.9489 35.9489 --0.328125 0.046875 -0.171875 -35.442 -35.442 -35.442 --0.328125 0.046875 -0.140625 -32.8121 -32.8121 -32.8121 --0.359375 0.078125 -0.203125 547.614 547.614 547.614 --0.359375 0.078125 -0.171875 235.272 235.272 235.272 --0.328125 0.078125 -0.171875 -10.0691 -10.0691 -10.0691 --0.328125 0.078125 -0.140625 295.483 295.483 295.483 --0.328125 0.109375 -0.171875 -35.6757 -35.6757 -35.6757 --0.328125 0.109375 -0.140625 51.6159 51.6159 51.6159 --0.296875 0.015625 -0.234375 2048.08 2048.08 2048.08 --0.296875 0.015625 -0.203125 -12.8549 -12.8549 -12.8549 --0.296875 0.046875 -0.234375 -6846.72 -6846.72 -6846.72 --0.296875 0.046875 -0.203125 41.9219 41.9219 41.9219 --0.265625 0.046875 -0.234375 -1342.96 -1342.96 -1342.96 --0.265625 0.046875 -0.203125 353.307 353.307 353.307 --0.296875 0.015625 -0.140625 234.472 234.472 234.472 --0.296875 0.046875 -0.171875 -236.884 -236.884 -236.884 --0.265625 0.015625 -0.171875 -147.795 -147.795 -147.795 --0.265625 0.015625 -0.140625 -25.6263 -25.6263 -25.6263 --0.265625 0.046875 -0.171875 42.4567 42.4567 42.4567 --0.265625 0.046875 -0.140625 -31.8645 -31.8645 -31.8645 --0.296875 0.078125 -0.203125 -548.081 -548.081 -548.081 --0.296875 0.109375 -0.203125 -458.671 -458.671 -458.671 --0.265625 0.078125 -0.234375 5359.64 5359.64 5359.64 --0.265625 0.078125 -0.203125 -32.798 -32.798 -32.798 --0.265625 0.109375 -0.234375 -1468.49 -1468.49 -1468.49 --0.265625 0.109375 -0.203125 -68.8212 -68.8212 -68.8212 --0.296875 0.078125 -0.171875 116.336 116.336 116.336 --0.296875 0.109375 -0.171875 -107.938 -107.938 -107.938 --0.265625 0.078125 -0.171875 28.3998 28.3998 28.3998 --0.359375 0.046875 -0.109375 525.751 525.751 525.751 --0.359375 0.046875 -0.078125 -45.396 -45.396 -45.396 --0.328125 0.015625 -0.109375 24.9385 24.9385 24.9385 --0.328125 0.046875 -0.109375 417.372 417.372 417.372 --0.328125 0.046875 -0.078125 -40.9655 -40.9655 -40.9655 --0.359375 0.015625 -0.046875 -22.0636 -22.0636 -22.0636 --0.359375 0.015625 -0.015625 18.5501 18.5501 18.5501 --0.359375 0.046875 -0.046875 21.4231 21.4231 21.4231 --0.328125 0.015625 -0.046875 94.9906 94.9906 94.9906 --0.328125 0.015625 -0.015625 -6.93924 -6.93924 -6.93924 --0.328125 0.046875 -0.046875 25.7528 25.7528 25.7528 --0.328125 0.078125 -0.109375 28.3219 28.3219 28.3219 --0.328125 0.109375 -0.109375 -239.399 -239.399 -239.399 --0.328125 0.078125 -0.015625 -11.9711 -11.9711 -11.9711 --0.328125 0.109375 -0.015625 51.1759 51.1759 51.1759 --0.296875 0.015625 -0.109375 77.7809 77.7809 77.7809 --0.296875 0.015625 -0.078125 -229.767 -229.767 -229.767 --0.296875 0.046875 -0.109375 -228.162 -228.162 -228.162 --0.296875 0.046875 -0.078125 -201.327 -201.327 -201.327 --0.265625 0.015625 -0.109375 -80.5277 -80.5277 -80.5277 --0.265625 0.046875 -0.109375 -26.4757 -26.4757 -26.4757 --0.265625 0.046875 -0.078125 -47.2101 -47.2101 -47.2101 --0.296875 0.015625 -0.046875 -100.448 -100.448 -100.448 --0.296875 0.015625 -0.015625 79.0115 79.0115 79.0115 --0.296875 0.046875 -0.046875 -2.67964 -2.67964 -2.67964 --0.265625 0.015625 -0.046875 -21.7132 -21.7132 -21.7132 --0.265625 0.015625 -0.015625 25.2961 25.2961 25.2961 --0.265625 0.046875 -0.046875 -59.1066 -59.1066 -59.1066 --0.296875 0.078125 -0.109375 0.0344086 0.0344086 0.0344086 --0.296875 0.078125 -0.078125 118.145 118.145 118.145 --0.296875 0.109375 -0.109375 -274.846 -274.846 -274.846 --0.265625 0.078125 -0.109375 19.7834 19.7834 19.7834 --0.265625 0.078125 -0.078125 115.125 115.125 115.125 --0.265625 0.109375 -0.109375 3.96277 3.96277 3.96277 --0.265625 0.109375 -0.078125 -80.2609 -80.2609 -80.2609 --0.296875 0.078125 -0.015625 -53.7353 -53.7353 -53.7353 --0.296875 0.109375 -0.046875 75.1989 75.1989 75.1989 --0.296875 0.109375 -0.015625 28.0035 28.0035 28.0035 --0.265625 0.078125 -0.046875 -69.1945 -69.1945 -69.1945 --0.265625 0.078125 -0.015625 -20.9574 -20.9574 -20.9574 --0.265625 0.109375 -0.046875 -163.748 -163.748 -163.748 --0.265625 0.109375 -0.015625 -21.1365 -21.1365 -21.1365 --0.328125 0.140625 -0.171875 -19.7334 -19.7334 -19.7334 --0.328125 0.140625 -0.140625 -127.102 -127.102 -127.102 --0.296875 0.140625 -0.203125 401.453 401.453 401.453 --0.265625 0.140625 -0.203125 -95.4245 -95.4245 -95.4245 --0.296875 0.140625 -0.171875 -9.85533 -9.85533 -9.85533 --0.296875 0.140625 -0.140625 -66.8349 -66.8349 -66.8349 --0.296875 0.171875 -0.171875 -38.4292 -38.4292 -38.4292 --0.296875 0.171875 -0.140625 70.7918 70.7918 70.7918 --0.265625 0.140625 -0.171875 270.987 270.987 270.987 --0.265625 0.140625 -0.140625 113.762 113.762 113.762 --0.265625 0.171875 -0.171875 -430.755 -430.755 -430.755 --0.265625 0.171875 -0.140625 -266.554 -266.554 -266.554 --0.265625 0.203125 -0.140625 -80.615 -80.615 -80.615 --0.265625 0.234375 -0.171875 33.0073 33.0073 33.0073 --0.265625 0.234375 -0.140625 284.12 284.12 284.12 --0.328125 0.140625 -0.109375 -180.244 -180.244 -180.244 --0.359375 0.140625 -0.015625 21.7779 21.7779 21.7779 --0.359375 0.171875 -0.015625 59.0385 59.0385 59.0385 --0.328125 0.140625 -0.046875 152.254 152.254 152.254 --0.328125 0.140625 -0.015625 7.17267 7.17267 7.17267 --0.328125 0.171875 -0.046875 157.489 157.489 157.489 --0.328125 0.171875 -0.015625 33.9686 33.9686 33.9686 --0.359375 0.203125 -0.015625 28.9136 28.9136 28.9136 --0.328125 0.203125 -0.046875 109.644 109.644 109.644 --0.328125 0.203125 -0.015625 67.4864 67.4864 67.4864 --0.328125 0.234375 -0.046875 112.899 112.899 112.899 --0.328125 0.234375 -0.015625 27.7207 27.7207 27.7207 --0.296875 0.140625 -0.109375 -49.3944 -49.3944 -49.3944 --0.265625 0.140625 -0.109375 125.209 125.209 125.209 --0.265625 0.140625 -0.078125 -49.9165 -49.9165 -49.9165 --0.265625 0.171875 -0.109375 179.54 179.54 179.54 --0.265625 0.171875 -0.078125 100.41 100.41 100.41 --0.296875 0.140625 -0.046875 -107.689 -107.689 -107.689 --0.296875 0.140625 -0.015625 -35.0111 -35.0111 -35.0111 --0.296875 0.171875 -0.046875 -110.217 -110.217 -110.217 --0.265625 0.140625 -0.046875 -138.846 -138.846 -138.846 --0.265625 0.140625 -0.015625 -16.9507 -16.9507 -16.9507 --0.265625 0.171875 -0.046875 -477.197 -477.197 -477.197 --0.265625 0.171875 -0.015625 -234.295 -234.295 -234.295 --0.265625 0.203125 -0.109375 253.911 253.911 253.911 --0.265625 0.203125 -0.078125 113.183 113.183 113.183 --0.265625 0.234375 -0.109375 110.193 110.193 110.193 --0.265625 0.234375 -0.078125 -146.736 -146.736 -146.736 --0.296875 0.203125 -0.046875 100.413 100.413 100.413 --0.296875 0.234375 -0.046875 -54.4777 -54.4777 -54.4777 --0.296875 0.234375 -0.015625 87.0061 87.0061 87.0061 --0.265625 0.203125 -0.046875 21.036 21.036 21.036 --0.265625 0.234375 -0.046875 -179.569 -179.569 -179.569 --0.265625 0.234375 -0.015625 -22.9377 -22.9377 -22.9377 --0.265625 0.265625 -0.203125 6.60401 6.60401 6.60401 --0.265625 0.296875 -0.203125 -117.23 -117.23 -117.23 --0.265625 0.265625 -0.171875 -50.8623 -50.8623 -50.8623 --0.265625 0.265625 -0.140625 -703.887 -703.887 -703.887 --0.265625 0.296875 -0.171875 855.449 855.449 855.449 --0.265625 0.296875 -0.140625 375.199 375.199 375.199 --0.265625 0.328125 -0.203125 -1169.03 -1169.03 -1169.03 --0.265625 0.328125 -0.171875 -14.5332 -14.5332 -14.5332 --0.265625 0.328125 -0.140625 303.675 303.675 303.675 --0.265625 0.265625 -0.109375 -251.533 -251.533 -251.533 --0.265625 0.265625 -0.078125 -14.1411 -14.1411 -14.1411 --0.265625 0.296875 -0.109375 307.985 307.985 307.985 --0.265625 0.296875 -0.078125 212.923 212.923 212.923 --0.296875 0.265625 -0.015625 1266.02 1266.02 1266.02 --0.265625 0.265625 -0.046875 1512.67 1512.67 1512.67 --0.265625 0.265625 -0.015625 3752.37 3752.37 3752.37 --0.265625 0.296875 -0.046875 -1357.8 -1357.8 -1357.8 --0.140625 0.046875 -0.453125 -22.6112 -22.6112 -22.6112 --0.140625 0.046875 -0.421875 25.4906 25.4906 25.4906 --0.140625 0.046875 -0.390625 20.0858 20.0858 20.0858 --0.140625 0.078125 -0.453125 -269.531 -269.531 -269.531 --0.140625 0.078125 -0.421875 37.7785 37.7785 37.7785 --0.140625 0.078125 -0.390625 9.6183 9.6183 9.6183 --0.140625 0.109375 -0.421875 -9.52202 -9.52202 -9.52202 --0.234375 0.015625 -0.328125 -1205.39 -1205.39 -1205.39 --0.234375 0.046875 -0.328125 -5.19787 -5.19787 -5.19787 --0.203125 0.015625 -0.328125 33.1877 33.1877 33.1877 --0.203125 0.046875 -0.328125 -47.376 -47.376 -47.376 --0.234375 0.015625 -0.296875 -55.6549 -55.6549 -55.6549 --0.234375 0.046875 -0.296875 -319.532 -319.532 -319.532 --0.203125 0.046875 -0.296875 -10.1431 -10.1431 -10.1431 --0.234375 0.078125 -0.328125 75.6704 75.6704 75.6704 --0.234375 0.109375 -0.328125 -469.565 -469.565 -469.565 --0.203125 0.078125 -0.328125 -63.5081 -63.5081 -63.5081 --0.203125 0.109375 -0.328125 -176.608 -176.608 -176.608 --0.234375 0.078125 -0.296875 496.887 496.887 496.887 --0.234375 0.109375 -0.296875 551.206 551.206 551.206 --0.234375 0.109375 -0.265625 46.8467 46.8467 46.8467 --0.203125 0.109375 -0.296875 182.947 182.947 182.947 --0.171875 0.015625 -0.359375 27.9792 27.9792 27.9792 --0.171875 0.015625 -0.328125 -61.1442 -61.1442 -61.1442 --0.171875 0.046875 -0.359375 -43.1665 -43.1665 -43.1665 --0.171875 0.046875 -0.328125 1.0906 1.0906 1.0906 --0.140625 0.015625 -0.359375 0.41031 0.41031 0.41031 --0.140625 0.015625 -0.328125 14.4644 14.4644 14.4644 --0.140625 0.046875 -0.359375 -46.0327 -46.0327 -46.0327 --0.140625 0.046875 -0.328125 -60.2684 -60.2684 -60.2684 --0.171875 0.046875 -0.265625 82.3783 82.3783 82.3783 --0.140625 0.015625 -0.265625 15.3981 15.3981 15.3981 --0.140625 0.046875 -0.265625 -3.18424 -3.18424 -3.18424 --0.171875 0.078125 -0.359375 -45.6084 -45.6084 -45.6084 --0.171875 0.078125 -0.328125 -10.3683 -10.3683 -10.3683 --0.171875 0.109375 -0.328125 -11.4243 -11.4243 -11.4243 --0.140625 0.078125 -0.359375 -27.3486 -27.3486 -27.3486 --0.140625 0.078125 -0.328125 -2.35482 -2.35482 -2.35482 --0.140625 0.109375 -0.328125 -50.1001 -50.1001 -50.1001 --0.171875 0.109375 -0.296875 -5.67083 -5.67083 -5.67083 --0.140625 0.078125 -0.265625 -122.16 -122.16 -122.16 --0.140625 0.109375 -0.296875 23.8549 23.8549 23.8549 --0.140625 0.109375 -0.265625 -1.06398 -1.06398 -1.06398 --0.203125 0.140625 -0.328125 72.9023 72.9023 72.9023 --0.234375 0.140625 -0.296875 -882.029 -882.029 -882.029 --0.234375 0.140625 -0.265625 955.325 955.325 955.325 --0.203125 0.140625 -0.296875 -73.9916 -73.9916 -73.9916 --0.203125 0.140625 -0.265625 -55.8781 -55.8781 -55.8781 --0.203125 0.171875 -0.265625 -124.217 -124.217 -124.217 --0.234375 0.203125 -0.265625 -6.21781 -6.21781 -6.21781 --0.234375 0.234375 -0.265625 -1407.82 -1407.82 -1407.82 --0.203125 0.203125 -0.296875 542.526 542.526 542.526 --0.203125 0.203125 -0.265625 814.629 814.629 814.629 --0.203125 0.234375 -0.296875 7.44553 7.44553 7.44553 --0.203125 0.234375 -0.265625 -1832.19 -1832.19 -1832.19 --0.171875 0.140625 -0.328125 -12.0877 -12.0877 -12.0877 --0.171875 0.140625 -0.296875 -25.3758 -25.3758 -25.3758 --0.171875 0.140625 -0.265625 -45.5159 -45.5159 -45.5159 --0.171875 0.171875 -0.265625 -460.055 -460.055 -460.055 --0.140625 0.140625 -0.296875 40.0629 40.0629 40.0629 --0.140625 0.140625 -0.265625 -38.5638 -38.5638 -38.5638 --0.140625 0.171875 -0.265625 -736.202 -736.202 -736.202 --0.171875 0.203125 -0.296875 155.712 155.712 155.712 --0.171875 0.203125 -0.265625 158.761 158.761 158.761 --0.171875 0.234375 -0.296875 1325.99 1325.99 1325.99 --0.171875 0.234375 -0.265625 763.256 763.256 763.256 --0.140625 0.203125 -0.296875 -190.228 -190.228 -190.228 --0.140625 0.203125 -0.265625 -818.534 -818.534 -818.534 --0.140625 0.234375 -0.296875 -202.212 -202.212 -202.212 --0.140625 0.234375 -0.265625 -182.243 -182.243 -182.243 --0.109375 0.015625 -0.453125 11.6841 11.6841 11.6841 --0.109375 0.046875 -0.453125 -5.10829 -5.10829 -5.10829 --0.078125 0.015625 -0.453125 -1.79641 -1.79641 -1.79641 --0.078125 0.046875 -0.453125 -3.76284 -3.76284 -3.76284 --0.109375 0.015625 -0.421875 -4.25238 -4.25238 -4.25238 --0.109375 0.015625 -0.390625 5.95869 5.95869 5.95869 --0.109375 0.046875 -0.421875 -4.14612 -4.14612 -4.14612 --0.109375 0.046875 -0.390625 -10.5831 -10.5831 -10.5831 --0.078125 0.015625 -0.421875 17.0188 17.0188 17.0188 --0.078125 0.015625 -0.390625 10.0677 10.0677 10.0677 --0.078125 0.046875 -0.390625 -12.5108 -12.5108 -12.5108 --0.109375 0.078125 -0.453125 7.63937 7.63937 7.63937 --0.109375 0.109375 -0.453125 29.7714 29.7714 29.7714 --0.078125 0.078125 -0.453125 182.653 182.653 182.653 --0.078125 0.109375 -0.453125 115.131 115.131 115.131 --0.109375 0.078125 -0.421875 -8.09289 -8.09289 -8.09289 --0.109375 0.078125 -0.390625 -4.46276 -4.46276 -4.46276 --0.109375 0.109375 -0.421875 12.6687 12.6687 12.6687 --0.109375 0.109375 -0.390625 -5.70736 -5.70736 -5.70736 --0.078125 0.109375 -0.421875 -8.42897 -8.42897 -8.42897 --0.078125 0.109375 -0.390625 -17.8035 -17.8035 -17.8035 --0.046875 0.015625 -0.453125 3.2128 3.2128 3.2128 --0.046875 0.046875 -0.453125 13.1194 13.1194 13.1194 --0.015625 0.015625 -0.453125 93.1762 93.1762 93.1762 --0.015625 0.046875 -0.453125 -4.00999 -4.00999 -4.00999 --0.046875 0.015625 -0.421875 -0.844465 -0.844465 -0.844465 --0.046875 0.015625 -0.390625 7.06166 7.06166 7.06166 --0.046875 0.046875 -0.421875 -8.22815 -8.22815 -8.22815 --0.015625 0.015625 -0.421875 -71.9228 -71.9228 -71.9228 --0.015625 0.046875 -0.421875 -15.4196 -15.4196 -15.4196 --0.046875 0.078125 -0.453125 -2.77465 -2.77465 -2.77465 --0.046875 0.109375 -0.453125 2.1495 2.1495 2.1495 --0.015625 0.078125 -0.453125 25.1246 25.1246 25.1246 --0.015625 0.109375 -0.453125 213.266 213.266 213.266 --0.015625 0.078125 -0.421875 291.914 291.914 291.914 --0.109375 0.015625 -0.328125 -23.6378 -23.6378 -23.6378 --0.109375 0.046875 -0.359375 31.1539 31.1539 31.1539 --0.109375 0.046875 -0.328125 -73.0516 -73.0516 -73.0516 --0.078125 0.015625 -0.359375 19.3671 19.3671 19.3671 --0.078125 0.015625 -0.328125 -82.2483 -82.2483 -82.2483 --0.078125 0.046875 -0.359375 84.2155 84.2155 84.2155 --0.078125 0.046875 -0.328125 30.5703 30.5703 30.5703 --0.109375 0.015625 -0.296875 43.5843 43.5843 43.5843 --0.109375 0.015625 -0.265625 28.6384 28.6384 28.6384 --0.109375 0.046875 -0.296875 -163.143 -163.143 -163.143 --0.109375 0.046875 -0.265625 -64.2059 -64.2059 -64.2059 --0.078125 0.015625 -0.296875 -106.738 -106.738 -106.738 --0.078125 0.015625 -0.265625 23.8019 23.8019 23.8019 --0.078125 0.046875 -0.296875 23.8948 23.8948 23.8948 --0.078125 0.046875 -0.265625 -25.6604 -25.6604 -25.6604 --0.109375 0.078125 -0.359375 -57.2394 -57.2394 -57.2394 --0.109375 0.078125 -0.328125 69.1428 69.1428 69.1428 --0.109375 0.109375 -0.359375 -37.3184 -37.3184 -37.3184 --0.109375 0.109375 -0.328125 -58.7962 -58.7962 -58.7962 --0.078125 0.078125 -0.359375 23.1056 23.1056 23.1056 --0.078125 0.078125 -0.328125 220.838 220.838 220.838 --0.078125 0.109375 -0.359375 26.5 26.5 26.5 --0.078125 0.109375 -0.328125 69.505 69.505 69.505 --0.109375 0.078125 -0.296875 23.6938 23.6938 23.6938 --0.109375 0.078125 -0.265625 -86.0347 -86.0347 -86.0347 --0.109375 0.109375 -0.296875 19.5148 19.5148 19.5148 --0.109375 0.109375 -0.265625 4.65474 4.65474 4.65474 --0.078125 0.078125 -0.296875 122.812 122.812 122.812 --0.078125 0.078125 -0.265625 8.30292 8.30292 8.30292 --0.078125 0.109375 -0.296875 50.2673 50.2673 50.2673 --0.078125 0.109375 -0.265625 59.2532 59.2532 59.2532 --0.046875 0.046875 -0.359375 11.041 11.041 11.041 --0.046875 0.046875 -0.328125 59.8369 59.8369 59.8369 --0.015625 0.046875 -0.328125 4.97221 4.97221 4.97221 --0.046875 0.015625 -0.265625 -12.2789 -12.2789 -12.2789 --0.046875 0.046875 -0.265625 2.28942 2.28942 2.28942 --0.015625 0.015625 -0.265625 6.29784 6.29784 6.29784 --0.015625 0.046875 -0.265625 -2.86343 -2.86343 -2.86343 --0.046875 0.078125 -0.328125 95.8592 95.8592 95.8592 --0.046875 0.109375 -0.359375 -57.0464 -57.0464 -57.0464 --0.046875 0.109375 -0.328125 23.9705 23.9705 23.9705 --0.015625 0.078125 -0.359375 63.7711 63.7711 63.7711 --0.015625 0.078125 -0.328125 -9.33107 -9.33107 -9.33107 --0.015625 0.109375 -0.359375 7.14713 7.14713 7.14713 --0.015625 0.109375 -0.328125 -22.9354 -22.9354 -22.9354 --0.046875 0.078125 -0.296875 42.3152 42.3152 42.3152 --0.046875 0.078125 -0.265625 14.4152 14.4152 14.4152 --0.046875 0.109375 -0.296875 -38.7943 -38.7943 -38.7943 --0.015625 0.078125 -0.296875 0.544109 0.544109 0.544109 --0.015625 0.078125 -0.265625 18.2059 18.2059 18.2059 --0.015625 0.109375 -0.296875 -9.06945 -9.06945 -9.06945 --0.015625 0.109375 -0.265625 -1.03591 -1.03591 -1.03591 --0.078125 0.140625 -0.453125 -101.841 -101.841 -101.841 --0.078125 0.140625 -0.421875 9.13924 9.13924 9.13924 --0.078125 0.140625 -0.390625 -31.9833 -31.9833 -31.9833 --0.078125 0.171875 -0.421875 27.755 27.755 27.755 --0.078125 0.171875 -0.390625 -53.3776 -53.3776 -53.3776 --0.046875 0.140625 -0.453125 31.8339 31.8339 31.8339 --0.046875 0.171875 -0.453125 34.618 34.618 34.618 --0.015625 0.140625 -0.453125 42.0087 42.0087 42.0087 --0.015625 0.171875 -0.453125 -64.9927 -64.9927 -64.9927 --0.046875 0.140625 -0.421875 -80.688 -80.688 -80.688 --0.046875 0.140625 -0.390625 7.23328 7.23328 7.23328 --0.046875 0.171875 -0.421875 63.3283 63.3283 63.3283 --0.046875 0.171875 -0.390625 13.1314 13.1314 13.1314 --0.015625 0.171875 -0.421875 -51.9061 -51.9061 -51.9061 --0.046875 0.203125 -0.421875 -46.6099 -46.6099 -46.6099 --0.046875 0.203125 -0.390625 -207.943 -207.943 -207.943 --0.015625 0.203125 -0.421875 -87.8156 -87.8156 -87.8156 --0.015625 0.203125 -0.390625 171.305 171.305 171.305 --0.015625 0.234375 -0.390625 570.902 570.902 570.902 --0.078125 0.140625 -0.359375 53.1448 53.1448 53.1448 --0.109375 0.140625 -0.265625 23.5133 23.5133 23.5133 --0.078125 0.140625 -0.296875 15.7901 15.7901 15.7901 --0.078125 0.140625 -0.265625 37.0049 37.0049 37.0049 --0.078125 0.171875 -0.296875 626.674 626.674 626.674 --0.078125 0.171875 -0.265625 -183.929 -183.929 -183.929 --0.078125 0.203125 -0.296875 1846.17 1846.17 1846.17 --0.078125 0.203125 -0.265625 625.23 625.23 625.23 --0.046875 0.140625 -0.359375 -39.1423 -39.1423 -39.1423 --0.046875 0.140625 -0.328125 16.0303 16.0303 16.0303 --0.046875 0.171875 -0.359375 117.716 117.716 117.716 --0.046875 0.171875 -0.328125 365.132 365.132 365.132 --0.015625 0.140625 -0.359375 -61.3671 -61.3671 -61.3671 --0.015625 0.140625 -0.328125 -39.4901 -39.4901 -39.4901 --0.015625 0.171875 -0.359375 192.141 192.141 192.141 --0.015625 0.171875 -0.328125 13.8882 13.8882 13.8882 --0.046875 0.140625 -0.296875 -58.2999 -58.2999 -58.2999 --0.046875 0.171875 -0.296875 54.4415 54.4415 54.4415 --0.015625 0.140625 -0.296875 -3.62008 -3.62008 -3.62008 --0.046875 0.203125 -0.359375 -259.064 -259.064 -259.064 --0.046875 0.203125 -0.328125 413.51 413.51 413.51 --0.015625 0.203125 -0.359375 114.025 114.025 114.025 --0.015625 0.203125 -0.328125 -316.3 -316.3 -316.3 --0.015625 0.234375 -0.359375 -308.695 -308.695 -308.695 --0.015625 0.234375 -0.328125 -887.571 -887.571 -887.571 --0.046875 0.203125 -0.296875 391.746 391.746 391.746 --0.046875 0.203125 -0.265625 34.6824 34.6824 34.6824 --0.046875 0.234375 -0.265625 20441.3 20441.3 20441.3 --0.015625 0.203125 -0.296875 -202.087 -202.087 -202.087 --0.015625 0.234375 -0.296875 12307.1 12307.1 12307.1 --0.015625 0.234375 -0.265625 6199.9 6199.9 6199.9 --0.234375 0.015625 -0.203125 15.4955 15.4955 15.4955 --0.234375 0.046875 -0.203125 99.6557 99.6557 99.6557 --0.203125 0.015625 -0.234375 25.4511 25.4511 25.4511 --0.203125 0.015625 -0.203125 -253.14 -253.14 -253.14 --0.203125 0.046875 -0.234375 54.05 54.05 54.05 --0.203125 0.046875 -0.203125 -198.797 -198.797 -198.797 --0.234375 0.015625 -0.171875 -77.6135 -77.6135 -77.6135 --0.234375 0.015625 -0.140625 102.134 102.134 102.134 --0.234375 0.046875 -0.171875 29.3324 29.3324 29.3324 --0.234375 0.046875 -0.140625 -37.3821 -37.3821 -37.3821 --0.203125 0.015625 -0.171875 -27.9517 -27.9517 -27.9517 --0.203125 0.046875 -0.171875 -79.8787 -79.8787 -79.8787 --0.203125 0.046875 -0.140625 -35.1082 -35.1082 -35.1082 --0.234375 0.078125 -0.234375 -955.094 -955.094 -955.094 --0.234375 0.078125 -0.203125 -106.614 -106.614 -106.614 --0.234375 0.109375 -0.234375 -168.209 -168.209 -168.209 --0.234375 0.109375 -0.203125 -17.2523 -17.2523 -17.2523 --0.203125 0.078125 -0.234375 52.1762 52.1762 52.1762 --0.203125 0.078125 -0.203125 -106.259 -106.259 -106.259 --0.203125 0.109375 -0.234375 134.241 134.241 134.241 --0.203125 0.109375 -0.203125 -47.747 -47.747 -47.747 --0.234375 0.078125 -0.171875 137.478 137.478 137.478 --0.234375 0.109375 -0.171875 -5.44955 -5.44955 -5.44955 --0.203125 0.078125 -0.171875 24.3266 24.3266 24.3266 --0.203125 0.078125 -0.140625 69.1882 69.1882 69.1882 --0.203125 0.109375 -0.171875 -82.1943 -82.1943 -82.1943 --0.171875 0.015625 -0.234375 87.0478 87.0478 87.0478 --0.171875 0.015625 -0.203125 12.1004 12.1004 12.1004 --0.171875 0.046875 -0.234375 -88.0333 -88.0333 -88.0333 --0.171875 0.046875 -0.203125 38.7194 38.7194 38.7194 --0.140625 0.015625 -0.234375 3.82737 3.82737 3.82737 --0.140625 0.015625 -0.203125 -1.40986 -1.40986 -1.40986 --0.140625 0.046875 -0.234375 -18.5625 -18.5625 -18.5625 --0.140625 0.046875 -0.203125 23.6445 23.6445 23.6445 --0.171875 0.015625 -0.171875 -42.4203 -42.4203 -42.4203 --0.171875 0.046875 -0.171875 -42.0664 -42.0664 -42.0664 --0.171875 0.046875 -0.140625 -107.708 -107.708 -107.708 --0.140625 0.015625 -0.171875 3.60662 3.60662 3.60662 --0.140625 0.015625 -0.140625 -6.07883 -6.07883 -6.07883 --0.140625 0.046875 -0.171875 8.62134 8.62134 8.62134 --0.140625 0.046875 -0.140625 -20.5909 -20.5909 -20.5909 --0.171875 0.078125 -0.234375 -77.3994 -77.3994 -77.3994 --0.171875 0.078125 -0.203125 -265.021 -265.021 -265.021 --0.171875 0.109375 -0.234375 42.4344 42.4344 42.4344 --0.171875 0.109375 -0.203125 -167.788 -167.788 -167.788 --0.140625 0.078125 -0.234375 9.84758 9.84758 9.84758 --0.140625 0.109375 -0.234375 -13.3512 -13.3512 -13.3512 --0.171875 0.078125 -0.171875 101.685 101.685 101.685 --0.171875 0.078125 -0.140625 54.6663 54.6663 54.6663 --0.171875 0.109375 -0.140625 254.251 254.251 254.251 --0.140625 0.078125 -0.171875 -25.3679 -25.3679 -25.3679 --0.140625 0.078125 -0.140625 -49.3475 -49.3475 -49.3475 --0.140625 0.109375 -0.140625 -86.2432 -86.2432 -86.2432 --0.234375 0.015625 -0.109375 -32.783 -32.783 -32.783 --0.234375 0.046875 -0.109375 -15.8739 -15.8739 -15.8739 --0.234375 0.046875 -0.078125 -73.0717 -73.0717 -73.0717 --0.203125 0.015625 -0.109375 134.471 134.471 134.471 --0.203125 0.015625 -0.078125 120.334 120.334 120.334 --0.203125 0.046875 -0.109375 -19.3916 -19.3916 -19.3916 --0.203125 0.046875 -0.078125 -56.5749 -56.5749 -56.5749 --0.234375 0.015625 -0.046875 -81.9967 -81.9967 -81.9967 --0.234375 0.015625 -0.015625 11.974 11.974 11.974 --0.234375 0.046875 -0.046875 56.1057 56.1057 56.1057 --0.234375 0.046875 -0.015625 36.231 36.231 36.231 --0.203125 0.015625 -0.046875 92.6839 92.6839 92.6839 --0.203125 0.015625 -0.015625 15.5159 15.5159 15.5159 --0.203125 0.046875 -0.046875 -6.30367 -6.30367 -6.30367 --0.203125 0.046875 -0.015625 10.5851 10.5851 10.5851 --0.203125 0.078125 -0.109375 -22.8174 -22.8174 -22.8174 --0.234375 0.078125 -0.046875 7.05811 7.05811 7.05811 --0.234375 0.078125 -0.015625 137.702 137.702 137.702 --0.234375 0.109375 -0.046875 8.87397 8.87397 8.87397 --0.234375 0.109375 -0.015625 -34.7893 -34.7893 -34.7893 --0.203125 0.078125 -0.046875 2.27607 2.27607 2.27607 --0.203125 0.078125 -0.015625 76.2415 76.2415 76.2415 --0.203125 0.109375 -0.046875 -138.394 -138.394 -138.394 --0.203125 0.109375 -0.015625 43.6903 43.6903 43.6903 --0.171875 0.015625 -0.109375 84.2984 84.2984 84.2984 --0.171875 0.015625 -0.078125 -29.3336 -29.3336 -29.3336 --0.171875 0.046875 -0.109375 -77.4484 -77.4484 -77.4484 --0.171875 0.046875 -0.078125 -18.2998 -18.2998 -18.2998 --0.140625 0.015625 -0.109375 1.78907 1.78907 1.78907 --0.140625 0.015625 -0.078125 -5.59785 -5.59785 -5.59785 --0.140625 0.046875 -0.109375 21.6605 21.6605 21.6605 --0.171875 0.015625 -0.046875 105.315 105.315 105.315 --0.171875 0.015625 -0.015625 6.94977 6.94977 6.94977 --0.171875 0.046875 -0.046875 15.704 15.704 15.704 --0.171875 0.046875 -0.015625 -6.89269 -6.89269 -6.89269 --0.140625 0.015625 -0.046875 32.2549 32.2549 32.2549 --0.140625 0.015625 -0.015625 43.7736 43.7736 43.7736 --0.140625 0.046875 -0.046875 -66.441 -66.441 -66.441 --0.140625 0.046875 -0.015625 4.59723 4.59723 4.59723 --0.171875 0.078125 -0.109375 26.5297 26.5297 26.5297 --0.171875 0.109375 -0.109375 92.746 92.746 92.746 --0.140625 0.078125 -0.109375 6.71649 6.71649 6.71649 --0.140625 0.109375 -0.109375 2.40857 2.40857 2.40857 --0.140625 0.109375 -0.078125 13.5369 13.5369 13.5369 --0.171875 0.078125 -0.046875 -51.3737 -51.3737 -51.3737 --0.171875 0.078125 -0.015625 -72.1227 -72.1227 -72.1227 --0.171875 0.109375 -0.015625 5.32841 5.32841 5.32841 --0.140625 0.078125 -0.046875 -27.8935 -27.8935 -27.8935 --0.140625 0.078125 -0.015625 -70.3345 -70.3345 -70.3345 --0.140625 0.109375 -0.015625 -116.995 -116.995 -116.995 --0.234375 0.140625 -0.234375 1649.7 1649.7 1649.7 --0.234375 0.140625 -0.203125 52.8655 52.8655 52.8655 --0.234375 0.171875 -0.203125 -32.292 -32.292 -32.292 --0.203125 0.140625 -0.234375 61.4284 61.4284 61.4284 --0.203125 0.140625 -0.203125 38.5336 38.5336 38.5336 --0.203125 0.171875 -0.234375 -579.209 -579.209 -579.209 --0.203125 0.171875 -0.203125 100.478 100.478 100.478 --0.234375 0.140625 -0.171875 -3.87188 -3.87188 -3.87188 --0.234375 0.171875 -0.171875 62.2788 62.2788 62.2788 --0.234375 0.171875 -0.140625 7.62027 7.62027 7.62027 --0.203125 0.140625 -0.171875 33.842 33.842 33.842 --0.203125 0.171875 -0.171875 -152.453 -152.453 -152.453 --0.234375 0.203125 -0.234375 431.186 431.186 431.186 --0.234375 0.203125 -0.203125 433.31 433.31 433.31 --0.234375 0.234375 -0.234375 -875.633 -875.633 -875.633 --0.234375 0.234375 -0.203125 -198.144 -198.144 -198.144 --0.203125 0.203125 -0.234375 179.34 179.34 179.34 --0.203125 0.203125 -0.203125 258.591 258.591 258.591 --0.203125 0.234375 -0.234375 -1410.53 -1410.53 -1410.53 --0.234375 0.203125 -0.171875 68.9908 68.9908 68.9908 --0.234375 0.203125 -0.140625 -48.0328 -48.0328 -48.0328 --0.234375 0.234375 -0.171875 53.1091 53.1091 53.1091 --0.234375 0.234375 -0.140625 -44.0268 -44.0268 -44.0268 --0.203125 0.203125 -0.171875 -9.11626 -9.11626 -9.11626 --0.203125 0.203125 -0.140625 87.1131 87.1131 87.1131 --0.203125 0.234375 -0.171875 -74.3972 -74.3972 -74.3972 --0.203125 0.234375 -0.140625 -259.954 -259.954 -259.954 --0.171875 0.140625 -0.234375 -47.6703 -47.6703 -47.6703 --0.171875 0.140625 -0.203125 -207.338 -207.338 -207.338 --0.171875 0.171875 -0.234375 -135.943 -135.943 -135.943 --0.171875 0.171875 -0.203125 -180.702 -180.702 -180.702 --0.140625 0.140625 -0.234375 -27.5164 -27.5164 -27.5164 --0.140625 0.140625 -0.203125 32.7985 32.7985 32.7985 --0.140625 0.171875 -0.234375 -138.114 -138.114 -138.114 --0.140625 0.171875 -0.203125 17.6435 17.6435 17.6435 --0.171875 0.171875 -0.140625 138.506 138.506 138.506 --0.140625 0.140625 -0.140625 239.144 239.144 239.144 --0.140625 0.203125 -0.234375 -1298.01 -1298.01 -1298.01 --0.140625 0.203125 -0.203125 5.53632 5.53632 5.53632 --0.140625 0.234375 -0.234375 -198.378 -198.378 -198.378 --0.140625 0.234375 -0.203125 -210.173 -210.173 -210.173 --0.171875 0.203125 -0.140625 106.68 106.68 106.68 --0.140625 0.234375 -0.140625 185.349 185.349 185.349 --0.234375 0.140625 -0.109375 -78.8887 -78.8887 -78.8887 --0.234375 0.140625 -0.078125 -161.193 -161.193 -161.193 --0.234375 0.171875 -0.109375 5.88482 5.88482 5.88482 --0.234375 0.171875 -0.078125 15.3425 15.3425 15.3425 --0.203125 0.140625 -0.109375 43.9813 43.9813 43.9813 --0.203125 0.140625 -0.078125 -134.563 -134.563 -134.563 --0.203125 0.171875 -0.109375 -120.197 -120.197 -120.197 --0.203125 0.171875 -0.078125 -97.3075 -97.3075 -97.3075 --0.234375 0.140625 -0.046875 257.193 257.193 257.193 --0.234375 0.140625 -0.015625 60.4569 60.4569 60.4569 --0.234375 0.171875 -0.046875 -104.395 -104.395 -104.395 --0.234375 0.171875 -0.015625 -88.2915 -88.2915 -88.2915 --0.203125 0.140625 -0.046875 127.206 127.206 127.206 --0.203125 0.140625 -0.015625 74.7723 74.7723 74.7723 --0.203125 0.171875 -0.046875 -104.669 -104.669 -104.669 --0.203125 0.171875 -0.015625 9.91109 9.91109 9.91109 --0.234375 0.203125 -0.109375 97.8917 97.8917 97.8917 --0.234375 0.234375 -0.109375 -28.454 -28.454 -28.454 --0.203125 0.203125 -0.109375 -37.0198 -37.0198 -37.0198 --0.203125 0.234375 -0.109375 -50.6931 -50.6931 -50.6931 --0.234375 0.203125 -0.046875 -76.0596 -76.0596 -76.0596 --0.203125 0.203125 -0.046875 -810.568 -810.568 -810.568 --0.203125 0.203125 -0.015625 144.199 144.199 144.199 --0.171875 0.140625 -0.109375 52.2834 52.2834 52.2834 --0.171875 0.140625 -0.078125 87.3592 87.3592 87.3592 --0.171875 0.171875 -0.109375 61.1378 61.1378 61.1378 --0.171875 0.171875 -0.078125 26.3808 26.3808 26.3808 --0.140625 0.140625 -0.109375 -17.5177 -17.5177 -17.5177 --0.140625 0.140625 -0.078125 -54.9164 -54.9164 -54.9164 --0.140625 0.171875 -0.109375 -43.36 -43.36 -43.36 --0.140625 0.171875 -0.078125 15.5454 15.5454 15.5454 --0.171875 0.140625 -0.015625 78.2055 78.2055 78.2055 --0.171875 0.171875 -0.046875 -328.079 -328.079 -328.079 --0.171875 0.171875 -0.015625 -112.041 -112.041 -112.041 --0.140625 0.140625 -0.015625 -70.6379 -70.6379 -70.6379 --0.140625 0.171875 -0.046875 -40.4384 -40.4384 -40.4384 --0.140625 0.171875 -0.015625 15.2349 15.2349 15.2349 --0.171875 0.203125 -0.109375 -12.7445 -12.7445 -12.7445 --0.171875 0.203125 -0.078125 165.328 165.328 165.328 --0.171875 0.234375 -0.109375 -109.77 -109.77 -109.77 --0.171875 0.234375 -0.078125 -422.243 -422.243 -422.243 --0.140625 0.203125 -0.109375 29.4414 29.4414 29.4414 --0.140625 0.203125 -0.078125 -221.324 -221.324 -221.324 --0.140625 0.234375 -0.109375 -104.944 -104.944 -104.944 --0.140625 0.234375 -0.078125 1290.63 1290.63 1290.63 --0.171875 0.203125 -0.046875 -442.916 -442.916 -442.916 --0.171875 0.203125 -0.015625 -128.978 -128.978 -128.978 --0.140625 0.203125 -0.046875 169.668 169.668 169.668 --0.140625 0.203125 -0.015625 -323.034 -323.034 -323.034 --0.140625 0.234375 -0.046875 267.132 267.132 267.132 --0.140625 0.234375 -0.015625 -225.937 -225.937 -225.937 --0.109375 0.015625 -0.203125 -1.65175 -1.65175 -1.65175 --0.078125 0.015625 -0.234375 -23.0729 -23.0729 -23.0729 --0.078125 0.046875 -0.234375 -38.2492 -38.2492 -38.2492 --0.109375 0.015625 -0.171875 -33.1736 -33.1736 -33.1736 --0.109375 0.015625 -0.140625 -23.989 -23.989 -23.989 --0.109375 0.046875 -0.171875 -68.2859 -68.2859 -68.2859 --0.109375 0.046875 -0.140625 -5.03289 -5.03289 -5.03289 --0.078125 0.015625 -0.140625 -34.2732 -34.2732 -34.2732 --0.109375 0.078125 -0.234375 6.58366 6.58366 6.58366 --0.109375 0.078125 -0.203125 10.9302 10.9302 10.9302 --0.109375 0.109375 -0.234375 3.27547 3.27547 3.27547 --0.109375 0.109375 -0.203125 -90.4175 -90.4175 -90.4175 --0.078125 0.078125 -0.234375 8.04896 8.04896 8.04896 --0.078125 0.078125 -0.203125 -17.25 -17.25 -17.25 --0.078125 0.109375 -0.234375 51.7672 51.7672 51.7672 --0.078125 0.109375 -0.203125 19.3251 19.3251 19.3251 --0.109375 0.078125 -0.171875 25.746 25.746 25.746 --0.109375 0.078125 -0.140625 123.695 123.695 123.695 --0.109375 0.109375 -0.171875 -17.5879 -17.5879 -17.5879 --0.109375 0.109375 -0.140625 8.18128 8.18128 8.18128 --0.078125 0.078125 -0.171875 -1.68444 -1.68444 -1.68444 --0.078125 0.109375 -0.171875 -27.2384 -27.2384 -27.2384 --0.078125 0.109375 -0.140625 -22.6037 -22.6037 -22.6037 --0.046875 0.015625 -0.234375 -165.305 -165.305 -165.305 --0.046875 0.046875 -0.234375 -33.1047 -33.1047 -33.1047 --0.046875 0.046875 -0.203125 -37.0249 -37.0249 -37.0249 --0.015625 0.015625 -0.234375 2.85129 2.85129 2.85129 --0.015625 0.015625 -0.203125 -0.110821 -0.110821 -0.110821 --0.015625 0.046875 -0.234375 10.998 10.998 10.998 --0.015625 0.046875 -0.203125 -6.91786 -6.91786 -6.91786 --0.046875 0.015625 -0.140625 -153.535 -153.535 -153.535 --0.046875 0.046875 -0.140625 44.8801 44.8801 44.8801 --0.015625 0.015625 -0.171875 -0.908338 -0.908338 -0.908338 --0.015625 0.015625 -0.140625 -128.588 -128.588 -128.588 --0.015625 0.046875 -0.171875 -6.86517 -6.86517 -6.86517 --0.015625 0.046875 -0.140625 -81.4487 -81.4487 -81.4487 --0.046875 0.078125 -0.234375 33.5539 33.5539 33.5539 --0.046875 0.078125 -0.203125 29.4917 29.4917 29.4917 --0.046875 0.109375 -0.203125 22.3126 22.3126 22.3126 --0.015625 0.078125 -0.234375 34.3184 34.3184 34.3184 --0.015625 0.078125 -0.203125 39.9781 39.9781 39.9781 --0.015625 0.109375 -0.234375 21.9324 21.9324 21.9324 --0.015625 0.109375 -0.203125 76.7917 76.7917 76.7917 --0.046875 0.078125 -0.171875 -4.14958 -4.14958 -4.14958 --0.046875 0.078125 -0.140625 58.0801 58.0801 58.0801 --0.046875 0.109375 -0.171875 -136.767 -136.767 -136.767 --0.046875 0.109375 -0.140625 126.979 126.979 126.979 --0.015625 0.078125 -0.171875 16.122 16.122 16.122 --0.015625 0.078125 -0.140625 12.1653 12.1653 12.1653 --0.015625 0.109375 -0.140625 144.181 144.181 144.181 --0.109375 0.015625 -0.109375 -5.34812 -5.34812 -5.34812 --0.109375 0.015625 -0.078125 -14.1834 -14.1834 -14.1834 --0.109375 0.046875 -0.109375 18.5835 18.5835 18.5835 --0.078125 0.015625 -0.109375 55.374 55.374 55.374 --0.078125 0.015625 -0.078125 180.556 180.556 180.556 --0.078125 0.046875 -0.109375 47.5843 47.5843 47.5843 --0.078125 0.046875 -0.078125 -307.367 -307.367 -307.367 --0.109375 0.015625 -0.046875 7.48214 7.48214 7.48214 --0.109375 0.015625 -0.015625 9.02975 9.02975 9.02975 --0.109375 0.046875 -0.046875 -12.7033 -12.7033 -12.7033 --0.109375 0.046875 -0.015625 -21.1782 -21.1782 -21.1782 --0.078125 0.015625 -0.046875 -7.90514 -7.90514 -7.90514 --0.078125 0.015625 -0.015625 -16.517 -16.517 -16.517 --0.078125 0.046875 -0.046875 -4.18048 -4.18048 -4.18048 --0.078125 0.046875 -0.015625 -7.27221 -7.27221 -7.27221 --0.109375 0.078125 -0.109375 33.8123 33.8123 33.8123 --0.109375 0.109375 -0.109375 -33.1394 -33.1394 -33.1394 --0.109375 0.109375 -0.078125 -47.3474 -47.3474 -47.3474 --0.078125 0.078125 -0.109375 22.2999 22.2999 22.2999 --0.078125 0.078125 -0.078125 69.3111 69.3111 69.3111 --0.078125 0.109375 -0.109375 -53.6559 -53.6559 -53.6559 --0.078125 0.109375 -0.078125 1.24895 1.24895 1.24895 --0.109375 0.078125 -0.015625 -22.2877 -22.2877 -22.2877 --0.109375 0.109375 -0.015625 -59.2239 -59.2239 -59.2239 --0.078125 0.078125 -0.046875 15.6872 15.6872 15.6872 --0.078125 0.078125 -0.015625 19.1672 19.1672 19.1672 --0.078125 0.109375 -0.046875 12.9875 12.9875 12.9875 --0.078125 0.109375 -0.015625 -10.065 -10.065 -10.065 --0.046875 0.015625 -0.109375 158.041 158.041 158.041 --0.046875 0.015625 -0.078125 13.7521 13.7521 13.7521 --0.046875 0.046875 -0.109375 65.6435 65.6435 65.6435 --0.046875 0.046875 -0.078125 -109.016 -109.016 -109.016 --0.015625 0.015625 -0.109375 -25.7296 -25.7296 -25.7296 --0.015625 0.015625 -0.078125 118.344 118.344 118.344 --0.015625 0.046875 -0.109375 22.8838 22.8838 22.8838 --0.015625 0.046875 -0.078125 -54.9238 -54.9238 -54.9238 --0.046875 0.015625 -0.046875 -17.1604 -17.1604 -17.1604 --0.046875 0.015625 -0.015625 -13.8094 -13.8094 -13.8094 --0.046875 0.046875 -0.046875 1.81031 1.81031 1.81031 --0.046875 0.046875 -0.015625 -7.30683 -7.30683 -7.30683 --0.015625 0.015625 -0.046875 -13.9019 -13.9019 -13.9019 --0.015625 0.046875 -0.046875 -8.05813 -8.05813 -8.05813 --0.015625 0.046875 -0.015625 -44.9351 -44.9351 -44.9351 --0.046875 0.078125 -0.109375 59.7878 59.7878 59.7878 --0.046875 0.078125 -0.078125 67.5341 67.5341 67.5341 --0.046875 0.109375 -0.109375 25.0386 25.0386 25.0386 --0.046875 0.109375 -0.078125 8.61244 8.61244 8.61244 --0.015625 0.078125 -0.109375 -10.4805 -10.4805 -10.4805 --0.015625 0.078125 -0.078125 21.7073 21.7073 21.7073 --0.015625 0.109375 -0.078125 14.3622 14.3622 14.3622 --0.046875 0.078125 -0.046875 5.9348 5.9348 5.9348 --0.046875 0.078125 -0.015625 20.3774 20.3774 20.3774 --0.046875 0.109375 -0.046875 0.658145 0.658145 0.658145 --0.046875 0.109375 -0.015625 -28.9828 -28.9828 -28.9828 --0.015625 0.078125 -0.046875 7.01312 7.01312 7.01312 --0.015625 0.109375 -0.046875 -25.8362 -25.8362 -25.8362 --0.109375 0.140625 -0.234375 82.3149 82.3149 82.3149 --0.109375 0.140625 -0.203125 -79.0064 -79.0064 -79.0064 --0.109375 0.171875 -0.234375 -27.1527 -27.1527 -27.1527 --0.109375 0.171875 -0.203125 170.726 170.726 170.726 --0.078125 0.140625 -0.234375 59.2672 59.2672 59.2672 --0.078125 0.140625 -0.203125 16.6595 16.6595 16.6595 --0.078125 0.171875 -0.234375 350.68 350.68 350.68 --0.078125 0.171875 -0.203125 59.2923 59.2923 59.2923 --0.109375 0.140625 -0.171875 -65.6179 -65.6179 -65.6179 --0.109375 0.140625 -0.140625 -57.6556 -57.6556 -57.6556 --0.109375 0.171875 -0.171875 117.994 117.994 117.994 --0.078125 0.140625 -0.171875 19.1657 19.1657 19.1657 --0.078125 0.140625 -0.140625 -14.6073 -14.6073 -14.6073 --0.078125 0.171875 -0.171875 5.95226 5.95226 5.95226 --0.109375 0.203125 -0.234375 346.516 346.516 346.516 --0.109375 0.203125 -0.203125 5.94383 5.94383 5.94383 --0.109375 0.234375 -0.203125 -61.5878 -61.5878 -61.5878 --0.078125 0.203125 -0.234375 215.928 215.928 215.928 --0.078125 0.203125 -0.203125 53.0811 53.0811 53.0811 --0.078125 0.234375 -0.203125 -6.92729 -6.92729 -6.92729 --0.109375 0.203125 -0.171875 -25.9238 -25.9238 -25.9238 --0.109375 0.234375 -0.171875 -44.9779 -44.9779 -44.9779 --0.109375 0.234375 -0.140625 -49.7191 -49.7191 -49.7191 --0.078125 0.234375 -0.171875 -133.913 -133.913 -133.913 --0.046875 0.140625 -0.203125 89.3645 89.3645 89.3645 --0.046875 0.171875 -0.234375 -84.4347 -84.4347 -84.4347 --0.046875 0.171875 -0.203125 37.1441 37.1441 37.1441 --0.015625 0.140625 -0.234375 146.599 146.599 146.599 --0.015625 0.140625 -0.203125 145.517 145.517 145.517 --0.015625 0.171875 -0.203125 218.131 218.131 218.131 --0.046875 0.140625 -0.140625 -48.2173 -48.2173 -48.2173 --0.046875 0.171875 -0.171875 60.3656 60.3656 60.3656 --0.046875 0.171875 -0.140625 5.83795 5.83795 5.83795 --0.015625 0.140625 -0.140625 -100.96 -100.96 -100.96 --0.015625 0.171875 -0.171875 187.966 187.966 187.966 --0.015625 0.171875 -0.140625 38.114 38.114 38.114 --0.046875 0.203125 -0.234375 -7.10532 -7.10532 -7.10532 --0.046875 0.203125 -0.203125 25.0644 25.0644 25.0644 --0.046875 0.234375 -0.234375 13946 13946 13946 --0.046875 0.234375 -0.203125 -30.4952 -30.4952 -30.4952 --0.015625 0.203125 -0.203125 -492.703 -492.703 -492.703 --0.015625 0.234375 -0.234375 5074.66 5074.66 5074.66 --0.015625 0.234375 -0.203125 257.118 257.118 257.118 --0.046875 0.203125 -0.171875 -4.05657 -4.05657 -4.05657 --0.046875 0.234375 -0.171875 -10.9679 -10.9679 -10.9679 --0.046875 0.234375 -0.140625 -114.524 -114.524 -114.524 --0.015625 0.203125 -0.171875 -610.98 -610.98 -610.98 --0.015625 0.234375 -0.171875 -34.6008 -34.6008 -34.6008 --0.015625 0.234375 -0.140625 180.207 180.207 180.207 --0.109375 0.140625 -0.109375 57.8972 57.8972 57.8972 --0.109375 0.140625 -0.078125 -16.7087 -16.7087 -16.7087 --0.109375 0.171875 -0.078125 -28.4064 -28.4064 -28.4064 --0.078125 0.140625 -0.109375 -35.2116 -35.2116 -35.2116 --0.078125 0.140625 -0.078125 -29.5478 -29.5478 -29.5478 --0.078125 0.171875 -0.109375 -2.24576 -2.24576 -2.24576 --0.078125 0.171875 -0.078125 -78.525 -78.525 -78.525 --0.109375 0.140625 -0.046875 -23.9582 -23.9582 -23.9582 --0.109375 0.140625 -0.015625 22.1401 22.1401 22.1401 --0.109375 0.171875 -0.046875 80.8323 80.8323 80.8323 --0.109375 0.171875 -0.015625 -350.039 -350.039 -350.039 --0.078125 0.140625 -0.046875 -62.1174 -62.1174 -62.1174 --0.078125 0.140625 -0.015625 0.995727 0.995727 0.995727 --0.078125 0.171875 -0.046875 -47.1223 -47.1223 -47.1223 --0.078125 0.171875 -0.015625 637.67 637.67 637.67 --0.109375 0.203125 -0.109375 -99.4949 -99.4949 -99.4949 --0.109375 0.203125 -0.078125 46.22 46.22 46.22 --0.109375 0.234375 -0.109375 47.4562 47.4562 47.4562 --0.109375 0.234375 -0.078125 81.8248 81.8248 81.8248 --0.078125 0.203125 -0.109375 -56.9129 -56.9129 -56.9129 --0.078125 0.203125 -0.078125 -155.929 -155.929 -155.929 --0.078125 0.234375 -0.109375 361.393 361.393 361.393 --0.078125 0.234375 -0.078125 136.298 136.298 136.298 --0.109375 0.203125 -0.046875 -87.9784 -87.9784 -87.9784 --0.109375 0.234375 -0.046875 -333.041 -333.041 -333.041 --0.109375 0.234375 -0.015625 325.73 325.73 325.73 --0.078125 0.203125 -0.046875 -111.326 -111.326 -111.326 --0.078125 0.203125 -0.015625 310.066 310.066 310.066 --0.078125 0.234375 -0.046875 -29.2695 -29.2695 -29.2695 --0.078125 0.234375 -0.015625 65.6377 65.6377 65.6377 --0.046875 0.140625 -0.109375 195.724 195.724 195.724 --0.046875 0.140625 -0.078125 35.281 35.281 35.281 --0.015625 0.140625 -0.109375 -0.295742 -0.295742 -0.295742 --0.015625 0.140625 -0.078125 36.7344 36.7344 36.7344 --0.015625 0.171875 -0.078125 37.0196 37.0196 37.0196 --0.046875 0.140625 -0.046875 17.089 17.089 17.089 --0.046875 0.140625 -0.015625 -44.7442 -44.7442 -44.7442 --0.046875 0.171875 -0.046875 -167.836 -167.836 -167.836 --0.046875 0.171875 -0.015625 -25.3272 -25.3272 -25.3272 --0.015625 0.140625 -0.046875 -37.0253 -37.0253 -37.0253 --0.015625 0.140625 -0.015625 -19.4056 -19.4056 -19.4056 --0.015625 0.171875 -0.046875 98.292 98.292 98.292 --0.015625 0.171875 -0.015625 -36.6688 -36.6688 -36.6688 --0.046875 0.234375 -0.109375 174.776 174.776 174.776 --0.046875 0.234375 -0.078125 56.7096 56.7096 56.7096 --0.015625 0.203125 -0.078125 -79.9039 -79.9039 -79.9039 --0.015625 0.234375 -0.109375 -6.38655 -6.38655 -6.38655 --0.015625 0.234375 -0.078125 -64.0751 -64.0751 -64.0751 --0.046875 0.203125 -0.046875 440.941 440.941 440.941 --0.046875 0.203125 -0.015625 229.983 229.983 229.983 --0.046875 0.234375 -0.046875 -348.95 -348.95 -348.95 --0.046875 0.234375 -0.015625 -406.902 -406.902 -406.902 --0.015625 0.203125 -0.046875 12.0664 12.0664 12.0664 --0.015625 0.203125 -0.015625 -79.1448 -79.1448 -79.1448 --0.015625 0.234375 -0.046875 230.786 230.786 230.786 --0.015625 0.234375 -0.015625 -12.9475 -12.9475 -12.9475 --0.234375 0.265625 -0.265625 290.309 290.309 290.309 --0.203125 0.265625 -0.265625 190.627 190.627 190.627 --0.203125 0.296875 -0.265625 -3524.7 -3524.7 -3524.7 --0.203125 0.328125 -0.265625 -1447.01 -1447.01 -1447.01 --0.171875 0.265625 -0.296875 -350.062 -350.062 -350.062 --0.171875 0.265625 -0.265625 2.15153 2.15153 2.15153 --0.171875 0.296875 -0.296875 -5468.67 -5468.67 -5468.67 --0.171875 0.296875 -0.265625 -12404.2 -12404.2 -12404.2 --0.140625 0.265625 -0.296875 -529.21 -529.21 -529.21 --0.140625 0.265625 -0.265625 -114.664 -114.664 -114.664 --0.140625 0.296875 -0.296875 4103.27 4103.27 4103.27 --0.171875 0.328125 -0.296875 3994.5 3994.5 3994.5 --0.171875 0.328125 -0.265625 -6559.08 -6559.08 -6559.08 --0.171875 0.359375 -0.265625 11826.7 11826.7 11826.7 --0.140625 0.328125 -0.296875 6035.73 6035.73 6035.73 --0.140625 0.328125 -0.265625 -1668.35 -1668.35 -1668.35 --0.140625 0.359375 -0.296875 873.243 873.243 873.243 --0.140625 0.359375 -0.265625 10320.8 10320.8 10320.8 --0.171875 0.390625 -0.265625 364.13 364.13 364.13 --0.140625 0.390625 -0.296875 121.546 121.546 121.546 --0.140625 0.390625 -0.265625 846.64 846.64 846.64 --0.109375 0.265625 -0.296875 -786.174 -786.174 -786.174 --0.109375 0.265625 -0.265625 4238.51 4238.51 4238.51 --0.109375 0.296875 -0.296875 -854.496 -854.496 -854.496 --0.109375 0.296875 -0.265625 34241.3 34241.3 34241.3 --0.078125 0.265625 -0.296875 -148.909 -148.909 -148.909 --0.078125 0.265625 -0.265625 -2496.2 -2496.2 -2496.2 --0.078125 0.296875 -0.296875 -8850.43 -8850.43 -8850.43 --0.078125 0.296875 -0.265625 4225.09 4225.09 4225.09 --0.109375 0.328125 -0.296875 -43.221 -43.221 -43.221 --0.109375 0.359375 -0.296875 201.899 201.899 201.899 --0.078125 0.328125 -0.296875 700.757 700.757 700.757 --0.078125 0.328125 -0.265625 28142.8 28142.8 28142.8 --0.078125 0.359375 -0.296875 636.364 636.364 636.364 --0.078125 0.359375 -0.265625 1972.44 1972.44 1972.44 --0.046875 0.265625 -0.296875 -9681.84 -9681.84 -9681.84 --0.046875 0.265625 -0.265625 -16.6342 -16.6342 -16.6342 --0.046875 0.296875 -0.296875 2046.93 2046.93 2046.93 --0.015625 0.265625 -0.296875 -15957.6 -15957.6 -15957.6 --0.015625 0.265625 -0.265625 -5833.48 -5833.48 -5833.48 --0.015625 0.296875 -0.296875 -12011.4 -12011.4 -12011.4 --0.015625 0.296875 -0.265625 -5122.79 -5122.79 -5122.79 --0.046875 0.328125 -0.296875 -383.379 -383.379 -383.379 --0.046875 0.328125 -0.265625 -14874.4 -14874.4 -14874.4 --0.046875 0.359375 -0.265625 -195.969 -195.969 -195.969 --0.015625 0.328125 -0.296875 -328.632 -328.632 -328.632 --0.015625 0.328125 -0.265625 799.708 799.708 799.708 --0.015625 0.359375 -0.265625 -1010.94 -1010.94 -1010.94 --0.109375 0.390625 -0.296875 65.2034 65.2034 65.2034 --0.109375 0.390625 -0.265625 359.139 359.139 359.139 --0.078125 0.390625 -0.296875 723.473 723.473 723.473 --0.078125 0.390625 -0.265625 405.345 405.345 405.345 --0.046875 0.390625 -0.265625 314.61 314.61 314.61 --0.234375 0.265625 -0.234375 608.269 608.269 608.269 --0.234375 0.265625 -0.203125 64.5645 64.5645 64.5645 --0.234375 0.296875 -0.234375 76.5821 76.5821 76.5821 --0.234375 0.296875 -0.203125 -321.731 -321.731 -321.731 --0.203125 0.265625 -0.234375 583.026 583.026 583.026 --0.203125 0.296875 -0.234375 -1075.1 -1075.1 -1075.1 --0.234375 0.265625 -0.140625 -270.201 -270.201 -270.201 --0.234375 0.296875 -0.140625 -1353.52 -1353.52 -1353.52 --0.203125 0.265625 -0.140625 217.63 217.63 217.63 --0.234375 0.328125 -0.234375 -636.362 -636.362 -636.362 --0.234375 0.328125 -0.203125 169.379 169.379 169.379 --0.203125 0.328125 -0.234375 -3629.63 -3629.63 -3629.63 --0.203125 0.328125 -0.203125 -479.753 -479.753 -479.753 --0.203125 0.359375 -0.234375 1733.05 1733.05 1733.05 --0.203125 0.359375 -0.203125 34.9313 34.9313 34.9313 --0.234375 0.328125 -0.171875 901.541 901.541 901.541 --0.234375 0.328125 -0.140625 5018.88 5018.88 5018.88 --0.203125 0.328125 -0.171875 30.5774 30.5774 30.5774 --0.203125 0.328125 -0.140625 2002.47 2002.47 2002.47 --0.203125 0.359375 -0.171875 -204.863 -204.863 -204.863 --0.171875 0.265625 -0.234375 -206.048 -206.048 -206.048 --0.140625 0.265625 -0.234375 117.023 117.023 117.023 --0.140625 0.265625 -0.203125 -242.022 -242.022 -242.022 --0.140625 0.296875 -0.203125 157.619 157.619 157.619 --0.171875 0.265625 -0.171875 89.8825 89.8825 89.8825 --0.171875 0.265625 -0.140625 26.7043 26.7043 26.7043 --0.171875 0.296875 -0.171875 -35.8575 -35.8575 -35.8575 --0.171875 0.296875 -0.140625 1939.11 1939.11 1939.11 --0.140625 0.265625 -0.171875 -103.811 -103.811 -103.811 --0.140625 0.265625 -0.140625 -20.9667 -20.9667 -20.9667 --0.140625 0.296875 -0.171875 -105.629 -105.629 -105.629 --0.140625 0.296875 -0.140625 -335.332 -335.332 -335.332 --0.171875 0.328125 -0.234375 -10888.8 -10888.8 -10888.8 --0.171875 0.359375 -0.234375 1550.64 1550.64 1550.64 --0.171875 0.359375 -0.203125 56.9015 56.9015 56.9015 --0.140625 0.328125 -0.203125 -58.3821 -58.3821 -58.3821 --0.140625 0.359375 -0.234375 6279.51 6279.51 6279.51 --0.140625 0.359375 -0.203125 67.1133 67.1133 67.1133 --0.171875 0.328125 -0.171875 -217.488 -217.488 -217.488 --0.171875 0.328125 -0.140625 4203.15 4203.15 4203.15 --0.171875 0.359375 -0.171875 8.14545 8.14545 8.14545 --0.140625 0.328125 -0.171875 -17.4879 -17.4879 -17.4879 --0.140625 0.328125 -0.140625 1148.23 1148.23 1148.23 --0.140625 0.359375 -0.171875 -14.1165 -14.1165 -14.1165 --0.140625 0.359375 -0.140625 53959.9 53959.9 53959.9 --0.234375 0.265625 -0.109375 -412.267 -412.267 -412.267 --0.234375 0.265625 -0.078125 457.061 457.061 457.061 --0.234375 0.296875 -0.109375 -6541.24 -6541.24 -6541.24 --0.234375 0.296875 -0.078125 -11246.8 -11246.8 -11246.8 --0.203125 0.265625 -0.109375 118.813 118.813 118.813 --0.203125 0.265625 -0.078125 -598.395 -598.395 -598.395 --0.203125 0.296875 -0.109375 -505.145 -505.145 -505.145 --0.203125 0.296875 -0.078125 -6859.53 -6859.53 -6859.53 --0.234375 0.265625 -0.046875 -2477.43 -2477.43 -2477.43 --0.234375 0.265625 -0.015625 -1863.01 -1863.01 -1863.01 --0.234375 0.296875 -0.046875 -3225.3 -3225.3 -3225.3 --0.234375 0.296875 -0.015625 -1916.47 -1916.47 -1916.47 --0.203125 0.296875 -0.046875 -60.3305 -60.3305 -60.3305 --0.203125 0.296875 -0.015625 1071.33 1071.33 1071.33 --0.234375 0.328125 -0.109375 7341.53 7341.53 7341.53 --0.203125 0.328125 -0.109375 4977.57 4977.57 4977.57 --0.203125 0.328125 -0.078125 7981.22 7981.22 7981.22 --0.203125 0.359375 -0.109375 2852.7 2852.7 2852.7 --0.203125 0.359375 -0.078125 511.715 511.715 511.715 --0.203125 0.328125 -0.046875 -2535.96 -2535.96 -2535.96 --0.203125 0.328125 -0.015625 -2927.49 -2927.49 -2927.49 --0.203125 0.359375 -0.046875 616.667 616.667 616.667 --0.203125 0.359375 -0.015625 -1643.85 -1643.85 -1643.85 --0.171875 0.296875 -0.109375 -2191.5 -2191.5 -2191.5 --0.140625 0.296875 -0.109375 -948.78 -948.78 -948.78 --0.140625 0.265625 -0.046875 -356.366 -356.366 -356.366 --0.140625 0.265625 -0.015625 316.892 316.892 316.892 --0.140625 0.296875 -0.015625 9864.48 9864.48 9864.48 --0.171875 0.328125 -0.109375 4656.53 4656.53 4656.53 --0.171875 0.328125 -0.078125 -4305.82 -4305.82 -4305.82 --0.171875 0.359375 -0.109375 -394167 -394167 -394167 --0.140625 0.328125 -0.109375 36.5272 36.5272 36.5272 --0.140625 0.359375 -0.109375 108788 108788 108788 --0.171875 0.328125 -0.015625 -5018.89 -5018.89 -5018.89 --0.171875 0.359375 -0.015625 -5275.22 -5275.22 -5275.22 --0.140625 0.328125 -0.015625 1670.88 1670.88 1670.88 --0.140625 0.359375 -0.015625 -9885.15 -9885.15 -9885.15 --0.171875 0.390625 -0.234375 -78.1066 -78.1066 -78.1066 --0.140625 0.390625 -0.234375 -248.44 -248.44 -248.44 --0.140625 0.390625 -0.203125 26.6176 26.6176 26.6176 --0.203125 0.390625 -0.109375 -2716.37 -2716.37 -2716.37 --0.203125 0.390625 -0.078125 -3399.13 -3399.13 -3399.13 --0.203125 0.421875 -0.078125 -2631.21 -2631.21 -2631.21 --0.203125 0.390625 -0.046875 13120.2 13120.2 13120.2 --0.203125 0.390625 -0.015625 5523.41 5523.41 5523.41 --0.203125 0.421875 -0.046875 -1468.23 -1468.23 -1468.23 --0.171875 0.390625 -0.109375 -85554.2 -85554.2 -85554.2 --0.171875 0.390625 -0.078125 -374158 -374158 -374158 --0.171875 0.421875 -0.078125 -166864 -166864 -166864 --0.140625 0.390625 -0.109375 280552 280552 280552 --0.140625 0.390625 -0.078125 82612.2 82612.2 82612.2 --0.140625 0.421875 -0.078125 429891 429891 429891 --0.171875 0.390625 -0.015625 7658.64 7658.64 7658.64 --0.171875 0.421875 -0.046875 235.475 235.475 235.475 --0.171875 0.421875 -0.015625 -5098.04 -5098.04 -5098.04 --0.140625 0.390625 -0.046875 -1382.6 -1382.6 -1382.6 --0.140625 0.390625 -0.015625 -10136 -10136 -10136 --0.140625 0.421875 -0.046875 564.28 564.28 564.28 --0.140625 0.421875 -0.015625 -355.773 -355.773 -355.773 --0.109375 0.265625 -0.234375 1608.68 1608.68 1608.68 --0.109375 0.265625 -0.203125 -7119.53 -7119.53 -7119.53 --0.109375 0.296875 -0.234375 -3397.78 -3397.78 -3397.78 --0.109375 0.296875 -0.203125 -14316.5 -14316.5 -14316.5 --0.078125 0.265625 -0.234375 -4842.36 -4842.36 -4842.36 --0.078125 0.265625 -0.203125 9868.26 9868.26 9868.26 --0.078125 0.296875 -0.234375 5026.45 5026.45 5026.45 --0.078125 0.296875 -0.203125 -9324.97 -9324.97 -9324.97 --0.109375 0.265625 -0.171875 -95.5516 -95.5516 -95.5516 --0.109375 0.265625 -0.140625 65.8204 65.8204 65.8204 --0.109375 0.296875 -0.171875 -305.976 -305.976 -305.976 --0.109375 0.296875 -0.140625 235.011 235.011 235.011 --0.078125 0.265625 -0.171875 79.3923 79.3923 79.3923 --0.078125 0.265625 -0.140625 57.6697 57.6697 57.6697 --0.078125 0.296875 -0.171875 8.67644 8.67644 8.67644 --0.109375 0.328125 -0.203125 8132.54 8132.54 8132.54 --0.109375 0.359375 -0.203125 45.0007 45.0007 45.0007 --0.109375 0.328125 -0.171875 233.232 233.232 233.232 --0.109375 0.328125 -0.140625 531.097 531.097 531.097 --0.109375 0.359375 -0.171875 -76.3933 -76.3933 -76.3933 --0.109375 0.359375 -0.140625 -10236.4 -10236.4 -10236.4 --0.078125 0.328125 -0.171875 78.7827 78.7827 78.7827 --0.078125 0.328125 -0.140625 -393.511 -393.511 -393.511 --0.078125 0.359375 -0.171875 -171.641 -171.641 -171.641 --0.078125 0.359375 -0.140625 735.337 735.337 735.337 --0.046875 0.265625 -0.234375 -10772.2 -10772.2 -10772.2 --0.046875 0.265625 -0.203125 -22151.4 -22151.4 -22151.4 --0.046875 0.296875 -0.203125 -3826.83 -3826.83 -3826.83 --0.015625 0.265625 -0.234375 -6362.95 -6362.95 -6362.95 --0.015625 0.265625 -0.203125 416.674 416.674 416.674 --0.015625 0.296875 -0.203125 125.097 125.097 125.097 --0.046875 0.265625 -0.171875 -69.0089 -69.0089 -69.0089 --0.046875 0.265625 -0.140625 6.63885 6.63885 6.63885 --0.046875 0.296875 -0.171875 85.9051 85.9051 85.9051 --0.046875 0.296875 -0.140625 -11580.1 -11580.1 -11580.1 --0.015625 0.296875 -0.171875 126.795 126.795 126.795 --0.015625 0.296875 -0.140625 -2466.95 -2466.95 -2466.95 --0.046875 0.359375 -0.234375 -283.425 -283.425 -283.425 --0.015625 0.328125 -0.234375 320.114 320.114 320.114 --0.015625 0.359375 -0.234375 -385.081 -385.081 -385.081 --0.015625 0.359375 -0.203125 141.054 141.054 141.054 --0.046875 0.328125 -0.171875 163.676 163.676 163.676 --0.046875 0.328125 -0.140625 1949.5 1949.5 1949.5 --0.046875 0.359375 -0.171875 -44.5179 -44.5179 -44.5179 --0.046875 0.359375 -0.140625 7860.59 7860.59 7860.59 --0.015625 0.328125 -0.140625 1158.77 1158.77 1158.77 --0.015625 0.359375 -0.140625 6259.46 6259.46 6259.46 --0.109375 0.265625 -0.109375 210.805 210.805 210.805 --0.109375 0.265625 -0.078125 -168.302 -168.302 -168.302 --0.109375 0.296875 -0.109375 521.93 521.93 521.93 --0.109375 0.296875 -0.078125 -8363.8 -8363.8 -8363.8 --0.078125 0.265625 -0.109375 107.678 107.678 107.678 --0.078125 0.265625 -0.078125 -243.315 -243.315 -243.315 --0.078125 0.296875 -0.109375 109.777 109.777 109.777 --0.109375 0.265625 -0.046875 -749.984 -749.984 -749.984 --0.109375 0.265625 -0.015625 -140.405 -140.405 -140.405 --0.109375 0.296875 -0.046875 8462.57 8462.57 8462.57 --0.109375 0.296875 -0.015625 517.367 517.367 517.367 --0.078125 0.265625 -0.046875 -130.607 -130.607 -130.607 --0.078125 0.265625 -0.015625 -328.622 -328.622 -328.622 --0.078125 0.296875 -0.046875 -409.669 -409.669 -409.669 --0.078125 0.296875 -0.015625 -725.521 -725.521 -725.521 --0.109375 0.328125 -0.109375 1457.3 1457.3 1457.3 --0.109375 0.359375 -0.109375 694398 694398 694398 --0.078125 0.328125 -0.109375 587.355 587.355 587.355 --0.078125 0.359375 -0.109375 199.735 199.735 199.735 --0.078125 0.359375 -0.078125 294.936 294.936 294.936 --0.109375 0.328125 -0.015625 5873.99 5873.99 5873.99 --0.109375 0.359375 -0.015625 5609.43 5609.43 5609.43 --0.078125 0.328125 -0.015625 1572.92 1572.92 1572.92 --0.078125 0.359375 -0.015625 -187.241 -187.241 -187.241 --0.046875 0.265625 -0.109375 -65.7658 -65.7658 -65.7658 --0.046875 0.265625 -0.078125 -1.58806 -1.58806 -1.58806 --0.046875 0.296875 -0.109375 -2687.39 -2687.39 -2687.39 --0.015625 0.265625 -0.109375 138.794 138.794 138.794 --0.015625 0.265625 -0.078125 168.779 168.779 168.779 --0.015625 0.296875 -0.109375 -11935.2 -11935.2 -11935.2 --0.046875 0.265625 -0.046875 -56.7621 -56.7621 -56.7621 --0.046875 0.265625 -0.015625 1071.09 1071.09 1071.09 --0.046875 0.296875 -0.015625 657.017 657.017 657.017 --0.015625 0.265625 -0.046875 356.534 356.534 356.534 --0.015625 0.265625 -0.015625 330.098 330.098 330.098 --0.015625 0.296875 -0.015625 1274.51 1274.51 1274.51 --0.046875 0.328125 -0.109375 -2586.74 -2586.74 -2586.74 --0.046875 0.359375 -0.109375 2502.64 2502.64 2502.64 --0.046875 0.359375 -0.078125 3434.39 3434.39 3434.39 --0.015625 0.328125 -0.109375 -4786.19 -4786.19 -4786.19 --0.015625 0.328125 -0.078125 -13406.2 -13406.2 -13406.2 --0.015625 0.359375 -0.109375 9431.62 9431.62 9431.62 --0.015625 0.359375 -0.078125 2753.32 2753.32 2753.32 --0.046875 0.328125 -0.015625 892.542 892.542 892.542 --0.046875 0.359375 -0.046875 -91.5718 -91.5718 -91.5718 --0.046875 0.359375 -0.015625 -993.333 -993.333 -993.333 --0.015625 0.328125 -0.015625 815.149 815.149 815.149 --0.015625 0.359375 -0.046875 -1108.8 -1108.8 -1108.8 --0.015625 0.359375 -0.015625 -799.564 -799.564 -799.564 --0.109375 0.390625 -0.234375 -1356.35 -1356.35 -1356.35 --0.109375 0.390625 -0.203125 382.405 382.405 382.405 --0.109375 0.421875 -0.203125 34.2536 34.2536 34.2536 --0.078125 0.390625 -0.234375 -1261.56 -1261.56 -1261.56 --0.078125 0.390625 -0.203125 218.267 218.267 218.267 --0.078125 0.421875 -0.203125 438.449 438.449 438.449 --0.109375 0.390625 -0.171875 32.7868 32.7868 32.7868 --0.109375 0.390625 -0.140625 -589246 -589246 -589246 --0.109375 0.421875 -0.171875 -314.478 -314.478 -314.478 --0.078125 0.390625 -0.171875 -53.471 -53.471 -53.471 --0.078125 0.390625 -0.140625 812.618 812.618 812.618 --0.078125 0.421875 -0.171875 -86.7256 -86.7256 -86.7256 --0.046875 0.390625 -0.234375 353.642 353.642 353.642 --0.046875 0.390625 -0.203125 456.211 456.211 456.211 --0.015625 0.390625 -0.234375 153.854 153.854 153.854 --0.015625 0.390625 -0.203125 39.0916 39.0916 39.0916 --0.046875 0.390625 -0.171875 6.04401 6.04401 6.04401 --0.046875 0.390625 -0.140625 483.086 483.086 483.086 --0.015625 0.390625 -0.171875 -90.8686 -90.8686 -90.8686 --0.015625 0.390625 -0.140625 -15.9859 -15.9859 -15.9859 --0.109375 0.390625 -0.109375 -46498.4 -46498.4 -46498.4 --0.109375 0.390625 -0.078125 24161.6 24161.6 24161.6 --0.078125 0.390625 -0.078125 -1978.69 -1978.69 -1978.69 --0.109375 0.390625 -0.046875 1376.9 1376.9 1376.9 --0.109375 0.390625 -0.015625 3633.05 3633.05 3633.05 --0.109375 0.421875 -0.046875 -327.269 -327.269 -327.269 --0.109375 0.421875 -0.015625 1463.72 1463.72 1463.72 --0.078125 0.390625 -0.046875 -709.42 -709.42 -709.42 --0.078125 0.390625 -0.015625 -917.037 -917.037 -917.037 --0.046875 0.390625 -0.109375 293.069 293.069 293.069 --0.046875 0.390625 -0.078125 -647.305 -647.305 -647.305 --0.015625 0.390625 -0.109375 -48.2363 -48.2363 -48.2363 --0.046875 0.390625 -0.046875 845.68 845.68 845.68 --0.046875 0.390625 -0.015625 -168.547 -168.547 -168.547 --0.421875 0.015625 0.015625 -46.8593 -46.8593 -46.8593 --0.421875 0.015625 0.046875 -1226.73 -1226.73 -1226.73 --0.390625 0.015625 0.015625 -29.1749 -29.1749 -29.1749 --0.390625 0.015625 0.046875 -387.844 -387.844 -387.844 --0.421875 0.015625 0.078125 694.285 694.285 694.285 --0.390625 0.015625 0.078125 -101.165 -101.165 -101.165 --0.390625 0.015625 0.109375 111.485 111.485 111.485 --0.359375 0.015625 0.015625 -56.7245 -56.7245 -56.7245 --0.359375 0.015625 0.046875 -928.985 -928.985 -928.985 --0.328125 0.015625 0.015625 -20.4891 -20.4891 -20.4891 --0.328125 0.015625 0.046875 -24.6365 -24.6365 -24.6365 --0.359375 0.015625 0.078125 -583.177 -583.177 -583.177 --0.359375 0.015625 0.109375 981.792 981.792 981.792 --0.328125 0.015625 0.078125 -107.42 -107.42 -107.42 --0.328125 0.015625 0.109375 395.776 395.776 395.776 --0.328125 0.046875 0.078125 65.2066 65.2066 65.2066 --0.328125 0.046875 0.109375 823.983 823.983 823.983 --0.328125 0.078125 0.015625 -57.0959 -57.0959 -57.0959 --0.328125 0.078125 0.046875 -62.8063 -62.8063 -62.8063 --0.328125 0.109375 0.015625 -44.9557 -44.9557 -44.9557 --0.328125 0.109375 0.046875 111.714 111.714 111.714 --0.328125 0.078125 0.078125 31.7773 31.7773 31.7773 --0.328125 0.078125 0.109375 34.2633 34.2633 34.2633 --0.328125 0.109375 0.078125 337.91 337.91 337.91 --0.296875 0.015625 0.046875 -98.0374 -98.0374 -98.0374 --0.296875 0.046875 0.046875 -75.2917 -75.2917 -75.2917 --0.265625 0.015625 0.015625 -31.5016 -31.5016 -31.5016 --0.265625 0.015625 0.046875 29.828 29.828 29.828 --0.265625 0.046875 0.015625 -13.5769 -13.5769 -13.5769 --0.265625 0.046875 0.046875 -11.0462 -11.0462 -11.0462 --0.296875 0.015625 0.078125 -43.1684 -43.1684 -43.1684 --0.296875 0.046875 0.078125 88.8601 88.8601 88.8601 --0.265625 0.015625 0.078125 37.194 37.194 37.194 --0.265625 0.046875 0.078125 68.5456 68.5456 68.5456 --0.296875 0.078125 0.015625 -23.8803 -23.8803 -23.8803 --0.296875 0.078125 0.046875 -19.3806 -19.3806 -19.3806 --0.296875 0.109375 0.046875 -8.7992 -8.7992 -8.7992 --0.265625 0.078125 0.015625 -55.1187 -55.1187 -55.1187 --0.265625 0.078125 0.046875 -56.0755 -56.0755 -56.0755 --0.296875 0.078125 0.078125 48.775 48.775 48.775 --0.296875 0.078125 0.109375 9.87786 9.87786 9.87786 --0.296875 0.109375 0.078125 18.9131 18.9131 18.9131 --0.296875 0.109375 0.109375 -5.57851 -5.57851 -5.57851 --0.265625 0.078125 0.078125 -6.20516 -6.20516 -6.20516 --0.265625 0.078125 0.109375 -13.5791 -13.5791 -13.5791 --0.265625 0.109375 0.078125 27.8472 27.8472 27.8472 --0.265625 0.109375 0.109375 -1.94994 -1.94994 -1.94994 --0.359375 0.015625 0.140625 3339.01 3339.01 3339.01 --0.359375 0.015625 0.171875 62.5935 62.5935 62.5935 --0.359375 0.046875 0.140625 305.307 305.307 305.307 --0.359375 0.046875 0.171875 1583.45 1583.45 1583.45 --0.328125 0.015625 0.140625 711.99 711.99 711.99 --0.328125 0.015625 0.171875 -2695.21 -2695.21 -2695.21 --0.328125 0.046875 0.140625 -672.66 -672.66 -672.66 --0.359375 0.015625 0.203125 -1609.07 -1609.07 -1609.07 --0.359375 0.046875 0.203125 -1110.51 -1110.51 -1110.51 --0.328125 0.015625 0.203125 1066.42 1066.42 1066.42 --0.328125 0.015625 0.234375 0.892883 0.892883 0.892883 --0.328125 0.046875 0.203125 1317.64 1317.64 1317.64 --0.328125 0.046875 0.234375 -30.4638 -30.4638 -30.4638 --0.359375 0.078125 0.140625 -261.012 -261.012 -261.012 --0.359375 0.078125 0.171875 156.436 156.436 156.436 --0.359375 0.109375 0.140625 -240.292 -240.292 -240.292 --0.359375 0.109375 0.171875 -157.877 -157.877 -157.877 --0.328125 0.078125 0.140625 -295.192 -295.192 -295.192 --0.328125 0.109375 0.140625 -318.663 -318.663 -318.663 --0.328125 0.109375 0.171875 -163.752 -163.752 -163.752 --0.359375 0.078125 0.203125 -835.458 -835.458 -835.458 --0.359375 0.109375 0.203125 74.1968 74.1968 74.1968 --0.328125 0.078125 0.203125 1392.09 1392.09 1392.09 --0.328125 0.078125 0.234375 -133.77 -133.77 -133.77 --0.328125 0.109375 0.203125 56.0605 56.0605 56.0605 --0.328125 0.109375 0.234375 26.3143 26.3143 26.3143 --0.296875 0.015625 0.140625 -290.916 -290.916 -290.916 --0.296875 0.015625 0.171875 -457.478 -457.478 -457.478 --0.265625 0.015625 0.140625 -39.7121 -39.7121 -39.7121 --0.296875 0.015625 0.203125 275.253 275.253 275.253 --0.296875 0.015625 0.234375 -227.182 -227.182 -227.182 --0.296875 0.046875 0.203125 -310.571 -310.571 -310.571 --0.296875 0.046875 0.234375 -12.9739 -12.9739 -12.9739 --0.265625 0.015625 0.203125 22.7843 22.7843 22.7843 --0.265625 0.015625 0.234375 -240.433 -240.433 -240.433 --0.265625 0.046875 0.203125 14.6917 14.6917 14.6917 --0.296875 0.078125 0.140625 -187.973 -187.973 -187.973 --0.296875 0.109375 0.140625 -168.515 -168.515 -168.515 --0.296875 0.109375 0.171875 14.873 14.873 14.873 --0.265625 0.109375 0.140625 -47.247 -47.247 -47.247 --0.265625 0.109375 0.171875 -69.839 -69.839 -69.839 --0.296875 0.078125 0.203125 83.5001 83.5001 83.5001 --0.296875 0.078125 0.234375 -102.969 -102.969 -102.969 --0.296875 0.109375 0.203125 -40.3013 -40.3013 -40.3013 --0.296875 0.109375 0.234375 -34.6137 -34.6137 -34.6137 --0.265625 0.078125 0.203125 -39.8716 -39.8716 -39.8716 --0.265625 0.078125 0.234375 32.6967 32.6967 32.6967 --0.265625 0.109375 0.203125 3.05119 3.05119 3.05119 --0.265625 0.109375 0.234375 85.3418 85.3418 85.3418 --0.359375 0.140625 0.015625 -151.867 -151.867 -151.867 --0.359375 0.140625 0.046875 -137.713 -137.713 -137.713 --0.359375 0.171875 0.015625 243.532 243.532 243.532 --0.359375 0.171875 0.046875 -13.0036 -13.0036 -13.0036 --0.328125 0.140625 0.015625 -271.511 -271.511 -271.511 --0.328125 0.140625 0.046875 -9.09509 -9.09509 -9.09509 --0.328125 0.171875 0.015625 -344.205 -344.205 -344.205 --0.328125 0.171875 0.046875 280.038 280.038 280.038 --0.328125 0.140625 0.078125 374.236 374.236 374.236 --0.359375 0.203125 0.015625 -17.6389 -17.6389 -17.6389 --0.328125 0.203125 0.015625 -24.9526 -24.9526 -24.9526 --0.328125 0.203125 0.046875 7.32594 7.32594 7.32594 --0.328125 0.234375 0.015625 262.532 262.532 262.532 --0.328125 0.234375 0.046875 848.704 848.704 848.704 --0.296875 0.140625 0.046875 -39.1493 -39.1493 -39.1493 --0.296875 0.171875 0.046875 -28.6138 -28.6138 -28.6138 --0.265625 0.171875 0.046875 -191.147 -191.147 -191.147 --0.296875 0.140625 0.078125 62.0148 62.0148 62.0148 --0.296875 0.171875 0.078125 2.82706 2.82706 2.82706 --0.265625 0.140625 0.078125 4.39647 4.39647 4.39647 --0.265625 0.171875 0.078125 -9.09882 -9.09882 -9.09882 --0.296875 0.203125 0.046875 -19.9101 -19.9101 -19.9101 --0.296875 0.234375 0.015625 -902.662 -902.662 -902.662 --0.296875 0.234375 0.046875 147.964 147.964 147.964 --0.265625 0.203125 0.046875 -29.2747 -29.2747 -29.2747 --0.265625 0.234375 0.015625 1058.03 1058.03 1058.03 --0.265625 0.234375 0.046875 -709.615 -709.615 -709.615 --0.265625 0.203125 0.078125 -11.3707 -11.3707 -11.3707 --0.265625 0.203125 0.109375 24.5862 24.5862 24.5862 --0.265625 0.234375 0.078125 -385.451 -385.451 -385.451 --0.265625 0.234375 0.109375 82.4432 82.4432 82.4432 --0.265625 0.140625 0.171875 5.45768 5.45768 5.45768 --0.265625 0.171875 0.171875 -52.1827 -52.1827 -52.1827 --0.265625 0.140625 0.203125 -34.3884 -34.3884 -34.3884 --0.265625 0.140625 0.234375 -350.568 -350.568 -350.568 --0.265625 0.171875 0.203125 -78.5862 -78.5862 -78.5862 --0.265625 0.171875 0.234375 181.256 181.256 181.256 --0.265625 0.203125 0.140625 16.3544 16.3544 16.3544 --0.265625 0.203125 0.171875 -22.5673 -22.5673 -22.5673 --0.265625 0.234375 0.140625 239.728 239.728 239.728 --0.265625 0.234375 0.171875 -192.37 -192.37 -192.37 --0.265625 0.203125 0.203125 -347.974 -347.974 -347.974 --0.265625 0.203125 0.234375 208.388 208.388 208.388 --0.296875 0.015625 0.265625 -185.899 -185.899 -185.899 --0.296875 0.046875 0.265625 77.575 77.575 77.575 --0.296875 0.046875 0.296875 -106.938 -106.938 -106.938 --0.265625 0.015625 0.265625 104.445 104.445 104.445 --0.265625 0.015625 0.296875 137.544 137.544 137.544 --0.265625 0.046875 0.296875 13.8337 13.8337 13.8337 --0.296875 0.078125 0.265625 -134.574 -134.574 -134.574 --0.265625 0.078125 0.265625 174.455 174.455 174.455 --0.265625 0.078125 0.296875 -29.7655 -29.7655 -29.7655 --0.265625 0.109375 0.265625 143.127 143.127 143.127 --0.265625 0.140625 0.265625 -1167.73 -1167.73 -1167.73 --0.265625 0.171875 0.265625 -558.398 -558.398 -558.398 --0.296875 0.265625 0.015625 -844.662 -844.662 -844.662 --0.265625 0.265625 0.015625 -1679.85 -1679.85 -1679.85 --0.265625 0.265625 0.046875 -340.567 -340.567 -340.567 --0.265625 0.265625 0.109375 -44.3064 -44.3064 -44.3064 --0.265625 0.265625 0.140625 264.231 264.231 264.231 --0.265625 0.265625 0.171875 95.4811 95.4811 95.4811 --0.234375 0.015625 0.015625 17.5921 17.5921 17.5921 --0.234375 0.015625 0.046875 94.9273 94.9273 94.9273 --0.234375 0.046875 0.015625 -1.89443 -1.89443 -1.89443 --0.234375 0.046875 0.046875 9.47312 9.47312 9.47312 --0.203125 0.015625 0.046875 10.301 10.301 10.301 --0.203125 0.046875 0.015625 13.4783 13.4783 13.4783 --0.203125 0.046875 0.046875 13.1806 13.1806 13.1806 --0.234375 0.015625 0.078125 30.7204 30.7204 30.7204 --0.234375 0.015625 0.109375 -42.4824 -42.4824 -42.4824 --0.234375 0.046875 0.078125 11.7217 11.7217 11.7217 --0.234375 0.046875 0.109375 -31.7197 -31.7197 -31.7197 --0.203125 0.015625 0.078125 32.2669 32.2669 32.2669 --0.203125 0.015625 0.109375 -1.84348 -1.84348 -1.84348 --0.203125 0.046875 0.078125 37.3389 37.3389 37.3389 --0.203125 0.046875 0.109375 26.2096 26.2096 26.2096 --0.234375 0.078125 0.015625 92.213 92.213 92.213 --0.234375 0.078125 0.046875 2.57034 2.57034 2.57034 --0.234375 0.109375 0.015625 25.0033 25.0033 25.0033 --0.203125 0.078125 0.015625 60.8968 60.8968 60.8968 --0.203125 0.078125 0.046875 -11.8048 -11.8048 -11.8048 --0.203125 0.109375 0.015625 150.096 150.096 150.096 --0.203125 0.109375 0.046875 12.5458 12.5458 12.5458 --0.234375 0.078125 0.078125 -39.6907 -39.6907 -39.6907 --0.234375 0.078125 0.109375 1.18958 1.18958 1.18958 --0.234375 0.109375 0.078125 12.75 12.75 12.75 --0.234375 0.109375 0.109375 -10.9585 -10.9585 -10.9585 --0.203125 0.078125 0.078125 -9.1836 -9.1836 -9.1836 --0.203125 0.078125 0.109375 -36.6413 -36.6413 -36.6413 --0.203125 0.109375 0.078125 20.9095 20.9095 20.9095 --0.203125 0.109375 0.109375 -18.6194 -18.6194 -18.6194 --0.171875 0.015625 0.078125 17.9491 17.9491 17.9491 --0.171875 0.015625 0.109375 -1.65607 -1.65607 -1.65607 --0.171875 0.046875 0.109375 -0.483016 -0.483016 -0.483016 --0.140625 0.015625 0.109375 2.82432 2.82432 2.82432 --0.140625 0.046875 0.109375 3.14118 3.14118 3.14118 --0.171875 0.078125 0.015625 -17.4341 -17.4341 -17.4341 --0.171875 0.078125 0.046875 -1.69166 -1.69166 -1.69166 --0.171875 0.109375 0.015625 58.8388 58.8388 58.8388 --0.171875 0.109375 0.046875 -3.63163 -3.63163 -3.63163 --0.140625 0.078125 0.015625 -1.22913 -1.22913 -1.22913 --0.140625 0.078125 0.046875 -3.31651 -3.31651 -3.31651 --0.140625 0.109375 0.015625 9.61716 9.61716 9.61716 --0.140625 0.109375 0.046875 -4.96093 -4.96093 -4.96093 --0.171875 0.078125 0.078125 -0.83043 -0.83043 -0.83043 --0.171875 0.109375 0.078125 -3.27242 -3.27242 -3.27242 --0.234375 0.015625 0.140625 -32.139 -32.139 -32.139 --0.234375 0.046875 0.140625 10.0424 10.0424 10.0424 --0.203125 0.015625 0.140625 4.10412 4.10412 4.10412 --0.203125 0.015625 0.171875 -4.48881 -4.48881 -4.48881 --0.203125 0.046875 0.140625 34.6603 34.6603 34.6603 --0.203125 0.046875 0.171875 3.71558 3.71558 3.71558 --0.234375 0.015625 0.203125 13.2383 13.2383 13.2383 --0.234375 0.015625 0.234375 -11.0284 -11.0284 -11.0284 --0.203125 0.015625 0.203125 -4.27001 -4.27001 -4.27001 --0.203125 0.015625 0.234375 -18.8099 -18.8099 -18.8099 --0.203125 0.046875 0.203125 32.4722 32.4722 32.4722 --0.203125 0.046875 0.234375 1.46231 1.46231 1.46231 --0.234375 0.078125 0.140625 -5.6367 -5.6367 -5.6367 --0.234375 0.078125 0.171875 -16.1673 -16.1673 -16.1673 --0.234375 0.109375 0.140625 52.0469 52.0469 52.0469 --0.234375 0.109375 0.171875 24.6854 24.6854 24.6854 --0.203125 0.078125 0.140625 7.97154 7.97154 7.97154 --0.203125 0.078125 0.171875 -21.8973 -21.8973 -21.8973 --0.203125 0.109375 0.140625 -19.5399 -19.5399 -19.5399 --0.203125 0.109375 0.171875 4.71738 4.71738 4.71738 --0.234375 0.109375 0.203125 32.4594 32.4594 32.4594 --0.234375 0.109375 0.234375 -227.931 -227.931 -227.931 --0.203125 0.109375 0.203125 20.7847 20.7847 20.7847 --0.171875 0.015625 0.140625 -2.3458 -2.3458 -2.3458 --0.171875 0.015625 0.171875 -8.79541 -8.79541 -8.79541 --0.171875 0.046875 0.140625 -17.0489 -17.0489 -17.0489 --0.171875 0.046875 0.171875 -10.2974 -10.2974 -10.2974 --0.140625 0.015625 0.140625 1.82278 1.82278 1.82278 --0.140625 0.015625 0.171875 3.54014 3.54014 3.54014 --0.140625 0.046875 0.140625 40.3975 40.3975 40.3975 --0.140625 0.046875 0.171875 10.0253 10.0253 10.0253 --0.171875 0.015625 0.203125 2.07714 2.07714 2.07714 --0.171875 0.015625 0.234375 -40.0555 -40.0555 -40.0555 --0.171875 0.046875 0.203125 7.2481 7.2481 7.2481 --0.171875 0.046875 0.234375 6.86017 6.86017 6.86017 --0.140625 0.015625 0.203125 -3.3551 -3.3551 -3.3551 --0.140625 0.046875 0.203125 -4.06282 -4.06282 -4.06282 --0.171875 0.078125 0.171875 -31.5931 -31.5931 -31.5931 --0.171875 0.109375 0.171875 -15.5679 -15.5679 -15.5679 --0.140625 0.078125 0.140625 -1.66044 -1.66044 -1.66044 --0.140625 0.078125 0.171875 -0.709484 -0.709484 -0.709484 --0.140625 0.109375 0.171875 -21.7001 -21.7001 -21.7001 --0.171875 0.078125 0.203125 -14.8171 -14.8171 -14.8171 --0.171875 0.078125 0.234375 -14.002 -14.002 -14.002 --0.171875 0.109375 0.203125 17.0908 17.0908 17.0908 --0.140625 0.078125 0.203125 -4.43478 -4.43478 -4.43478 --0.140625 0.078125 0.234375 0.0178327 0.0178327 0.0178327 --0.140625 0.109375 0.203125 14.6609 14.6609 14.6609 --0.203125 0.140625 0.015625 64.8009 64.8009 64.8009 --0.203125 0.140625 0.046875 -1.27495 -1.27495 -1.27495 --0.234375 0.140625 0.078125 5.49422 5.49422 5.49422 --0.234375 0.171875 0.078125 -2.09322 -2.09322 -2.09322 --0.234375 0.171875 0.109375 11.8759 11.8759 11.8759 --0.203125 0.140625 0.078125 7.26752 7.26752 7.26752 --0.203125 0.140625 0.109375 -20.0087 -20.0087 -20.0087 --0.203125 0.171875 0.078125 53.5041 53.5041 53.5041 --0.203125 0.171875 0.109375 -2.60219 -2.60219 -2.60219 --0.234375 0.234375 0.046875 -7.93752 -7.93752 -7.93752 --0.203125 0.203125 0.046875 -20.9847 -20.9847 -20.9847 --0.203125 0.234375 0.046875 37.4478 37.4478 37.4478 --0.234375 0.203125 0.078125 4.32113 4.32113 4.32113 --0.234375 0.203125 0.109375 44.853 44.853 44.853 --0.234375 0.234375 0.078125 16.1639 16.1639 16.1639 --0.234375 0.234375 0.109375 27.3155 27.3155 27.3155 --0.203125 0.203125 0.078125 34.4475 34.4475 34.4475 --0.203125 0.203125 0.109375 -7.00126 -7.00126 -7.00126 --0.203125 0.234375 0.078125 4.47962 4.47962 4.47962 --0.203125 0.234375 0.109375 -23.3656 -23.3656 -23.3656 --0.171875 0.140625 0.015625 -28.8753 -28.8753 -28.8753 --0.171875 0.140625 0.046875 -19.2901 -19.2901 -19.2901 --0.171875 0.171875 0.015625 52.931 52.931 52.931 --0.171875 0.171875 0.046875 -16.7261 -16.7261 -16.7261 --0.140625 0.140625 0.015625 -56.3913 -56.3913 -56.3913 --0.140625 0.140625 0.046875 -7.06791 -7.06791 -7.06791 --0.140625 0.171875 0.015625 -91.0084 -91.0084 -91.0084 --0.140625 0.171875 0.046875 -46.266 -46.266 -46.266 --0.171875 0.140625 0.078125 1.74683 1.74683 1.74683 --0.171875 0.140625 0.109375 0.158557 0.158557 0.158557 --0.171875 0.171875 0.078125 -3.0001 -3.0001 -3.0001 --0.140625 0.140625 0.078125 -6.08607 -6.08607 -6.08607 --0.140625 0.171875 0.078125 -37.0471 -37.0471 -37.0471 --0.171875 0.203125 0.015625 -89.385 -89.385 -89.385 --0.171875 0.203125 0.046875 5.60153 5.60153 5.60153 --0.171875 0.234375 0.015625 384.247 384.247 384.247 --0.171875 0.234375 0.046875 123.496 123.496 123.496 --0.140625 0.203125 0.015625 -205.167 -205.167 -205.167 --0.140625 0.203125 0.046875 -135.908 -135.908 -135.908 --0.140625 0.234375 0.015625 176.888 176.888 176.888 --0.140625 0.234375 0.046875 148.093 148.093 148.093 --0.171875 0.203125 0.078125 -30.5378 -30.5378 -30.5378 --0.171875 0.234375 0.078125 -51.9538 -51.9538 -51.9538 --0.140625 0.203125 0.078125 -133.789 -133.789 -133.789 --0.140625 0.234375 0.078125 -30.2521 -30.2521 -30.2521 --0.234375 0.140625 0.171875 59.8971 59.8971 59.8971 --0.234375 0.171875 0.140625 -21.9983 -21.9983 -21.9983 --0.234375 0.171875 0.171875 -2.4004 -2.4004 -2.4004 --0.203125 0.140625 0.140625 -18.4435 -18.4435 -18.4435 --0.203125 0.140625 0.171875 -34.5424 -34.5424 -34.5424 --0.203125 0.171875 0.140625 -7.06037 -7.06037 -7.06037 --0.203125 0.171875 0.171875 -17.5359 -17.5359 -17.5359 --0.234375 0.140625 0.203125 -1.88834 -1.88834 -1.88834 --0.203125 0.140625 0.203125 -5.06169 -5.06169 -5.06169 --0.234375 0.203125 0.140625 12.6908 12.6908 12.6908 --0.234375 0.203125 0.171875 -150.499 -150.499 -150.499 --0.234375 0.234375 0.171875 95.0487 95.0487 95.0487 --0.234375 0.203125 0.203125 67.6115 67.6115 67.6115 --0.234375 0.203125 0.234375 374.164 374.164 374.164 --0.234375 0.234375 0.203125 -114.64 -114.64 -114.64 --0.203125 0.203125 0.203125 -4.20837 -4.20837 -4.20837 --0.203125 0.203125 0.234375 -26.7916 -26.7916 -26.7916 --0.203125 0.234375 0.203125 25.1071 25.1071 25.1071 --0.203125 0.234375 0.234375 148.877 148.877 148.877 --0.171875 0.140625 0.140625 -43.8952 -43.8952 -43.8952 --0.171875 0.140625 0.171875 -13.0826 -13.0826 -13.0826 --0.171875 0.171875 0.171875 -7.46651 -7.46651 -7.46651 --0.140625 0.140625 0.140625 7.38364 7.38364 7.38364 --0.140625 0.140625 0.171875 -5.29927 -5.29927 -5.29927 --0.140625 0.171875 0.171875 17.5262 17.5262 17.5262 --0.171875 0.140625 0.203125 3.92003 3.92003 3.92003 --0.171875 0.140625 0.234375 3.31918 3.31918 3.31918 --0.171875 0.171875 0.203125 -20.1211 -20.1211 -20.1211 --0.171875 0.171875 0.234375 -6.88716 -6.88716 -6.88716 --0.140625 0.140625 0.203125 38.3389 38.3389 38.3389 --0.140625 0.171875 0.203125 15.2193 15.2193 15.2193 --0.140625 0.171875 0.234375 18.2989 18.2989 18.2989 --0.171875 0.203125 0.171875 -5.06762 -5.06762 -5.06762 --0.171875 0.234375 0.171875 -8.89962 -8.89962 -8.89962 --0.140625 0.203125 0.171875 10.8196 10.8196 10.8196 --0.171875 0.203125 0.203125 0.834246 0.834246 0.834246 --0.171875 0.203125 0.234375 -229.552 -229.552 -229.552 --0.171875 0.234375 0.203125 28.766 28.766 28.766 --0.171875 0.234375 0.234375 382.682 382.682 382.682 --0.140625 0.203125 0.203125 -176.613 -176.613 -176.613 --0.140625 0.203125 0.234375 -163.572 -163.572 -163.572 --0.140625 0.234375 0.234375 215.666 215.666 215.666 --0.109375 0.015625 0.015625 7.50993 7.50993 7.50993 --0.109375 0.015625 0.046875 42.8326 42.8326 42.8326 --0.109375 0.046875 0.015625 11.6719 11.6719 11.6719 --0.109375 0.046875 0.046875 -50.4219 -50.4219 -50.4219 --0.078125 0.015625 0.015625 -20.641 -20.641 -20.641 --0.078125 0.015625 0.046875 -46.171 -46.171 -46.171 --0.078125 0.046875 0.015625 -17.1963 -17.1963 -17.1963 --0.078125 0.046875 0.046875 27.6984 27.6984 27.6984 --0.109375 0.046875 0.078125 -25.3681 -25.3681 -25.3681 --0.109375 0.046875 0.109375 -0.269312 -0.269312 -0.269312 --0.078125 0.015625 0.109375 58.8577 58.8577 58.8577 --0.078125 0.046875 0.078125 109.006 109.006 109.006 --0.078125 0.046875 0.109375 26.1982 26.1982 26.1982 --0.109375 0.078125 0.015625 1.99851 1.99851 1.99851 --0.109375 0.078125 0.046875 44.2261 44.2261 44.2261 --0.109375 0.109375 0.015625 11.4096 11.4096 11.4096 --0.109375 0.109375 0.046875 4.44952 4.44952 4.44952 --0.078125 0.078125 0.015625 -9.92085 -9.92085 -9.92085 --0.078125 0.078125 0.046875 -5.96887 -5.96887 -5.96887 --0.078125 0.109375 0.015625 -0.656841 -0.656841 -0.656841 --0.078125 0.109375 0.046875 32.874 32.874 32.874 --0.109375 0.078125 0.109375 -69.8239 -69.8239 -69.8239 --0.109375 0.109375 0.078125 -6.01182 -6.01182 -6.01182 --0.078125 0.078125 0.078125 53.8553 53.8553 53.8553 --0.078125 0.078125 0.109375 -68.6288 -68.6288 -68.6288 --0.078125 0.109375 0.078125 21.0431 21.0431 21.0431 --0.078125 0.109375 0.109375 0.167341 0.167341 0.167341 --0.046875 0.015625 0.046875 -33.9037 -33.9037 -33.9037 --0.046875 0.046875 0.015625 -7.87117 -7.87117 -7.87117 --0.046875 0.046875 0.046875 -14.8758 -14.8758 -14.8758 --0.015625 0.015625 0.046875 2.93128 2.93128 2.93128 --0.015625 0.046875 0.015625 -3.53756 -3.53756 -3.53756 --0.015625 0.046875 0.046875 4.03268 4.03268 4.03268 --0.046875 0.015625 0.078125 -16.5848 -16.5848 -16.5848 --0.046875 0.015625 0.109375 -11.1762 -11.1762 -11.1762 --0.046875 0.046875 0.078125 -28.543 -28.543 -28.543 --0.046875 0.046875 0.109375 22.0882 22.0882 22.0882 --0.015625 0.015625 0.078125 -1.86907 -1.86907 -1.86907 --0.015625 0.015625 0.109375 -105.385 -105.385 -105.385 --0.015625 0.046875 0.078125 -22.7951 -22.7951 -22.7951 --0.046875 0.078125 0.015625 23.5678 23.5678 23.5678 --0.046875 0.078125 0.046875 64.9706 64.9706 64.9706 --0.015625 0.078125 0.015625 39.54 39.54 39.54 --0.015625 0.078125 0.046875 15.7027 15.7027 15.7027 --0.046875 0.078125 0.078125 -18.2815 -18.2815 -18.2815 --0.046875 0.109375 0.078125 -10.0293 -10.0293 -10.0293 --0.046875 0.109375 0.109375 -14.3857 -14.3857 -14.3857 --0.015625 0.078125 0.078125 -38.084 -38.084 -38.084 --0.015625 0.078125 0.109375 -3.02673 -3.02673 -3.02673 --0.015625 0.109375 0.078125 -48.2112 -48.2112 -48.2112 --0.015625 0.109375 0.109375 10.5878 10.5878 10.5878 --0.109375 0.015625 0.140625 -12.2443 -12.2443 -12.2443 --0.109375 0.015625 0.171875 9.20655 9.20655 9.20655 --0.109375 0.046875 0.140625 13.4517 13.4517 13.4517 --0.109375 0.046875 0.171875 -0.545803 -0.545803 -0.545803 --0.078125 0.015625 0.140625 36.9814 36.9814 36.9814 --0.078125 0.015625 0.171875 4.77898 4.77898 4.77898 --0.078125 0.046875 0.140625 31.0301 31.0301 31.0301 --0.109375 0.015625 0.203125 20.7077 20.7077 20.7077 --0.109375 0.015625 0.234375 -20.1279 -20.1279 -20.1279 --0.109375 0.046875 0.203125 17.86 17.86 17.86 --0.109375 0.046875 0.234375 30.7538 30.7538 30.7538 --0.078125 0.015625 0.203125 -19.9361 -19.9361 -19.9361 --0.078125 0.015625 0.234375 -101.905 -101.905 -101.905 --0.078125 0.046875 0.203125 20.6193 20.6193 20.6193 --0.078125 0.046875 0.234375 -65.2062 -65.2062 -65.2062 --0.109375 0.078125 0.140625 13.2981 13.2981 13.2981 --0.109375 0.078125 0.171875 4.37424 4.37424 4.37424 --0.109375 0.109375 0.140625 49.5457 49.5457 49.5457 --0.109375 0.109375 0.171875 15.5656 15.5656 15.5656 --0.109375 0.078125 0.203125 6.00557 6.00557 6.00557 --0.109375 0.078125 0.234375 9.54334 9.54334 9.54334 --0.109375 0.109375 0.203125 -13.3302 -13.3302 -13.3302 --0.109375 0.109375 0.234375 -0.785891 -0.785891 -0.785891 --0.078125 0.078125 0.234375 -15.778 -15.778 -15.778 --0.078125 0.109375 0.203125 -65.0665 -65.0665 -65.0665 --0.078125 0.109375 0.234375 -9.88576 -9.88576 -9.88576 --0.046875 0.015625 0.140625 -58.2214 -58.2214 -58.2214 --0.015625 0.015625 0.140625 57.7938 57.7938 57.7938 --0.015625 0.015625 0.171875 201.809 201.809 201.809 --0.046875 0.015625 0.203125 -39.0903 -39.0903 -39.0903 --0.046875 0.015625 0.234375 12.7004 12.7004 12.7004 --0.046875 0.046875 0.203125 2.61934 2.61934 2.61934 --0.046875 0.046875 0.234375 -18.8892 -18.8892 -18.8892 --0.015625 0.015625 0.203125 96.2015 96.2015 96.2015 --0.015625 0.015625 0.234375 19.4948 19.4948 19.4948 --0.015625 0.046875 0.203125 77.8581 77.8581 77.8581 --0.015625 0.046875 0.234375 -51.0714 -51.0714 -51.0714 --0.046875 0.109375 0.171875 -96.1868 -96.1868 -96.1868 --0.015625 0.078125 0.171875 14.0087 14.0087 14.0087 --0.015625 0.109375 0.140625 -96.8976 -96.8976 -96.8976 --0.015625 0.109375 0.171875 -20.4454 -20.4454 -20.4454 --0.046875 0.078125 0.203125 -47.0757 -47.0757 -47.0757 --0.046875 0.078125 0.234375 -10.3577 -10.3577 -10.3577 --0.046875 0.109375 0.203125 -39.0506 -39.0506 -39.0506 --0.046875 0.109375 0.234375 -0.97511 -0.97511 -0.97511 --0.015625 0.078125 0.203125 155.478 155.478 155.478 --0.015625 0.078125 0.234375 -42.0529 -42.0529 -42.0529 --0.015625 0.109375 0.203125 74.3053 74.3053 74.3053 --0.015625 0.109375 0.234375 71.2931 71.2931 71.2931 --0.109375 0.140625 0.015625 1.75604 1.75604 1.75604 --0.109375 0.140625 0.046875 -4.55126 -4.55126 -4.55126 --0.109375 0.171875 0.015625 240.719 240.719 240.719 --0.109375 0.171875 0.046875 -244.975 -244.975 -244.975 --0.078125 0.140625 0.015625 -12.9345 -12.9345 -12.9345 --0.078125 0.140625 0.046875 -1.72081 -1.72081 -1.72081 --0.078125 0.171875 0.015625 206.997 206.997 206.997 --0.078125 0.171875 0.046875 -53.8552 -53.8552 -53.8552 --0.109375 0.140625 0.078125 10.8924 10.8924 10.8924 --0.109375 0.171875 0.078125 -79.9659 -79.9659 -79.9659 --0.078125 0.140625 0.078125 -0.167071 -0.167071 -0.167071 --0.078125 0.140625 0.109375 41.6774 41.6774 41.6774 --0.078125 0.171875 0.078125 -69.8889 -69.8889 -69.8889 --0.078125 0.171875 0.109375 0.570531 0.570531 0.570531 --0.109375 0.203125 0.046875 73.6323 73.6323 73.6323 --0.109375 0.234375 0.015625 -12.7469 -12.7469 -12.7469 --0.109375 0.234375 0.046875 174.044 174.044 174.044 --0.078125 0.203125 0.015625 -240.307 -240.307 -240.307 --0.078125 0.203125 0.046875 326.254 326.254 326.254 --0.078125 0.234375 0.015625 104.023 104.023 104.023 --0.078125 0.234375 0.046875 64.0085 64.0085 64.0085 --0.109375 0.203125 0.078125 -29.2394 -29.2394 -29.2394 --0.078125 0.203125 0.078125 40.4216 40.4216 40.4216 --0.078125 0.203125 0.109375 56.5882 56.5882 56.5882 --0.078125 0.234375 0.078125 -46.9934 -46.9934 -46.9934 --0.078125 0.234375 0.109375 113.517 113.517 113.517 --0.046875 0.140625 0.046875 76.9304 76.9304 76.9304 --0.046875 0.171875 0.015625 -147.92 -147.92 -147.92 --0.046875 0.171875 0.046875 124.47 124.47 124.47 --0.015625 0.171875 0.046875 91.1059 91.1059 91.1059 --0.046875 0.140625 0.078125 -45.889 -45.889 -45.889 --0.046875 0.140625 0.109375 16.4322 16.4322 16.4322 --0.046875 0.171875 0.078125 -186.435 -186.435 -186.435 --0.046875 0.171875 0.109375 -99.4654 -99.4654 -99.4654 --0.015625 0.140625 0.078125 -50.8906 -50.8906 -50.8906 --0.015625 0.140625 0.109375 -14.2228 -14.2228 -14.2228 --0.015625 0.171875 0.078125 -26.8411 -26.8411 -26.8411 --0.015625 0.171875 0.109375 139.166 139.166 139.166 --0.046875 0.203125 0.015625 -112.372 -112.372 -112.372 --0.046875 0.234375 0.015625 -739.613 -739.613 -739.613 --0.046875 0.234375 0.046875 -53.4685 -53.4685 -53.4685 --0.015625 0.203125 0.015625 -0.768486 -0.768486 -0.768486 --0.015625 0.203125 0.046875 126.158 126.158 126.158 --0.046875 0.203125 0.109375 19.1035 19.1035 19.1035 --0.046875 0.234375 0.078125 -282.735 -282.735 -282.735 --0.046875 0.234375 0.109375 -75.6789 -75.6789 -75.6789 --0.109375 0.140625 0.171875 -130.346 -130.346 -130.346 --0.109375 0.171875 0.140625 85.6715 85.6715 85.6715 --0.109375 0.171875 0.171875 0.199312 0.199312 0.199312 --0.078125 0.171875 0.140625 122.667 122.667 122.667 --0.078125 0.171875 0.171875 45.355 45.355 45.355 --0.109375 0.140625 0.203125 -37.0025 -37.0025 -37.0025 --0.109375 0.140625 0.234375 12.798 12.798 12.798 --0.109375 0.171875 0.203125 -37.4044 -37.4044 -37.4044 --0.109375 0.171875 0.234375 -157.308 -157.308 -157.308 --0.078125 0.140625 0.203125 -184.502 -184.502 -184.502 --0.078125 0.140625 0.234375 218.591 218.591 218.591 --0.078125 0.171875 0.203125 92.8903 92.8903 92.8903 --0.109375 0.203125 0.140625 40.5045 40.5045 40.5045 --0.109375 0.203125 0.171875 123.882 123.882 123.882 --0.109375 0.234375 0.140625 73.5375 73.5375 73.5375 --0.109375 0.234375 0.171875 22.5419 22.5419 22.5419 --0.078125 0.203125 0.140625 39.2346 39.2346 39.2346 --0.078125 0.203125 0.171875 14.435 14.435 14.435 --0.078125 0.234375 0.140625 -47.3773 -47.3773 -47.3773 --0.109375 0.203125 0.203125 -60.6952 -60.6952 -60.6952 --0.109375 0.203125 0.234375 -76.6634 -76.6634 -76.6634 --0.109375 0.234375 0.203125 53.7236 53.7236 53.7236 --0.109375 0.234375 0.234375 55.4172 55.4172 55.4172 --0.078125 0.234375 0.203125 -14.79 -14.79 -14.79 --0.046875 0.140625 0.140625 12.3915 12.3915 12.3915 --0.046875 0.140625 0.171875 40.4329 40.4329 40.4329 --0.046875 0.171875 0.140625 31.7828 31.7828 31.7828 --0.046875 0.171875 0.171875 -53.7753 -53.7753 -53.7753 --0.015625 0.140625 0.140625 -27.6181 -27.6181 -27.6181 --0.015625 0.140625 0.171875 81.7026 81.7026 81.7026 --0.046875 0.140625 0.203125 -256.948 -256.948 -256.948 --0.046875 0.140625 0.234375 -530.274 -530.274 -530.274 --0.046875 0.171875 0.203125 368.938 368.938 368.938 --0.015625 0.140625 0.234375 -292.647 -292.647 -292.647 --0.234375 0.015625 0.265625 -49.3589 -49.3589 -49.3589 --0.234375 0.015625 0.296875 1.51547 1.51547 1.51547 --0.234375 0.046875 0.296875 -24.9945 -24.9945 -24.9945 --0.203125 0.015625 0.265625 -26.1619 -26.1619 -26.1619 --0.203125 0.015625 0.296875 31.2085 31.2085 31.2085 --0.203125 0.046875 0.265625 43.9905 43.9905 43.9905 --0.203125 0.046875 0.296875 49.0959 49.0959 49.0959 --0.234375 0.078125 0.265625 -34.1146 -34.1146 -34.1146 --0.234375 0.078125 0.296875 -9.13669 -9.13669 -9.13669 --0.234375 0.109375 0.265625 -82.511 -82.511 -82.511 --0.234375 0.109375 0.296875 204.295 204.295 204.295 --0.203125 0.078125 0.265625 39.0595 39.0595 39.0595 --0.203125 0.078125 0.296875 12.0558 12.0558 12.0558 --0.203125 0.109375 0.296875 -0.770201 -0.770201 -0.770201 --0.171875 0.046875 0.265625 18.7355 18.7355 18.7355 --0.171875 0.078125 0.265625 -49.3105 -49.3105 -49.3105 --0.171875 0.078125 0.296875 -86.1974 -86.1974 -86.1974 --0.171875 0.109375 0.296875 -0.917731 -0.917731 -0.917731 --0.140625 0.078125 0.265625 14.2864 14.2864 14.2864 --0.140625 0.078125 0.296875 9.26352 9.26352 9.26352 --0.140625 0.109375 0.296875 51.6992 51.6992 51.6992 --0.234375 0.140625 0.265625 -139.827 -139.827 -139.827 --0.234375 0.140625 0.296875 1052.11 1052.11 1052.11 --0.234375 0.171875 0.265625 125.934 125.934 125.934 --0.234375 0.171875 0.296875 539.423 539.423 539.423 --0.203125 0.140625 0.296875 0.182839 0.182839 0.182839 --0.203125 0.171875 0.265625 -78.956 -78.956 -78.956 --0.203125 0.171875 0.296875 -53.4687 -53.4687 -53.4687 --0.234375 0.203125 0.265625 -114.63 -114.63 -114.63 --0.234375 0.203125 0.296875 -278.374 -278.374 -278.374 --0.203125 0.203125 0.265625 -211.681 -211.681 -211.681 --0.203125 0.203125 0.296875 -611.992 -611.992 -611.992 --0.171875 0.140625 0.265625 -5.92215 -5.92215 -5.92215 --0.171875 0.140625 0.296875 0.472891 0.472891 0.472891 --0.171875 0.171875 0.265625 -36.262 -36.262 -36.262 --0.171875 0.171875 0.296875 -9.32359 -9.32359 -9.32359 --0.140625 0.140625 0.296875 -13.3216 -13.3216 -13.3216 --0.140625 0.171875 0.265625 51.4293 51.4293 51.4293 --0.140625 0.171875 0.296875 -66.7374 -66.7374 -66.7374 --0.171875 0.203125 0.265625 -153.145 -153.145 -153.145 --0.171875 0.234375 0.265625 311.017 311.017 311.017 --0.140625 0.234375 0.265625 207.694 207.694 207.694 --0.078125 0.046875 0.265625 465.241 465.241 465.241 --0.109375 0.078125 0.265625 20.1028 20.1028 20.1028 --0.109375 0.078125 0.296875 -11.5544 -11.5544 -11.5544 --0.109375 0.109375 0.265625 15.6602 15.6602 15.6602 --0.109375 0.109375 0.296875 33.3569 33.3569 33.3569 --0.078125 0.078125 0.265625 5.22399 5.22399 5.22399 --0.078125 0.078125 0.296875 11.4223 11.4223 11.4223 --0.078125 0.109375 0.265625 -3.22565 -3.22565 -3.22565 --0.078125 0.109375 0.296875 -44.1512 -44.1512 -44.1512 --0.046875 0.015625 0.265625 -1108.11 -1108.11 -1108.11 --0.046875 0.046875 0.265625 -455.069 -455.069 -455.069 --0.046875 0.046875 0.296875 -474.544 -474.544 -474.544 --0.015625 0.015625 0.265625 6.10014 6.10014 6.10014 --0.015625 0.015625 0.296875 -171.439 -171.439 -171.439 --0.015625 0.046875 0.265625 94.775 94.775 94.775 --0.015625 0.046875 0.296875 -52.5064 -52.5064 -52.5064 --0.046875 0.078125 0.296875 -51.6977 -51.6977 -51.6977 --0.046875 0.109375 0.265625 -9.20421 -9.20421 -9.20421 --0.046875 0.109375 0.296875 -63.9701 -63.9701 -63.9701 --0.015625 0.078125 0.296875 128.949 128.949 128.949 --0.015625 0.109375 0.265625 43.8276 43.8276 43.8276 --0.015625 0.109375 0.296875 -39.8162 -39.8162 -39.8162 --0.109375 0.140625 0.265625 93.8286 93.8286 93.8286 --0.109375 0.140625 0.296875 -6.19651 -6.19651 -6.19651 --0.109375 0.171875 0.265625 167.895 167.895 167.895 --0.109375 0.171875 0.296875 -101.669 -101.669 -101.669 --0.078125 0.140625 0.265625 442.638 442.638 442.638 --0.109375 0.234375 0.265625 -128.08 -128.08 -128.08 --0.046875 0.140625 0.265625 927.049 927.049 927.049 --0.046875 0.140625 0.296875 -116.651 -116.651 -116.651 --0.015625 0.140625 0.265625 -140.074 -140.074 -140.074 --0.015625 0.140625 0.296875 -124.002 -124.002 -124.002 --0.234375 0.265625 0.015625 3040.31 3040.31 3040.31 --0.234375 0.265625 0.046875 -41.962 -41.962 -41.962 --0.234375 0.296875 0.015625 2558.56 2558.56 2558.56 --0.234375 0.296875 0.046875 806.311 806.311 806.311 --0.203125 0.265625 0.046875 -17.3928 -17.3928 -17.3928 --0.203125 0.296875 0.015625 220.062 220.062 220.062 --0.203125 0.296875 0.046875 -1491.61 -1491.61 -1491.61 --0.234375 0.265625 0.109375 -64.4389 -64.4389 -64.4389 --0.203125 0.265625 0.078125 -33.6723 -33.6723 -33.6723 --0.203125 0.265625 0.109375 -10.864 -10.864 -10.864 --0.203125 0.296875 0.078125 196.573 196.573 196.573 --0.203125 0.296875 0.109375 23.7751 23.7751 23.7751 --0.203125 0.328125 0.015625 4241.29 4241.29 4241.29 --0.203125 0.328125 0.046875 -998.074 -998.074 -998.074 --0.203125 0.359375 0.015625 2356.86 2356.86 2356.86 --0.203125 0.359375 0.046875 -1724.92 -1724.92 -1724.92 --0.203125 0.328125 0.078125 1015.23 1015.23 1015.23 --0.203125 0.328125 0.109375 45.8085 45.8085 45.8085 --0.203125 0.359375 0.078125 1368.14 1368.14 1368.14 --0.203125 0.359375 0.109375 4.75952 4.75952 4.75952 --0.171875 0.265625 0.015625 106.764 106.764 106.764 --0.171875 0.265625 0.046875 -7.35441 -7.35441 -7.35441 --0.171875 0.296875 0.015625 1320.65 1320.65 1320.65 --0.171875 0.296875 0.046875 1138.85 1138.85 1138.85 --0.140625 0.265625 0.015625 235.303 235.303 235.303 --0.140625 0.265625 0.046875 100.042 100.042 100.042 --0.140625 0.296875 0.015625 265.115 265.115 265.115 --0.140625 0.296875 0.046875 -149.748 -149.748 -149.748 --0.171875 0.265625 0.078125 -47.4233 -47.4233 -47.4233 --0.171875 0.296875 0.078125 -535.522 -535.522 -535.522 --0.171875 0.296875 0.109375 9.99 9.99 9.99 --0.140625 0.265625 0.078125 6.54506 6.54506 6.54506 --0.140625 0.265625 0.109375 49.9789 49.9789 49.9789 --0.140625 0.296875 0.078125 -34.9851 -34.9851 -34.9851 --0.140625 0.296875 0.109375 132.858 132.858 132.858 --0.171875 0.328125 0.015625 -620.226 -620.226 -620.226 --0.171875 0.359375 0.015625 -162.369 -162.369 -162.369 --0.140625 0.328125 0.015625 124.429 124.429 124.429 --0.140625 0.359375 0.015625 -3566.05 -3566.05 -3566.05 --0.171875 0.328125 0.078125 73.8593 73.8593 73.8593 --0.171875 0.328125 0.109375 24.859 24.859 24.859 --0.171875 0.359375 0.109375 -36.2454 -36.2454 -36.2454 --0.140625 0.328125 0.078125 -216.735 -216.735 -216.735 --0.140625 0.328125 0.109375 -39.6156 -39.6156 -39.6156 --0.140625 0.359375 0.078125 151.112 151.112 151.112 --0.140625 0.359375 0.109375 -98.6342 -98.6342 -98.6342 --0.234375 0.265625 0.140625 -40.2724 -40.2724 -40.2724 --0.234375 0.265625 0.171875 -92.226 -92.226 -92.226 --0.234375 0.296875 0.140625 -26.1258 -26.1258 -26.1258 --0.234375 0.296875 0.171875 -40.3253 -40.3253 -40.3253 --0.203125 0.265625 0.140625 9.04658 9.04658 9.04658 --0.203125 0.265625 0.171875 -47.5801 -47.5801 -47.5801 --0.203125 0.296875 0.140625 -26.6428 -26.6428 -26.6428 --0.234375 0.265625 0.203125 101.689 101.689 101.689 --0.234375 0.296875 0.203125 10.3116 10.3116 10.3116 --0.203125 0.265625 0.203125 28.9764 28.9764 28.9764 --0.203125 0.265625 0.234375 179.55 179.55 179.55 --0.203125 0.296875 0.203125 -13.897 -13.897 -13.897 --0.203125 0.296875 0.234375 10.8982 10.8982 10.8982 --0.234375 0.328125 0.140625 0.187626 0.187626 0.187626 --0.234375 0.328125 0.171875 -24.9381 -24.9381 -24.9381 --0.234375 0.359375 0.140625 12.0398 12.0398 12.0398 --0.234375 0.359375 0.171875 -4.18076 -4.18076 -4.18076 --0.203125 0.328125 0.140625 -54.8237 -54.8237 -54.8237 --0.203125 0.359375 0.140625 19.1948 19.1948 19.1948 --0.203125 0.359375 0.171875 -20.2168 -20.2168 -20.2168 --0.234375 0.328125 0.203125 52.7104 52.7104 52.7104 --0.234375 0.359375 0.203125 8.22363 8.22363 8.22363 --0.203125 0.328125 0.203125 14.9227 14.9227 14.9227 --0.203125 0.328125 0.234375 -51.5212 -51.5212 -51.5212 --0.203125 0.359375 0.203125 57.1483 57.1483 57.1483 --0.171875 0.296875 0.140625 13.6085 13.6085 13.6085 --0.140625 0.296875 0.140625 -36.5664 -36.5664 -36.5664 --0.171875 0.265625 0.234375 224.679 224.679 224.679 --0.171875 0.296875 0.234375 22.9455 22.9455 22.9455 --0.140625 0.265625 0.234375 234.599 234.599 234.599 --0.140625 0.296875 0.203125 -115.442 -115.442 -115.442 --0.140625 0.296875 0.234375 25.8807 25.8807 25.8807 --0.171875 0.328125 0.140625 -66.1876 -66.1876 -66.1876 --0.171875 0.359375 0.140625 -53.5359 -53.5359 -53.5359 --0.171875 0.359375 0.171875 4.72038 4.72038 4.72038 --0.140625 0.328125 0.140625 20.6097 20.6097 20.6097 --0.140625 0.328125 0.171875 -140.503 -140.503 -140.503 --0.140625 0.359375 0.140625 -41.5733 -41.5733 -41.5733 --0.140625 0.359375 0.171875 11.6412 11.6412 11.6412 --0.171875 0.328125 0.203125 38.7208 38.7208 38.7208 --0.171875 0.328125 0.234375 -89.9543 -89.9543 -89.9543 --0.171875 0.359375 0.203125 135.321 135.321 135.321 --0.140625 0.328125 0.203125 -118.359 -118.359 -118.359 --0.140625 0.359375 0.203125 23.5897 23.5897 23.5897 --0.203125 0.390625 0.015625 -2085.58 -2085.58 -2085.58 --0.203125 0.390625 0.046875 -219.378 -219.378 -219.378 --0.203125 0.421875 0.015625 -2422.66 -2422.66 -2422.66 --0.203125 0.421875 0.046875 -2425.15 -2425.15 -2425.15 --0.203125 0.390625 0.078125 -1541.29 -1541.29 -1541.29 --0.203125 0.390625 0.109375 24.4898 24.4898 24.4898 --0.203125 0.421875 0.078125 180.729 180.729 180.729 --0.171875 0.390625 0.015625 476.546 476.546 476.546 --0.171875 0.421875 0.015625 -6801.34 -6801.34 -6801.34 --0.171875 0.421875 0.046875 -754.855 -754.855 -754.855 --0.140625 0.390625 0.015625 -1120.71 -1120.71 -1120.71 --0.140625 0.421875 0.015625 2173.6 2173.6 2173.6 --0.140625 0.421875 0.046875 -1832.24 -1832.24 -1832.24 --0.171875 0.390625 0.078125 1775 1775 1775 --0.171875 0.390625 0.109375 -33.6107 -33.6107 -33.6107 --0.171875 0.421875 0.078125 74.0953 74.0953 74.0953 --0.171875 0.421875 0.109375 -228.028 -228.028 -228.028 --0.140625 0.421875 0.109375 -2.26948 -2.26948 -2.26948 --0.171875 0.453125 0.015625 -10425.2 -10425.2 -10425.2 --0.171875 0.453125 0.046875 -1308.55 -1308.55 -1308.55 --0.171875 0.484375 0.046875 1159.84 1159.84 1159.84 --0.140625 0.453125 0.015625 5373.86 5373.86 5373.86 --0.140625 0.453125 0.046875 2251.03 2251.03 2251.03 --0.140625 0.484375 0.015625 1595.71 1595.71 1595.71 --0.140625 0.484375 0.046875 1023.03 1023.03 1023.03 --0.171875 0.453125 0.078125 -723.478 -723.478 -723.478 --0.171875 0.453125 0.109375 -37.1996 -37.1996 -37.1996 --0.171875 0.484375 0.078125 -911.466 -911.466 -911.466 --0.171875 0.484375 0.109375 54.7168 54.7168 54.7168 --0.140625 0.453125 0.109375 -81.2588 -81.2588 -81.2588 --0.140625 0.484375 0.078125 -615.568 -615.568 -615.568 --0.140625 0.484375 0.109375 0.443931 0.443931 0.443931 --0.171875 0.390625 0.140625 51.2696 51.2696 51.2696 --0.171875 0.421875 0.140625 25.6005 25.6005 25.6005 --0.140625 0.390625 0.140625 38.8163 38.8163 38.8163 --0.140625 0.390625 0.171875 96.5908 96.5908 96.5908 --0.140625 0.421875 0.140625 84.8354 84.8354 84.8354 --0.140625 0.421875 0.171875 -7.38533 -7.38533 -7.38533 --0.140625 0.453125 0.140625 -2.30069 -2.30069 -2.30069 --0.140625 0.484375 0.140625 44.6815 44.6815 44.6815 --0.109375 0.265625 0.015625 526.891 526.891 526.891 --0.109375 0.296875 0.015625 163.912 163.912 163.912 --0.078125 0.265625 0.015625 -27.0592 -27.0592 -27.0592 --0.078125 0.296875 0.015625 -72.4003 -72.4003 -72.4003 --0.109375 0.265625 0.078125 -44.6437 -44.6437 -44.6437 --0.109375 0.265625 0.109375 45.3111 45.3111 45.3111 --0.109375 0.296875 0.078125 55.6443 55.6443 55.6443 --0.109375 0.296875 0.109375 80.5523 80.5523 80.5523 --0.078125 0.265625 0.078125 13.8147 13.8147 13.8147 --0.078125 0.265625 0.109375 -32.0126 -32.0126 -32.0126 --0.078125 0.296875 0.078125 278.587 278.587 278.587 --0.109375 0.328125 0.015625 310.919 310.919 310.919 --0.109375 0.328125 0.046875 1480.86 1480.86 1480.86 --0.109375 0.359375 0.015625 -2259.58 -2259.58 -2259.58 --0.109375 0.359375 0.046875 -1194.26 -1194.26 -1194.26 --0.078125 0.328125 0.015625 -2054.3 -2054.3 -2054.3 --0.078125 0.328125 0.046875 -1150.42 -1150.42 -1150.42 --0.078125 0.359375 0.015625 539.114 539.114 539.114 --0.078125 0.359375 0.046875 -2169.13 -2169.13 -2169.13 --0.109375 0.328125 0.078125 534.815 534.815 534.815 --0.109375 0.328125 0.109375 -59.3378 -59.3378 -59.3378 --0.109375 0.359375 0.078125 -632.279 -632.279 -632.279 --0.078125 0.328125 0.078125 587.342 587.342 587.342 --0.078125 0.328125 0.109375 -16.1893 -16.1893 -16.1893 --0.078125 0.359375 0.078125 291.245 291.245 291.245 --0.078125 0.359375 0.109375 -19.3913 -19.3913 -19.3913 --0.046875 0.265625 0.015625 -1077.04 -1077.04 -1077.04 --0.046875 0.265625 0.046875 115.462 115.462 115.462 --0.046875 0.296875 0.015625 -123.998 -123.998 -123.998 --0.046875 0.296875 0.046875 -609.464 -609.464 -609.464 --0.015625 0.296875 0.015625 859.305 859.305 859.305 --0.046875 0.265625 0.078125 -36.2012 -36.2012 -36.2012 --0.046875 0.296875 0.078125 -298.646 -298.646 -298.646 --0.046875 0.328125 0.015625 1978.22 1978.22 1978.22 --0.046875 0.328125 0.046875 125.953 125.953 125.953 --0.015625 0.328125 0.015625 1657.23 1657.23 1657.23 --0.015625 0.359375 0.015625 -50.3415 -50.3415 -50.3415 --0.046875 0.359375 0.109375 249.48 249.48 249.48 --0.109375 0.265625 0.140625 55.6045 55.6045 55.6045 --0.109375 0.265625 0.171875 -226.217 -226.217 -226.217 --0.109375 0.296875 0.140625 68.175 68.175 68.175 --0.109375 0.296875 0.171875 -248.212 -248.212 -248.212 --0.078125 0.265625 0.140625 22.6371 22.6371 22.6371 --0.109375 0.265625 0.203125 -86.1098 -86.1098 -86.1098 --0.109375 0.265625 0.234375 -48.3227 -48.3227 -48.3227 --0.109375 0.296875 0.203125 -58.82 -58.82 -58.82 --0.109375 0.296875 0.234375 23.478 23.478 23.478 --0.078125 0.265625 0.203125 2.14576 2.14576 2.14576 --0.109375 0.328125 0.140625 33.9956 33.9956 33.9956 --0.109375 0.328125 0.171875 170.783 170.783 170.783 --0.109375 0.359375 0.140625 -387.23 -387.23 -387.23 --0.109375 0.359375 0.171875 -99.7035 -99.7035 -99.7035 --0.078125 0.328125 0.140625 -190.133 -190.133 -190.133 --0.078125 0.359375 0.140625 32.8845 32.8845 32.8845 --0.078125 0.359375 0.171875 86.9394 86.9394 86.9394 --0.046875 0.359375 0.140625 -84.1221 -84.1221 -84.1221 --0.109375 0.390625 0.015625 -299.977 -299.977 -299.977 --0.109375 0.421875 0.015625 -2905.34 -2905.34 -2905.34 --0.109375 0.421875 0.046875 -2778.36 -2778.36 -2778.36 --0.078125 0.390625 0.015625 -1177.41 -1177.41 -1177.41 --0.078125 0.390625 0.046875 285.577 285.577 285.577 --0.078125 0.421875 0.015625 1666.06 1666.06 1666.06 --0.078125 0.421875 0.046875 2611.18 2611.18 2611.18 --0.109375 0.421875 0.109375 29.2085 29.2085 29.2085 --0.078125 0.390625 0.078125 562.289 562.289 562.289 --0.078125 0.390625 0.109375 150.425 150.425 150.425 --0.078125 0.421875 0.078125 1705.94 1705.94 1705.94 --0.078125 0.421875 0.109375 76.0165 76.0165 76.0165 --0.109375 0.453125 0.015625 -3679.16 -3679.16 -3679.16 --0.109375 0.453125 0.046875 5901.53 5901.53 5901.53 --0.109375 0.484375 0.015625 494.251 494.251 494.251 --0.109375 0.484375 0.046875 -261.61 -261.61 -261.61 --0.078125 0.453125 0.015625 -2369.5 -2369.5 -2369.5 --0.078125 0.453125 0.046875 -1878.39 -1878.39 -1878.39 --0.078125 0.484375 0.046875 -850.455 -850.455 -850.455 --0.109375 0.453125 0.109375 64.838 64.838 64.838 --0.109375 0.484375 0.078125 -368.86 -368.86 -368.86 --0.109375 0.484375 0.109375 9.65484 9.65484 9.65484 --0.078125 0.453125 0.078125 -1339.47 -1339.47 -1339.47 --0.078125 0.453125 0.109375 15.0108 15.0108 15.0108 --0.078125 0.484375 0.078125 -478.164 -478.164 -478.164 --0.078125 0.484375 0.109375 -14.0364 -14.0364 -14.0364 --0.046875 0.390625 0.109375 16.2209 16.2209 16.2209 --0.046875 0.421875 0.109375 -386.521 -386.521 -386.521 --0.109375 0.390625 0.171875 -106.269 -106.269 -106.269 --0.109375 0.421875 0.140625 -71.8655 -71.8655 -71.8655 --0.109375 0.421875 0.171875 54.1903 54.1903 54.1903 --0.078125 0.390625 0.140625 145.768 145.768 145.768 --0.078125 0.390625 0.171875 62.2287 62.2287 62.2287 --0.078125 0.421875 0.140625 19.5068 19.5068 19.5068 --0.078125 0.421875 0.171875 -46.6167 -46.6167 -46.6167 --0.109375 0.453125 0.140625 -35.685 -35.685 -35.685 --0.109375 0.484375 0.140625 47.6983 47.6983 47.6983 --0.046875 0.390625 0.140625 383.292 383.292 383.292 --0.171875 0.265625 0.265625 311.742 311.742 311.742 --0.140625 0.265625 0.265625 -92.5965 -92.5965 -92.5965 --0.109375 0.265625 0.265625 -78.2489 -78.2489 -78.2489 -0.109375 -0.390625 -0.390625 -204.662 -204.662 -204.662 -0.109375 -0.453125 -0.296875 7.64056 7.64056 7.64056 -0.109375 -0.453125 -0.265625 -106.482 -106.482 -106.482 -0.078125 -0.390625 -0.359375 -60.6878 -60.6878 -60.6878 -0.078125 -0.390625 -0.328125 214.907 214.907 214.907 -0.109375 -0.421875 -0.359375 -81.7099 -81.7099 -81.7099 -0.109375 -0.421875 -0.328125 202.726 202.726 202.726 -0.109375 -0.390625 -0.359375 -180.795 -180.795 -180.795 -0.109375 -0.390625 -0.328125 -138.682 -138.682 -138.682 -0.078125 -0.421875 -0.296875 1.24022 1.24022 1.24022 -0.078125 -0.421875 -0.265625 -2.6539 -2.6539 -2.6539 -0.078125 -0.390625 -0.296875 161.105 161.105 161.105 -0.078125 -0.390625 -0.265625 35.4383 35.4383 35.4383 -0.109375 -0.421875 -0.296875 193.65 193.65 193.65 -0.109375 -0.421875 -0.265625 -67.5374 -67.5374 -67.5374 -0.109375 -0.390625 -0.296875 -3.93626 -3.93626 -3.93626 -0.078125 -0.359375 -0.390625 -332.575 -332.575 -332.575 -0.078125 -0.328125 -0.390625 -259.928 -259.928 -259.928 -0.109375 -0.359375 -0.390625 453.853 453.853 453.853 -0.109375 -0.328125 -0.390625 -136.966 -136.966 -136.966 -0.078125 -0.296875 -0.390625 206.318 206.318 206.318 -0.109375 -0.296875 -0.390625 85.0815 85.0815 85.0815 -0.046875 -0.359375 -0.328125 2766.28 2766.28 2766.28 -0.046875 -0.328125 -0.328125 265.468 265.468 265.468 -0.046875 -0.359375 -0.296875 239.221 239.221 239.221 -0.046875 -0.328125 -0.296875 200.342 200.342 200.342 -0.046875 -0.328125 -0.265625 -351.227 -351.227 -351.227 -0.046875 -0.296875 -0.328125 -2733.39 -2733.39 -2733.39 -0.046875 -0.265625 -0.359375 20.0934 20.0934 20.0934 -0.046875 -0.265625 -0.328125 179.18 179.18 179.18 -0.015625 -0.296875 -0.265625 -110.79 -110.79 -110.79 -0.015625 -0.265625 -0.296875 245.788 245.788 245.788 -0.015625 -0.265625 -0.265625 44.8932 44.8932 44.8932 -0.046875 -0.296875 -0.296875 144.662 144.662 144.662 -0.046875 -0.296875 -0.265625 -140.521 -140.521 -140.521 -0.046875 -0.265625 -0.296875 804.176 804.176 804.176 -0.046875 -0.265625 -0.265625 -3831.13 -3831.13 -3831.13 -0.078125 -0.359375 -0.359375 87.8613 87.8613 87.8613 -0.078125 -0.359375 -0.328125 -43.0879 -43.0879 -43.0879 -0.078125 -0.328125 -0.359375 -138.84 -138.84 -138.84 -0.078125 -0.328125 -0.328125 -9.61773 -9.61773 -9.61773 -0.109375 -0.359375 -0.359375 -229.168 -229.168 -229.168 -0.078125 -0.359375 -0.296875 108.501 108.501 108.501 -0.078125 -0.359375 -0.265625 -98.8072 -98.8072 -98.8072 -0.078125 -0.328125 -0.296875 -352.413 -352.413 -352.413 -0.078125 -0.328125 -0.265625 -331.879 -331.879 -331.879 -0.078125 -0.296875 -0.359375 -63.1536 -63.1536 -63.1536 -0.078125 -0.296875 -0.328125 -74.3181 -74.3181 -74.3181 -0.078125 -0.265625 -0.359375 -1.83543 -1.83543 -1.83543 -0.078125 -0.265625 -0.328125 -24.0919 -24.0919 -24.0919 -0.109375 -0.296875 -0.359375 52.0346 52.0346 52.0346 -0.109375 -0.296875 -0.328125 -80.8942 -80.8942 -80.8942 -0.109375 -0.265625 -0.328125 -2245.02 -2245.02 -2245.02 -0.078125 -0.296875 -0.296875 -5.73276 -5.73276 -5.73276 -0.078125 -0.265625 -0.296875 4349.52 4349.52 4349.52 -0.109375 -0.265625 -0.296875 4957.67 4957.67 4957.67 -0.109375 -0.265625 -0.265625 -6315.44 -6315.44 -6315.44 -0.140625 -0.390625 -0.390625 127.936 127.936 127.936 -0.171875 -0.390625 -0.390625 -28.6801 -28.6801 -28.6801 -0.140625 -0.453125 -0.296875 -91.4306 -91.4306 -91.4306 -0.140625 -0.453125 -0.265625 72.9792 72.9792 72.9792 -0.140625 -0.421875 -0.359375 142.888 142.888 142.888 -0.140625 -0.421875 -0.328125 518.035 518.035 518.035 -0.140625 -0.390625 -0.359375 185.63 185.63 185.63 -0.140625 -0.390625 -0.328125 -296.7 -296.7 -296.7 -0.171875 -0.390625 -0.359375 138.454 138.454 138.454 -0.171875 -0.390625 -0.328125 -194.837 -194.837 -194.837 -0.140625 -0.421875 -0.296875 -50.2291 -50.2291 -50.2291 -0.140625 -0.421875 -0.265625 41.1593 41.1593 41.1593 -0.140625 -0.390625 -0.296875 -213.839 -213.839 -213.839 -0.140625 -0.390625 -0.265625 -386.722 -386.722 -386.722 -0.171875 -0.421875 -0.296875 82.2689 82.2689 82.2689 -0.171875 -0.421875 -0.265625 425.792 425.792 425.792 -0.171875 -0.390625 -0.296875 75.9417 75.9417 75.9417 -0.171875 -0.390625 -0.265625 349.607 349.607 349.607 -0.140625 -0.359375 -0.390625 141.765 141.765 141.765 -0.140625 -0.328125 -0.390625 1476.1 1476.1 1476.1 -0.171875 -0.359375 -0.390625 -86.2816 -86.2816 -86.2816 -0.140625 -0.296875 -0.390625 -1869.94 -1869.94 -1869.94 -0.140625 -0.359375 -0.359375 110.047 110.047 110.047 -0.140625 -0.359375 -0.328125 -141.806 -141.806 -141.806 -0.140625 -0.328125 -0.359375 -1119.58 -1119.58 -1119.58 -0.140625 -0.328125 -0.328125 280.228 280.228 280.228 -0.171875 -0.359375 -0.359375 -107.599 -107.599 -107.599 -0.171875 -0.359375 -0.328125 -300.141 -300.141 -300.141 -0.171875 -0.328125 -0.359375 369.517 369.517 369.517 -0.171875 -0.328125 -0.328125 133.946 133.946 133.946 -0.140625 -0.359375 -0.296875 596.429 596.429 596.429 -0.140625 -0.359375 -0.265625 32.0494 32.0494 32.0494 -0.140625 -0.328125 -0.296875 331.446 331.446 331.446 -0.140625 -0.328125 -0.265625 228.029 228.029 228.029 -0.171875 -0.359375 -0.296875 327.522 327.522 327.522 -0.171875 -0.359375 -0.265625 138.468 138.468 138.468 -0.171875 -0.328125 -0.296875 -26.2201 -26.2201 -26.2201 -0.171875 -0.328125 -0.265625 394.809 394.809 394.809 -0.140625 -0.296875 -0.359375 -1058.52 -1058.52 -1058.52 -0.140625 -0.296875 -0.328125 670.145 670.145 670.145 -0.140625 -0.265625 -0.328125 8982.16 8982.16 8982.16 -0.140625 -0.296875 -0.296875 2.134 2.134 2.134 -0.140625 -0.296875 -0.265625 -160.688 -160.688 -160.688 -0.140625 -0.265625 -0.296875 -6195.34 -6195.34 -6195.34 -0.140625 -0.265625 -0.265625 -9977.33 -9977.33 -9977.33 -0.078125 -0.421875 -0.234375 43209.9 43209.9 43209.9 -0.078125 -0.390625 -0.234375 468857 468857 468857 -0.078125 -0.390625 -0.203125 287187 287187 287187 -0.109375 -0.421875 -0.234375 -376627 -376627 -376627 -0.109375 -0.390625 -0.234375 -340488 -340488 -340488 -0.109375 -0.390625 -0.203125 -82704 -82704 -82704 -0.046875 -0.328125 -0.234375 -99.7897 -99.7897 -99.7897 -0.046875 -0.328125 -0.203125 -90.7195 -90.7195 -90.7195 -0.015625 -0.296875 -0.234375 228.744 228.744 228.744 -0.015625 -0.265625 -0.234375 -89.1617 -89.1617 -89.1617 -0.015625 -0.265625 -0.203125 340.827 340.827 340.827 -0.046875 -0.296875 -0.234375 426.876 426.876 426.876 -0.046875 -0.296875 -0.203125 544.275 544.275 544.275 -0.046875 -0.265625 -0.234375 1258.25 1258.25 1258.25 -0.046875 -0.265625 -0.203125 2277.47 2277.47 2277.47 -0.046875 -0.265625 -0.171875 624.017 624.017 624.017 -0.078125 -0.359375 -0.234375 -130.998 -130.998 -130.998 -0.078125 -0.359375 -0.203125 -78.814 -78.814 -78.814 -0.078125 -0.328125 -0.234375 -232.377 -232.377 -232.377 -0.078125 -0.328125 -0.203125 -214.524 -214.524 -214.524 -0.109375 -0.359375 -0.234375 -203.095 -203.095 -203.095 -0.109375 -0.359375 -0.203125 -99.4421 -99.4421 -99.4421 -0.109375 -0.328125 -0.234375 -199.322 -199.322 -199.322 -0.109375 -0.328125 -0.203125 456.952 456.952 456.952 -0.078125 -0.296875 -0.203125 -1887.24 -1887.24 -1887.24 -0.078125 -0.265625 -0.203125 10295.7 10295.7 10295.7 -0.109375 -0.296875 -0.203125 3029.88 3029.88 3029.88 -0.109375 -0.265625 -0.203125 1831.26 1831.26 1831.26 -0.078125 -0.265625 -0.171875 -3293.59 -3293.59 -3293.59 -0.109375 -0.265625 -0.171875 4890.97 4890.97 4890.97 -0.140625 -0.421875 -0.234375 148.134 148.134 148.134 -0.140625 -0.390625 -0.234375 66.6674 66.6674 66.6674 -0.140625 -0.390625 -0.203125 -232.764 -232.764 -232.764 -0.171875 -0.390625 -0.234375 366.946 366.946 366.946 -0.140625 -0.359375 -0.234375 -332.844 -332.844 -332.844 -0.140625 -0.359375 -0.203125 -114.187 -114.187 -114.187 -0.140625 -0.328125 -0.234375 -258.965 -258.965 -258.965 -0.140625 -0.328125 -0.203125 -155.178 -155.178 -155.178 -0.171875 -0.359375 -0.234375 -354.642 -354.642 -354.642 -0.140625 -0.296875 -0.234375 -621.667 -621.667 -621.667 -0.140625 -0.296875 -0.203125 -622.279 -622.279 -622.279 -0.140625 -0.265625 -0.234375 2428.02 2428.02 2428.02 -0.140625 -0.265625 -0.203125 -785.229 -785.229 -785.229 -0.046875 -0.234375 -0.390625 -6525.27 -6525.27 -6525.27 -0.046875 -0.203125 -0.390625 2289.27 2289.27 2289.27 -0.046875 -0.171875 -0.390625 3565.34 3565.34 3565.34 -0.078125 -0.234375 -0.390625 -687.894 -687.894 -687.894 -0.078125 -0.203125 -0.390625 -6708.98 -6708.98 -6708.98 -0.109375 -0.234375 -0.390625 -225.892 -225.892 -225.892 -0.109375 -0.203125 -0.390625 -7080.79 -7080.79 -7080.79 -0.078125 -0.171875 -0.390625 -4864.26 -4864.26 -4864.26 -0.015625 -0.234375 -0.359375 2314.55 2314.55 2314.55 -0.015625 -0.234375 -0.328125 4204.84 4204.84 4204.84 -0.015625 -0.203125 -0.359375 -2775.7 -2775.7 -2775.7 -0.015625 -0.203125 -0.328125 1576.99 1576.99 1576.99 -0.046875 -0.234375 -0.359375 -3120.61 -3120.61 -3120.61 -0.046875 -0.234375 -0.328125 5842.07 5842.07 5842.07 -0.046875 -0.203125 -0.359375 2104.9 2104.9 2104.9 -0.015625 -0.234375 -0.296875 333.225 333.225 333.225 -0.015625 -0.203125 -0.296875 1185.49 1185.49 1185.49 -0.046875 -0.234375 -0.296875 105.421 105.421 105.421 -0.015625 -0.171875 -0.359375 -3412.37 -3412.37 -3412.37 -0.015625 -0.171875 -0.328125 -3077.4 -3077.4 -3077.4 -0.015625 -0.140625 -0.328125 -184.041 -184.041 -184.041 -0.046875 -0.171875 -0.359375 840.982 840.982 840.982 -0.046875 -0.171875 -0.328125 -3018.79 -3018.79 -3018.79 -0.046875 -0.140625 -0.328125 -1277.6 -1277.6 -1277.6 -0.015625 -0.140625 -0.296875 245.2 245.2 245.2 -0.015625 -0.140625 -0.265625 386.905 386.905 386.905 -0.046875 -0.140625 -0.296875 -307.498 -307.498 -307.498 -0.046875 -0.140625 -0.265625 1008.13 1008.13 1008.13 -0.078125 -0.234375 -0.359375 -701.451 -701.451 -701.451 -0.078125 -0.234375 -0.328125 -0.37339 -0.37339 -0.37339 -0.078125 -0.203125 -0.359375 5934.98 5934.98 5934.98 -0.109375 -0.234375 -0.359375 311.809 311.809 311.809 -0.109375 -0.234375 -0.328125 1463.73 1463.73 1463.73 -0.109375 -0.203125 -0.359375 8618.21 8618.21 8618.21 -0.109375 -0.203125 -0.328125 0.217224 0.217224 0.217224 -0.078125 -0.234375 -0.296875 -3069.88 -3069.88 -3069.88 -0.078125 -0.203125 -0.265625 -3033.23 -3033.23 -3033.23 -0.109375 -0.234375 -0.296875 3438.92 3438.92 3438.92 -0.109375 -0.234375 -0.265625 -874.479 -874.479 -874.479 -0.109375 -0.203125 -0.296875 3220.3 3220.3 3220.3 -0.109375 -0.203125 -0.265625 -4150.2 -4150.2 -4150.2 -0.078125 -0.171875 -0.359375 1249.56 1249.56 1249.56 -0.078125 -0.140625 -0.359375 -9607.98 -9607.98 -9607.98 -0.078125 -0.140625 -0.328125 -9149.24 -9149.24 -9149.24 -0.109375 -0.171875 -0.359375 -211.055 -211.055 -211.055 -0.109375 -0.171875 -0.328125 16038.7 16038.7 16038.7 -0.109375 -0.140625 -0.328125 548.168 548.168 548.168 -0.078125 -0.171875 -0.265625 1560.36 1560.36 1560.36 -0.078125 -0.140625 -0.296875 5240.85 5240.85 5240.85 -0.078125 -0.140625 -0.265625 3338.18 3338.18 3338.18 -0.109375 -0.171875 -0.296875 -15477 -15477 -15477 -0.109375 -0.171875 -0.265625 -1847.85 -1847.85 -1847.85 -0.109375 -0.140625 -0.296875 5001.06 5001.06 5001.06 -0.109375 -0.140625 -0.265625 -304.467 -304.467 -304.467 -0.015625 -0.015625 -0.421875 -285.037 -285.037 -285.037 -0.015625 -0.015625 -0.390625 262.905 262.905 262.905 -0.015625 -0.109375 -0.296875 -32.5425 -32.5425 -32.5425 -0.015625 -0.109375 -0.265625 147.512 147.512 147.512 -0.015625 -0.078125 -0.265625 4.83007 4.83007 4.83007 -0.046875 -0.109375 -0.265625 445.855 445.855 445.855 -0.015625 -0.046875 -0.359375 -23.1761 -23.1761 -23.1761 -0.015625 -0.015625 -0.359375 118.6 118.6 118.6 -0.015625 -0.015625 -0.328125 8.50878 8.50878 8.50878 -0.046875 -0.015625 -0.328125 -8.46118 -8.46118 -8.46118 -0.015625 -0.015625 -0.296875 -18.7645 -18.7645 -18.7645 -0.015625 -0.015625 -0.265625 -24.9003 -24.9003 -24.9003 -0.046875 -0.015625 -0.296875 0.924621 0.924621 0.924621 -0.046875 -0.015625 -0.265625 10.4508 10.4508 10.4508 -0.078125 -0.109375 -0.265625 -244.938 -244.938 -244.938 -0.078125 -0.078125 -0.265625 -238.13 -238.13 -238.13 -0.109375 -0.109375 -0.265625 -3702.99 -3702.99 -3702.99 -0.109375 -0.078125 -0.265625 1401.61 1401.61 1401.61 -0.078125 -0.046875 -0.296875 -754.402 -754.402 -754.402 -0.078125 -0.046875 -0.265625 4785.72 4785.72 4785.72 -0.078125 -0.015625 -0.296875 30.8679 30.8679 30.8679 -0.078125 -0.015625 -0.265625 -38.6598 -38.6598 -38.6598 -0.109375 -0.046875 -0.296875 2188.52 2188.52 2188.52 -0.109375 -0.046875 -0.265625 -3196.61 -3196.61 -3196.61 -0.109375 -0.015625 -0.296875 34.6702 34.6702 34.6702 -0.140625 -0.203125 -0.328125 -2343.21 -2343.21 -2343.21 -0.140625 -0.234375 -0.265625 4317.91 4317.91 4317.91 -0.140625 -0.203125 -0.296875 7468.32 7468.32 7468.32 -0.140625 -0.171875 -0.296875 6608.19 6608.19 6608.19 -0.140625 -0.140625 -0.265625 -1371.38 -1371.38 -1371.38 -0.140625 -0.109375 -0.265625 784.162 784.162 784.162 -0.140625 -0.078125 -0.265625 2679 2679 2679 -0.171875 -0.078125 -0.265625 -6320.69 -6320.69 -6320.69 -0.140625 -0.046875 -0.296875 8274.79 8274.79 8274.79 -0.140625 -0.046875 -0.265625 4243.94 4243.94 4243.94 -0.140625 -0.015625 -0.296875 17.2581 17.2581 17.2581 -0.171875 -0.046875 -0.265625 1867.7 1867.7 1867.7 -0.171875 -0.015625 -0.296875 6.78345 6.78345 6.78345 -0.171875 -0.015625 -0.265625 -18.9207 -18.9207 -18.9207 -0.203125 -0.015625 -0.265625 -23.571 -23.571 -23.571 -0.015625 -0.234375 -0.234375 -67.1291 -67.1291 -67.1291 -0.015625 -0.234375 -0.203125 291.806 291.806 291.806 -0.015625 -0.203125 -0.234375 -167.606 -167.606 -167.606 -0.015625 -0.203125 -0.203125 -20.209 -20.209 -20.209 -0.046875 -0.234375 -0.203125 -2019.59 -2019.59 -2019.59 -0.046875 -0.203125 -0.234375 -2969.19 -2969.19 -2969.19 -0.046875 -0.203125 -0.203125 -658.65 -658.65 -658.65 -0.015625 -0.203125 -0.140625 533.276 533.276 533.276 -0.046875 -0.234375 -0.171875 2389.13 2389.13 2389.13 -0.046875 -0.203125 -0.171875 102.937 102.937 102.937 -0.046875 -0.203125 -0.140625 2749.35 2749.35 2749.35 -0.015625 -0.171875 -0.234375 256.44 256.44 256.44 -0.015625 -0.171875 -0.203125 -120.839 -120.839 -120.839 -0.015625 -0.140625 -0.234375 46.2678 46.2678 46.2678 -0.015625 -0.140625 -0.203125 -100.042 -100.042 -100.042 -0.046875 -0.171875 -0.234375 -152.457 -152.457 -152.457 -0.046875 -0.171875 -0.203125 523.32 523.32 523.32 -0.046875 -0.140625 -0.234375 -936.879 -936.879 -936.879 -0.046875 -0.140625 -0.203125 272.321 272.321 272.321 -0.015625 -0.171875 -0.171875 147.096 147.096 147.096 -0.015625 -0.171875 -0.140625 459.557 459.557 459.557 -0.015625 -0.140625 -0.171875 -1105.09 -1105.09 -1105.09 -0.046875 -0.171875 -0.171875 -31.0645 -31.0645 -31.0645 -0.046875 -0.171875 -0.140625 1233.23 1233.23 1233.23 -0.046875 -0.140625 -0.171875 -1090.64 -1090.64 -1090.64 -0.078125 -0.234375 -0.203125 26.0486 26.0486 26.0486 -0.078125 -0.203125 -0.234375 -3162.78 -3162.78 -3162.78 -0.078125 -0.203125 -0.203125 -6948.07 -6948.07 -6948.07 -0.109375 -0.234375 -0.203125 -4249.64 -4249.64 -4249.64 -0.109375 -0.203125 -0.234375 -9182.91 -9182.91 -9182.91 -0.109375 -0.203125 -0.203125 -3168.54 -3168.54 -3168.54 -0.078125 -0.234375 -0.171875 5509.25 5509.25 5509.25 -0.078125 -0.203125 -0.171875 819.836 819.836 819.836 -0.078125 -0.203125 -0.140625 1718.01 1718.01 1718.01 -0.109375 -0.234375 -0.171875 1829.66 1829.66 1829.66 -0.109375 -0.203125 -0.171875 -430.545 -430.545 -430.545 -0.109375 -0.203125 -0.140625 -1507.14 -1507.14 -1507.14 -0.078125 -0.171875 -0.234375 383.693 383.693 383.693 -0.078125 -0.171875 -0.203125 61.6781 61.6781 61.6781 -0.078125 -0.140625 -0.234375 -814.701 -814.701 -814.701 -0.078125 -0.140625 -0.203125 -496.801 -496.801 -496.801 -0.109375 -0.171875 -0.234375 -322.83 -322.83 -322.83 -0.109375 -0.171875 -0.203125 1146.98 1146.98 1146.98 -0.109375 -0.140625 -0.234375 767.14 767.14 767.14 -0.109375 -0.140625 -0.203125 -1081.47 -1081.47 -1081.47 -0.078125 -0.171875 -0.171875 613.813 613.813 613.813 -0.078125 -0.140625 -0.171875 413.361 413.361 413.361 -0.109375 -0.171875 -0.171875 968.127 968.127 968.127 -0.109375 -0.171875 -0.140625 -3.87598 -3.87598 -3.87598 -0.109375 -0.140625 -0.171875 1123.42 1123.42 1123.42 -0.109375 -0.140625 -0.140625 -868.933 -868.933 -868.933 -0.015625 -0.203125 -0.109375 -284.329 -284.329 -284.329 -0.015625 -0.203125 -0.078125 -278.85 -278.85 -278.85 -0.046875 -0.203125 -0.109375 1170.84 1170.84 1170.84 -0.015625 -0.171875 -0.078125 -411.11 -411.11 -411.11 -0.015625 -0.140625 -0.078125 -95.9725 -95.9725 -95.9725 -0.046875 -0.171875 -0.109375 2251.32 2251.32 2251.32 -0.046875 -0.171875 -0.078125 -1492.66 -1492.66 -1492.66 -0.046875 -0.140625 -0.078125 68.2282 68.2282 68.2282 -0.015625 -0.171875 -0.046875 -29.4381 -29.4381 -29.4381 -0.015625 -0.171875 -0.015625 -180.675 -180.675 -180.675 -0.015625 -0.140625 -0.046875 -517.955 -517.955 -517.955 -0.015625 -0.140625 -0.015625 -338.178 -338.178 -338.178 -0.078125 -0.203125 -0.109375 -2003.45 -2003.45 -2003.45 -0.078125 -0.203125 -0.078125 -166.448 -166.448 -166.448 -0.109375 -0.203125 -0.109375 158.459 158.459 158.459 -0.109375 -0.203125 -0.078125 -573.051 -573.051 -573.051 -0.078125 -0.171875 -0.078125 835.293 835.293 835.293 -0.078125 -0.140625 -0.078125 -259.191 -259.191 -259.191 -0.109375 -0.171875 -0.109375 -1153.59 -1153.59 -1153.59 -0.109375 -0.171875 -0.078125 -693.928 -693.928 -693.928 -0.109375 -0.140625 -0.109375 229.849 229.849 229.849 -0.109375 -0.140625 -0.078125 385.68 385.68 385.68 -0.015625 -0.109375 -0.234375 217.107 217.107 217.107 -0.015625 -0.109375 -0.203125 97.3234 97.3234 97.3234 -0.015625 -0.078125 -0.234375 -67.8506 -67.8506 -67.8506 -0.015625 -0.078125 -0.203125 -41.2612 -41.2612 -41.2612 -0.046875 -0.109375 -0.234375 1547.35 1547.35 1547.35 -0.046875 -0.109375 -0.203125 864.184 864.184 864.184 -0.046875 -0.078125 -0.203125 1103.59 1103.59 1103.59 -0.015625 -0.109375 -0.171875 -598.025 -598.025 -598.025 -0.015625 -0.046875 -0.203125 32.4868 32.4868 32.4868 -0.015625 -0.015625 -0.234375 -11.0442 -11.0442 -11.0442 -0.015625 -0.015625 -0.203125 2.7092 2.7092 2.7092 -0.046875 -0.046875 -0.203125 -173.624 -173.624 -173.624 -0.046875 -0.015625 -0.234375 -2.34684 -2.34684 -2.34684 -0.046875 -0.015625 -0.203125 -5.94834 -5.94834 -5.94834 -0.015625 -0.015625 -0.171875 7.10234 7.10234 7.10234 -0.046875 -0.046875 -0.171875 -264.698 -264.698 -264.698 -0.046875 -0.015625 -0.171875 12.3187 12.3187 12.3187 -0.078125 -0.109375 -0.234375 -1320.24 -1320.24 -1320.24 -0.078125 -0.109375 -0.203125 1148.73 1148.73 1148.73 -0.078125 -0.078125 -0.234375 -1655.77 -1655.77 -1655.77 -0.078125 -0.078125 -0.203125 1117.91 1117.91 1117.91 -0.109375 -0.078125 -0.234375 1430.18 1430.18 1430.18 -0.109375 -0.109375 -0.171875 316.871 316.871 316.871 -0.109375 -0.109375 -0.140625 -666.4 -666.4 -666.4 -0.109375 -0.078125 -0.140625 -637.909 -637.909 -637.909 -0.078125 -0.046875 -0.234375 -2305.38 -2305.38 -2305.38 -0.078125 -0.046875 -0.203125 -296.982 -296.982 -296.982 -0.078125 -0.015625 -0.234375 -38.5163 -38.5163 -38.5163 -0.078125 -0.015625 -0.203125 -0.160862 -0.160862 -0.160862 -0.109375 -0.046875 -0.234375 611.9 611.9 611.9 -0.109375 -0.046875 -0.203125 -3339.19 -3339.19 -3339.19 -0.109375 -0.015625 -0.203125 132.512 132.512 132.512 -0.078125 -0.046875 -0.171875 -73.4462 -73.4462 -73.4462 -0.078125 -0.046875 -0.140625 -302.924 -302.924 -302.924 -0.078125 -0.015625 -0.171875 -72.2712 -72.2712 -72.2712 -0.078125 -0.015625 -0.140625 64.6683 64.6683 64.6683 -0.109375 -0.046875 -0.171875 -71.5679 -71.5679 -71.5679 -0.109375 -0.015625 -0.171875 38.6984 38.6984 38.6984 -0.109375 -0.015625 -0.140625 -12.9186 -12.9186 -12.9186 -0.015625 -0.109375 -0.109375 283.974 283.974 283.974 -0.015625 -0.109375 -0.078125 -187.029 -187.029 -187.029 -0.015625 -0.078125 -0.109375 -82.4036 -82.4036 -82.4036 -0.015625 -0.078125 -0.078125 -107.206 -107.206 -107.206 -0.046875 -0.109375 -0.078125 336.582 336.582 336.582 -0.046875 -0.078125 -0.109375 479.281 479.281 479.281 -0.046875 -0.078125 -0.078125 710.147 710.147 710.147 -0.015625 -0.109375 -0.046875 -62.879 -62.879 -62.879 -0.015625 -0.109375 -0.015625 23.8602 23.8602 23.8602 -0.015625 -0.078125 -0.046875 -57.1358 -57.1358 -57.1358 -0.046875 -0.109375 -0.046875 -361.791 -361.791 -361.791 -0.046875 -0.109375 -0.015625 -7830.71 -7830.71 -7830.71 -0.046875 -0.078125 -0.046875 -5804.31 -5804.31 -5804.31 -0.046875 -0.078125 -0.015625 -5521.73 -5521.73 -5521.73 -0.015625 -0.046875 -0.109375 -116.395 -116.395 -116.395 -0.015625 -0.046875 -0.078125 1.9373 1.9373 1.9373 -0.015625 -0.015625 -0.109375 19.3599 19.3599 19.3599 -0.015625 -0.015625 -0.078125 -63.8638 -63.8638 -63.8638 -0.046875 -0.046875 -0.109375 666.955 666.955 666.955 -0.046875 -0.046875 -0.078125 673.414 673.414 673.414 -0.046875 -0.015625 -0.109375 -105.486 -105.486 -105.486 -0.046875 -0.015625 -0.078125 -94.2252 -94.2252 -94.2252 -0.015625 -0.046875 -0.046875 -37.0898 -37.0898 -37.0898 -0.046875 -0.046875 -0.046875 3709.66 3709.66 3709.66 -0.046875 -0.046875 -0.015625 -3530.07 -3530.07 -3530.07 -0.078125 -0.109375 -0.109375 -313.366 -313.366 -313.366 -0.078125 -0.109375 -0.078125 -1162.82 -1162.82 -1162.82 -0.078125 -0.078125 -0.109375 -396.483 -396.483 -396.483 -0.078125 -0.078125 -0.078125 -263.237 -263.237 -263.237 -0.109375 -0.109375 -0.109375 -969.564 -969.564 -969.564 -0.109375 -0.109375 -0.078125 -159.233 -159.233 -159.233 -0.109375 -0.078125 -0.109375 -82.6766 -82.6766 -82.6766 -0.109375 -0.078125 -0.078125 1254.2 1254.2 1254.2 -0.078125 -0.078125 -0.046875 9257.24 9257.24 9257.24 -0.078125 -0.078125 -0.015625 -2609.32 -2609.32 -2609.32 -0.078125 -0.046875 -0.109375 -119.186 -119.186 -119.186 -0.078125 -0.046875 -0.078125 264.76 264.76 264.76 -0.078125 -0.015625 -0.109375 -20.0455 -20.0455 -20.0455 -0.078125 -0.015625 -0.078125 -87.3831 -87.3831 -87.3831 -0.109375 -0.046875 -0.109375 -487.837 -487.837 -487.837 -0.109375 -0.046875 -0.078125 -439.414 -439.414 -439.414 -0.078125 -0.046875 -0.046875 4243.92 4243.92 4243.92 -0.078125 -0.046875 -0.015625 9033.56 9033.56 9033.56 -0.078125 -0.015625 -0.046875 -41.1782 -41.1782 -41.1782 -0.078125 -0.015625 -0.015625 34.8696 34.8696 34.8696 -0.109375 -0.046875 -0.046875 -1147.26 -1147.26 -1147.26 -0.109375 -0.015625 -0.046875 -15.1856 -15.1856 -15.1856 -0.109375 -0.015625 -0.015625 20.1815 20.1815 20.1815 -0.140625 -0.234375 -0.234375 -341.381 -341.381 -341.381 -0.140625 -0.234375 -0.203125 -46.4854 -46.4854 -46.4854 -0.140625 -0.203125 -0.234375 4684.85 4684.85 4684.85 -0.140625 -0.203125 -0.140625 -3379.46 -3379.46 -3379.46 -0.140625 -0.171875 -0.234375 399.814 399.814 399.814 -0.140625 -0.171875 -0.203125 3797.93 3797.93 3797.93 -0.140625 -0.140625 -0.234375 5624.86 5624.86 5624.86 -0.140625 -0.140625 -0.203125 1956.04 1956.04 1956.04 -0.171875 -0.140625 -0.203125 988.797 988.797 988.797 -0.140625 -0.171875 -0.171875 1918.83 1918.83 1918.83 -0.140625 -0.171875 -0.140625 -2892.18 -2892.18 -2892.18 -0.140625 -0.140625 -0.171875 1041.55 1041.55 1041.55 -0.140625 -0.140625 -0.140625 -3246.96 -3246.96 -3246.96 -0.171875 -0.140625 -0.171875 -379.387 -379.387 -379.387 -0.171875 -0.140625 -0.140625 -1353.46 -1353.46 -1353.46 -0.203125 -0.140625 -0.171875 -58.6957 -58.6957 -58.6957 -0.203125 -0.140625 -0.140625 -25219.5 -25219.5 -25219.5 -0.140625 -0.203125 -0.109375 837.303 837.303 837.303 -0.140625 -0.171875 -0.109375 711.548 711.548 711.548 -0.140625 -0.171875 -0.078125 2705.07 2705.07 2705.07 -0.140625 -0.140625 -0.109375 252.189 252.189 252.189 -0.140625 -0.140625 -0.078125 1496.15 1496.15 1496.15 -0.140625 -0.109375 -0.234375 4208.85 4208.85 4208.85 -0.140625 -0.078125 -0.234375 -2119.07 -2119.07 -2119.07 -0.171875 -0.109375 -0.234375 -1317.3 -1317.3 -1317.3 -0.171875 -0.109375 -0.203125 -4495.33 -4495.33 -4495.33 -0.171875 -0.078125 -0.234375 -1817.58 -1817.58 -1817.58 -0.140625 -0.109375 -0.171875 81.0002 81.0002 81.0002 -0.140625 -0.109375 -0.140625 -643.505 -643.505 -643.505 -0.140625 -0.078125 -0.140625 -334.248 -334.248 -334.248 -0.171875 -0.109375 -0.171875 -229.705 -229.705 -229.705 -0.171875 -0.109375 -0.140625 -684.032 -684.032 -684.032 -0.140625 -0.046875 -0.234375 370.952 370.952 370.952 -0.171875 -0.046875 -0.234375 -568.577 -568.577 -568.577 -0.140625 -0.046875 -0.171875 -109.582 -109.582 -109.582 -0.140625 -0.046875 -0.140625 -88.5296 -88.5296 -88.5296 -0.140625 -0.015625 -0.171875 -83.3597 -83.3597 -83.3597 -0.140625 -0.015625 -0.140625 -42.5033 -42.5033 -42.5033 -0.171875 -0.046875 -0.140625 -638.747 -638.747 -638.747 -0.171875 -0.015625 -0.140625 -59.311 -59.311 -59.311 -0.203125 -0.109375 -0.234375 -1161.89 -1161.89 -1161.89 -0.203125 -0.109375 -0.203125 -2611.65 -2611.65 -2611.65 -0.203125 -0.078125 -0.234375 -2826.86 -2826.86 -2826.86 -0.203125 -0.078125 -0.203125 -1072.1 -1072.1 -1072.1 -0.234375 -0.109375 -0.203125 -475.13 -475.13 -475.13 -0.234375 -0.078125 -0.203125 -787.723 -787.723 -787.723 -0.203125 -0.109375 -0.171875 104.908 104.908 104.908 -0.203125 -0.109375 -0.140625 -14785.4 -14785.4 -14785.4 -0.234375 -0.109375 -0.171875 48.4683 48.4683 48.4683 -0.234375 -0.109375 -0.140625 -21561.1 -21561.1 -21561.1 -0.234375 -0.078125 -0.171875 78.8796 78.8796 78.8796 -0.234375 -0.078125 -0.140625 459.46 459.46 459.46 -0.203125 -0.046875 -0.234375 -1004.15 -1004.15 -1004.15 -0.203125 -0.046875 -0.203125 -489.697 -489.697 -489.697 -0.203125 -0.015625 -0.234375 5.49085 5.49085 5.49085 -0.203125 -0.015625 -0.203125 -82.9121 -82.9121 -82.9121 -0.234375 -0.046875 -0.203125 -5.63544 -5.63544 -5.63544 -0.234375 -0.015625 -0.234375 -11.4859 -11.4859 -11.4859 -0.234375 -0.015625 -0.203125 12.4909 12.4909 12.4909 -0.203125 -0.015625 -0.140625 19.6372 19.6372 19.6372 -0.234375 -0.046875 -0.140625 -168.805 -168.805 -168.805 -0.234375 -0.015625 -0.171875 26.5649 26.5649 26.5649 -0.234375 -0.015625 -0.140625 -101.264 -101.264 -101.264 -0.140625 -0.109375 -0.109375 -116.898 -116.898 -116.898 -0.140625 -0.078125 -0.109375 404.139 404.139 404.139 -0.140625 -0.078125 -0.078125 -434.402 -434.402 -434.402 -0.171875 -0.109375 -0.109375 -1354.4 -1354.4 -1354.4 -0.171875 -0.078125 -0.109375 -433.99 -433.99 -433.99 -0.140625 -0.046875 -0.109375 471.726 471.726 471.726 -0.140625 -0.046875 -0.078125 31.9449 31.9449 31.9449 -0.140625 -0.015625 -0.109375 -60.6841 -60.6841 -60.6841 -0.140625 -0.015625 -0.078125 56.0382 56.0382 56.0382 -0.171875 -0.046875 -0.109375 669.822 669.822 669.822 -0.171875 -0.046875 -0.078125 -516.968 -516.968 -516.968 -0.171875 -0.015625 -0.109375 166.161 166.161 166.161 -0.171875 -0.015625 -0.078125 -123.232 -123.232 -123.232 -0.140625 -0.046875 -0.046875 239.787 239.787 239.787 -0.140625 -0.015625 -0.046875 58.6726 58.6726 58.6726 -0.140625 -0.015625 -0.015625 708.115 708.115 708.115 -0.203125 -0.109375 -0.109375 26202.1 26202.1 26202.1 -0.203125 -0.078125 -0.109375 24916.2 24916.2 24916.2 -0.234375 -0.078125 -0.109375 22917.8 22917.8 22917.8 -0.203125 -0.046875 -0.109375 332.696 332.696 332.696 -0.203125 -0.015625 -0.109375 245.536 245.536 245.536 -0.234375 -0.046875 -0.109375 344.881 344.881 344.881 -0.234375 -0.015625 -0.109375 268.154 268.154 268.154 -0.265625 -0.078125 -0.203125 -445.498 -445.498 -445.498 -0.265625 -0.078125 -0.171875 35.7856 35.7856 35.7856 -0.265625 -0.078125 -0.140625 -14559.7 -14559.7 -14559.7 -0.265625 -0.046875 -0.203125 99.2274 99.2274 99.2274 -0.265625 -0.015625 -0.203125 -29.2536 -29.2536 -29.2536 -0.265625 -0.046875 -0.171875 -91.9008 -91.9008 -91.9008 -0.265625 -0.046875 -0.140625 -421.055 -421.055 -421.055 -0.265625 -0.015625 -0.171875 49.9525 49.9525 49.9525 -0.265625 -0.015625 -0.140625 -185.042 -185.042 -185.042 -0.265625 -0.046875 -0.109375 469.873 469.873 469.873 -0.265625 -0.015625 -0.109375 -359.317 -359.317 -359.317 -0.015625 -0.265625 0.109375 135.769 135.769 135.769 -0.046875 -0.265625 0.109375 -345.347 -345.347 -345.347 -0.015625 -0.265625 0.140625 -78.7379 -78.7379 -78.7379 -0.015625 -0.265625 0.171875 -69.0739 -69.0739 -69.0739 -0.046875 -0.265625 0.140625 -224.81 -224.81 -224.81 -0.015625 -0.265625 0.203125 83.4406 83.4406 83.4406 -0.015625 -0.234375 0.078125 -34.2127 -34.2127 -34.2127 -0.015625 -0.234375 0.109375 -27.3734 -27.3734 -27.3734 -0.015625 -0.203125 0.078125 145.899 145.899 145.899 -0.015625 -0.203125 0.109375 111.605 111.605 111.605 -0.046875 -0.234375 0.109375 -67.0929 -67.0929 -67.0929 -0.046875 -0.203125 0.109375 60.7618 60.7618 60.7618 -0.015625 -0.171875 0.015625 277.117 277.117 277.117 -0.015625 -0.171875 0.046875 58.1839 58.1839 58.1839 -0.015625 -0.140625 0.015625 290.646 290.646 290.646 -0.015625 -0.140625 0.046875 -176.328 -176.328 -176.328 -0.015625 -0.171875 0.078125 39.3245 39.3245 39.3245 -0.015625 -0.171875 0.109375 242.699 242.699 242.699 -0.015625 -0.140625 0.109375 70.1664 70.1664 70.1664 -0.046875 -0.171875 0.109375 171.233 171.233 171.233 -0.078125 -0.234375 0.109375 130.765 130.765 130.765 -0.078125 -0.203125 0.109375 -10.0573 -10.0573 -10.0573 -0.015625 -0.234375 0.140625 -144.216 -144.216 -144.216 -0.015625 -0.234375 0.171875 110.033 110.033 110.033 -0.046875 -0.234375 0.140625 -141.261 -141.261 -141.261 -0.046875 -0.234375 0.171875 100.661 100.661 100.661 -0.046875 -0.203125 0.140625 -297.805 -297.805 -297.805 -0.046875 -0.203125 0.171875 284.253 284.253 284.253 -0.015625 -0.234375 0.203125 95.7119 95.7119 95.7119 -0.015625 -0.234375 0.234375 38.9157 38.9157 38.9157 -0.015625 -0.203125 0.203125 140.415 140.415 140.415 -0.015625 -0.203125 0.234375 -199.598 -199.598 -199.598 -0.046875 -0.234375 0.203125 -303.715 -303.715 -303.715 -0.046875 -0.203125 0.203125 -426.865 -426.865 -426.865 -0.046875 -0.203125 0.234375 -35.3105 -35.3105 -35.3105 -0.015625 -0.171875 0.140625 -9.83951 -9.83951 -9.83951 -0.015625 -0.140625 0.140625 212.348 212.348 212.348 -0.015625 -0.140625 0.171875 -96.4489 -96.4489 -96.4489 -0.046875 -0.171875 0.140625 34.6256 34.6256 34.6256 -0.046875 -0.171875 0.171875 259.317 259.317 259.317 -0.046875 -0.140625 0.140625 224.274 224.274 224.274 -0.046875 -0.140625 0.171875 179.603 179.603 179.603 -0.046875 -0.171875 0.203125 -239.461 -239.461 -239.461 -0.046875 -0.171875 0.234375 39.6422 39.6422 39.6422 -0.046875 -0.140625 0.203125 -35.212 -35.212 -35.212 -0.046875 -0.140625 0.234375 -15.0952 -15.0952 -15.0952 -0.078125 -0.234375 0.140625 -812.013 -812.013 -812.013 -0.078125 -0.203125 0.140625 772.296 772.296 772.296 -0.078125 -0.171875 0.234375 50.7705 50.7705 50.7705 -0.078125 -0.140625 0.234375 -11.6209 -11.6209 -11.6209 -0.015625 -0.109375 0.015625 282.067 282.067 282.067 -0.015625 -0.109375 0.046875 -359.441 -359.441 -359.441 -0.015625 -0.078125 0.046875 -159.384 -159.384 -159.384 -0.046875 -0.109375 0.015625 3811.48 3811.48 3811.48 -0.046875 -0.109375 0.046875 -304.725 -304.725 -304.725 -0.046875 -0.078125 0.015625 -5092.59 -5092.59 -5092.59 -0.046875 -0.078125 0.046875 -845.327 -845.327 -845.327 -0.015625 -0.109375 0.109375 -200.376 -200.376 -200.376 -0.015625 -0.078125 0.078125 194.228 194.228 194.228 -0.015625 -0.078125 0.109375 -176.145 -176.145 -176.145 -0.046875 -0.109375 0.109375 45.9033 45.9033 45.9033 -0.046875 -0.078125 0.078125 578.194 578.194 578.194 -0.046875 -0.078125 0.109375 191.736 191.736 191.736 -0.015625 -0.046875 0.015625 46.1154 46.1154 46.1154 -0.015625 -0.046875 0.046875 -62.4867 -62.4867 -62.4867 -0.015625 -0.015625 0.015625 75.6183 75.6183 75.6183 -0.046875 -0.046875 0.015625 -4042.05 -4042.05 -4042.05 -0.046875 -0.046875 0.046875 195.533 195.533 195.533 -0.046875 -0.015625 0.015625 60.72 60.72 60.72 -0.046875 -0.015625 0.046875 -19.7949 -19.7949 -19.7949 -0.015625 -0.046875 0.078125 -53.4268 -53.4268 -53.4268 -0.015625 -0.046875 0.109375 -54.5918 -54.5918 -54.5918 -0.015625 -0.015625 0.078125 12.332 12.332 12.332 -0.015625 -0.015625 0.109375 21.3398 21.3398 21.3398 -0.046875 -0.046875 0.078125 -279.008 -279.008 -279.008 -0.046875 -0.046875 0.109375 -29.4739 -29.4739 -29.4739 -0.046875 -0.015625 0.078125 -3.9502 -3.9502 -3.9502 -0.046875 -0.015625 0.109375 118.931 118.931 118.931 -0.078125 -0.078125 0.015625 28.5096 28.5096 28.5096 -0.078125 -0.046875 0.015625 6219.27 6219.27 6219.27 -0.078125 -0.015625 0.015625 -26.4912 -26.4912 -26.4912 -0.078125 -0.015625 0.046875 -17.6547 -17.6547 -17.6547 -0.109375 -0.015625 0.015625 -53.8549 -53.8549 -53.8549 -0.109375 -0.015625 0.046875 -170.433 -170.433 -170.433 -0.078125 -0.015625 0.078125 90.2731 90.2731 90.2731 -0.109375 -0.015625 0.078125 79.4623 79.4623 79.4623 -0.015625 -0.109375 0.140625 147.009 147.009 147.009 -0.015625 -0.109375 0.171875 99.1705 99.1705 99.1705 -0.015625 -0.078125 0.171875 -30.9165 -30.9165 -30.9165 -0.046875 -0.109375 0.140625 78.6265 78.6265 78.6265 -0.046875 -0.109375 0.171875 68.3182 68.3182 68.3182 -0.046875 -0.078125 0.140625 75.3732 75.3732 75.3732 -0.046875 -0.078125 0.171875 92.0614 92.0614 92.0614 -0.015625 -0.109375 0.203125 117.214 117.214 117.214 -0.015625 -0.109375 0.234375 40.7372 40.7372 40.7372 -0.015625 -0.078125 0.234375 -182.491 -182.491 -182.491 -0.046875 -0.109375 0.203125 -169.138 -169.138 -169.138 -0.046875 -0.109375 0.234375 -137.768 -137.768 -137.768 -0.046875 -0.078125 0.234375 46.0702 46.0702 46.0702 -0.015625 -0.046875 0.171875 -28.8302 -28.8302 -28.8302 -0.015625 -0.015625 0.140625 210.963 210.963 210.963 -0.015625 -0.015625 0.171875 258.038 258.038 258.038 -0.046875 -0.046875 0.140625 1.46737 1.46737 1.46737 -0.046875 -0.046875 0.171875 23.4726 23.4726 23.4726 -0.046875 -0.015625 0.140625 143.249 143.249 143.249 -0.046875 -0.015625 0.171875 41.8579 41.8579 41.8579 -0.015625 -0.046875 0.203125 -10.2309 -10.2309 -10.2309 -0.015625 -0.046875 0.234375 -47.2769 -47.2769 -47.2769 -0.015625 -0.015625 0.203125 127.532 127.532 127.532 -0.015625 -0.015625 0.234375 -107.606 -107.606 -107.606 -0.046875 -0.046875 0.234375 289.451 289.451 289.451 -0.046875 -0.015625 0.234375 39.0964 39.0964 39.0964 -0.078125 -0.109375 0.234375 -25.9519 -25.9519 -25.9519 -0.078125 -0.078125 0.234375 55.9242 55.9242 55.9242 -0.140625 -0.015625 0.015625 144.828 144.828 144.828 -0.140625 -0.015625 0.046875 126.037 126.037 126.037 -0.171875 -0.015625 0.015625 -1149.91 -1149.91 -1149.91 -0.171875 -0.015625 0.046875 -171.579 -171.579 -171.579 -0.140625 -0.015625 0.078125 11.9971 11.9971 11.9971 -0.015625 -0.203125 0.265625 53.5395 53.5395 53.5395 -0.015625 -0.203125 0.296875 136.951 136.951 136.951 -0.046875 -0.203125 0.265625 32.7807 32.7807 32.7807 -0.015625 -0.171875 0.265625 152.78 152.78 152.78 -0.015625 -0.171875 0.296875 86.1086 86.1086 86.1086 -0.046875 -0.171875 0.265625 1.68456 1.68456 1.68456 -0.046875 -0.171875 0.296875 31.2466 31.2466 31.2466 -0.046875 -0.140625 0.296875 29.061 29.061 29.061 -0.015625 -0.171875 0.328125 348.636 348.636 348.636 -0.015625 -0.140625 0.328125 -129.974 -129.974 -129.974 -0.015625 -0.140625 0.359375 261.564 261.564 261.564 -0.046875 -0.171875 0.328125 -213.396 -213.396 -213.396 -0.046875 -0.171875 0.359375 197.026 197.026 197.026 -0.046875 -0.140625 0.328125 899.367 899.367 899.367 -0.046875 -0.140625 0.359375 99.8373 99.8373 99.8373 -0.078125 -0.171875 0.265625 22.8307 22.8307 22.8307 -0.078125 -0.140625 0.265625 34.1642 34.1642 34.1642 -0.078125 -0.140625 0.296875 23.8464 23.8464 23.8464 -0.109375 -0.140625 0.296875 29.1723 29.1723 29.1723 -0.078125 -0.171875 0.328125 -186.837 -186.837 -186.837 -0.078125 -0.171875 0.359375 -330.312 -330.312 -330.312 -0.078125 -0.140625 0.328125 -598.636 -598.636 -598.636 -0.078125 -0.140625 0.359375 -479.145 -479.145 -479.145 -0.109375 -0.171875 0.328125 14.9003 14.9003 14.9003 -0.109375 -0.171875 0.359375 22.4034 22.4034 22.4034 -0.109375 -0.140625 0.328125 -56.0105 -56.0105 -56.0105 -0.109375 -0.140625 0.359375 89.8047 89.8047 89.8047 -0.046875 -0.140625 0.390625 130.368 130.368 130.368 -0.078125 -0.140625 0.390625 -32.0927 -32.0927 -32.0927 -0.109375 -0.140625 0.390625 105.412 105.412 105.412 -0.015625 -0.078125 0.265625 -109.151 -109.151 -109.151 -0.015625 -0.078125 0.296875 -92.4259 -92.4259 -92.4259 -0.046875 -0.078125 0.265625 -81.8991 -81.8991 -81.8991 -0.046875 -0.078125 0.296875 17.2494 17.2494 17.2494 -0.015625 -0.109375 0.359375 20.4602 20.4602 20.4602 -0.015625 -0.078125 0.328125 15.8828 15.8828 15.8828 -0.015625 -0.078125 0.359375 -54.7462 -54.7462 -54.7462 -0.046875 -0.109375 0.359375 -13.6319 -13.6319 -13.6319 -0.046875 -0.078125 0.359375 -245.676 -245.676 -245.676 -0.015625 -0.046875 0.265625 196.39 196.39 196.39 -0.015625 -0.046875 0.296875 165.026 165.026 165.026 -0.015625 -0.015625 0.296875 -36.4224 -36.4224 -36.4224 -0.046875 -0.046875 0.265625 -59.4053 -59.4053 -59.4053 -0.046875 -0.046875 0.296875 -53.5953 -53.5953 -53.5953 -0.046875 -0.015625 0.265625 112.969 112.969 112.969 -0.046875 -0.015625 0.296875 18.5608 18.5608 18.5608 -0.015625 -0.046875 0.328125 421.192 421.192 421.192 -0.015625 -0.046875 0.359375 -359.413 -359.413 -359.413 -0.015625 -0.015625 0.328125 293.082 293.082 293.082 -0.046875 -0.046875 0.328125 -187.534 -187.534 -187.534 -0.046875 -0.046875 0.359375 -103.27 -103.27 -103.27 -0.078125 -0.109375 0.265625 50.3659 50.3659 50.3659 -0.078125 -0.109375 0.296875 12.2544 12.2544 12.2544 -0.078125 -0.078125 0.265625 21.7247 21.7247 21.7247 -0.078125 -0.078125 0.296875 -140.832 -140.832 -140.832 -0.109375 -0.109375 0.296875 -12.1603 -12.1603 -12.1603 -0.109375 -0.078125 0.296875 -109.615 -109.615 -109.615 -0.078125 -0.078125 0.359375 6.26168 6.26168 6.26168 -0.109375 -0.109375 0.328125 42.2397 42.2397 42.2397 -0.109375 -0.109375 0.359375 68.7672 68.7672 68.7672 -0.109375 -0.078125 0.328125 191.975 191.975 191.975 -0.109375 -0.078125 0.359375 175.245 175.245 175.245 -0.078125 -0.046875 0.296875 -39.4896 -39.4896 -39.4896 -0.078125 -0.046875 0.328125 223.081 223.081 223.081 -0.078125 -0.046875 0.359375 -17.515 -17.515 -17.515 -0.109375 -0.046875 0.328125 -149.502 -149.502 -149.502 -0.109375 -0.046875 0.359375 -361.641 -361.641 -361.641 -0.046875 -0.109375 0.390625 12.6055 12.6055 12.6055 -0.046875 -0.078125 0.390625 31.5191 31.5191 31.5191 -0.078125 -0.109375 0.390625 -24.5376 -24.5376 -24.5376 -0.078125 -0.078125 0.390625 -45.0773 -45.0773 -45.0773 -0.109375 -0.109375 0.390625 -83.2409 -83.2409 -83.2409 -0.109375 -0.078125 0.390625 115.006 115.006 115.006 -0.140625 -0.140625 0.328125 -95.5286 -95.5286 -95.5286 -0.140625 -0.140625 0.359375 -76.3091 -76.3091 -76.3091 -0.140625 -0.109375 0.328125 -105.242 -105.242 -105.242 -0.140625 -0.109375 0.359375 -172.958 -172.958 -172.958 -0.140625 -0.078125 0.328125 -65.5197 -65.5197 -65.5197 -0.140625 -0.078125 0.359375 -65.0803 -65.0803 -65.0803 -0.015625 0.046875 -0.453125 -134.687 -134.687 -134.687 -0.015625 0.015625 -0.421875 -39.1494 -39.1494 -39.1494 -0.015625 0.015625 -0.390625 91.9193 91.9193 91.9193 -0.015625 0.046875 -0.421875 -387.946 -387.946 -387.946 -0.046875 0.015625 -0.390625 90.6043 90.6043 90.6043 -0.046875 0.046875 -0.421875 -503.452 -503.452 -503.452 -0.046875 0.046875 -0.390625 -279.352 -279.352 -279.352 -0.015625 0.078125 -0.453125 146.123 146.123 146.123 -0.015625 0.109375 -0.453125 -235.147 -235.147 -235.147 -0.015625 0.078125 -0.421875 207.114 207.114 207.114 -0.015625 0.078125 -0.390625 273.052 273.052 273.052 -0.015625 0.109375 -0.421875 103.351 103.351 103.351 -0.015625 0.109375 -0.390625 225.182 225.182 225.182 -0.046875 0.078125 -0.390625 258.912 258.912 258.912 -0.015625 0.015625 -0.359375 136.989 136.989 136.989 -0.015625 0.015625 -0.328125 16.5278 16.5278 16.5278 -0.015625 0.046875 -0.359375 -326.171 -326.171 -326.171 -0.015625 0.046875 -0.328125 -8.02802 -8.02802 -8.02802 -0.046875 0.015625 -0.359375 1.29148 1.29148 1.29148 -0.046875 0.015625 -0.328125 12.2089 12.2089 12.2089 -0.046875 0.046875 -0.359375 -148.783 -148.783 -148.783 -0.046875 0.046875 -0.328125 28.1145 28.1145 28.1145 -0.015625 0.046875 -0.265625 9.50978 9.50978 9.50978 -0.046875 0.015625 -0.296875 16.1328 16.1328 16.1328 -0.046875 0.015625 -0.265625 -4.65225 -4.65225 -4.65225 -0.046875 0.046875 -0.296875 5.39191 5.39191 5.39191 -0.046875 0.046875 -0.265625 -14.9445 -14.9445 -14.9445 -0.015625 0.078125 -0.359375 29.9483 29.9483 29.9483 -0.015625 0.078125 -0.328125 -1.53975 -1.53975 -1.53975 -0.015625 0.109375 -0.359375 0.40123 0.40123 0.40123 -0.015625 0.109375 -0.328125 24.1515 24.1515 24.1515 -0.046875 0.078125 -0.359375 -57.8566 -57.8566 -57.8566 -0.046875 0.078125 -0.328125 11.8645 11.8645 11.8645 -0.046875 0.109375 -0.359375 23.9225 23.9225 23.9225 -0.046875 0.109375 -0.328125 57.0701 57.0701 57.0701 -0.015625 0.078125 -0.296875 -11.3821 -11.3821 -11.3821 -0.015625 0.078125 -0.265625 3.12948 3.12948 3.12948 -0.015625 0.109375 -0.296875 17.1081 17.1081 17.1081 -0.015625 0.109375 -0.265625 -12.0337 -12.0337 -12.0337 -0.046875 0.078125 -0.296875 -10.305 -10.305 -10.305 -0.046875 0.078125 -0.265625 -17.1643 -17.1643 -17.1643 -0.046875 0.109375 -0.296875 52.0573 52.0573 52.0573 -0.046875 0.109375 -0.265625 27.0519 27.0519 27.0519 -0.078125 0.015625 -0.328125 49.5958 49.5958 49.5958 -0.078125 0.046875 -0.328125 -116.737 -116.737 -116.737 -0.109375 0.046875 -0.328125 280.618 280.618 280.618 -0.078125 0.015625 -0.296875 -76.3382 -76.3382 -76.3382 -0.078125 0.015625 -0.265625 -25.9581 -25.9581 -25.9581 -0.078125 0.046875 -0.296875 -207.771 -207.771 -207.771 -0.078125 0.046875 -0.265625 -84.6298 -84.6298 -84.6298 -0.109375 0.015625 -0.296875 157.187 157.187 157.187 -0.109375 0.015625 -0.265625 88.2401 88.2401 88.2401 -0.109375 0.046875 -0.296875 -104.011 -104.011 -104.011 -0.109375 0.046875 -0.265625 -47.5165 -47.5165 -47.5165 -0.078125 0.078125 -0.328125 21.4931 21.4931 21.4931 -0.078125 0.109375 -0.359375 -64.0299 -64.0299 -64.0299 -0.078125 0.109375 -0.328125 21.2611 21.2611 21.2611 -0.109375 0.078125 -0.328125 201.842 201.842 201.842 -0.109375 0.109375 -0.359375 30.9219 30.9219 30.9219 -0.109375 0.109375 -0.328125 -528.361 -528.361 -528.361 -0.078125 0.078125 -0.296875 142.519 142.519 142.519 -0.078125 0.078125 -0.265625 -1.5782 -1.5782 -1.5782 -0.078125 0.109375 -0.296875 93.527 93.527 93.527 -0.078125 0.109375 -0.265625 -166.166 -166.166 -166.166 -0.109375 0.078125 -0.296875 114.884 114.884 114.884 -0.109375 0.078125 -0.265625 72.7896 72.7896 72.7896 -0.109375 0.109375 -0.296875 -384.279 -384.279 -384.279 -0.109375 0.109375 -0.265625 -222.561 -222.561 -222.561 -0.015625 0.140625 -0.453125 21.7034 21.7034 21.7034 -0.015625 0.140625 -0.421875 -13.1641 -13.1641 -13.1641 -0.015625 0.140625 -0.390625 -151.305 -151.305 -151.305 -0.015625 0.171875 -0.421875 143.671 143.671 143.671 -0.015625 0.171875 -0.390625 55.5062 55.5062 55.5062 -0.046875 0.140625 -0.390625 -179.193 -179.193 -179.193 -0.046875 0.171875 -0.390625 38.9311 38.9311 38.9311 -0.015625 0.203125 -0.421875 -204.865 -204.865 -204.865 -0.015625 0.203125 -0.390625 -169.877 -169.877 -169.877 -0.015625 0.234375 -0.390625 216.063 216.063 216.063 -0.046875 0.203125 -0.390625 -175.039 -175.039 -175.039 -0.046875 0.234375 -0.390625 -144.261 -144.261 -144.261 -0.078125 0.140625 -0.390625 -37.8748 -37.8748 -37.8748 -0.078125 0.171875 -0.390625 -112.702 -112.702 -112.702 -0.109375 0.140625 -0.390625 89.7949 89.7949 89.7949 -0.109375 0.171875 -0.390625 -321.278 -321.278 -321.278 -0.015625 0.140625 -0.359375 20.8256 20.8256 20.8256 -0.015625 0.140625 -0.328125 44.9445 44.9445 44.9445 -0.015625 0.171875 -0.359375 229.322 229.322 229.322 -0.015625 0.171875 -0.328125 -40.6527 -40.6527 -40.6527 -0.046875 0.140625 -0.359375 -75.9858 -75.9858 -75.9858 -0.046875 0.140625 -0.328125 61.7148 61.7148 61.7148 -0.046875 0.171875 -0.359375 12.4557 12.4557 12.4557 -0.046875 0.140625 -0.265625 176.706 176.706 176.706 -0.046875 0.171875 -0.265625 -699.952 -699.952 -699.952 -0.015625 0.234375 -0.359375 -198.26 -198.26 -198.26 -0.015625 0.234375 -0.328125 -481.807 -481.807 -481.807 -0.046875 0.203125 -0.359375 -178.083 -178.083 -178.083 -0.046875 0.234375 -0.359375 192.314 192.314 192.314 -0.046875 0.234375 -0.328125 -168.104 -168.104 -168.104 -0.015625 0.203125 -0.296875 295.807 295.807 295.807 -0.015625 0.203125 -0.265625 358.623 358.623 358.623 -0.015625 0.234375 -0.296875 220.733 220.733 220.733 -0.015625 0.234375 -0.265625 -139.652 -139.652 -139.652 -0.046875 0.203125 -0.265625 270.01 270.01 270.01 -0.046875 0.234375 -0.296875 -280.657 -280.657 -280.657 -0.046875 0.234375 -0.265625 36.0598 36.0598 36.0598 -0.078125 0.140625 -0.359375 0.0163364 0.0163364 0.0163364 -0.078125 0.171875 -0.359375 25.0146 25.0146 25.0146 -0.109375 0.140625 -0.359375 43.7416 43.7416 43.7416 -0.109375 0.171875 -0.359375 -346.281 -346.281 -346.281 -0.078125 0.140625 -0.265625 -200.752 -200.752 -200.752 -0.078125 0.171875 -0.265625 -681.599 -681.599 -681.599 -0.109375 0.140625 -0.265625 -470.868 -470.868 -470.868 -0.109375 0.171875 -0.296875 -398.517 -398.517 -398.517 -0.109375 0.171875 -0.265625 -70.0097 -70.0097 -70.0097 -0.078125 0.203125 -0.359375 49.9959 49.9959 49.9959 -0.078125 0.203125 -0.328125 29.0362 29.0362 29.0362 -0.078125 0.234375 -0.359375 225.463 225.463 225.463 -0.078125 0.234375 -0.328125 161.23 161.23 161.23 -0.109375 0.203125 -0.359375 -637.395 -637.395 -637.395 -0.109375 0.203125 -0.328125 370.051 370.051 370.051 -0.078125 0.203125 -0.296875 1336.69 1336.69 1336.69 -0.078125 0.203125 -0.265625 643.642 643.642 643.642 -0.078125 0.234375 -0.296875 86.0018 86.0018 86.0018 -0.078125 0.234375 -0.265625 679.763 679.763 679.763 -0.109375 0.203125 -0.296875 441.737 441.737 441.737 -0.171875 0.109375 -0.390625 -4.2703 -4.2703 -4.2703 -0.203125 0.109375 -0.390625 2361.69 2361.69 2361.69 -0.234375 0.109375 -0.390625 -124.518 -124.518 -124.518 -0.140625 0.015625 -0.328125 -21.3372 -21.3372 -21.3372 -0.140625 0.046875 -0.328125 -18.0753 -18.0753 -18.0753 -0.171875 0.015625 -0.328125 0.506442 0.506442 0.506442 -0.171875 0.046875 -0.328125 38.6196 38.6196 38.6196 -0.140625 0.015625 -0.296875 -42.0918 -42.0918 -42.0918 -0.140625 0.046875 -0.296875 -231.331 -231.331 -231.331 -0.171875 0.015625 -0.296875 -0.376956 -0.376956 -0.376956 -0.171875 0.015625 -0.265625 26.2218 26.2218 26.2218 -0.171875 0.046875 -0.296875 20.7068 20.7068 20.7068 -0.140625 0.078125 -0.328125 134.312 134.312 134.312 -0.140625 0.109375 -0.359375 417.453 417.453 417.453 -0.140625 0.109375 -0.328125 -180.749 -180.749 -180.749 -0.171875 0.078125 -0.328125 32.5022 32.5022 32.5022 -0.171875 0.109375 -0.359375 -132.75 -132.75 -132.75 -0.171875 0.109375 -0.328125 92.4794 92.4794 92.4794 -0.140625 0.109375 -0.296875 136.899 136.899 136.899 -0.140625 0.109375 -0.265625 -272.187 -272.187 -272.187 -0.171875 0.078125 -0.296875 65.485 65.485 65.485 -0.171875 0.109375 -0.296875 23.82 23.82 23.82 -0.171875 0.109375 -0.265625 -713.435 -713.435 -713.435 -0.203125 0.046875 -0.328125 -111.611 -111.611 -111.611 -0.203125 0.015625 -0.296875 -7.97169 -7.97169 -7.97169 -0.203125 0.015625 -0.265625 14.426 14.426 14.426 -0.203125 0.046875 -0.296875 18.5294 18.5294 18.5294 -0.203125 0.046875 -0.265625 -33.418 -33.418 -33.418 -0.203125 0.078125 -0.359375 -48.0678 -48.0678 -48.0678 -0.203125 0.078125 -0.328125 -35.3074 -35.3074 -35.3074 -0.203125 0.109375 -0.359375 1596.94 1596.94 1596.94 -0.203125 0.109375 -0.328125 457.983 457.983 457.983 -0.234375 0.078125 -0.359375 128.478 128.478 128.478 -0.234375 0.078125 -0.328125 61.8229 61.8229 61.8229 -0.234375 0.109375 -0.359375 -330.706 -330.706 -330.706 -0.203125 0.078125 -0.296875 21.381 21.381 21.381 -0.203125 0.078125 -0.265625 34.9834 34.9834 34.9834 -0.203125 0.109375 -0.296875 59.7096 59.7096 59.7096 -0.203125 0.109375 -0.265625 336.674 336.674 336.674 -0.234375 0.078125 -0.296875 -35.848 -35.848 -35.848 -0.234375 0.078125 -0.265625 5.41989 5.41989 5.41989 -0.234375 0.109375 -0.296875 -90.6934 -90.6934 -90.6934 -0.234375 0.109375 -0.265625 -1055.86 -1055.86 -1055.86 -0.171875 0.140625 -0.390625 -409.178 -409.178 -409.178 -0.171875 0.171875 -0.390625 850.937 850.937 850.937 -0.203125 0.140625 -0.390625 1390.95 1390.95 1390.95 -0.203125 0.171875 -0.390625 3312.35 3312.35 3312.35 -0.234375 0.140625 -0.390625 -947.181 -947.181 -947.181 -0.234375 0.171875 -0.390625 1513.32 1513.32 1513.32 -0.140625 0.140625 -0.359375 548.2 548.2 548.2 -0.140625 0.140625 -0.328125 -15655.1 -15655.1 -15655.1 -0.140625 0.171875 -0.359375 -282.413 -282.413 -282.413 -0.140625 0.171875 -0.328125 -14200.3 -14200.3 -14200.3 -0.171875 0.140625 -0.359375 500.663 500.663 500.663 -0.171875 0.140625 -0.328125 17432.1 17432.1 17432.1 -0.171875 0.171875 -0.359375 332.704 332.704 332.704 -0.171875 0.171875 -0.328125 -14537.4 -14537.4 -14537.4 -0.140625 0.140625 -0.296875 7005.14 7005.14 7005.14 -0.140625 0.140625 -0.265625 4817.91 4817.91 4817.91 -0.140625 0.171875 -0.296875 -6597.84 -6597.84 -6597.84 -0.140625 0.171875 -0.265625 2793.3 2793.3 2793.3 -0.171875 0.140625 -0.296875 18942.3 18942.3 18942.3 -0.171875 0.171875 -0.296875 35501.5 35501.5 35501.5 -0.140625 0.203125 -0.359375 -557.013 -557.013 -557.013 -0.140625 0.203125 -0.328125 -18709.3 -18709.3 -18709.3 -0.140625 0.203125 -0.296875 -8413.91 -8413.91 -8413.91 -0.203125 0.171875 -0.359375 -470.829 -470.829 -470.829 -0.203125 0.171875 -0.328125 2470.18 2470.18 2470.18 -0.234375 0.140625 -0.359375 -2918.02 -2918.02 -2918.02 -0.234375 0.171875 -0.359375 -2942.92 -2942.92 -2942.92 -0.203125 0.140625 -0.296875 -5814.07 -5814.07 -5814.07 -0.203125 0.171875 -0.296875 -6279.22 -6279.22 -6279.22 -0.234375 0.140625 -0.296875 -2350.78 -2350.78 -2350.78 -0.234375 0.140625 -0.265625 986.598 986.598 986.598 -0.234375 0.171875 -0.296875 -974.577 -974.577 -974.577 -0.234375 0.171875 -0.265625 370.44 370.44 370.44 -0.203125 0.203125 -0.359375 1562.62 1562.62 1562.62 -0.203125 0.203125 -0.328125 969.308 969.308 969.308 -0.203125 0.234375 -0.359375 -2304.42 -2304.42 -2304.42 -0.203125 0.234375 -0.328125 4168.72 4168.72 4168.72 -0.234375 0.203125 -0.359375 313.69 313.69 313.69 -0.234375 0.234375 -0.359375 -4430.23 -4430.23 -4430.23 -0.234375 0.234375 -0.328125 3021.72 3021.72 3021.72 -0.203125 0.203125 -0.296875 15796.3 15796.3 15796.3 -0.203125 0.234375 -0.296875 5794.72 5794.72 5794.72 -0.234375 0.203125 -0.296875 -867.049 -867.049 -867.049 -0.234375 0.203125 -0.265625 -2618.88 -2618.88 -2618.88 -0.234375 0.234375 -0.296875 273.241 273.241 273.241 -0.015625 0.015625 -0.234375 -3.37417 -3.37417 -3.37417 -0.015625 0.015625 -0.203125 0.352195 0.352195 0.352195 -0.015625 0.046875 -0.234375 -9.03021 -9.03021 -9.03021 -0.015625 0.046875 -0.203125 -18.3278 -18.3278 -18.3278 -0.046875 0.015625 -0.234375 -5.38926 -5.38926 -5.38926 -0.046875 0.015625 -0.203125 0.844854 0.844854 0.844854 -0.046875 0.046875 -0.234375 -13.9624 -13.9624 -13.9624 -0.046875 0.046875 -0.203125 28.0294 28.0294 28.0294 -0.015625 0.015625 -0.171875 15.3247 15.3247 15.3247 -0.015625 0.015625 -0.140625 -25.2559 -25.2559 -25.2559 -0.015625 0.046875 -0.171875 -14.8301 -14.8301 -14.8301 -0.015625 0.046875 -0.140625 -16.4447 -16.4447 -16.4447 -0.046875 0.015625 -0.171875 -27.2574 -27.2574 -27.2574 -0.046875 0.015625 -0.140625 -15.7802 -15.7802 -15.7802 -0.046875 0.046875 -0.171875 -52.0846 -52.0846 -52.0846 -0.046875 0.046875 -0.140625 -51.2774 -51.2774 -51.2774 -0.015625 0.078125 -0.203125 -10.828 -10.828 -10.828 -0.015625 0.109375 -0.234375 8.19132 8.19132 8.19132 -0.015625 0.109375 -0.203125 -98.4802 -98.4802 -98.4802 -0.046875 0.078125 -0.234375 -31.6995 -31.6995 -31.6995 -0.046875 0.078125 -0.203125 10.4631 10.4631 10.4631 -0.046875 0.109375 -0.234375 39.5344 39.5344 39.5344 -0.046875 0.109375 -0.203125 -12.4583 -12.4583 -12.4583 -0.015625 0.078125 -0.171875 64.2726 64.2726 64.2726 -0.015625 0.078125 -0.140625 -6.78621 -6.78621 -6.78621 -0.015625 0.109375 -0.171875 -243.211 -243.211 -243.211 -0.015625 0.109375 -0.140625 -44.2674 -44.2674 -44.2674 -0.078125 0.015625 -0.234375 -37.1172 -37.1172 -37.1172 -0.078125 0.015625 -0.203125 -62.8122 -62.8122 -62.8122 -0.078125 0.046875 -0.234375 -117.094 -117.094 -117.094 -0.078125 0.046875 -0.203125 -14.9496 -14.9496 -14.9496 -0.109375 0.015625 -0.203125 109.381 109.381 109.381 -0.078125 0.015625 -0.171875 -83.217 -83.217 -83.217 -0.078125 0.015625 -0.140625 20.7608 20.7608 20.7608 -0.078125 0.046875 -0.140625 -49.6975 -49.6975 -49.6975 -0.109375 0.015625 -0.171875 107.962 107.962 107.962 -0.109375 0.015625 -0.140625 -47.3507 -47.3507 -47.3507 -0.109375 0.046875 -0.140625 -57.2333 -57.2333 -57.2333 -0.078125 0.078125 -0.234375 -9.52375 -9.52375 -9.52375 -0.078125 0.109375 -0.234375 -153.362 -153.362 -153.362 -0.078125 0.109375 -0.203125 -51.1148 -51.1148 -51.1148 -0.109375 0.109375 -0.234375 -367.622 -367.622 -367.622 -0.109375 0.109375 -0.203125 -17.7921 -17.7921 -17.7921 -0.078125 0.109375 -0.171875 -18.1885 -18.1885 -18.1885 -0.078125 0.109375 -0.140625 -13.3346 -13.3346 -13.3346 -0.109375 0.078125 -0.140625 -76.8455 -76.8455 -76.8455 -0.109375 0.109375 -0.171875 16.2053 16.2053 16.2053 -0.109375 0.109375 -0.140625 -29.0519 -29.0519 -29.0519 -0.015625 0.015625 -0.109375 -37.6119 -37.6119 -37.6119 -0.015625 0.015625 -0.078125 63.0404 63.0404 63.0404 -0.015625 0.046875 -0.109375 -27.3231 -27.3231 -27.3231 -0.015625 0.046875 -0.078125 0.464113 0.464113 0.464113 -0.046875 0.015625 -0.109375 15.0777 15.0777 15.0777 -0.046875 0.015625 -0.078125 111.838 111.838 111.838 -0.046875 0.046875 -0.109375 49.044 49.044 49.044 -0.046875 0.046875 -0.078125 13.7471 13.7471 13.7471 -0.015625 0.015625 -0.046875 127.053 127.053 127.053 -0.015625 0.046875 -0.046875 8.52594 8.52594 8.52594 -0.015625 0.078125 -0.109375 44.9155 44.9155 44.9155 -0.015625 0.078125 -0.078125 2.77143 2.77143 2.77143 -0.046875 0.078125 -0.078125 -31.5098 -31.5098 -31.5098 -0.046875 0.109375 -0.078125 -32.6826 -32.6826 -32.6826 -0.015625 0.078125 -0.046875 -30.2029 -30.2029 -30.2029 -0.015625 0.109375 -0.046875 -14.2809 -14.2809 -14.2809 -0.015625 0.109375 -0.015625 -88.8323 -88.8323 -88.8323 -0.046875 0.078125 -0.046875 55.0948 55.0948 55.0948 -0.046875 0.078125 -0.015625 69.2904 69.2904 69.2904 -0.046875 0.109375 -0.046875 7.98417 7.98417 7.98417 -0.046875 0.109375 -0.015625 36.3631 36.3631 36.3631 -0.078125 0.015625 -0.109375 -57.745 -57.745 -57.745 -0.078125 0.015625 -0.078125 17.499 17.499 17.499 -0.078125 0.046875 -0.109375 26.9081 26.9081 26.9081 -0.078125 0.046875 -0.078125 14.6975 14.6975 14.6975 -0.109375 0.015625 -0.109375 -10.8895 -10.8895 -10.8895 -0.109375 0.015625 -0.078125 31.568 31.568 31.568 -0.109375 0.046875 -0.109375 -7.49878 -7.49878 -7.49878 -0.109375 0.046875 -0.078125 -24.8743 -24.8743 -24.8743 -0.078125 0.015625 -0.046875 42.4526 42.4526 42.4526 -0.078125 0.046875 -0.046875 111.204 111.204 111.204 -0.109375 0.015625 -0.046875 -40.7326 -40.7326 -40.7326 -0.109375 0.046875 -0.046875 -124.409 -124.409 -124.409 -0.109375 0.046875 -0.015625 -328.863 -328.863 -328.863 -0.078125 0.078125 -0.109375 -117.044 -117.044 -117.044 -0.078125 0.078125 -0.078125 45.6573 45.6573 45.6573 -0.078125 0.109375 -0.109375 -43.2288 -43.2288 -43.2288 -0.078125 0.109375 -0.078125 8.67814 8.67814 8.67814 -0.109375 0.078125 -0.109375 -75.5877 -75.5877 -75.5877 -0.109375 0.078125 -0.078125 42.9012 42.9012 42.9012 -0.109375 0.109375 -0.109375 -44.3725 -44.3725 -44.3725 -0.109375 0.109375 -0.078125 0.470558 0.470558 0.470558 -0.078125 0.078125 -0.046875 85.5592 85.5592 85.5592 -0.078125 0.078125 -0.015625 89.7191 89.7191 89.7191 -0.078125 0.109375 -0.046875 -129.549 -129.549 -129.549 -0.078125 0.109375 -0.015625 30.1536 30.1536 30.1536 -0.109375 0.078125 -0.046875 162.508 162.508 162.508 -0.109375 0.078125 -0.015625 -160.991 -160.991 -160.991 -0.109375 0.109375 -0.046875 -67.2052 -67.2052 -67.2052 -0.109375 0.109375 -0.015625 -74.5728 -74.5728 -74.5728 -0.015625 0.140625 -0.234375 53.6985 53.6985 53.6985 -0.015625 0.140625 -0.203125 -82.0983 -82.0983 -82.0983 -0.015625 0.171875 -0.234375 287.98 287.98 287.98 -0.015625 0.171875 -0.203125 84.8132 84.8132 84.8132 -0.046875 0.140625 -0.234375 89.0185 89.0185 89.0185 -0.046875 0.140625 -0.203125 -58.2398 -58.2398 -58.2398 -0.046875 0.171875 -0.234375 100.809 100.809 100.809 -0.046875 0.171875 -0.203125 -98.2843 -98.2843 -98.2843 -0.015625 0.140625 -0.171875 -712.361 -712.361 -712.361 -0.015625 0.140625 -0.140625 -76.1122 -76.1122 -76.1122 -0.015625 0.171875 -0.171875 346.862 346.862 346.862 -0.015625 0.171875 -0.140625 -20.6186 -20.6186 -20.6186 -0.046875 0.140625 -0.171875 -91.5813 -91.5813 -91.5813 -0.046875 0.140625 -0.140625 21.625 21.625 21.625 -0.046875 0.171875 -0.140625 33.9744 33.9744 33.9744 -0.015625 0.203125 -0.234375 -1449.4 -1449.4 -1449.4 -0.015625 0.203125 -0.203125 -537.461 -537.461 -537.461 -0.015625 0.234375 -0.234375 323.971 323.971 323.971 -0.015625 0.234375 -0.203125 310.283 310.283 310.283 -0.046875 0.203125 -0.234375 -1325.56 -1325.56 -1325.56 -0.046875 0.203125 -0.203125 -402.132 -402.132 -402.132 -0.046875 0.234375 -0.234375 -5.49772 -5.49772 -5.49772 -0.015625 0.203125 -0.171875 -198.11 -198.11 -198.11 -0.015625 0.203125 -0.140625 -61.1489 -61.1489 -61.1489 -0.015625 0.234375 -0.171875 -167.018 -167.018 -167.018 -0.015625 0.234375 -0.140625 -87.7014 -87.7014 -87.7014 -0.046875 0.203125 -0.140625 12.4247 12.4247 12.4247 -0.046875 0.234375 -0.140625 -30.0313 -30.0313 -30.0313 -0.078125 0.140625 -0.203125 73.1333 73.1333 73.1333 -0.078125 0.140625 -0.171875 79.3096 79.3096 79.3096 -0.078125 0.140625 -0.140625 -18.4518 -18.4518 -18.4518 -0.109375 0.140625 -0.171875 421.414 421.414 421.414 -0.015625 0.140625 -0.078125 82.5961 82.5961 82.5961 -0.015625 0.171875 -0.078125 -0.00169969 -0.00169969 -0.00169969 -0.046875 0.140625 -0.109375 14.931 14.931 14.931 -0.046875 0.140625 -0.078125 35.5158 35.5158 35.5158 -0.046875 0.171875 -0.109375 -29.5363 -29.5363 -29.5363 -0.046875 0.171875 -0.078125 -1.66039 -1.66039 -1.66039 -0.015625 0.140625 -0.046875 30.0412 30.0412 30.0412 -0.015625 0.140625 -0.015625 -160.014 -160.014 -160.014 -0.015625 0.171875 -0.046875 25.7327 25.7327 25.7327 -0.015625 0.171875 -0.015625 66.6026 66.6026 66.6026 -0.046875 0.140625 -0.046875 -26.6539 -26.6539 -26.6539 -0.046875 0.140625 -0.015625 -46.6076 -46.6076 -46.6076 -0.046875 0.171875 -0.015625 14.258 14.258 14.258 -0.015625 0.203125 -0.078125 -38.056 -38.056 -38.056 -0.015625 0.234375 -0.109375 -103.099 -103.099 -103.099 -0.015625 0.234375 -0.078125 -234.179 -234.179 -234.179 -0.046875 0.203125 -0.109375 -29.5237 -29.5237 -29.5237 -0.046875 0.203125 -0.078125 -21.1925 -21.1925 -21.1925 -0.046875 0.234375 -0.109375 17.4893 17.4893 17.4893 -0.046875 0.234375 -0.078125 -84.2848 -84.2848 -84.2848 -0.015625 0.203125 -0.046875 -111.007 -111.007 -111.007 -0.015625 0.203125 -0.015625 -22.8787 -22.8787 -22.8787 -0.015625 0.234375 -0.046875 -77.1978 -77.1978 -77.1978 -0.015625 0.234375 -0.015625 562.708 562.708 562.708 -0.046875 0.203125 -0.015625 -5.26277 -5.26277 -5.26277 -0.046875 0.234375 -0.046875 -90.0586 -90.0586 -90.0586 -0.046875 0.234375 -0.015625 -170.548 -170.548 -170.548 -0.078125 0.140625 -0.109375 44.9379 44.9379 44.9379 -0.078125 0.140625 -0.078125 -34.8495 -34.8495 -34.8495 -0.078125 0.234375 -0.078125 32.3271 32.3271 32.3271 -0.109375 0.234375 -0.078125 -42.7395 -42.7395 -42.7395 -0.078125 0.234375 -0.046875 59.3676 59.3676 59.3676 -0.078125 0.234375 -0.015625 -13.3613 -13.3613 -13.3613 -0.109375 0.234375 -0.046875 35.0392 35.0392 35.0392 -0.109375 0.234375 -0.015625 -3.16877 -3.16877 -3.16877 -0.140625 0.015625 -0.203125 23.167 23.167 23.167 -0.171875 0.046875 -0.203125 27.5473 27.5473 27.5473 -0.140625 0.015625 -0.171875 29.0579 29.0579 29.0579 -0.140625 0.015625 -0.140625 -9.96332 -9.96332 -9.96332 -0.140625 0.046875 -0.171875 75.0609 75.0609 75.0609 -0.140625 0.046875 -0.140625 -46.6385 -46.6385 -46.6385 -0.171875 0.015625 -0.140625 -43.71 -43.71 -43.71 -0.171875 0.046875 -0.171875 -29.2199 -29.2199 -29.2199 -0.171875 0.046875 -0.140625 -11.9479 -11.9479 -11.9479 -0.140625 0.078125 -0.203125 -46.0696 -46.0696 -46.0696 -0.140625 0.109375 -0.234375 -154.445 -154.445 -154.445 -0.140625 0.109375 -0.203125 17.6365 17.6365 17.6365 -0.171875 0.078125 -0.234375 -139.114 -139.114 -139.114 -0.171875 0.078125 -0.203125 -69.8868 -69.8868 -69.8868 -0.171875 0.109375 -0.234375 -347.052 -347.052 -347.052 -0.171875 0.109375 -0.203125 -99.2516 -99.2516 -99.2516 -0.140625 0.078125 -0.171875 -8.59537 -8.59537 -8.59537 -0.140625 0.078125 -0.140625 -129.471 -129.471 -129.471 -0.140625 0.109375 -0.171875 -38.9836 -38.9836 -38.9836 -0.140625 0.109375 -0.140625 59.4639 59.4639 59.4639 -0.171875 0.078125 -0.171875 -32.2382 -32.2382 -32.2382 -0.171875 0.078125 -0.140625 15.5791 15.5791 15.5791 -0.171875 0.109375 -0.140625 45.0007 45.0007 45.0007 -0.203125 0.015625 -0.234375 31.9624 31.9624 31.9624 -0.203125 0.015625 -0.203125 7.46965 7.46965 7.46965 -0.203125 0.046875 -0.234375 -23.2087 -23.2087 -23.2087 -0.203125 0.046875 -0.203125 7.21987 7.21987 7.21987 -0.234375 0.015625 -0.234375 -4.21943 -4.21943 -4.21943 -0.234375 0.015625 -0.203125 -12.6977 -12.6977 -12.6977 -0.234375 0.046875 -0.203125 -1.0662 -1.0662 -1.0662 -0.203125 0.015625 -0.140625 16.1832 16.1832 16.1832 -0.203125 0.046875 -0.171875 32.4582 32.4582 32.4582 -0.203125 0.046875 -0.140625 17.7204 17.7204 17.7204 -0.234375 0.015625 -0.171875 46.3982 46.3982 46.3982 -0.234375 0.015625 -0.140625 -88.2555 -88.2555 -88.2555 -0.234375 0.046875 -0.171875 -21.1757 -21.1757 -21.1757 -0.234375 0.046875 -0.140625 -73.4066 -73.4066 -73.4066 -0.203125 0.078125 -0.234375 -31.446 -31.446 -31.446 -0.203125 0.078125 -0.203125 -53.4848 -53.4848 -53.4848 -0.203125 0.109375 -0.203125 -308.22 -308.22 -308.22 -0.234375 0.078125 -0.234375 23.0961 23.0961 23.0961 -0.234375 0.078125 -0.203125 -0.917817 -0.917817 -0.917817 -0.234375 0.109375 -0.234375 775.097 775.097 775.097 -0.234375 0.109375 -0.203125 103.37 103.37 103.37 -0.203125 0.078125 -0.140625 13.5731 13.5731 13.5731 -0.203125 0.109375 -0.171875 19.7927 19.7927 19.7927 -0.203125 0.109375 -0.140625 13.252 13.252 13.252 -0.234375 0.078125 -0.171875 -16.879 -16.879 -16.879 -0.234375 0.078125 -0.140625 -21.2866 -21.2866 -21.2866 -0.234375 0.109375 -0.171875 -180.156 -180.156 -180.156 -0.234375 0.109375 -0.140625 3.28602 3.28602 3.28602 -0.140625 0.015625 -0.109375 31.7656 31.7656 31.7656 -0.140625 0.015625 -0.078125 23.4002 23.4002 23.4002 -0.140625 0.046875 -0.109375 11.5498 11.5498 11.5498 -0.171875 0.015625 -0.109375 24.1354 24.1354 24.1354 -0.171875 0.015625 -0.078125 -116.372 -116.372 -116.372 -0.171875 0.046875 -0.109375 33.2427 33.2427 33.2427 -0.171875 0.046875 -0.078125 -28.043 -28.043 -28.043 -0.140625 0.015625 -0.046875 -17.2002 -17.2002 -17.2002 -0.140625 0.015625 -0.015625 147.905 147.905 147.905 -0.140625 0.046875 -0.046875 113.712 113.712 113.712 -0.140625 0.046875 -0.015625 678.01 678.01 678.01 -0.171875 0.015625 -0.046875 -53.0201 -53.0201 -53.0201 -0.171875 0.015625 -0.015625 2096.28 2096.28 2096.28 -0.171875 0.046875 -0.046875 46.0028 46.0028 46.0028 -0.171875 0.046875 -0.015625 -6.96943 -6.96943 -6.96943 -0.140625 0.078125 -0.109375 -4.26106 -4.26106 -4.26106 -0.140625 0.078125 -0.078125 -71.452 -71.452 -71.452 -0.140625 0.109375 -0.078125 -71.481 -71.481 -71.481 -0.171875 0.078125 -0.109375 18.6699 18.6699 18.6699 -0.171875 0.078125 -0.078125 84.8961 84.8961 84.8961 -0.171875 0.109375 -0.109375 -22.3087 -22.3087 -22.3087 -0.171875 0.109375 -0.078125 -265.02 -265.02 -265.02 -0.140625 0.078125 -0.046875 -0.412164 -0.412164 -0.412164 -0.140625 0.078125 -0.015625 -102.676 -102.676 -102.676 -0.140625 0.109375 -0.046875 -87.7827 -87.7827 -87.7827 -0.171875 0.078125 -0.046875 -400.835 -400.835 -400.835 -0.171875 0.078125 -0.015625 -372.911 -372.911 -372.911 -0.171875 0.109375 -0.046875 99.7025 99.7025 99.7025 -0.203125 0.015625 -0.109375 51.0284 51.0284 51.0284 -0.203125 0.015625 -0.078125 -263.159 -263.159 -263.159 -0.203125 0.046875 -0.109375 34.4972 34.4972 34.4972 -0.203125 0.046875 -0.078125 18.7649 18.7649 18.7649 -0.234375 0.015625 -0.109375 -28.4379 -28.4379 -28.4379 -0.234375 0.015625 -0.078125 -1.55812 -1.55812 -1.55812 -0.234375 0.046875 -0.109375 38.7026 38.7026 38.7026 -0.234375 0.046875 -0.078125 -14.4097 -14.4097 -14.4097 -0.203125 0.015625 -0.046875 5.18734 5.18734 5.18734 -0.203125 0.046875 -0.046875 -174.256 -174.256 -174.256 -0.234375 0.046875 -0.046875 78.6689 78.6689 78.6689 -0.203125 0.078125 -0.109375 24.3522 24.3522 24.3522 -0.203125 0.078125 -0.078125 -35.9305 -35.9305 -35.9305 -0.203125 0.109375 -0.109375 -28.9979 -28.9979 -28.9979 -0.203125 0.109375 -0.078125 -77.4015 -77.4015 -77.4015 -0.234375 0.078125 -0.078125 223.295 223.295 223.295 -0.234375 0.109375 -0.109375 -74.5132 -74.5132 -74.5132 -0.234375 0.109375 -0.078125 -67.0304 -67.0304 -67.0304 -0.203125 0.078125 -0.046875 -204.186 -204.186 -204.186 -0.234375 0.078125 -0.046875 100.394 100.394 100.394 -0.203125 0.140625 -0.203125 404.558 404.558 404.558 -0.234375 0.140625 -0.234375 656.546 656.546 656.546 -0.234375 0.140625 -0.203125 85.2753 85.2753 85.2753 -0.234375 0.171875 -0.234375 -317.345 -317.345 -317.345 -0.234375 0.171875 -0.203125 -638.483 -638.483 -638.483 -0.203125 0.140625 -0.171875 106.607 106.607 106.607 -0.203125 0.140625 -0.140625 -14.7891 -14.7891 -14.7891 -0.234375 0.140625 -0.171875 -488.399 -488.399 -488.399 -0.234375 0.140625 -0.140625 -13.3153 -13.3153 -13.3153 -0.234375 0.171875 -0.171875 20.6653 20.6653 20.6653 -0.203125 0.140625 -0.109375 -6.73004 -6.73004 -6.73004 -0.203125 0.140625 -0.078125 29.4605 29.4605 29.4605 -0.234375 0.140625 -0.109375 -11.7299 -11.7299 -11.7299 -0.234375 0.140625 -0.078125 -64.9054 -64.9054 -64.9054 -0.015625 0.265625 -0.359375 766.743 766.743 766.743 -0.015625 0.265625 -0.328125 179.842 179.842 179.842 -0.046875 0.265625 -0.359375 1113.22 1113.22 1113.22 -0.046875 0.265625 -0.328125 488.347 488.347 488.347 -0.015625 0.265625 -0.265625 -244.166 -244.166 -244.166 -0.015625 0.296875 -0.265625 -268.543 -268.543 -268.543 -0.015625 0.328125 -0.265625 580.725 580.725 580.725 -0.015625 0.265625 -0.234375 -117.757 -117.757 -117.757 -0.015625 0.265625 -0.203125 400.525 400.525 400.525 -0.015625 0.296875 -0.234375 -97.4057 -97.4057 -97.4057 -0.015625 0.296875 -0.203125 -63.9965 -63.9965 -63.9965 -0.046875 0.296875 -0.203125 -16.0729 -16.0729 -16.0729 -0.015625 0.296875 -0.171875 277.61 277.61 277.61 -0.015625 0.296875 -0.140625 6376.27 6376.27 6376.27 -0.046875 0.296875 -0.171875 232.65 232.65 232.65 -0.046875 0.296875 -0.140625 242.705 242.705 242.705 -0.015625 0.328125 -0.234375 147.278 147.278 147.278 -0.015625 0.328125 -0.203125 53.5587 53.5587 53.5587 -0.015625 0.359375 -0.234375 3.66797 3.66797 3.66797 -0.015625 0.359375 -0.203125 470.026 470.026 470.026 -0.046875 0.328125 -0.203125 52.8237 52.8237 52.8237 -0.046875 0.359375 -0.203125 -85.903 -85.903 -85.903 -0.015625 0.328125 -0.140625 5480.61 5480.61 5480.61 -0.015625 0.359375 -0.171875 44.0654 44.0654 44.0654 -0.015625 0.359375 -0.140625 -3910.01 -3910.01 -3910.01 -0.046875 0.328125 -0.171875 122.821 122.821 122.821 -0.046875 0.328125 -0.140625 145.52 145.52 145.52 -0.046875 0.359375 -0.171875 -139.57 -139.57 -139.57 -0.015625 0.265625 -0.109375 -103.732 -103.732 -103.732 -0.015625 0.296875 -0.109375 6247.5 6247.5 6247.5 -0.046875 0.265625 -0.109375 415.098 415.098 415.098 -0.046875 0.265625 -0.078125 -293.788 -293.788 -293.788 -0.046875 0.296875 -0.109375 316.093 316.093 316.093 -0.046875 0.296875 -0.078125 -494.295 -494.295 -494.295 -0.015625 0.265625 -0.015625 94.1738 94.1738 94.1738 -0.015625 0.296875 -0.015625 832.954 832.954 832.954 -0.046875 0.265625 -0.015625 -15.1675 -15.1675 -15.1675 -0.015625 0.328125 -0.109375 -1365.81 -1365.81 -1365.81 -0.015625 0.328125 -0.078125 -6427.97 -6427.97 -6427.97 -0.015625 0.359375 -0.078125 7420.38 7420.38 7420.38 -0.046875 0.328125 -0.109375 -141.774 -141.774 -141.774 -0.046875 0.328125 -0.078125 -91.2281 -91.2281 -91.2281 -0.046875 0.359375 -0.078125 -427.043 -427.043 -427.043 -0.015625 0.328125 -0.046875 647.546 647.546 647.546 -0.015625 0.328125 -0.015625 629.13 629.13 629.13 -0.015625 0.359375 -0.046875 -542.095 -542.095 -542.095 -0.015625 0.359375 -0.015625 672.27 672.27 672.27 -0.046875 0.328125 -0.046875 25.0921 25.0921 25.0921 -0.046875 0.328125 -0.015625 178.507 178.507 178.507 -0.046875 0.359375 -0.046875 206.528 206.528 206.528 -0.046875 0.359375 -0.015625 253.384 253.384 253.384 -0.078125 0.265625 -0.078125 -155.318 -155.318 -155.318 -0.078125 0.296875 -0.078125 -635.724 -635.724 -635.724 -0.109375 0.265625 -0.078125 -29.9223 -29.9223 -29.9223 -0.109375 0.296875 -0.078125 -70.8283 -70.8283 -70.8283 -0.078125 0.265625 -0.015625 -145.18 -145.18 -145.18 -0.078125 0.296875 -0.015625 92.5455 92.5455 92.5455 -0.109375 0.265625 -0.046875 24.1715 24.1715 24.1715 -0.109375 0.265625 -0.015625 6.84605 6.84605 6.84605 -0.109375 0.296875 -0.046875 -170.068 -170.068 -170.068 -0.109375 0.296875 -0.015625 -8.65591 -8.65591 -8.65591 -0.078125 0.328125 -0.078125 -23.8828 -23.8828 -23.8828 -0.078125 0.359375 -0.078125 -435.494 -435.494 -435.494 -0.109375 0.328125 -0.078125 52.8293 52.8293 52.8293 -0.078125 0.328125 -0.015625 224.947 224.947 224.947 -0.078125 0.359375 -0.046875 -241.135 -241.135 -241.135 -0.078125 0.359375 -0.015625 364.994 364.994 364.994 -0.109375 0.328125 -0.046875 -44.4728 -44.4728 -44.4728 -0.109375 0.328125 -0.015625 -64.12 -64.12 -64.12 -0.109375 0.359375 -0.046875 134.414 134.414 134.414 -0.015625 0.390625 -0.203125 216.795 216.795 216.795 -0.015625 0.390625 -0.171875 94.9774 94.9774 94.9774 -0.015625 0.390625 -0.140625 -30.0655 -30.0655 -30.0655 -0.265625 0.109375 -0.390625 44.3661 44.3661 44.3661 -0.265625 0.078125 -0.359375 56.1011 56.1011 56.1011 -0.265625 0.078125 -0.328125 91.3889 91.3889 91.3889 -0.265625 0.109375 -0.359375 -2430.42 -2430.42 -2430.42 -0.296875 0.078125 -0.359375 -0.593079 -0.593079 -0.593079 -0.296875 0.078125 -0.328125 -25.459 -25.459 -25.459 -0.296875 0.109375 -0.359375 -801.292 -801.292 -801.292 -0.296875 0.109375 -0.328125 -3321.34 -3321.34 -3321.34 -0.265625 0.078125 -0.296875 -66.5028 -66.5028 -66.5028 -0.265625 0.078125 -0.265625 -9.17839 -9.17839 -9.17839 -0.265625 0.109375 -0.296875 725.846 725.846 725.846 -0.265625 0.109375 -0.265625 2964.55 2964.55 2964.55 -0.296875 0.078125 -0.296875 -130.487 -130.487 -130.487 -0.296875 0.078125 -0.265625 -2.63606 -2.63606 -2.63606 -0.296875 0.109375 -0.296875 1203.42 1203.42 1203.42 -0.296875 0.109375 -0.265625 734.598 734.598 734.598 -0.328125 0.109375 -0.359375 593.175 593.175 593.175 -0.328125 0.109375 -0.328125 3455.31 3455.31 3455.31 -0.359375 0.109375 -0.328125 30.5412 30.5412 30.5412 -0.328125 0.078125 -0.296875 -109.746 -109.746 -109.746 -0.328125 0.078125 -0.265625 -7.86055 -7.86055 -7.86055 -0.328125 0.109375 -0.296875 -1519.07 -1519.07 -1519.07 -0.328125 0.109375 -0.265625 -3810.29 -3810.29 -3810.29 -0.359375 0.109375 -0.296875 34.5063 34.5063 34.5063 -0.359375 0.109375 -0.265625 65.9411 65.9411 65.9411 -0.265625 0.140625 -0.390625 -2131.3 -2131.3 -2131.3 -0.265625 0.171875 -0.390625 -2647.07 -2647.07 -2647.07 -0.296875 0.140625 -0.390625 2789.92 2789.92 2789.92 -0.296875 0.171875 -0.390625 -1040.62 -1040.62 -1040.62 -0.265625 0.203125 -0.390625 326.938 326.938 326.938 -0.265625 0.140625 -0.359375 2168.09 2168.09 2168.09 -0.265625 0.171875 -0.359375 783.761 783.761 783.761 -0.296875 0.140625 -0.359375 -187.991 -187.991 -187.991 -0.296875 0.171875 -0.359375 521.38 521.38 521.38 -0.265625 0.171875 -0.296875 -788.749 -788.749 -788.749 -0.265625 0.171875 -0.265625 -1900.3 -1900.3 -1900.3 -0.296875 0.171875 -0.265625 1655.28 1655.28 1655.28 -0.265625 0.203125 -0.359375 -1205.08 -1205.08 -1205.08 -0.265625 0.234375 -0.359375 -2754.84 -2754.84 -2754.84 -0.265625 0.234375 -0.328125 -3807.94 -3807.94 -3807.94 -0.296875 0.203125 -0.359375 -290.858 -290.858 -290.858 -0.296875 0.203125 -0.328125 70.7222 70.7222 70.7222 -0.296875 0.234375 -0.359375 -525.058 -525.058 -525.058 -0.296875 0.234375 -0.328125 -1058.7 -1058.7 -1058.7 -0.265625 0.203125 -0.296875 -2159.48 -2159.48 -2159.48 -0.265625 0.203125 -0.265625 -2832.44 -2832.44 -2832.44 -0.265625 0.234375 -0.296875 294.82 294.82 294.82 -0.296875 0.203125 -0.296875 277.093 277.093 277.093 -0.296875 0.203125 -0.265625 1004.53 1004.53 1004.53 -0.296875 0.234375 -0.296875 -468.749 -468.749 -468.749 -0.328125 0.140625 -0.359375 525.658 525.658 525.658 -0.328125 0.140625 -0.328125 3712.69 3712.69 3712.69 -0.328125 0.171875 -0.359375 -1459.27 -1459.27 -1459.27 -0.328125 0.171875 -0.328125 1116.14 1116.14 1116.14 -0.359375 0.140625 -0.328125 562.98 562.98 562.98 -0.359375 0.171875 -0.328125 -619.106 -619.106 -619.106 -0.328125 0.140625 -0.265625 -4310.04 -4310.04 -4310.04 -0.328125 0.171875 -0.296875 2665.03 2665.03 2665.03 -0.328125 0.171875 -0.265625 -1875 -1875 -1875 -0.359375 0.140625 -0.296875 908.863 908.863 908.863 -0.359375 0.140625 -0.265625 28.1589 28.1589 28.1589 -0.359375 0.171875 -0.296875 147.928 147.928 147.928 -0.359375 0.171875 -0.265625 -5.10192 -5.10192 -5.10192 -0.328125 0.203125 -0.359375 23.2427 23.2427 23.2427 -0.328125 0.203125 -0.328125 -419.809 -419.809 -419.809 -0.328125 0.203125 -0.296875 1004.63 1004.63 1004.63 -0.328125 0.203125 -0.265625 209.366 209.366 209.366 -0.265625 0.046875 -0.203125 -11.3449 -11.3449 -11.3449 -0.296875 0.046875 -0.234375 115.795 115.795 115.795 -0.296875 0.046875 -0.203125 14.8134 14.8134 14.8134 -0.265625 0.015625 -0.171875 -21.5344 -21.5344 -21.5344 -0.265625 0.015625 -0.140625 48.0748 48.0748 48.0748 -0.265625 0.046875 -0.171875 12.7736 12.7736 12.7736 -0.265625 0.046875 -0.140625 21.9231 21.9231 21.9231 -0.296875 0.015625 -0.171875 -25.9211 -25.9211 -25.9211 -0.296875 0.015625 -0.140625 -30.0655 -30.0655 -30.0655 -0.296875 0.046875 -0.171875 29.8697 29.8697 29.8697 -0.265625 0.078125 -0.234375 -6.08649 -6.08649 -6.08649 -0.265625 0.078125 -0.203125 -47.2905 -47.2905 -47.2905 -0.296875 0.078125 -0.234375 79.2036 79.2036 79.2036 -0.296875 0.078125 -0.203125 -36.176 -36.176 -36.176 -0.296875 0.109375 -0.171875 -144.253 -144.253 -144.253 -0.296875 0.109375 -0.140625 34.7463 34.7463 34.7463 -0.328125 0.015625 -0.203125 22.2156 22.2156 22.2156 -0.328125 0.046875 -0.203125 -9.60355 -9.60355 -9.60355 -0.359375 0.046875 -0.203125 104.192 104.192 104.192 -0.328125 0.015625 -0.171875 13.008 13.008 13.008 -0.328125 0.015625 -0.140625 -61.7448 -61.7448 -61.7448 -0.328125 0.046875 -0.171875 17.2329 17.2329 17.2329 -0.359375 0.015625 -0.171875 20.4521 20.4521 20.4521 -0.359375 0.015625 -0.140625 -29.8806 -29.8806 -29.8806 -0.359375 0.046875 -0.171875 54.148 54.148 54.148 -0.359375 0.046875 -0.140625 5.96677 5.96677 5.96677 -0.328125 0.078125 -0.234375 40.7188 40.7188 40.7188 -0.328125 0.078125 -0.203125 34.3445 34.3445 34.3445 -0.328125 0.109375 -0.234375 -22.4035 -22.4035 -22.4035 -0.328125 0.109375 -0.203125 23.9235 23.9235 23.9235 -0.359375 0.078125 -0.234375 28.473 28.473 28.473 -0.359375 0.078125 -0.203125 30.6997 30.6997 30.6997 -0.359375 0.109375 -0.234375 -41.311 -41.311 -41.311 -0.359375 0.109375 -0.203125 3.10618 3.10618 3.10618 -0.328125 0.078125 -0.171875 68.3286 68.3286 68.3286 -0.328125 0.109375 -0.171875 44.9934 44.9934 44.9934 -0.328125 0.109375 -0.140625 0.275782 0.275782 0.275782 -0.359375 0.078125 -0.171875 37.5571 37.5571 37.5571 -0.359375 0.078125 -0.140625 -70.4937 -70.4937 -70.4937 -0.359375 0.109375 -0.171875 44.9381 44.9381 44.9381 -0.359375 0.109375 -0.140625 -103.005 -103.005 -103.005 -0.265625 0.015625 -0.109375 -271.028 -271.028 -271.028 -0.265625 0.015625 -0.078125 -174.234 -174.234 -174.234 -0.265625 0.046875 -0.109375 -19.7805 -19.7805 -19.7805 -0.265625 0.046875 -0.078125 -394.101 -394.101 -394.101 -0.296875 0.015625 -0.109375 15.8828 15.8828 15.8828 -0.296875 0.015625 -0.078125 202.618 202.618 202.618 -0.296875 0.046875 -0.109375 -51.9718 -51.9718 -51.9718 -0.296875 0.046875 -0.078125 43.9435 43.9435 43.9435 -0.265625 0.046875 -0.046875 -336.078 -336.078 -336.078 -0.265625 0.078125 -0.078125 6.77439 6.77439 6.77439 -0.265625 0.109375 -0.109375 -69.2352 -69.2352 -69.2352 -0.265625 0.109375 -0.078125 -58.8976 -58.8976 -58.8976 -0.296875 0.078125 -0.109375 37.5763 37.5763 37.5763 -0.296875 0.078125 -0.078125 38.7997 38.7997 38.7997 -0.296875 0.109375 -0.109375 -56.2129 -56.2129 -56.2129 -0.296875 0.109375 -0.078125 32.5239 32.5239 32.5239 -0.265625 0.078125 -0.046875 153.545 153.545 153.545 -0.328125 0.015625 -0.109375 355.762 355.762 355.762 -0.328125 0.015625 -0.078125 286.359 286.359 286.359 -0.328125 0.046875 -0.109375 293.206 293.206 293.206 -0.328125 0.046875 -0.078125 79.1358 79.1358 79.1358 -0.359375 0.015625 -0.109375 8.94158 8.94158 8.94158 -0.359375 0.046875 -0.109375 -4.86821 -4.86821 -4.86821 -0.328125 0.078125 -0.109375 58.0706 58.0706 58.0706 -0.328125 0.078125 -0.078125 -3.16133 -3.16133 -3.16133 -0.328125 0.109375 -0.109375 -62.2347 -62.2347 -62.2347 -0.359375 0.078125 -0.109375 -23.7169 -23.7169 -23.7169 -0.265625 0.140625 -0.203125 -398.746 -398.746 -398.746 -0.265625 0.171875 -0.234375 -251.806 -251.806 -251.806 -0.265625 0.171875 -0.203125 -197.386 -197.386 -197.386 -0.296875 0.171875 -0.234375 315.581 315.581 315.581 -0.296875 0.171875 -0.203125 -182.911 -182.911 -182.911 -0.265625 0.140625 -0.171875 -83.2796 -83.2796 -83.2796 -0.265625 0.140625 -0.140625 14.3608 14.3608 14.3608 -0.265625 0.171875 -0.171875 -465.519 -465.519 -465.519 -0.296875 0.140625 -0.171875 5.62367 5.62367 5.62367 -0.296875 0.140625 -0.140625 -4.00439 -4.00439 -4.00439 -0.296875 0.171875 -0.171875 228.399 228.399 228.399 -0.265625 0.203125 -0.234375 -1282.28 -1282.28 -1282.28 -0.296875 0.203125 -0.234375 -1419.75 -1419.75 -1419.75 -0.328125 0.140625 -0.234375 -292.454 -292.454 -292.454 -0.328125 0.140625 -0.203125 -73.4321 -73.4321 -73.4321 -0.328125 0.171875 -0.234375 188.404 188.404 188.404 -0.328125 0.171875 -0.203125 191.39 191.39 191.39 -0.359375 0.140625 -0.234375 -27.8006 -27.8006 -27.8006 -0.359375 0.140625 -0.203125 48.9273 48.9273 48.9273 -0.328125 0.140625 -0.171875 29.4433 29.4433 29.4433 -0.265625 0.140625 -0.109375 -36.3843 -36.3843 -36.3843 -0.296875 0.140625 -0.109375 -11.1755 -11.1755 -11.1755 -0.015625 0.015625 0.046875 17.2196 17.2196 17.2196 -0.015625 0.046875 0.046875 23.628 23.628 23.628 -0.046875 0.015625 0.046875 14.924 14.924 14.924 -0.046875 0.046875 0.046875 27.9577 27.9577 27.9577 -0.015625 0.015625 0.078125 34.2883 34.2883 34.2883 -0.015625 0.015625 0.109375 11.2463 11.2463 11.2463 -0.015625 0.046875 0.078125 14.0178 14.0178 14.0178 -0.015625 0.046875 0.109375 -115.948 -115.948 -115.948 -0.046875 0.015625 0.078125 -9.34556 -9.34556 -9.34556 -0.046875 0.046875 0.078125 -0.973704 -0.973704 -0.973704 -0.015625 0.078125 0.046875 15.8111 15.8111 15.8111 -0.046875 0.078125 0.015625 5.46682 5.46682 5.46682 -0.046875 0.078125 0.046875 12.8131 12.8131 12.8131 -0.046875 0.109375 0.015625 -12.6184 -12.6184 -12.6184 -0.046875 0.109375 0.046875 -1.10623 -1.10623 -1.10623 -0.015625 0.078125 0.078125 -29.0767 -29.0767 -29.0767 -0.015625 0.078125 0.109375 -37.4683 -37.4683 -37.4683 -0.015625 0.109375 0.078125 22.6039 22.6039 22.6039 -0.015625 0.109375 0.109375 -15.7841 -15.7841 -15.7841 -0.046875 0.078125 0.078125 46.7407 46.7407 46.7407 -0.046875 0.109375 0.078125 13.1691 13.1691 13.1691 -0.046875 0.109375 0.109375 25.4636 25.4636 25.4636 -0.078125 0.015625 0.046875 -112.241 -112.241 -112.241 -0.078125 0.046875 0.046875 -64.5512 -64.5512 -64.5512 -0.078125 0.015625 0.078125 -31.3267 -31.3267 -31.3267 -0.078125 0.046875 0.078125 -38.5485 -38.5485 -38.5485 -0.109375 0.015625 0.078125 -53.1812 -53.1812 -53.1812 -0.109375 0.046875 0.078125 18.0234 18.0234 18.0234 -0.078125 0.078125 0.015625 12.9588 12.9588 12.9588 -0.078125 0.078125 0.046875 -40.9417 -40.9417 -40.9417 -0.078125 0.109375 0.015625 -169.089 -169.089 -169.089 -0.109375 0.078125 0.015625 54.9392 54.9392 54.9392 -0.109375 0.078125 0.046875 421.968 421.968 421.968 -0.109375 0.109375 0.015625 -98.7996 -98.7996 -98.7996 -0.078125 0.078125 0.078125 -0.314137 -0.314137 -0.314137 -0.109375 0.078125 0.078125 42.439 42.439 42.439 -0.015625 0.015625 0.140625 -49.5256 -49.5256 -49.5256 -0.015625 0.015625 0.171875 -70.1899 -70.1899 -70.1899 -0.015625 0.046875 0.140625 -106.509 -106.509 -106.509 -0.015625 0.046875 0.171875 221.444 221.444 221.444 -0.046875 0.046875 0.140625 -198.583 -198.583 -198.583 -0.015625 0.015625 0.203125 108.737 108.737 108.737 -0.015625 0.015625 0.234375 77.5367 77.5367 77.5367 -0.015625 0.046875 0.203125 130.722 130.722 130.722 -0.015625 0.046875 0.234375 -262.721 -262.721 -262.721 -0.046875 0.015625 0.234375 59.5517 59.5517 59.5517 -0.046875 0.046875 0.234375 29.9984 29.9984 29.9984 -0.015625 0.078125 0.140625 -289.911 -289.911 -289.911 -0.015625 0.078125 0.171875 135.024 135.024 135.024 -0.015625 0.109375 0.140625 -111.468 -111.468 -111.468 -0.015625 0.109375 0.171875 -144.221 -144.221 -144.221 -0.015625 0.078125 0.234375 -230.44 -230.44 -230.44 -0.015625 0.109375 0.234375 415.859 415.859 415.859 -0.015625 0.171875 0.015625 82.0463 82.0463 82.0463 -0.015625 0.171875 0.046875 143.917 143.917 143.917 -0.046875 0.140625 0.015625 205.28 205.28 205.28 -0.046875 0.140625 0.046875 -5.53117 -5.53117 -5.53117 -0.046875 0.171875 0.015625 -35.0701 -35.0701 -35.0701 -0.046875 0.171875 0.046875 0.78626 0.78626 0.78626 -0.015625 0.140625 0.078125 -44.9557 -44.9557 -44.9557 -0.015625 0.140625 0.109375 26.504 26.504 26.504 -0.015625 0.171875 0.078125 53.6336 53.6336 53.6336 -0.015625 0.171875 0.109375 59.1662 59.1662 59.1662 -0.046875 0.140625 0.078125 -35.6439 -35.6439 -35.6439 -0.046875 0.140625 0.109375 8.90929 8.90929 8.90929 -0.046875 0.171875 0.078125 -43.8005 -43.8005 -43.8005 -0.015625 0.203125 0.015625 -221.064 -221.064 -221.064 -0.015625 0.203125 0.046875 -133.907 -133.907 -133.907 -0.046875 0.203125 0.015625 -5.85861 -5.85861 -5.85861 -0.140625 0.015625 0.015625 -301.143 -301.143 -301.143 -0.140625 0.015625 0.046875 -185.014 -185.014 -185.014 -0.140625 0.046875 0.015625 491.178 491.178 491.178 -0.140625 0.046875 0.046875 -180.542 -180.542 -180.542 -0.171875 0.015625 0.015625 -440.123 -440.123 -440.123 -0.171875 0.015625 0.046875 -1357.85 -1357.85 -1357.85 -0.171875 0.046875 0.015625 277.086 277.086 277.086 -0.171875 0.046875 0.046875 121.817 121.817 121.817 -0.140625 0.015625 0.078125 31.5016 31.5016 31.5016 -0.140625 0.046875 0.078125 47.7493 47.7493 47.7493 -0.171875 0.015625 0.078125 66.292 66.292 66.292 -0.171875 0.046875 0.078125 1.55659 1.55659 1.55659 -0.140625 0.078125 0.015625 452.956 452.956 452.956 -0.140625 0.078125 0.046875 28.2691 28.2691 28.2691 -0.171875 0.078125 0.046875 93.982 93.982 93.982 -0.140625 0.078125 0.078125 -179.818 -179.818 -179.818 -0.015625 0.015625 0.296875 67.3857 67.3857 67.3857 -0.015625 0.046875 0.265625 36.2145 36.2145 36.2145 -0.015625 0.046875 0.296875 -201.326 -201.326 -201.326 -0.046875 0.015625 0.265625 101.494 101.494 101.494 -0.046875 0.015625 0.296875 190.195 190.195 190.195 -0.046875 0.046875 0.265625 -193.187 -193.187 -193.187 -0.046875 0.046875 0.296875 -118.783 -118.783 -118.783 -0.015625 0.015625 0.328125 13.3545 13.3545 13.3545 -0.015625 0.078125 0.265625 -661.595 -661.595 -661.595 -0.015625 0.078125 0.296875 452.616 452.616 452.616 -0.015625 0.109375 0.265625 -257.273 -257.273 -257.273 -0.015625 0.109375 0.296875 7.71944 7.71944 7.71944 -0.015625 0.265625 0.015625 -954.37 -954.37 -954.37 -0.015625 0.296875 0.015625 507.312 507.312 507.312 -0.046875 0.265625 0.015625 -292.488 -292.488 -292.488 -0.046875 0.296875 0.015625 -701.532 -701.532 -701.532 -0.015625 0.328125 0.015625 -161.733 -161.733 -161.733 -0.046875 0.328125 0.015625 -97.5299 -97.5299 -97.5299 -0.078125 0.265625 0.015625 -432.051 -432.051 -432.051 -0.078125 0.296875 0.015625 -71.4656 -71.4656 -71.4656 -0.078125 0.328125 0.015625 -329.037 -329.037 -329.037 - diff --git a/tensorflow/script/ocnn_lrp_results/heatmap_1.ply b/tensorflow/script/ocnn_lrp_results/heatmap_1.ply deleted file mode 100644 index de5b63d..0000000 --- a/tensorflow/script/ocnn_lrp_results/heatmap_1.ply +++ /dev/null @@ -1,6986 +0,0 @@ -ply -format ascii 1.0 -element vertex 6973 -property float x -property float y -property float z -property float nx -property float ny -property float nz -element face 0 -property list uchar int vertex_indices -end_header --0.328125 -0.265625 -0.234375 -1.18435 -1.18435 -1.18435 --0.328125 -0.265625 -0.203125 -1.52027 -1.52027 -1.52027 --0.328125 -0.265625 -0.171875 -2.43562 -2.43562 -2.43562 --0.328125 -0.265625 -0.140625 -2.12642 -2.12642 -2.12642 --0.296875 -0.265625 -0.234375 -1.00854 -1.00854 -1.00854 --0.296875 -0.265625 -0.203125 -1.40556 -1.40556 -1.40556 --0.296875 -0.265625 -0.171875 -1.82911 -1.82911 -1.82911 --0.296875 -0.265625 -0.140625 -1.42634 -1.42634 -1.42634 --0.265625 -0.265625 -0.171875 -1.24359 -1.24359 -1.24359 --0.265625 -0.265625 -0.140625 -1.24044 -1.24044 -1.24044 --0.328125 -0.234375 -0.265625 -1.35847 -1.35847 -1.35847 --0.328125 -0.203125 -0.265625 -1.28947 -1.28947 -1.28947 --0.328125 -0.171875 -0.265625 -1.69545 -1.69545 -1.69545 --0.296875 -0.234375 -0.265625 -1.03771 -1.03771 -1.03771 --0.296875 -0.203125 -0.265625 -1.2917 -1.2917 -1.2917 --0.265625 -0.234375 -0.265625 -1.84375 -1.84375 -1.84375 --0.265625 -0.203125 -0.265625 -1.60463 -1.60463 -1.60463 --0.296875 -0.171875 -0.265625 -1.67774 -1.67774 -1.67774 --0.265625 -0.171875 -0.265625 -1.88081 -1.88081 -1.88081 --0.484375 -0.203125 -0.203125 -1.26078 -1.26078 -1.26078 --0.453125 -0.234375 -0.203125 -1.21894 -1.21894 -1.21894 --0.453125 -0.203125 -0.203125 -1.32358 -1.32358 -1.32358 --0.484375 -0.234375 -0.171875 -0.770092 -0.770092 -0.770092 --0.484375 -0.234375 -0.140625 -1.16901 -1.16901 -1.16901 --0.484375 -0.203125 -0.171875 -1.07265 -1.07265 -1.07265 --0.484375 -0.203125 -0.140625 -1.36238 -1.36238 -1.36238 --0.453125 -0.234375 -0.171875 -1.15939 -1.15939 -1.15939 --0.453125 -0.234375 -0.140625 -1.16286 -1.16286 -1.16286 --0.484375 -0.171875 -0.203125 -1.1786 -1.1786 -1.1786 --0.453125 -0.171875 -0.203125 20.2683 20.2683 20.2683 --0.453125 -0.140625 -0.203125 -1.2347 -1.2347 -1.2347 --0.484375 -0.171875 -0.171875 -1.24456 -1.24456 -1.24456 --0.484375 -0.171875 -0.140625 -1.11308 -1.11308 -1.11308 --0.484375 -0.140625 -0.171875 -1.45279 -1.45279 -1.45279 --0.484375 -0.140625 -0.140625 -1.01801 -1.01801 -1.01801 --0.453125 -0.140625 -0.171875 -1.34509 -1.34509 -1.34509 --0.453125 -0.140625 -0.140625 -1.19021 -1.19021 -1.19021 --0.421875 -0.234375 -0.203125 -1.14711 -1.14711 -1.14711 --0.421875 -0.203125 -0.203125 -1.5993 -1.5993 -1.5993 --0.390625 -0.234375 -0.203125 -2.40333 -2.40333 -2.40333 --0.390625 -0.203125 -0.234375 -2.28526 -2.28526 -2.28526 --0.390625 -0.203125 -0.203125 -2.32885 -2.32885 -2.32885 --0.421875 -0.234375 -0.171875 -1.2289 -1.2289 -1.2289 --0.421875 -0.234375 -0.140625 -1.12093 -1.12093 -1.12093 --0.421875 -0.203125 -0.171875 -1.20992 -1.20992 -1.20992 --0.390625 -0.234375 -0.171875 -1.99874 -1.99874 -1.99874 --0.390625 -0.234375 -0.140625 -1.73107 -1.73107 -1.73107 --0.390625 -0.203125 -0.140625 -1.58953 -1.58953 -1.58953 --0.421875 -0.171875 -0.203125 -1.63329 -1.63329 -1.63329 --0.421875 -0.140625 -0.203125 -1.64022 -1.64022 -1.64022 --0.390625 -0.171875 -0.234375 -1.71563 -1.71563 -1.71563 --0.390625 -0.140625 -0.234375 -1.29241 -1.29241 -1.29241 --0.421875 -0.140625 -0.171875 -1.37257 -1.37257 -1.37257 --0.390625 -0.140625 -0.140625 -1.34646 -1.34646 -1.34646 --0.484375 -0.203125 -0.109375 -0.956011 -0.956011 -0.956011 --0.453125 -0.203125 -0.109375 -0.938933 -0.938933 -0.938933 --0.453125 -0.171875 -0.109375 -0.974257 -0.974257 -0.974257 --0.453125 -0.140625 -0.109375 -1.34285 -1.34285 -1.34285 --0.421875 -0.203125 -0.109375 -1.56271 -1.56271 -1.56271 --0.390625 -0.203125 -0.109375 -1.63993 -1.63993 -1.63993 --0.421875 -0.171875 -0.109375 -1.33726 -1.33726 -1.33726 --0.421875 -0.140625 -0.109375 -1.39689 -1.39689 -1.39689 --0.390625 -0.171875 -0.109375 -1.53427 -1.53427 -1.53427 --0.390625 -0.140625 -0.109375 -1.35141 -1.35141 -1.35141 --0.390625 -0.140625 -0.078125 -1.15886 -1.15886 -1.15886 --0.453125 -0.078125 -0.203125 -0.950281 -0.950281 -0.950281 --0.453125 -0.078125 -0.171875 -1.23277 -1.23277 -1.23277 --0.453125 -0.078125 -0.140625 -1.1083 -1.1083 -1.1083 --0.453125 -0.046875 -0.203125 -1.01126 -1.01126 -1.01126 --0.453125 -0.015625 -0.203125 -1.54474 -1.54474 -1.54474 --0.453125 -0.046875 -0.171875 -1.32309 -1.32309 -1.32309 --0.453125 -0.046875 -0.140625 -1.35908 -1.35908 -1.35908 --0.453125 -0.015625 -0.171875 -1.43724 -1.43724 -1.43724 --0.453125 -0.015625 -0.140625 -1.3135 -1.3135 -1.3135 --0.421875 -0.109375 -0.203125 -1.62883 -1.62883 -1.62883 --0.421875 -0.078125 -0.203125 -1.31749 -1.31749 -1.31749 --0.390625 -0.109375 -0.234375 -0.984559 -0.984559 -0.984559 --0.390625 -0.109375 -0.203125 -1.56068 -1.56068 -1.56068 --0.390625 -0.078125 -0.203125 -1.22632 -1.22632 -1.22632 --0.421875 -0.109375 -0.171875 -1.47965 -1.47965 -1.47965 --0.421875 -0.109375 -0.140625 -1.48452 -1.48452 -1.48452 --0.421875 -0.078125 -0.171875 -1.28565 -1.28565 -1.28565 --0.421875 -0.078125 -0.140625 -1.32369 -1.32369 -1.32369 --0.390625 -0.109375 -0.171875 -1.05455 -1.05455 -1.05455 --0.390625 -0.109375 -0.140625 -1.07475 -1.07475 -1.07475 --0.390625 -0.078125 -0.171875 -1.76393 -1.76393 -1.76393 --0.390625 -0.078125 -0.140625 -0.627024 -0.627024 -0.627024 --0.421875 -0.046875 -0.203125 -1.3024 -1.3024 -1.3024 --0.421875 -0.015625 -0.203125 -1.31264 -1.31264 -1.31264 --0.390625 -0.046875 -0.203125 -1.33668 -1.33668 -1.33668 --0.390625 -0.015625 -0.203125 3.82672 3.82672 3.82672 --0.421875 -0.015625 -0.171875 -1.44495 -1.44495 -1.44495 --0.421875 -0.015625 -0.140625 -1.22408 -1.22408 -1.22408 --0.453125 -0.046875 -0.109375 -0.86366 -0.86366 -0.86366 --0.453125 -0.015625 -0.109375 -1.38333 -1.38333 -1.38333 --0.421875 -0.078125 -0.109375 -1.06018 -1.06018 -1.06018 --0.390625 -0.109375 -0.109375 -1.51475 -1.51475 -1.51475 --0.390625 -0.109375 -0.078125 -1.32902 -1.32902 -1.32902 --0.390625 -0.078125 -0.109375 -1.08399 -1.08399 -1.08399 --0.390625 -0.078125 -0.078125 -1.1628 -1.1628 -1.1628 --0.390625 -0.109375 -0.046875 -1.38009 -1.38009 -1.38009 --0.390625 -0.078125 -0.046875 -1.34519 -1.34519 -1.34519 --0.421875 -0.046875 -0.109375 -1.28013 -1.28013 -1.28013 --0.421875 -0.015625 -0.109375 -1.4225 -1.4225 -1.4225 --0.390625 -0.046875 -0.109375 -1.89014 -1.89014 -1.89014 --0.390625 -0.046875 -0.078125 -2.36883 -2.36883 -2.36883 --0.390625 -0.015625 -0.109375 -2.0123 -2.0123 -2.0123 --0.390625 -0.015625 -0.078125 -2.3597 -2.3597 -2.3597 --0.359375 -0.234375 -0.234375 -1.00495 -1.00495 -1.00495 --0.359375 -0.234375 -0.203125 -1.69184 -1.69184 -1.69184 --0.359375 -0.203125 -0.234375 -1.73139 -1.73139 -1.73139 --0.359375 -0.203125 -0.203125 -1.474 -1.474 -1.474 --0.328125 -0.234375 -0.234375 -1.54301 -1.54301 -1.54301 --0.328125 -0.234375 -0.203125 -1.29623 -1.29623 -1.29623 --0.328125 -0.203125 -0.234375 -1.65563 -1.65563 -1.65563 --0.359375 -0.234375 -0.171875 -1.65057 -1.65057 -1.65057 --0.359375 -0.234375 -0.140625 -2.05713 -2.05713 -2.05713 --0.328125 -0.234375 -0.171875 -2.21909 -2.21909 -2.21909 --0.328125 -0.234375 -0.140625 -2.29053 -2.29053 -2.29053 --0.359375 -0.171875 -0.234375 -1.38896 -1.38896 -1.38896 --0.359375 -0.140625 -0.234375 -1.12735 -1.12735 -1.12735 --0.328125 -0.171875 -0.234375 -1.70324 -1.70324 -1.70324 --0.328125 -0.171875 -0.203125 -1.09265 -1.09265 -1.09265 --0.328125 -0.140625 -0.234375 -0.480864 -0.480864 -0.480864 --0.328125 -0.140625 -0.203125 -1.37879 -1.37879 -1.37879 --0.359375 -0.140625 -0.140625 -1.51412 -1.51412 -1.51412 --0.328125 -0.140625 -0.171875 -1.05225 -1.05225 -1.05225 --0.328125 -0.140625 -0.140625 -1.75422 -1.75422 -1.75422 --0.296875 -0.234375 -0.234375 -1.34252 -1.34252 -1.34252 --0.265625 -0.234375 -0.234375 -1.38123 -1.38123 -1.38123 --0.265625 -0.234375 -0.203125 -1.30189 -1.30189 -1.30189 --0.265625 -0.203125 -0.234375 -1.55105 -1.55105 -1.55105 --0.265625 -0.203125 -0.203125 -1.38706 -1.38706 -1.38706 --0.296875 -0.234375 -0.140625 -1.42054 -1.42054 -1.42054 --0.265625 -0.234375 -0.140625 -1.32614 -1.32614 -1.32614 --0.296875 -0.171875 -0.234375 -1.74635 -1.74635 -1.74635 --0.296875 -0.171875 -0.203125 -1.34131 -1.34131 -1.34131 --0.296875 -0.140625 -0.234375 -1.14111 -1.14111 -1.14111 --0.296875 -0.140625 -0.203125 -1.10187 -1.10187 -1.10187 --0.265625 -0.171875 -0.234375 -1.57422 -1.57422 -1.57422 --0.265625 -0.171875 -0.203125 -1.54674 -1.54674 -1.54674 --0.265625 -0.140625 -0.234375 -1.52828 -1.52828 -1.52828 --0.265625 -0.140625 -0.203125 -1.43254 -1.43254 -1.43254 --0.296875 -0.171875 -0.171875 -1.39002 -1.39002 -1.39002 --0.296875 -0.171875 -0.140625 -1.50821 -1.50821 -1.50821 --0.296875 -0.140625 -0.171875 -1.36844 -1.36844 -1.36844 --0.296875 -0.140625 -0.140625 -1.70791 -1.70791 -1.70791 --0.265625 -0.171875 -0.171875 -1.39249 -1.39249 -1.39249 --0.265625 -0.171875 -0.140625 -1.35068 -1.35068 -1.35068 --0.265625 -0.140625 -0.140625 -1.4728 -1.4728 -1.4728 --0.359375 -0.234375 -0.109375 -1.78186 -1.78186 -1.78186 --0.359375 -0.203125 -0.109375 -2.0627 -2.0627 -2.0627 --0.328125 -0.234375 -0.109375 -2.10349 -2.10349 -2.10349 --0.328125 -0.203125 -0.109375 -2.22168 -2.22168 -2.22168 --0.359375 -0.171875 -0.109375 -1.95386 -1.95386 -1.95386 --0.359375 -0.140625 -0.109375 -1.31333 -1.31333 -1.31333 --0.359375 -0.140625 -0.078125 -1.34366 -1.34366 -1.34366 --0.328125 -0.171875 -0.109375 -2.02199 -2.02199 -2.02199 --0.328125 -0.140625 -0.109375 -2.22026 -2.22026 -2.22026 --0.328125 -0.140625 -0.078125 -1.42859 -1.42859 -1.42859 --0.328125 -0.140625 -0.046875 -2.01873 -2.01873 -2.01873 --0.328125 -0.140625 -0.015625 -1.32134 -1.32134 -1.32134 --0.296875 -0.234375 -0.109375 -0.725448 -0.725448 -0.725448 --0.296875 -0.203125 -0.109375 -1.5494 -1.5494 -1.5494 --0.265625 -0.234375 -0.109375 -1.24995 -1.24995 -1.24995 --0.265625 -0.203125 -0.109375 -1.42632 -1.42632 -1.42632 --0.296875 -0.171875 -0.109375 -2.04668 -2.04668 -2.04668 --0.296875 -0.140625 -0.109375 -2.38946 -2.38946 -2.38946 --0.296875 -0.140625 -0.078125 -2.48866 -2.48866 -2.48866 --0.265625 -0.171875 -0.078125 -1.75138 -1.75138 -1.75138 --0.265625 -0.140625 -0.109375 -2.26145 -2.26145 -2.26145 --0.265625 -0.140625 -0.078125 -2.15619 -2.15619 -2.15619 --0.296875 -0.171875 -0.046875 -1.8488 -1.8488 -1.8488 --0.296875 -0.171875 -0.015625 -2.0408 -2.0408 -2.0408 --0.296875 -0.140625 -0.046875 -2.38095 -2.38095 -2.38095 --0.296875 -0.140625 -0.015625 -2.42051 -2.42051 -2.42051 --0.265625 -0.171875 -0.046875 -2.18876 -2.18876 -2.18876 --0.265625 -0.171875 -0.015625 -1.72267 -1.72267 -1.72267 --0.265625 -0.140625 -0.046875 -2.04386 -2.04386 -2.04386 --0.359375 -0.109375 -0.234375 -0.98906 -0.98906 -0.98906 --0.359375 -0.078125 -0.234375 -1.47983 -1.47983 -1.47983 --0.359375 -0.078125 -0.203125 -1.81373 -1.81373 -1.81373 --0.328125 -0.109375 -0.234375 -0.992739 -0.992739 -0.992739 --0.328125 -0.109375 -0.203125 -1.87583 -1.87583 -1.87583 --0.328125 -0.078125 -0.203125 -1.01335 -1.01335 -1.01335 --0.359375 -0.109375 -0.171875 -0.861837 -0.861837 -0.861837 --0.359375 -0.109375 -0.140625 -0.812353 -0.812353 -0.812353 --0.359375 -0.078125 -0.171875 -0.535577 -0.535577 -0.535577 --0.359375 -0.078125 -0.140625 -0.0501968 -0.0501968 -0.0501968 --0.328125 -0.109375 -0.171875 -1.22606 -1.22606 -1.22606 --0.328125 -0.109375 -0.140625 -1.75548 -1.75548 -1.75548 --0.328125 -0.078125 -0.171875 -1.62417 -1.62417 -1.62417 --0.328125 -0.078125 -0.140625 -3.24168 -3.24168 -3.24168 --0.359375 -0.046875 -0.203125 0.145368 0.145368 0.145368 --0.359375 -0.015625 -0.203125 9.38567 9.38567 9.38567 --0.328125 -0.046875 -0.203125 -6.72466 -6.72466 -6.72466 --0.328125 -0.015625 -0.234375 -28.9284 -28.9284 -28.9284 --0.328125 -0.015625 -0.203125 -2.0667 -2.0667 -2.0667 --0.328125 -0.046875 -0.171875 0.404815 0.404815 0.404815 --0.328125 -0.015625 -0.171875 7.55861 7.55861 7.55861 --0.328125 -0.015625 -0.140625 -6.66999 -6.66999 -6.66999 --0.296875 -0.109375 -0.234375 -0.00459807 -0.00459807 -0.00459807 --0.296875 -0.109375 -0.203125 0.159143 0.159143 0.159143 --0.296875 -0.078125 -0.203125 0.529766 0.529766 0.529766 --0.265625 -0.109375 -0.234375 0.301208 0.301208 0.301208 --0.265625 -0.078125 -0.234375 -3.79626 -3.79626 -3.79626 --0.265625 -0.078125 -0.203125 0.746279 0.746279 0.746279 --0.296875 -0.109375 -0.140625 -1.20988 -1.20988 -1.20988 --0.296875 -0.078125 -0.171875 -0.471252 -0.471252 -0.471252 --0.296875 -0.078125 -0.140625 -2.50607 -2.50607 -2.50607 --0.296875 -0.046875 -0.234375 -1.4037 -1.4037 -1.4037 --0.296875 -0.046875 -0.203125 1.97023 1.97023 1.97023 --0.296875 -0.015625 -0.234375 3.37336 3.37336 3.37336 --0.265625 -0.046875 -0.234375 -2.12941 -2.12941 -2.12941 --0.265625 -0.046875 -0.203125 -6.51754 -6.51754 -6.51754 --0.265625 -0.015625 -0.234375 -3.09438 -3.09438 -3.09438 --0.296875 -0.046875 -0.171875 -2.29147 -2.29147 -2.29147 --0.296875 -0.046875 -0.140625 0.254815 0.254815 0.254815 --0.296875 -0.015625 -0.171875 1.05265 1.05265 1.05265 --0.296875 -0.015625 -0.140625 0.454681 0.454681 0.454681 --0.265625 -0.046875 -0.171875 -1.91018 -1.91018 -1.91018 --0.265625 -0.046875 -0.140625 -1.2111 -1.2111 -1.2111 --0.265625 -0.015625 -0.140625 -1.06599 -1.06599 -1.06599 --0.359375 -0.109375 -0.078125 -1.58383 -1.58383 -1.58383 --0.359375 -0.078125 -0.078125 -1.41533 -1.41533 -1.41533 --0.328125 -0.109375 -0.078125 -1.40911 -1.40911 -1.40911 --0.359375 -0.109375 -0.046875 -1.21011 -1.21011 -1.21011 --0.359375 -0.078125 -0.046875 -1.18622 -1.18622 -1.18622 --0.328125 -0.109375 -0.046875 -1.63181 -1.63181 -1.63181 --0.328125 -0.109375 -0.015625 -2.01203 -2.01203 -2.01203 --0.328125 -0.078125 -0.046875 -1.60598 -1.60598 -1.60598 --0.328125 -0.078125 -0.015625 -2.04281 -2.04281 -2.04281 --0.359375 -0.046875 -0.078125 -1.34274 -1.34274 -1.34274 --0.359375 -0.015625 -0.078125 -2.26954 -2.26954 -2.26954 --0.328125 -0.046875 -0.078125 -1.34062 -1.34062 -1.34062 --0.328125 -0.015625 -0.078125 -1.47731 -1.47731 -1.47731 --0.359375 -0.015625 -0.046875 -0.822195 -0.822195 -0.822195 --0.359375 -0.015625 -0.015625 -0.910819 -0.910819 -0.910819 --0.328125 -0.046875 -0.046875 -2.39064 -2.39064 -2.39064 --0.328125 -0.046875 -0.015625 -1.14397 -1.14397 -1.14397 --0.328125 -0.015625 -0.046875 -0.728296 -0.728296 -0.728296 --0.328125 -0.015625 -0.015625 -1.01335 -1.01335 -1.01335 --0.296875 -0.109375 -0.078125 -2.28751 -2.28751 -2.28751 --0.296875 -0.109375 -0.046875 -2.14 -2.14 -2.14 --0.296875 -0.078125 -0.046875 -1.77382 -1.77382 -1.77382 --0.296875 -0.078125 -0.015625 -1.98474 -1.98474 -1.98474 --0.296875 -0.046875 -0.078125 -1.90068 -1.90068 -1.90068 --0.296875 -0.015625 -0.078125 -1.10503 -1.10503 -1.10503 --0.265625 -0.046875 -0.109375 -1.93254 -1.93254 -1.93254 --0.265625 -0.046875 -0.078125 -1.74363 -1.74363 -1.74363 --0.265625 -0.015625 -0.109375 -1.41216 -1.41216 -1.41216 --0.265625 -0.015625 -0.078125 -1.46344 -1.46344 -1.46344 --0.296875 -0.046875 -0.046875 -1.92381 -1.92381 -1.92381 --0.296875 -0.046875 -0.015625 -2.11821 -2.11821 -2.11821 --0.296875 -0.015625 -0.046875 -1.04626 -1.04626 -1.04626 --0.296875 -0.015625 -0.015625 -1.26808 -1.26808 -1.26808 --0.265625 -0.046875 -0.046875 -1.85279 -1.85279 -1.85279 --0.265625 -0.046875 -0.015625 -1.99407 -1.99407 -1.99407 --0.265625 -0.015625 -0.046875 -1.09981 -1.09981 -1.09981 --0.265625 -0.015625 -0.015625 -1.3942 -1.3942 -1.3942 --0.203125 -0.265625 -0.265625 -1.82407 -1.82407 -1.82407 --0.171875 -0.265625 -0.265625 -1.78216 -1.78216 -1.78216 --0.140625 -0.265625 -0.265625 -0.969149 -0.969149 -0.969149 --0.234375 -0.296875 -0.234375 -0.698552 -0.698552 -0.698552 --0.234375 -0.296875 -0.203125 -0.8487 -0.8487 -0.8487 --0.234375 -0.265625 -0.234375 -0.971232 -0.971232 -0.971232 --0.234375 -0.265625 -0.203125 -1.01439 -1.01439 -1.01439 --0.203125 -0.296875 -0.234375 -0.887071 -0.887071 -0.887071 --0.203125 -0.296875 -0.203125 -1.01369 -1.01369 -1.01369 --0.203125 -0.265625 -0.234375 -1.08815 -1.08815 -1.08815 --0.234375 -0.265625 -0.171875 -0.934388 -0.934388 -0.934388 --0.234375 -0.265625 -0.140625 -1.17573 -1.17573 -1.17573 --0.203125 -0.296875 -0.171875 -0.819783 -0.819783 -0.819783 --0.203125 -0.265625 -0.171875 -0.985024 -0.985024 -0.985024 --0.171875 -0.296875 -0.234375 -1.01029 -1.01029 -1.01029 --0.171875 -0.296875 -0.203125 -0.978603 -0.978603 -0.978603 --0.171875 -0.265625 -0.234375 -1.17272 -1.17272 -1.17272 --0.171875 -0.265625 -0.203125 -1.6503 -1.6503 -1.6503 --0.140625 -0.265625 -0.234375 -1.08939 -1.08939 -1.08939 --0.140625 -0.265625 -0.203125 -1.02822 -1.02822 -1.02822 --0.171875 -0.265625 -0.171875 -0.960368 -0.960368 -0.960368 --0.171875 -0.265625 -0.015625 -1.80392 -1.80392 -1.80392 --0.140625 -0.296875 -0.015625 -0.932753 -0.932753 -0.932753 --0.140625 -0.265625 -0.015625 -1.98104 -1.98104 -1.98104 --0.109375 -0.265625 -0.234375 -0.844741 -0.844741 -0.844741 --0.109375 -0.265625 -0.203125 -0.820398 -0.820398 -0.820398 --0.109375 -0.296875 -0.015625 -1.74616 -1.74616 -1.74616 --0.109375 -0.265625 -0.015625 -2.57395 -2.57395 -2.57395 --0.078125 -0.265625 -0.015625 -2.05459 -2.05459 -2.05459 --0.046875 -0.296875 -0.046875 -1.39489 -1.39489 -1.39489 --0.046875 -0.296875 -0.015625 -0.521606 -0.521606 -0.521606 --0.046875 -0.265625 -0.046875 -1.81047 -1.81047 -1.81047 --0.046875 -0.265625 -0.015625 -1.70935 -1.70935 -1.70935 --0.015625 -0.296875 -0.046875 -0.985579 -0.985579 -0.985579 --0.015625 -0.296875 -0.015625 -3.13035 -3.13035 -3.13035 --0.015625 -0.265625 -0.046875 -1.52752 -1.52752 -1.52752 --0.234375 -0.234375 -0.296875 -1.76155 -1.76155 -1.76155 --0.234375 -0.234375 -0.265625 -2.06315 -2.06315 -2.06315 --0.234375 -0.203125 -0.296875 -1.70793 -1.70793 -1.70793 --0.234375 -0.203125 -0.265625 -2.16351 -2.16351 -2.16351 --0.203125 -0.234375 -0.296875 -1.67803 -1.67803 -1.67803 --0.203125 -0.234375 -0.265625 -2.03277 -2.03277 -2.03277 --0.203125 -0.203125 -0.296875 -1.76612 -1.76612 -1.76612 --0.234375 -0.171875 -0.296875 -1.66107 -1.66107 -1.66107 --0.234375 -0.171875 -0.265625 -2.19781 -2.19781 -2.19781 --0.234375 -0.140625 -0.265625 -1.86224 -1.86224 -1.86224 --0.203125 -0.171875 -0.296875 -1.72055 -1.72055 -1.72055 --0.203125 -0.140625 -0.296875 -1.60191 -1.60191 -1.60191 --0.203125 -0.140625 -0.265625 -2.01484 -2.01484 -2.01484 --0.171875 -0.234375 -0.265625 -1.33985 -1.33985 -1.33985 --0.171875 -0.203125 -0.296875 -1.43087 -1.43087 -1.43087 --0.171875 -0.203125 -0.265625 -1.81587 -1.81587 -1.81587 --0.140625 -0.234375 -0.265625 -1.12606 -1.12606 -1.12606 --0.140625 -0.203125 -0.265625 -1.95086 -1.95086 -1.95086 --0.171875 -0.171875 -0.296875 -1.69161 -1.69161 -1.69161 --0.171875 -0.140625 -0.296875 -1.68773 -1.68773 -1.68773 --0.171875 -0.140625 -0.265625 -2.16001 -2.16001 -2.16001 --0.140625 -0.171875 -0.296875 -1.74255 -1.74255 -1.74255 --0.140625 -0.171875 -0.265625 -2.22096 -2.22096 -2.22096 --0.140625 -0.140625 -0.265625 -2.2784 -2.2784 -2.2784 --0.203125 -0.078125 -0.390625 -1.97054 -1.97054 -1.97054 --0.203125 -0.046875 -0.390625 -2.20004 -2.20004 -2.20004 --0.203125 -0.015625 -0.390625 -2.55464 -2.55464 -2.55464 --0.171875 -0.078125 -0.390625 -2.40383 -2.40383 -2.40383 --0.140625 -0.078125 -0.390625 -2.1748 -2.1748 -2.1748 --0.171875 -0.046875 -0.390625 -2.32758 -2.32758 -2.32758 --0.171875 -0.015625 -0.390625 -2.34192 -2.34192 -2.34192 --0.140625 -0.046875 -0.421875 -1.74703 -1.74703 -1.74703 --0.140625 -0.046875 -0.390625 -2.1267 -2.1267 -2.1267 --0.140625 -0.015625 -0.421875 -2.46532 -2.46532 -2.46532 --0.140625 -0.015625 -0.390625 -2.64636 -2.64636 -2.64636 --0.203125 -0.078125 -0.359375 -2.51053 -2.51053 -2.51053 --0.203125 -0.078125 -0.328125 -2.74088 -2.74088 -2.74088 --0.234375 -0.078125 -0.265625 -6.56185 -6.56185 -6.56185 --0.203125 -0.109375 -0.265625 -2.50919 -2.50919 -2.50919 --0.203125 -0.078125 -0.296875 -0.951963 -0.951963 -0.951963 --0.203125 -0.078125 -0.265625 2.26722 2.26722 2.26722 --0.203125 -0.046875 -0.359375 -2.57083 -2.57083 -2.57083 --0.203125 -0.046875 -0.328125 -2.09444 -2.09444 -2.09444 --0.203125 -0.015625 -0.359375 -1.95757 -1.95757 -1.95757 --0.203125 -0.015625 -0.328125 -1.46307 -1.46307 -1.46307 --0.234375 -0.046875 -0.265625 3.28916 3.28916 3.28916 --0.203125 -0.046875 -0.296875 -1.81664 -1.81664 -1.81664 --0.203125 -0.046875 -0.265625 3.76006 3.76006 3.76006 --0.203125 -0.015625 -0.296875 -2.4061 -2.4061 -2.4061 --0.203125 -0.015625 -0.265625 -4.05796 -4.05796 -4.05796 --0.171875 -0.109375 -0.359375 -1.95255 -1.95255 -1.95255 --0.171875 -0.109375 -0.328125 -1.90267 -1.90267 -1.90267 --0.171875 -0.078125 -0.359375 -2.4362 -2.4362 -2.4362 --0.171875 -0.078125 -0.328125 -2.40136 -2.40136 -2.40136 --0.140625 -0.109375 -0.359375 -1.85673 -1.85673 -1.85673 --0.140625 -0.109375 -0.328125 -1.14757 -1.14757 -1.14757 --0.140625 -0.078125 -0.359375 -2.41346 -2.41346 -2.41346 --0.140625 -0.078125 -0.328125 -2.48491 -2.48491 -2.48491 --0.171875 -0.109375 -0.265625 -1.97776 -1.97776 -1.97776 --0.171875 -0.078125 -0.296875 -1.26807 -1.26807 -1.26807 --0.171875 -0.078125 -0.265625 -2.20508 -2.20508 -2.20508 --0.140625 -0.109375 -0.265625 -2.45833 -2.45833 -2.45833 --0.140625 -0.078125 -0.296875 -2.77286 -2.77286 -2.77286 --0.140625 -0.078125 -0.265625 -2.69493 -2.69493 -2.69493 --0.171875 -0.015625 -0.359375 -3.10843 -3.10843 -3.10843 --0.171875 -0.015625 -0.328125 -1.94678 -1.94678 -1.94678 --0.171875 -0.046875 -0.265625 -2.94048 -2.94048 -2.94048 --0.171875 -0.015625 -0.265625 -2.135 -2.135 -2.135 --0.140625 -0.046875 -0.265625 -1.67683 -1.67683 -1.67683 --0.109375 -0.203125 -0.328125 -0.871857 -0.871857 -0.871857 --0.078125 -0.203125 -0.328125 -1.05896 -1.05896 -1.05896 --0.109375 -0.203125 -0.296875 -0.985476 -0.985476 -0.985476 --0.109375 -0.203125 -0.265625 -1.04751 -1.04751 -1.04751 --0.078125 -0.203125 -0.296875 -1.0423 -1.0423 -1.0423 --0.078125 -0.203125 -0.265625 -0.963695 -0.963695 -0.963695 --0.109375 -0.171875 -0.328125 -0.991831 -0.991831 -0.991831 --0.109375 -0.140625 -0.328125 -0.93941 -0.93941 -0.93941 --0.078125 -0.171875 -0.359375 -0.869329 -0.869329 -0.869329 --0.078125 -0.171875 -0.328125 -1.47796 -1.47796 -1.47796 --0.078125 -0.140625 -0.328125 -0.935178 -0.935178 -0.935178 --0.109375 -0.171875 -0.296875 -1.0174 -1.0174 -1.0174 --0.109375 -0.171875 -0.265625 -1.11713 -1.11713 -1.11713 --0.109375 -0.140625 -0.296875 -1.21081 -1.21081 -1.21081 --0.109375 -0.140625 -0.265625 -1.23806 -1.23806 -1.23806 --0.046875 -0.203125 -0.328125 -0.724694 -0.724694 -0.724694 --0.046875 -0.203125 -0.296875 -1.23552 -1.23552 -1.23552 --0.046875 -0.203125 -0.265625 -1.0906 -1.0906 -1.0906 --0.046875 -0.171875 -0.328125 -0.879373 -0.879373 -0.879373 --0.046875 -0.140625 -0.328125 -0.607993 -0.607993 -0.607993 --0.015625 -0.140625 -0.328125 -43.4776 -43.4776 -43.4776 --0.046875 -0.171875 -0.296875 -1.15535 -1.15535 -1.15535 --0.046875 -0.171875 -0.265625 -1.43126 -1.43126 -1.43126 --0.015625 -0.171875 -0.296875 0.641363 0.641363 0.641363 --0.015625 -0.171875 -0.265625 -0.178714 -0.178714 -0.178714 --0.015625 -0.140625 -0.296875 -3.06091 -3.06091 -3.06091 --0.015625 -0.140625 -0.265625 -2.54283 -2.54283 -2.54283 --0.109375 -0.078125 -0.421875 -1.63832 -1.63832 -1.63832 --0.109375 -0.078125 -0.390625 -2.10251 -2.10251 -2.10251 --0.078125 -0.078125 -0.390625 -2.0036 -2.0036 -2.0036 --0.109375 -0.046875 -0.421875 -1.86896 -1.86896 -1.86896 --0.109375 -0.015625 -0.421875 -1.95495 -1.95495 -1.95495 --0.109375 -0.015625 -0.390625 -2.47329 -2.47329 -2.47329 --0.078125 -0.046875 -0.421875 -1.90887 -1.90887 -1.90887 --0.078125 -0.046875 -0.390625 -2.23117 -2.23117 -2.23117 --0.078125 -0.015625 -0.421875 -2.23047 -2.23047 -2.23047 --0.078125 -0.015625 -0.390625 -2.42085 -2.42085 -2.42085 --0.046875 -0.078125 -0.390625 -1.97835 -1.97835 -1.97835 --0.015625 -0.078125 -0.421875 -15.2479 -15.2479 -15.2479 --0.015625 -0.078125 -0.390625 -15.8626 -15.8626 -15.8626 --0.046875 -0.046875 -0.421875 -1.66437 -1.66437 -1.66437 --0.046875 -0.046875 -0.390625 -2.13849 -2.13849 -2.13849 --0.046875 -0.015625 -0.421875 -2.06634 -2.06634 -2.06634 --0.015625 -0.046875 -0.421875 3.82641 3.82641 3.82641 --0.015625 -0.015625 -0.421875 -1.63532 -1.63532 -1.63532 --0.109375 -0.109375 -0.328125 -1.42985 -1.42985 -1.42985 --0.109375 -0.078125 -0.359375 -2.02532 -2.02532 -2.02532 --0.109375 -0.078125 -0.328125 -2.09274 -2.09274 -2.09274 --0.078125 -0.109375 -0.359375 -1.06697 -1.06697 -1.06697 --0.078125 -0.109375 -0.328125 -1.29527 -1.29527 -1.29527 --0.078125 -0.078125 -0.359375 -2.2664 -2.2664 -2.2664 --0.078125 -0.078125 -0.328125 -1.38078 -1.38078 -1.38078 --0.109375 -0.109375 -0.296875 -1.54058 -1.54058 -1.54058 --0.109375 -0.109375 -0.265625 -2.33964 -2.33964 -2.33964 --0.109375 -0.078125 -0.296875 -1.61749 -1.61749 -1.61749 --0.109375 -0.078125 -0.265625 -2.03305 -2.03305 -2.03305 --0.078125 -0.078125 -0.296875 -0.943432 -0.943432 -0.943432 --0.078125 -0.078125 -0.265625 -0.831375 -0.831375 -0.831375 --0.109375 -0.046875 -0.328125 -2.08997 -2.08997 -2.08997 --0.078125 -0.046875 -0.359375 -2.11524 -2.11524 -2.11524 --0.078125 -0.046875 -0.328125 -1.85182 -1.85182 -1.85182 --0.109375 -0.046875 -0.296875 -1.35018 -1.35018 -1.35018 --0.109375 -0.046875 -0.265625 -1.35033 -1.35033 -1.35033 --0.078125 -0.046875 -0.296875 -0.886992 -0.886992 -0.886992 --0.046875 -0.109375 -0.359375 -1.46074 -1.46074 -1.46074 --0.046875 -0.109375 -0.328125 -1.30324 -1.30324 -1.30324 --0.046875 -0.078125 -0.359375 -1.95 -1.95 -1.95 --0.046875 -0.078125 -0.328125 -1.39619 -1.39619 -1.39619 --0.015625 -0.109375 -0.328125 -0.509562 -0.509562 -0.509562 --0.015625 -0.078125 -0.359375 -1.69458 -1.69458 -1.69458 --0.015625 -0.078125 -0.328125 -1.58124 -1.58124 -1.58124 --0.015625 -0.109375 -0.296875 -1.81865 -1.81865 -1.81865 --0.015625 -0.109375 -0.265625 -1.72818 -1.72818 -1.72818 --0.015625 -0.078125 -0.296875 -1.28497 -1.28497 -1.28497 --0.015625 -0.078125 -0.265625 -1.41779 -1.41779 -1.41779 --0.046875 -0.046875 -0.359375 -2.12259 -2.12259 -2.12259 --0.046875 -0.046875 -0.328125 -1.50138 -1.50138 -1.50138 --0.046875 -0.015625 -0.328125 -2.15294 -2.15294 -2.15294 --0.015625 -0.046875 -0.328125 -1.55934 -1.55934 -1.55934 --0.015625 -0.015625 -0.328125 -1.7403 -1.7403 -1.7403 --0.046875 -0.046875 -0.296875 -0.933596 -0.933596 -0.933596 --0.046875 -0.015625 -0.296875 -1.34478 -1.34478 -1.34478 --0.046875 -0.015625 -0.265625 -1.56792 -1.56792 -1.56792 --0.015625 -0.046875 -0.296875 -1.25556 -1.25556 -1.25556 --0.015625 -0.046875 -0.265625 -1.46926 -1.46926 -1.46926 --0.015625 -0.015625 -0.296875 -1.33328 -1.33328 -1.33328 --0.015625 -0.015625 -0.265625 -1.19752 -1.19752 -1.19752 --0.234375 -0.234375 -0.234375 -1.4935 -1.4935 -1.4935 --0.234375 -0.234375 -0.203125 -1.31337 -1.31337 -1.31337 --0.234375 -0.203125 -0.203125 -1.58759 -1.58759 -1.58759 --0.203125 -0.203125 -0.203125 -1.74892 -1.74892 -1.74892 --0.234375 -0.234375 -0.171875 -1.35156 -1.35156 -1.35156 --0.234375 -0.234375 -0.140625 -1.55505 -1.55505 -1.55505 --0.234375 -0.203125 -0.171875 -1.38202 -1.38202 -1.38202 --0.234375 -0.203125 -0.140625 -1.65044 -1.65044 -1.65044 --0.203125 -0.234375 -0.171875 -1.03439 -1.03439 -1.03439 --0.203125 -0.234375 -0.140625 -0.964539 -0.964539 -0.964539 --0.203125 -0.203125 -0.171875 -1.01051 -1.01051 -1.01051 --0.203125 -0.203125 -0.140625 -0.978187 -0.978187 -0.978187 --0.234375 -0.171875 -0.234375 -2.0222 -2.0222 -2.0222 --0.234375 -0.171875 -0.203125 -1.78713 -1.78713 -1.78713 --0.234375 -0.140625 -0.234375 -2.37071 -2.37071 -2.37071 --0.234375 -0.140625 -0.203125 -2.81615 -2.81615 -2.81615 --0.203125 -0.171875 -0.203125 -1.73822 -1.73822 -1.73822 --0.234375 -0.171875 -0.171875 -1.55185 -1.55185 -1.55185 --0.234375 -0.171875 -0.140625 -1.59698 -1.59698 -1.59698 --0.234375 -0.140625 -0.171875 -1.20262 -1.20262 -1.20262 --0.234375 -0.140625 -0.140625 -1.98427 -1.98427 -1.98427 --0.203125 -0.171875 -0.171875 -1.9705 -1.9705 -1.9705 --0.203125 -0.171875 -0.140625 -1.89504 -1.89504 -1.89504 --0.203125 -0.140625 -0.171875 -0.933291 -0.933291 -0.933291 --0.203125 -0.140625 -0.140625 -2.03798 -2.03798 -2.03798 --0.171875 -0.203125 -0.203125 -1.58951 -1.58951 -1.58951 --0.140625 -0.234375 -0.234375 -1.21528 -1.21528 -1.21528 --0.140625 -0.234375 -0.203125 -1.11835 -1.11835 -1.11835 --0.140625 -0.203125 -0.234375 -1.19781 -1.19781 -1.19781 --0.140625 -0.203125 -0.203125 -1.20521 -1.20521 -1.20521 --0.171875 -0.234375 -0.171875 -1.06019 -1.06019 -1.06019 --0.171875 -0.234375 -0.140625 -0.89222 -0.89222 -0.89222 --0.171875 -0.203125 -0.171875 -1.02666 -1.02666 -1.02666 --0.171875 -0.203125 -0.140625 -1.00279 -1.00279 -1.00279 --0.140625 -0.234375 -0.171875 -0.700245 -0.700245 -0.700245 --0.140625 -0.203125 -0.171875 -0.867511 -0.867511 -0.867511 --0.140625 -0.171875 -0.234375 -2.05976 -2.05976 -2.05976 --0.140625 -0.171875 -0.203125 -1.98407 -1.98407 -1.98407 --0.140625 -0.140625 -0.234375 -2.35035 -2.35035 -2.35035 --0.140625 -0.140625 -0.203125 -2.09661 -2.09661 -2.09661 --0.171875 -0.171875 -0.171875 -1.96068 -1.96068 -1.96068 --0.171875 -0.171875 -0.140625 -2.0271 -2.0271 -2.0271 --0.171875 -0.140625 -0.140625 -2.11215 -2.11215 -2.11215 --0.140625 -0.171875 -0.171875 -1.97677 -1.97677 -1.97677 --0.140625 -0.171875 -0.140625 -2.03521 -2.03521 -2.03521 --0.140625 -0.140625 -0.171875 -1.96652 -1.96652 -1.96652 --0.140625 -0.140625 -0.140625 -1.64716 -1.64716 -1.64716 --0.234375 -0.234375 -0.109375 -1.47806 -1.47806 -1.47806 --0.234375 -0.234375 -0.078125 -1.25938 -1.25938 -1.25938 --0.234375 -0.203125 -0.109375 -1.97962 -1.97962 -1.97962 --0.234375 -0.203125 -0.078125 -1.88138 -1.88138 -1.88138 --0.203125 -0.234375 -0.109375 -1.54961 -1.54961 -1.54961 --0.203125 -0.234375 -0.078125 -1.62273 -1.62273 -1.62273 --0.203125 -0.203125 -0.109375 -2.04242 -2.04242 -2.04242 --0.234375 -0.234375 -0.046875 -1.3948 -1.3948 -1.3948 --0.234375 -0.203125 -0.046875 -2.0149 -2.0149 -2.0149 --0.234375 -0.203125 -0.015625 -1.66731 -1.66731 -1.66731 --0.203125 -0.234375 -0.046875 -1.76267 -1.76267 -1.76267 --0.203125 -0.203125 -0.015625 -2.35089 -2.35089 -2.35089 --0.234375 -0.171875 -0.109375 -2.04703 -2.04703 -2.04703 --0.234375 -0.171875 -0.078125 -1.99751 -1.99751 -1.99751 --0.234375 -0.140625 -0.109375 -2.1834 -2.1834 -2.1834 --0.234375 -0.140625 -0.078125 -1.81239 -1.81239 -1.81239 --0.203125 -0.171875 -0.109375 -2.14419 -2.14419 -2.14419 --0.203125 -0.140625 -0.109375 -2.09684 -2.09684 -2.09684 --0.203125 -0.140625 -0.078125 -2.12308 -2.12308 -2.12308 --0.234375 -0.171875 -0.046875 -1.91717 -1.91717 -1.91717 --0.234375 -0.171875 -0.015625 -1.64428 -1.64428 -1.64428 --0.234375 -0.140625 -0.046875 -1.91807 -1.91807 -1.91807 --0.234375 -0.140625 -0.015625 -2.11983 -2.11983 -2.11983 --0.203125 -0.171875 -0.015625 -1.80431 -1.80431 -1.80431 --0.203125 -0.140625 -0.046875 -1.82821 -1.82821 -1.82821 --0.171875 -0.234375 -0.078125 -1.5354 -1.5354 -1.5354 --0.171875 -0.203125 -0.109375 -1.99844 -1.99844 -1.99844 --0.171875 -0.203125 -0.078125 -2.22446 -2.22446 -2.22446 --0.140625 -0.203125 -0.078125 -1.84754 -1.84754 -1.84754 --0.171875 -0.234375 -0.046875 -2.07745 -2.07745 -2.07745 --0.171875 -0.234375 -0.015625 -1.78789 -1.78789 -1.78789 --0.171875 -0.203125 -0.046875 -2.66623 -2.66623 -2.66623 --0.171875 -0.203125 -0.015625 -2.51164 -2.51164 -2.51164 --0.140625 -0.234375 -0.015625 -2.53147 -2.53147 -2.53147 --0.140625 -0.203125 -0.046875 -2.00021 -2.00021 -2.00021 --0.140625 -0.203125 -0.015625 -1.82658 -1.82658 -1.82658 --0.171875 -0.171875 -0.109375 -2.34645 -2.34645 -2.34645 --0.171875 -0.171875 -0.078125 -2.23021 -2.23021 -2.23021 --0.171875 -0.140625 -0.109375 -2.74229 -2.74229 -2.74229 --0.171875 -0.140625 -0.078125 -1.85364 -1.85364 -1.85364 --0.140625 -0.171875 -0.109375 -2.13764 -2.13764 -2.13764 --0.140625 -0.171875 -0.078125 -2.20524 -2.20524 -2.20524 --0.140625 -0.140625 -0.109375 -2.13814 -2.13814 -2.13814 --0.140625 -0.140625 -0.078125 -2.32844 -2.32844 -2.32844 --0.171875 -0.171875 -0.046875 -2.29266 -2.29266 -2.29266 --0.171875 -0.171875 -0.015625 -1.76854 -1.76854 -1.76854 --0.171875 -0.140625 -0.046875 -1.11815 -1.11815 -1.11815 --0.171875 -0.140625 -0.015625 -0.688719 -0.688719 -0.688719 --0.140625 -0.171875 -0.046875 -1.32009 -1.32009 -1.32009 --0.140625 -0.171875 -0.015625 -0.973085 -0.973085 -0.973085 --0.140625 -0.140625 -0.046875 -0.687261 -0.687261 -0.687261 --0.140625 -0.140625 -0.015625 -0.70278 -0.70278 -0.70278 --0.234375 -0.109375 -0.234375 -4.57237 -4.57237 -4.57237 --0.234375 -0.109375 -0.203125 0.890273 0.890273 0.890273 --0.234375 -0.078125 -0.234375 -11.0701 -11.0701 -11.0701 --0.203125 -0.109375 -0.234375 -3.9423 -3.9423 -3.9423 --0.234375 -0.109375 -0.140625 -0.98084 -0.98084 -0.98084 --0.203125 -0.109375 -0.140625 -2.03304 -2.03304 -2.03304 --0.203125 -0.078125 -0.140625 -1.67572 -1.67572 -1.67572 --0.234375 -0.046875 -0.234375 -4.27187 -4.27187 -4.27187 --0.234375 -0.015625 -0.234375 6.79236 6.79236 6.79236 --0.203125 -0.046875 -0.234375 0.916699 0.916699 0.916699 --0.203125 -0.015625 -0.234375 1.62171 1.62171 1.62171 --0.234375 -0.015625 -0.140625 -1.66044 -1.66044 -1.66044 --0.203125 -0.046875 -0.140625 -1.25065 -1.25065 -1.25065 --0.203125 -0.015625 -0.140625 -0.884763 -0.884763 -0.884763 --0.171875 -0.109375 -0.234375 -2.38338 -2.38338 -2.38338 --0.171875 -0.078125 -0.234375 -2.09407 -2.09407 -2.09407 --0.140625 -0.109375 -0.234375 -2.63987 -2.63987 -2.63987 --0.140625 -0.109375 -0.203125 -1.7458 -1.7458 -1.7458 --0.140625 -0.078125 -0.234375 -2.66754 -2.66754 -2.66754 --0.140625 -0.078125 -0.203125 -1.89402 -1.89402 -1.89402 --0.171875 -0.109375 -0.140625 -1.49386 -1.49386 -1.49386 --0.171875 -0.078125 -0.140625 -1.3063 -1.3063 -1.3063 --0.140625 -0.109375 -0.171875 -2.05192 -2.05192 -2.05192 --0.140625 -0.109375 -0.140625 -0.996662 -0.996662 -0.996662 --0.140625 -0.078125 -0.171875 -2.06623 -2.06623 -2.06623 --0.140625 -0.078125 -0.140625 -1.14562 -1.14562 -1.14562 --0.171875 -0.046875 -0.234375 -1.58589 -1.58589 -1.58589 --0.171875 -0.046875 -0.203125 -0.621618 -0.621618 -0.621618 --0.171875 -0.015625 -0.234375 -0.98734 -0.98734 -0.98734 --0.140625 -0.046875 -0.234375 -1.1961 -1.1961 -1.1961 --0.140625 -0.046875 -0.203125 -2.76763 -2.76763 -2.76763 --0.140625 -0.015625 -0.234375 -1.96776 -1.96776 -1.96776 --0.140625 -0.015625 -0.203125 -2.11328 -2.11328 -2.11328 --0.171875 -0.046875 -0.171875 -1.64272 -1.64272 -1.64272 --0.171875 -0.046875 -0.140625 -0.954019 -0.954019 -0.954019 --0.171875 -0.015625 -0.171875 -0.989623 -0.989623 -0.989623 --0.171875 -0.015625 -0.140625 -1.1964 -1.1964 -1.1964 --0.140625 -0.046875 -0.171875 -4.05992 -4.05992 -4.05992 --0.140625 -0.046875 -0.140625 -1.86583 -1.86583 -1.86583 --0.140625 -0.015625 -0.171875 -3.36692 -3.36692 -3.36692 --0.140625 -0.015625 -0.140625 -2.03048 -2.03048 -2.03048 --0.234375 -0.109375 -0.109375 -1.1106 -1.1106 -1.1106 --0.203125 -0.109375 -0.109375 -1.5957 -1.5957 -1.5957 --0.203125 -0.109375 -0.078125 -2.01525 -2.01525 -2.01525 --0.203125 -0.078125 -0.109375 -1.12089 -1.12089 -1.12089 --0.203125 -0.078125 -0.078125 -1.50688 -1.50688 -1.50688 --0.234375 -0.109375 -0.015625 -2.04582 -2.04582 -2.04582 --0.234375 -0.078125 -0.015625 -2.16811 -2.16811 -2.16811 --0.203125 -0.109375 -0.046875 -2.01463 -2.01463 -2.01463 --0.203125 -0.109375 -0.015625 -2.01895 -2.01895 -2.01895 --0.203125 -0.078125 -0.046875 -1.78017 -1.78017 -1.78017 --0.203125 -0.078125 -0.015625 -1.77377 -1.77377 -1.77377 --0.234375 -0.046875 -0.109375 -1.1674 -1.1674 -1.1674 --0.234375 -0.046875 -0.078125 -1.09249 -1.09249 -1.09249 --0.234375 -0.015625 -0.109375 -1.39747 -1.39747 -1.39747 --0.234375 -0.015625 -0.078125 -1.21948 -1.21948 -1.21948 --0.203125 -0.046875 -0.078125 -1.17045 -1.17045 -1.17045 --0.203125 -0.015625 -0.109375 -1.41822 -1.41822 -1.41822 --0.203125 -0.015625 -0.078125 -1.26413 -1.26413 -1.26413 --0.234375 -0.046875 -0.046875 -1.74711 -1.74711 -1.74711 --0.234375 -0.046875 -0.015625 -2.16528 -2.16528 -2.16528 --0.234375 -0.015625 -0.015625 -2.18575 -2.18575 -2.18575 --0.203125 -0.046875 -0.046875 -1.4632 -1.4632 -1.4632 --0.203125 -0.046875 -0.015625 -1.833 -1.833 -1.833 --0.203125 -0.015625 -0.046875 -0.935871 -0.935871 -0.935871 --0.203125 -0.015625 -0.015625 -1.35161 -1.35161 -1.35161 --0.171875 -0.109375 -0.109375 -2.27433 -2.27433 -2.27433 --0.171875 -0.078125 -0.109375 -1.29675 -1.29675 -1.29675 --0.171875 -0.078125 -0.078125 -1.48654 -1.48654 -1.48654 --0.140625 -0.109375 -0.109375 -1.95116 -1.95116 -1.95116 --0.140625 -0.078125 -0.109375 -2.23421 -2.23421 -2.23421 --0.140625 -0.078125 -0.078125 -0.219545 -0.219545 -0.219545 --0.171875 -0.109375 -0.046875 -0.82298 -0.82298 -0.82298 --0.171875 -0.109375 -0.015625 -0.60851 -0.60851 -0.60851 --0.171875 -0.078125 -0.046875 -1.59718 -1.59718 -1.59718 --0.171875 -0.078125 -0.015625 -1.83559 -1.83559 -1.83559 --0.140625 -0.109375 -0.046875 -0.738422 -0.738422 -0.738422 --0.140625 -0.109375 -0.015625 -0.632116 -0.632116 -0.632116 --0.140625 -0.078125 -0.046875 -1.53749 -1.53749 -1.53749 --0.140625 -0.078125 -0.015625 -1.07678 -1.07678 -1.07678 --0.171875 -0.015625 -0.078125 -1.37168 -1.37168 -1.37168 --0.171875 -0.046875 -0.046875 -1.3922 -1.3922 -1.3922 --0.171875 -0.015625 -0.046875 -0.781926 -0.781926 -0.781926 --0.140625 -0.046875 -0.046875 -1.3834 -1.3834 -1.3834 --0.140625 -0.046875 -0.015625 -1.87042 -1.87042 -1.87042 --0.140625 -0.015625 -0.046875 -1.07771 -1.07771 -1.07771 --0.140625 -0.015625 -0.015625 -1.0642 -1.0642 -1.0642 --0.109375 -0.234375 -0.234375 -1.02911 -1.02911 -1.02911 --0.109375 -0.234375 -0.203125 -0.925795 -0.925795 -0.925795 --0.109375 -0.203125 -0.234375 -1.19172 -1.19172 -1.19172 --0.078125 -0.203125 -0.234375 -1.08953 -1.08953 -1.08953 --0.109375 -0.171875 -0.234375 -1.04687 -1.04687 -1.04687 --0.109375 -0.140625 -0.234375 -1.25969 -1.25969 -1.25969 --0.078125 -0.171875 -0.234375 -0.997187 -0.997187 -0.997187 --0.078125 -0.171875 -0.203125 -0.820387 -0.820387 -0.820387 --0.078125 -0.140625 -0.234375 -1.01737 -1.01737 -1.01737 --0.078125 -0.140625 -0.203125 -1.9654 -1.9654 -1.9654 --0.109375 -0.171875 -0.171875 -1.64616 -1.64616 -1.64616 --0.109375 -0.171875 -0.140625 -1.87072 -1.87072 -1.87072 --0.109375 -0.140625 -0.171875 -1.894 -1.894 -1.894 --0.078125 -0.171875 -0.140625 -1.59315 -1.59315 -1.59315 --0.078125 -0.140625 -0.171875 -1.65473 -1.65473 -1.65473 --0.046875 -0.203125 -0.234375 -1.12335 -1.12335 -1.12335 --0.046875 -0.171875 -0.234375 -0.654436 -0.654436 -0.654436 --0.046875 -0.171875 -0.203125 -1.90624 -1.90624 -1.90624 --0.046875 -0.140625 -0.203125 -1.98434 -1.98434 -1.98434 --0.015625 -0.171875 -0.234375 -3.24234 -3.24234 -3.24234 --0.015625 -0.140625 -0.234375 -4.51041 -4.51041 -4.51041 --0.015625 -0.140625 -0.203125 -2.14518 -2.14518 -2.14518 --0.046875 -0.171875 -0.140625 65.9529 65.9529 65.9529 --0.046875 -0.140625 -0.171875 -2.03917 -2.03917 -2.03917 --0.046875 -0.140625 -0.140625 59.6095 59.6095 59.6095 --0.015625 -0.140625 -0.171875 -2.03542 -2.03542 -2.03542 --0.109375 -0.203125 -0.109375 -1.76446 -1.76446 -1.76446 --0.109375 -0.234375 -0.015625 -2.29494 -2.29494 -2.29494 --0.109375 -0.203125 -0.015625 -0.807767 -0.807767 -0.807767 --0.078125 -0.234375 -0.015625 -2.07058 -2.07058 -2.07058 --0.078125 -0.203125 -0.046875 -0.552195 -0.552195 -0.552195 --0.078125 -0.203125 -0.015625 -0.761413 -0.761413 -0.761413 --0.109375 -0.171875 -0.109375 -2.12527 -2.12527 -2.12527 --0.109375 -0.171875 -0.078125 -1.28559 -1.28559 -1.28559 --0.109375 -0.140625 -0.078125 -1.6541 -1.6541 -1.6541 --0.078125 -0.171875 -0.109375 -1.81578 -1.81578 -1.81578 --0.078125 -0.171875 -0.078125 -0.930145 -0.930145 -0.930145 --0.078125 -0.140625 -0.078125 -0.881408 -0.881408 -0.881408 --0.109375 -0.171875 -0.046875 -0.830205 -0.830205 -0.830205 --0.109375 -0.171875 -0.015625 -1.15827 -1.15827 -1.15827 --0.109375 -0.140625 -0.046875 -1.91959 -1.91959 -1.91959 --0.078125 -0.171875 -0.046875 -0.750977 -0.750977 -0.750977 --0.078125 -0.171875 -0.015625 -0.804579 -0.804579 -0.804579 --0.078125 -0.140625 -0.046875 -0.674792 -0.674792 -0.674792 --0.046875 -0.234375 -0.046875 -1.87206 -1.87206 -1.87206 --0.046875 -0.234375 -0.015625 -2.27298 -2.27298 -2.27298 --0.046875 -0.203125 -0.046875 -1.89495 -1.89495 -1.89495 --0.046875 -0.203125 -0.015625 -1.97959 -1.97959 -1.97959 --0.015625 -0.234375 -0.046875 -1.83889 -1.83889 -1.83889 --0.015625 -0.203125 -0.046875 -1.63469 -1.63469 -1.63469 --0.015625 -0.203125 -0.015625 -2.29689 -2.29689 -2.29689 --0.046875 -0.171875 -0.109375 15.4775 15.4775 15.4775 --0.046875 -0.171875 -0.078125 -23.3338 -23.3338 -23.3338 --0.046875 -0.140625 -0.109375 56.4691 56.4691 56.4691 --0.046875 -0.140625 -0.078125 29.4925 29.4925 29.4925 --0.046875 -0.171875 -0.046875 -0.676078 -0.676078 -0.676078 --0.046875 -0.171875 -0.015625 -0.927497 -0.927497 -0.927497 --0.046875 -0.140625 -0.046875 -0.838576 -0.838576 -0.838576 --0.046875 -0.140625 -0.015625 -1.11983 -1.11983 -1.11983 --0.015625 -0.140625 -0.015625 0.424306 0.424306 0.424306 --0.109375 -0.109375 -0.234375 -2.2217 -2.2217 -2.2217 --0.109375 -0.109375 -0.203125 -2.10803 -2.10803 -2.10803 --0.109375 -0.078125 -0.234375 -1.75923 -1.75923 -1.75923 --0.109375 -0.078125 -0.203125 -1.70465 -1.70465 -1.70465 --0.078125 -0.109375 -0.203125 -2.31176 -2.31176 -2.31176 --0.078125 -0.078125 -0.234375 -1.43392 -1.43392 -1.43392 --0.078125 -0.078125 -0.203125 -2.38482 -2.38482 -2.38482 --0.109375 -0.109375 -0.171875 -1.71658 -1.71658 -1.71658 --0.109375 -0.109375 -0.140625 -0.568445 -0.568445 -0.568445 --0.109375 -0.078125 -0.171875 -1.56523 -1.56523 -1.56523 --0.109375 -0.078125 -0.140625 -0.932729 -0.932729 -0.932729 --0.078125 -0.109375 -0.171875 -1.76806 -1.76806 -1.76806 --0.078125 -0.109375 -0.140625 -1.74765 -1.74765 -1.74765 --0.078125 -0.078125 -0.171875 -1.73762 -1.73762 -1.73762 --0.078125 -0.078125 -0.140625 -1.52119 -1.52119 -1.52119 --0.109375 -0.046875 -0.234375 -1.1881 -1.1881 -1.1881 --0.109375 -0.046875 -0.203125 -2.30426 -2.30426 -2.30426 --0.109375 -0.015625 -0.203125 0.320017 0.320017 0.320017 --0.078125 -0.046875 -0.203125 -3.15995 -3.15995 -3.15995 --0.078125 -0.015625 -0.203125 -5.76806 -5.76806 -5.76806 --0.109375 -0.046875 -0.171875 -2.77795 -2.77795 -2.77795 --0.109375 -0.046875 -0.140625 -1.64208 -1.64208 -1.64208 --0.109375 -0.015625 -0.171875 -2.21609 -2.21609 -2.21609 --0.109375 -0.015625 -0.140625 -2.20635 -2.20635 -2.20635 --0.078125 -0.046875 -0.171875 0.285266 0.285266 0.285266 --0.078125 -0.046875 -0.140625 -1.50981 -1.50981 -1.50981 --0.078125 -0.015625 -0.171875 1.69245 1.69245 1.69245 --0.078125 -0.015625 -0.140625 -1.50717 -1.50717 -1.50717 --0.015625 -0.109375 -0.203125 -2.08705 -2.08705 -2.08705 --0.046875 -0.109375 -0.171875 -1.89866 -1.89866 -1.89866 --0.046875 -0.109375 -0.140625 -2.19465 -2.19465 -2.19465 --0.046875 -0.078125 -0.171875 -1.82568 -1.82568 -1.82568 --0.046875 -0.078125 -0.140625 -1.78853 -1.78853 -1.78853 --0.015625 -0.109375 -0.171875 -1.98281 -1.98281 -1.98281 --0.015625 -0.078125 -0.171875 -1.81453 -1.81453 -1.81453 --0.015625 -0.078125 -0.140625 -2.0789 -2.0789 -2.0789 --0.015625 -0.015625 -0.234375 -2.31304 -2.31304 -2.31304 --0.046875 -0.046875 -0.171875 -2.55467 -2.55467 -2.55467 --0.046875 -0.046875 -0.140625 -1.79065 -1.79065 -1.79065 --0.046875 -0.015625 -0.171875 -1.83674 -1.83674 -1.83674 --0.046875 -0.015625 -0.140625 -1.49183 -1.49183 -1.49183 --0.015625 -0.046875 -0.171875 -1.81217 -1.81217 -1.81217 --0.015625 -0.046875 -0.140625 -29.8653 -29.8653 -29.8653 --0.109375 -0.109375 -0.078125 -1.7621 -1.7621 -1.7621 --0.109375 -0.078125 -0.078125 -0.637271 -0.637271 -0.637271 --0.078125 -0.109375 -0.109375 -1.60749 -1.60749 -1.60749 --0.078125 -0.109375 -0.078125 -1.16125 -1.16125 -1.16125 --0.078125 -0.078125 -0.078125 -0.715812 -0.715812 -0.715812 --0.109375 -0.109375 -0.046875 -1.57885 -1.57885 -1.57885 --0.109375 -0.078125 -0.046875 -0.720224 -0.720224 -0.720224 --0.109375 -0.078125 -0.015625 -1.6319 -1.6319 -1.6319 --0.078125 -0.109375 -0.046875 -2.14456 -2.14456 -2.14456 --0.109375 -0.046875 -0.078125 -0.515935 -0.515935 -0.515935 --0.078125 -0.046875 -0.078125 -0.902552 -0.902552 -0.902552 --0.078125 -0.015625 -0.109375 -1.64212 -1.64212 -1.64212 --0.078125 -0.015625 -0.078125 -1.6273 -1.6273 -1.6273 --0.109375 -0.046875 -0.046875 -0.878769 -0.878769 -0.878769 --0.109375 -0.046875 -0.015625 -1.25582 -1.25582 -1.25582 --0.109375 -0.015625 -0.046875 -1.59376 -1.59376 -1.59376 --0.109375 -0.015625 -0.015625 -2.53468 -2.53468 -2.53468 --0.078125 -0.046875 -0.046875 -0.610088 -0.610088 -0.610088 --0.078125 -0.046875 -0.015625 -0.491387 -0.491387 -0.491387 --0.078125 -0.015625 -0.046875 -1.56683 -1.56683 -1.56683 --0.078125 -0.015625 -0.015625 -2.11076 -2.11076 -2.11076 --0.046875 -0.109375 -0.109375 -1.92768 -1.92768 -1.92768 --0.046875 -0.078125 -0.109375 -1.6255 -1.6255 -1.6255 --0.046875 -0.078125 -0.078125 -1.18938 -1.18938 -1.18938 --0.015625 -0.078125 -0.109375 -2.1298 -2.1298 -2.1298 --0.015625 -0.078125 -0.078125 -1.5089 -1.5089 -1.5089 --0.046875 -0.109375 -0.046875 -1.52122 -1.52122 -1.52122 --0.046875 -0.078125 -0.046875 -1.30762 -1.30762 -1.30762 --0.015625 -0.109375 -0.046875 0.456995 0.456995 0.456995 --0.015625 -0.109375 -0.015625 -0.00787869 -0.00787869 -0.00787869 --0.015625 -0.078125 -0.046875 -0.73802 -0.73802 -0.73802 --0.015625 -0.078125 -0.015625 -0.464708 -0.464708 -0.464708 --0.046875 -0.046875 -0.078125 -1.24784 -1.24784 -1.24784 --0.046875 -0.015625 -0.109375 -2.02905 -2.02905 -2.02905 --0.046875 -0.015625 -0.078125 -2.05238 -2.05238 -2.05238 --0.015625 -0.015625 -0.078125 4.92092 4.92092 4.92092 --0.046875 -0.046875 -0.046875 -0.65957 -0.65957 -0.65957 --0.046875 -0.015625 -0.046875 -0.847201 -0.847201 -0.847201 --0.015625 -0.046875 -0.046875 -1.18312 -1.18312 -1.18312 --0.015625 -0.046875 -0.015625 -0.321174 -0.321174 -0.321174 --0.015625 -0.015625 -0.046875 -0.838866 -0.838866 -0.838866 --0.421875 -0.015625 0.171875 -2.80163 -2.80163 -2.80163 --0.390625 -0.015625 0.140625 -1.90425 -1.90425 -1.90425 --0.390625 -0.015625 0.171875 -1.13609 -1.13609 -1.13609 --0.390625 -0.046875 0.234375 -1.63445 -1.63445 -1.63445 --0.390625 -0.015625 0.203125 -0.563349 -0.563349 -0.563349 --0.390625 -0.015625 0.234375 -1.89222 -1.89222 -1.89222 --0.328125 -0.140625 0.015625 -2.22906 -2.22906 -2.22906 --0.296875 -0.171875 0.015625 -1.98273 -1.98273 -1.98273 --0.296875 -0.140625 0.015625 -2.07611 -2.07611 -2.07611 --0.296875 -0.140625 0.046875 -0.974261 -0.974261 -0.974261 --0.265625 -0.171875 0.015625 -1.70344 -1.70344 -1.70344 --0.265625 -0.140625 0.015625 -2.09149 -2.09149 -2.09149 --0.265625 -0.140625 0.046875 -2.14199 -2.14199 -2.14199 --0.265625 -0.140625 0.078125 -1.162 -1.162 -1.162 --0.328125 -0.109375 0.015625 -2.21868 -2.21868 -2.21868 --0.328125 -0.109375 0.046875 -1.28981 -1.28981 -1.28981 --0.328125 -0.078125 0.015625 -1.95937 -1.95937 -1.95937 --0.328125 -0.078125 0.046875 -1.26289 -1.26289 -1.26289 --0.359375 -0.109375 0.078125 -0.878487 -0.878487 -0.878487 --0.359375 -0.109375 0.109375 -0.658282 -0.658282 -0.658282 --0.359375 -0.078125 0.078125 -0.953528 -0.953528 -0.953528 --0.359375 -0.078125 0.109375 -0.852599 -0.852599 -0.852599 --0.328125 -0.109375 0.078125 -1.24854 -1.24854 -1.24854 --0.328125 -0.109375 0.109375 -1.15586 -1.15586 -1.15586 --0.328125 -0.078125 0.078125 -1.36536 -1.36536 -1.36536 --0.328125 -0.078125 0.109375 -1.0575 -1.0575 -1.0575 --0.359375 -0.015625 0.015625 -0.895332 -0.895332 -0.895332 --0.328125 -0.046875 0.015625 -2.19201 -2.19201 -2.19201 --0.328125 -0.046875 0.046875 -1.83214 -1.83214 -1.83214 --0.328125 -0.015625 0.015625 -1.13226 -1.13226 -1.13226 --0.328125 -0.015625 0.046875 -1.79025 -1.79025 -1.79025 --0.328125 -0.046875 0.078125 -1.0395 -1.0395 -1.0395 --0.328125 -0.046875 0.109375 -0.987144 -0.987144 -0.987144 --0.328125 -0.015625 0.078125 -1.82558 -1.82558 -1.82558 --0.328125 -0.015625 0.109375 -0.900681 -0.900681 -0.900681 --0.296875 -0.109375 0.015625 -1.85424 -1.85424 -1.85424 --0.296875 -0.109375 0.046875 -1.23167 -1.23167 -1.23167 --0.296875 -0.078125 0.015625 -1.95636 -1.95636 -1.95636 --0.296875 -0.109375 0.078125 -1.04431 -1.04431 -1.04431 --0.296875 -0.109375 0.109375 -0.78275 -0.78275 -0.78275 --0.265625 -0.109375 0.078125 -1.39565 -1.39565 -1.39565 --0.265625 -0.109375 0.109375 -0.871072 -0.871072 -0.871072 --0.296875 -0.046875 0.015625 -2.11124 -2.11124 -2.11124 --0.296875 -0.015625 0.015625 -1.57719 -1.57719 -1.57719 --0.296875 -0.015625 0.046875 -2.221 -2.221 -2.221 --0.265625 -0.015625 0.015625 -2.03932 -2.03932 -2.03932 --0.265625 -0.015625 0.046875 -1.9273 -1.9273 -1.9273 --0.296875 -0.015625 0.078125 -0.816296 -0.816296 -0.816296 --0.296875 -0.015625 0.109375 -0.721211 -0.721211 -0.721211 --0.265625 -0.046875 0.109375 -0.491736 -0.491736 -0.491736 --0.265625 -0.015625 0.078125 -1.08815 -1.08815 -1.08815 --0.265625 -0.015625 0.109375 0.368746 0.368746 0.368746 --0.328125 -0.078125 0.140625 -1.20067 -1.20067 -1.20067 --0.359375 -0.015625 0.140625 -1.70688 -1.70688 -1.70688 --0.359375 -0.015625 0.171875 -0.275851 -0.275851 -0.275851 --0.328125 -0.046875 0.140625 -0.0492439 -0.0492439 -0.0492439 --0.328125 -0.015625 0.140625 -0.419978 -0.419978 -0.419978 --0.328125 -0.015625 0.171875 -1.3915 -1.3915 -1.3915 --0.359375 -0.046875 0.234375 -2.67091 -2.67091 -2.67091 --0.359375 -0.015625 0.203125 -1.1466 -1.1466 -1.1466 --0.359375 -0.015625 0.234375 -0.343915 -0.343915 -0.343915 --0.328125 -0.046875 0.234375 -2.70712 -2.70712 -2.70712 --0.328125 -0.015625 0.203125 -1.95482 -1.95482 -1.95482 --0.328125 -0.015625 0.234375 3.61844 3.61844 3.61844 --0.296875 -0.109375 0.140625 -0.838761 -0.838761 -0.838761 --0.296875 -0.078125 0.140625 -1.11609 -1.11609 -1.11609 --0.265625 -0.109375 0.140625 -0.8157 -0.8157 -0.8157 --0.265625 -0.078125 0.140625 -1.18278 -1.18278 -1.18278 --0.265625 -0.078125 0.171875 -0.42242 -0.42242 -0.42242 --0.265625 -0.109375 0.234375 -3.11202 -3.11202 -3.11202 --0.265625 -0.078125 0.203125 -2.33648 -2.33648 -2.33648 --0.265625 -0.078125 0.234375 -11.5136 -11.5136 -11.5136 --0.296875 -0.046875 0.140625 -0.28314 -0.28314 -0.28314 --0.296875 -0.015625 0.140625 -0.695514 -0.695514 -0.695514 --0.265625 -0.046875 0.140625 -0.814989 -0.814989 -0.814989 --0.265625 -0.046875 0.171875 -0.597901 -0.597901 -0.597901 --0.296875 -0.046875 0.234375 -2.79961 -2.79961 -2.79961 --0.296875 -0.015625 0.234375 -17.9204 -17.9204 -17.9204 --0.265625 -0.046875 0.203125 -1.26079 -1.26079 -1.26079 --0.265625 -0.046875 0.234375 -1.56421 -1.56421 -1.56421 --0.265625 -0.015625 0.203125 -2.12464 -2.12464 -2.12464 --0.265625 -0.015625 0.234375 -4.5018 -4.5018 -4.5018 --0.390625 -0.046875 0.265625 -1.25096 -1.25096 -1.25096 --0.390625 -0.046875 0.296875 0.170822 0.170822 0.170822 --0.390625 -0.015625 0.265625 -0.173533 -0.173533 -0.173533 --0.390625 -0.015625 0.296875 -3.19811 -3.19811 -3.19811 --0.359375 -0.046875 0.265625 -2.8094 -2.8094 -2.8094 --0.359375 -0.046875 0.296875 1.21196 1.21196 1.21196 --0.359375 -0.015625 0.296875 21.3667 21.3667 21.3667 --0.328125 -0.046875 0.265625 -0.10049 -0.10049 -0.10049 --0.328125 -0.046875 0.296875 -1.7483 -1.7483 -1.7483 --0.328125 -0.015625 0.265625 3.71467 3.71467 3.71467 --0.328125 -0.015625 0.296875 14.3309 14.3309 14.3309 --0.265625 -0.078125 0.265625 6.76177 6.76177 6.76177 --0.296875 -0.015625 0.265625 8.70792 8.70792 8.70792 --0.265625 -0.046875 0.265625 -0.132835 -0.132835 -0.132835 --0.265625 -0.015625 0.265625 0.218241 0.218241 0.218241 --0.171875 -0.296875 0.015625 -1.12249 -1.12249 -1.12249 --0.171875 -0.296875 0.046875 -1.71646 -1.71646 -1.71646 --0.171875 -0.265625 0.015625 -2.1683 -2.1683 -2.1683 --0.171875 -0.265625 0.046875 -1.8034 -1.8034 -1.8034 --0.140625 -0.296875 0.015625 -2.29637 -2.29637 -2.29637 --0.140625 -0.296875 0.046875 -1.94715 -1.94715 -1.94715 --0.140625 -0.265625 0.046875 -2.48051 -2.48051 -2.48051 --0.171875 -0.265625 0.078125 -1.4158 -1.4158 -1.4158 --0.140625 -0.265625 0.078125 -2.10694 -2.10694 -2.10694 --0.109375 -0.296875 0.015625 -2.53324 -2.53324 -2.53324 --0.109375 -0.296875 0.046875 -1.78874 -1.78874 -1.78874 --0.109375 -0.265625 0.015625 -2.60016 -2.60016 -2.60016 --0.109375 -0.265625 0.046875 -2.56265 -2.56265 -2.56265 --0.078125 -0.265625 0.015625 -2.2563 -2.2563 -2.2563 --0.078125 -0.265625 0.046875 -2.12255 -2.12255 -2.12255 --0.109375 -0.265625 0.078125 -2.07168 -2.07168 -2.07168 --0.046875 -0.296875 0.015625 -2.12558 -2.12558 -2.12558 --0.046875 -0.265625 0.015625 -2.75933 -2.75933 -2.75933 --0.046875 -0.265625 0.046875 -3.64911 -3.64911 -3.64911 --0.015625 -0.296875 0.015625 -2.59238 -2.59238 -2.59238 --0.015625 -0.265625 0.015625 -1.49234 -1.49234 -1.49234 --0.015625 -0.265625 0.046875 -3.27369 -3.27369 -3.27369 --0.234375 -0.140625 0.015625 -2.03912 -2.03912 -2.03912 --0.234375 -0.140625 0.046875 -2.15227 -2.15227 -2.15227 --0.203125 -0.140625 0.015625 -1.95937 -1.95937 -1.95937 --0.203125 -0.140625 0.046875 -1.86931 -1.86931 -1.86931 --0.234375 -0.140625 0.078125 -1.85888 -1.85888 -1.85888 --0.171875 -0.234375 0.015625 -1.42048 -1.42048 -1.42048 --0.171875 -0.234375 0.046875 -1.40193 -1.40193 -1.40193 --0.171875 -0.203125 0.015625 -2.08602 -2.08602 -2.08602 --0.171875 -0.203125 0.046875 -1.27726 -1.27726 -1.27726 --0.140625 -0.234375 0.046875 -2.12608 -2.12608 -2.12608 --0.140625 -0.203125 0.015625 -1.051 -1.051 -1.051 --0.140625 -0.203125 0.046875 -1.13123 -1.13123 -1.13123 --0.140625 -0.234375 0.078125 -1.86462 -1.86462 -1.86462 --0.140625 -0.234375 0.109375 -2.0909 -2.0909 -2.0909 --0.140625 -0.203125 0.109375 -2.31128 -2.31128 -2.31128 --0.171875 -0.171875 0.015625 -0.932697 -0.932697 -0.932697 --0.171875 -0.171875 0.046875 -1.07501 -1.07501 -1.07501 --0.171875 -0.140625 0.015625 -0.784447 -0.784447 -0.784447 --0.171875 -0.140625 0.046875 -0.739344 -0.739344 -0.739344 --0.140625 -0.171875 0.015625 -0.818103 -0.818103 -0.818103 --0.140625 -0.171875 0.046875 -0.807181 -0.807181 -0.807181 --0.140625 -0.140625 0.015625 -0.709947 -0.709947 -0.709947 --0.171875 -0.171875 0.078125 -0.713625 -0.713625 -0.713625 --0.171875 -0.140625 0.078125 -0.778336 -0.778336 -0.778336 --0.140625 -0.171875 0.078125 -1.33565 -1.33565 -1.33565 --0.140625 -0.171875 0.109375 -0.481495 -0.481495 -0.481495 --0.140625 -0.140625 0.109375 -1.197 -1.197 -1.197 --0.171875 -0.203125 0.140625 -1.51852 -1.51852 -1.51852 --0.140625 -0.234375 0.140625 -1.83443 -1.83443 -1.83443 --0.140625 -0.234375 0.171875 -1.38682 -1.38682 -1.38682 --0.140625 -0.203125 0.140625 -1.16522 -1.16522 -1.16522 --0.140625 -0.203125 0.171875 -3.12675 -3.12675 -3.12675 --0.171875 -0.171875 0.140625 -1.46365 -1.46365 -1.46365 --0.140625 -0.171875 0.140625 -0.649094 -0.649094 -0.649094 --0.140625 -0.171875 0.171875 -1.53094 -1.53094 -1.53094 --0.140625 -0.140625 0.140625 -1.5763 -1.5763 -1.5763 --0.140625 -0.140625 0.171875 -1.39781 -1.39781 -1.39781 --0.234375 -0.078125 0.015625 -2.06589 -2.06589 -2.06589 --0.234375 -0.078125 0.046875 -2.1234 -2.1234 -2.1234 --0.203125 -0.109375 0.015625 -1.92693 -1.92693 -1.92693 --0.203125 -0.109375 0.046875 -1.93665 -1.93665 -1.93665 --0.203125 -0.078125 0.015625 -1.72992 -1.72992 -1.72992 --0.203125 -0.078125 0.046875 -2.07296 -2.07296 -2.07296 --0.234375 -0.109375 0.078125 -1.43717 -1.43717 -1.43717 --0.234375 -0.109375 0.109375 -0.997456 -0.997456 -0.997456 --0.234375 -0.078125 0.078125 -1.24248 -1.24248 -1.24248 --0.234375 -0.078125 0.109375 -0.814576 -0.814576 -0.814576 --0.203125 -0.078125 0.078125 -2.29117 -2.29117 -2.29117 --0.203125 -0.078125 0.109375 -1.50826 -1.50826 -1.50826 --0.234375 -0.046875 0.015625 -2.06962 -2.06962 -2.06962 --0.234375 -0.046875 0.046875 -2.03454 -2.03454 -2.03454 --0.234375 -0.015625 0.015625 -2.15981 -2.15981 -2.15981 --0.234375 -0.015625 0.046875 -1.84944 -1.84944 -1.84944 --0.203125 -0.046875 0.015625 -1.98121 -1.98121 -1.98121 --0.203125 -0.046875 0.046875 -2.1885 -2.1885 -2.1885 --0.203125 -0.015625 0.015625 -1.70768 -1.70768 -1.70768 --0.203125 -0.015625 0.046875 -2.05459 -2.05459 -2.05459 --0.234375 -0.046875 0.078125 -1.87883 -1.87883 -1.87883 --0.234375 -0.046875 0.109375 -1.21995 -1.21995 -1.21995 --0.234375 -0.015625 0.078125 -1.86685 -1.86685 -1.86685 --0.234375 -0.015625 0.109375 -2.70161 -2.70161 -2.70161 --0.203125 -0.046875 0.078125 -2.61916 -2.61916 -2.61916 --0.203125 -0.015625 0.078125 -2.6851 -2.6851 -2.6851 --0.171875 -0.109375 0.015625 -0.767043 -0.767043 -0.767043 --0.171875 -0.109375 0.046875 -0.676396 -0.676396 -0.676396 --0.171875 -0.078125 0.015625 -0.998537 -0.998537 -0.998537 --0.171875 -0.078125 0.046875 -1.07777 -1.07777 -1.07777 --0.140625 -0.109375 0.015625 -0.96949 -0.96949 -0.96949 --0.140625 -0.078125 0.015625 -1.11391 -1.11391 -1.11391 --0.140625 -0.078125 0.046875 -1.42813 -1.42813 -1.42813 --0.171875 -0.109375 0.078125 -0.988506 -0.988506 -0.988506 --0.171875 -0.078125 0.078125 -0.959795 -0.959795 -0.959795 --0.171875 -0.078125 0.109375 -2.40284 -2.40284 -2.40284 --0.140625 -0.109375 0.078125 -1.9422 -1.9422 -1.9422 --0.140625 -0.109375 0.109375 -1.83848 -1.83848 -1.83848 --0.140625 -0.078125 0.109375 -1.17831 -1.17831 -1.17831 --0.171875 -0.046875 0.015625 -0.530668 -0.530668 -0.530668 --0.171875 -0.046875 0.046875 -1.20787 -1.20787 -1.20787 --0.171875 -0.015625 0.015625 -1.80212 -1.80212 -1.80212 --0.171875 -0.015625 0.046875 -2.3129 -2.3129 -2.3129 --0.140625 -0.046875 0.015625 -0.777997 -0.777997 -0.777997 --0.140625 -0.046875 0.046875 -0.835123 -0.835123 -0.835123 --0.140625 -0.015625 0.015625 -1.66223 -1.66223 -1.66223 --0.140625 -0.015625 0.046875 -1.0037 -1.0037 -1.0037 --0.171875 -0.046875 0.078125 -0.952596 -0.952596 -0.952596 --0.171875 -0.046875 0.109375 -3.49941 -3.49941 -3.49941 --0.171875 -0.015625 0.078125 -2.02008 -2.02008 -2.02008 --0.171875 -0.015625 0.109375 -3.17744 -3.17744 -3.17744 --0.140625 -0.046875 0.078125 -0.659772 -0.659772 -0.659772 --0.140625 -0.046875 0.109375 1.07161 1.07161 1.07161 --0.140625 -0.015625 0.078125 -0.544847 -0.544847 -0.544847 --0.140625 -0.015625 0.109375 1.20968 1.20968 1.20968 --0.234375 -0.078125 0.140625 -2.01137 -2.01137 -2.01137 --0.234375 -0.078125 0.171875 0.0342392 0.0342392 0.0342392 --0.203125 -0.078125 0.140625 -1.94974 -1.94974 -1.94974 --0.203125 -0.078125 0.171875 -1.65571 -1.65571 -1.65571 --0.234375 -0.109375 0.203125 -1.7294 -1.7294 -1.7294 --0.234375 -0.109375 0.234375 2.9481 2.9481 2.9481 --0.234375 -0.078125 0.203125 -6.78922 -6.78922 -6.78922 --0.203125 -0.109375 0.234375 -5.56929 -5.56929 -5.56929 --0.203125 -0.078125 0.203125 -3.17998 -3.17998 -3.17998 --0.203125 -0.078125 0.234375 -2.75959 -2.75959 -2.75959 --0.234375 -0.046875 0.140625 -4.21507 -4.21507 -4.21507 --0.234375 -0.046875 0.171875 -0.806423 -0.806423 -0.806423 --0.234375 -0.015625 0.140625 -2.65312 -2.65312 -2.65312 --0.234375 -0.015625 0.171875 -1.39985 -1.39985 -1.39985 --0.203125 -0.046875 0.140625 -2.99068 -2.99068 -2.99068 --0.203125 -0.046875 0.171875 -2.68967 -2.68967 -2.68967 --0.203125 -0.015625 0.140625 -1.90302 -1.90302 -1.90302 --0.203125 -0.015625 0.171875 -4.64578 -4.64578 -4.64578 --0.234375 -0.015625 0.203125 -4.59007 -4.59007 -4.59007 --0.234375 -0.015625 0.234375 -4.00511 -4.00511 -4.00511 --0.203125 -0.046875 0.203125 -7.64808 -7.64808 -7.64808 --0.203125 -0.046875 0.234375 -1.96694 -1.96694 -1.96694 --0.203125 -0.015625 0.203125 -6.99722 -6.99722 -6.99722 --0.203125 -0.015625 0.234375 -3.25004 -3.25004 -3.25004 --0.171875 -0.078125 0.234375 -1.8711 -1.8711 -1.8711 --0.171875 -0.046875 0.140625 -6.30789 -6.30789 -6.30789 --0.171875 -0.015625 0.140625 -4.1073 -4.1073 -4.1073 --0.140625 -0.046875 0.171875 -9.97028 -9.97028 -9.97028 --0.140625 -0.015625 0.171875 -0.147538 -0.147538 -0.147538 --0.171875 -0.046875 0.203125 -9.50997 -9.50997 -9.50997 --0.171875 -0.046875 0.234375 -0.600548 -0.600548 -0.600548 --0.171875 -0.015625 0.234375 -0.613864 -0.613864 -0.613864 --0.140625 -0.046875 0.203125 -0.995691 -0.995691 -0.995691 --0.140625 -0.015625 0.203125 -1.05 -1.05 -1.05 --0.140625 -0.015625 0.234375 -44.05 -44.05 -44.05 --0.109375 -0.234375 0.015625 -1.09877 -1.09877 -1.09877 --0.109375 -0.234375 0.046875 -1.80447 -1.80447 -1.80447 --0.109375 -0.203125 0.015625 -0.786366 -0.786366 -0.786366 --0.109375 -0.203125 0.046875 -0.662952 -0.662952 -0.662952 --0.078125 -0.234375 0.015625 -1.4803 -1.4803 -1.4803 --0.078125 -0.234375 0.046875 -2.05144 -2.05144 -2.05144 --0.078125 -0.203125 0.015625 -0.749902 -0.749902 -0.749902 --0.078125 -0.203125 0.046875 -0.782962 -0.782962 -0.782962 --0.109375 -0.234375 0.078125 -1.86541 -1.86541 -1.86541 --0.109375 -0.234375 0.109375 -2.38182 -2.38182 -2.38182 --0.109375 -0.203125 0.078125 -1.22816 -1.22816 -1.22816 --0.109375 -0.203125 0.109375 -2.44529 -2.44529 -2.44529 --0.078125 -0.234375 0.109375 -1.83137 -1.83137 -1.83137 --0.078125 -0.203125 0.109375 -3.71529 -3.71529 -3.71529 --0.109375 -0.171875 0.078125 -0.97493 -0.97493 -0.97493 --0.109375 -0.171875 0.109375 -1.02656 -1.02656 -1.02656 --0.109375 -0.140625 0.109375 -1.07155 -1.07155 -1.07155 --0.078125 -0.171875 0.078125 -0.576434 -0.576434 -0.576434 --0.078125 -0.171875 0.109375 -2.34731 -2.34731 -2.34731 --0.078125 -0.140625 0.078125 -1.11097 -1.11097 -1.11097 --0.078125 -0.140625 0.109375 -1.40843 -1.40843 -1.40843 --0.046875 -0.234375 0.015625 -2.49417 -2.49417 -2.49417 --0.046875 -0.234375 0.046875 -2.10537 -2.10537 -2.10537 --0.046875 -0.203125 0.015625 -1.19044 -1.19044 -1.19044 --0.046875 -0.203125 0.046875 -0.76704 -0.76704 -0.76704 --0.015625 -0.234375 0.015625 -2.81875 -2.81875 -2.81875 --0.015625 -0.234375 0.046875 -1.31471 -1.31471 -1.31471 --0.015625 -0.203125 0.015625 -1.90443 -1.90443 -1.90443 --0.046875 -0.203125 0.109375 -2.37599 -2.37599 -2.37599 --0.015625 -0.203125 0.109375 -1.99031 -1.99031 -1.99031 --0.046875 -0.171875 0.015625 -1.21275 -1.21275 -1.21275 --0.046875 -0.171875 0.046875 -0.747386 -0.747386 -0.747386 --0.046875 -0.140625 0.015625 -1.07319 -1.07319 -1.07319 --0.046875 -0.140625 0.046875 -1.16702 -1.16702 -1.16702 --0.015625 -0.171875 0.015625 1.40443 1.40443 1.40443 --0.015625 -0.171875 0.046875 -0.867359 -0.867359 -0.867359 --0.015625 -0.140625 0.015625 -0.182982 -0.182982 -0.182982 --0.015625 -0.140625 0.046875 -1.0878 -1.0878 -1.0878 --0.046875 -0.171875 0.078125 -0.782709 -0.782709 -0.782709 --0.046875 -0.171875 0.109375 -1.98392 -1.98392 -1.98392 --0.046875 -0.140625 0.078125 -0.585594 -0.585594 -0.585594 --0.046875 -0.140625 0.109375 -1.48125 -1.48125 -1.48125 --0.015625 -0.171875 0.078125 -1.68124 -1.68124 -1.68124 --0.015625 -0.171875 0.109375 -2.11547 -2.11547 -2.11547 --0.015625 -0.140625 0.109375 -1.85664 -1.85664 -1.85664 --0.109375 -0.234375 0.140625 -1.85924 -1.85924 -1.85924 --0.109375 -0.234375 0.171875 -1.4524 -1.4524 -1.4524 --0.109375 -0.203125 0.171875 -1.53398 -1.53398 -1.53398 --0.078125 -0.234375 0.140625 -1.78612 -1.78612 -1.78612 --0.078125 -0.203125 0.140625 -1.18613 -1.18613 -1.18613 --0.078125 -0.203125 0.171875 -1.6811 -1.6811 -1.6811 --0.109375 -0.171875 0.171875 -0.997721 -0.997721 -0.997721 --0.109375 -0.140625 0.140625 -1.0055 -1.0055 -1.0055 --0.109375 -0.140625 0.171875 -1.32643 -1.32643 -1.32643 --0.078125 -0.171875 0.171875 -1.67719 -1.67719 -1.67719 --0.078125 -0.140625 0.140625 -2.52428 -2.52428 -2.52428 --0.078125 -0.140625 0.171875 -2.90412 -2.90412 -2.90412 --0.109375 -0.140625 0.234375 -1.06919 -1.06919 -1.06919 --0.078125 -0.140625 0.203125 -1.56333 -1.56333 -1.56333 --0.078125 -0.140625 0.234375 -1.11295 -1.11295 -1.11295 --0.046875 -0.203125 0.140625 -2.09678 -2.09678 -2.09678 --0.046875 -0.203125 0.171875 -1.94142 -1.94142 -1.94142 --0.015625 -0.203125 0.140625 -2.2685 -2.2685 -2.2685 --0.015625 -0.203125 0.171875 -1.7614 -1.7614 -1.7614 --0.046875 -0.171875 0.171875 -2.03001 -2.03001 -2.03001 --0.046875 -0.140625 0.171875 -2.30242 -2.30242 -2.30242 --0.015625 -0.171875 0.171875 -1.96052 -1.96052 -1.96052 --0.015625 -0.140625 0.140625 -2.18979 -2.18979 -2.18979 --0.015625 -0.140625 0.171875 -2.43106 -2.43106 -2.43106 --0.046875 -0.171875 0.203125 -1.63025 -1.63025 -1.63025 --0.046875 -0.140625 0.203125 -1.54907 -1.54907 -1.54907 --0.046875 -0.140625 0.234375 -1.46218 -1.46218 -1.46218 --0.015625 -0.140625 0.234375 -1.68093 -1.68093 -1.68093 --0.109375 -0.078125 0.015625 -2.06443 -2.06443 -2.06443 --0.078125 -0.109375 0.046875 -2.05084 -2.05084 -2.05084 --0.109375 -0.109375 0.109375 -0.907625 -0.907625 -0.907625 --0.109375 -0.078125 0.109375 -0.463286 -0.463286 -0.463286 --0.078125 -0.109375 0.078125 -1.63355 -1.63355 -1.63355 --0.078125 -0.109375 0.109375 -0.8993 -0.8993 -0.8993 --0.078125 -0.078125 0.078125 -1.20174 -1.20174 -1.20174 --0.078125 -0.078125 0.109375 0.113131 0.113131 0.113131 --0.109375 -0.046875 0.015625 -1.49594 -1.49594 -1.49594 --0.109375 -0.015625 0.015625 -2.44143 -2.44143 -2.44143 --0.109375 -0.015625 0.046875 -2.10459 -2.10459 -2.10459 --0.109375 -0.046875 0.109375 0.117216 0.117216 0.117216 --0.109375 -0.015625 0.109375 -0.775344 -0.775344 -0.775344 --0.078125 -0.046875 0.078125 -1.4002 -1.4002 -1.4002 --0.078125 -0.046875 0.109375 0.0138727 0.0138727 0.0138727 --0.078125 -0.015625 0.109375 1.13794 1.13794 1.13794 --0.046875 -0.109375 0.015625 -1.07307 -1.07307 -1.07307 --0.046875 -0.109375 0.046875 -1.30754 -1.30754 -1.30754 --0.046875 -0.078125 0.015625 -2.66058 -2.66058 -2.66058 --0.046875 -0.078125 0.046875 -2.56096 -2.56096 -2.56096 --0.015625 -0.109375 0.015625 -0.677078 -0.677078 -0.677078 --0.015625 -0.109375 0.046875 -1.36868 -1.36868 -1.36868 --0.015625 -0.078125 0.015625 -0.926706 -0.926706 -0.926706 --0.015625 -0.078125 0.046875 -1.14668 -1.14668 -1.14668 --0.046875 -0.109375 0.078125 -2.00159 -2.00159 -2.00159 --0.046875 -0.109375 0.109375 -1.57635 -1.57635 -1.57635 --0.046875 -0.078125 0.078125 -2.44779 -2.44779 -2.44779 --0.015625 -0.109375 0.078125 -2.47522 -2.47522 -2.47522 --0.015625 -0.109375 0.109375 -2.06765 -2.06765 -2.06765 --0.015625 -0.078125 0.078125 -2.18974 -2.18974 -2.18974 --0.015625 -0.078125 0.109375 -2.61371 -2.61371 -2.61371 --0.015625 -0.046875 0.015625 -1.6158 -1.6158 -1.6158 --0.015625 -0.046875 0.046875 -1.87043 -1.87043 -1.87043 --0.015625 -0.015625 0.046875 -2.1502 -2.1502 -2.1502 --0.046875 -0.046875 0.078125 -2.56709 -2.56709 -2.56709 --0.046875 -0.046875 0.109375 0.265173 0.265173 0.265173 --0.046875 -0.015625 0.078125 -1.95886 -1.95886 -1.95886 --0.046875 -0.015625 0.109375 5.06993 5.06993 5.06993 --0.015625 -0.046875 0.078125 -2.21003 -2.21003 -2.21003 --0.015625 -0.046875 0.109375 -2.31052 -2.31052 -2.31052 --0.015625 -0.015625 0.078125 -2.4125 -2.4125 -2.4125 --0.015625 -0.015625 0.109375 -0.649331 -0.649331 -0.649331 --0.109375 -0.078125 0.140625 0.845957 0.845957 0.845957 --0.109375 -0.078125 0.171875 -4.45575 -4.45575 -4.45575 --0.078125 -0.078125 0.140625 0.358394 0.358394 0.358394 --0.078125 -0.078125 0.171875 -4.54543 -4.54543 -4.54543 --0.109375 -0.109375 0.203125 -1.74185 -1.74185 -1.74185 --0.109375 -0.109375 0.234375 -1.30023 -1.30023 -1.30023 --0.109375 -0.078125 0.203125 10.0814 10.0814 10.0814 --0.109375 -0.078125 0.234375 -5.05979 -5.05979 -5.05979 --0.078125 -0.109375 0.203125 -1.45562 -1.45562 -1.45562 --0.078125 -0.078125 0.203125 -658.778 -658.778 -658.778 --0.109375 -0.046875 0.140625 -4.28268 -4.28268 -4.28268 --0.109375 -0.046875 0.171875 -5.38504 -5.38504 -5.38504 --0.109375 -0.015625 0.140625 -4.24159 -4.24159 -4.24159 --0.109375 -0.015625 0.171875 -5.20939 -5.20939 -5.20939 --0.078125 -0.046875 0.140625 115.479 115.479 115.479 --0.078125 -0.046875 0.171875 -285.333 -285.333 -285.333 --0.078125 -0.015625 0.140625 109.54 109.54 109.54 --0.109375 -0.046875 0.203125 1.55063 1.55063 1.55063 --0.109375 -0.046875 0.234375 -7.49652 -7.49652 -7.49652 --0.109375 -0.015625 0.203125 8.88323 8.88323 8.88323 --0.109375 -0.015625 0.234375 -273.924 -273.924 -273.924 --0.078125 -0.046875 0.234375 18.2901 18.2901 18.2901 --0.078125 -0.015625 0.234375 419.476 419.476 419.476 --0.046875 -0.109375 0.140625 -1.72214 -1.72214 -1.72214 --0.046875 -0.109375 0.171875 -2.301 -2.301 -2.301 --0.046875 -0.078125 0.140625 -3.05713 -3.05713 -3.05713 --0.046875 -0.078125 0.171875 -6.31167 -6.31167 -6.31167 --0.015625 -0.109375 0.140625 -2.11187 -2.11187 -2.11187 --0.015625 -0.109375 0.171875 -2.23271 -2.23271 -2.23271 --0.015625 -0.078125 0.140625 -1.77578 -1.77578 -1.77578 --0.015625 -0.078125 0.171875 -1.87093 -1.87093 -1.87093 --0.046875 -0.109375 0.203125 -1.6727 -1.6727 -1.6727 --0.046875 -0.078125 0.203125 29.5326 29.5326 29.5326 --0.046875 -0.078125 0.234375 -39.3306 -39.3306 -39.3306 --0.015625 -0.109375 0.203125 -1.82895 -1.82895 -1.82895 --0.015625 -0.109375 0.234375 -1.89704 -1.89704 -1.89704 --0.015625 -0.078125 0.203125 -5.87273 -5.87273 -5.87273 --0.015625 -0.078125 0.234375 -16.6937 -16.6937 -16.6937 --0.046875 -0.046875 0.140625 -263.724 -263.724 -263.724 --0.046875 -0.046875 0.171875 -166.057 -166.057 -166.057 --0.046875 -0.015625 0.140625 188.51 188.51 188.51 --0.046875 -0.015625 0.171875 -623.941 -623.941 -623.941 --0.015625 -0.046875 0.171875 199.695 199.695 199.695 --0.015625 -0.015625 0.140625 52.4896 52.4896 52.4896 --0.015625 -0.015625 0.171875 128.396 128.396 128.396 --0.046875 -0.046875 0.203125 45.7923 45.7923 45.7923 --0.046875 -0.046875 0.234375 -324.096 -324.096 -324.096 --0.046875 -0.015625 0.203125 257.226 257.226 257.226 --0.046875 -0.015625 0.234375 502.055 502.055 502.055 --0.015625 -0.046875 0.203125 171.929 171.929 171.929 --0.015625 -0.046875 0.234375 -55.6243 -55.6243 -55.6243 --0.015625 -0.015625 0.203125 458.992 458.992 458.992 --0.234375 -0.078125 0.265625 4.24548 4.24548 4.24548 --0.203125 -0.078125 0.265625 -9.84332 -9.84332 -9.84332 --0.234375 -0.046875 0.265625 -1.64415 -1.64415 -1.64415 --0.234375 -0.015625 0.265625 0.582134 0.582134 0.582134 --0.203125 -0.046875 0.265625 0.0245381 0.0245381 0.0245381 --0.203125 -0.015625 0.265625 0.418004 0.418004 0.418004 --0.171875 -0.015625 0.265625 0.893018 0.893018 0.893018 --0.140625 -0.015625 0.265625 -8.40515 -8.40515 -8.40515 --0.140625 -0.015625 0.296875 5.33998 5.33998 5.33998 --0.109375 -0.140625 0.265625 -1.0047 -1.0047 -1.0047 --0.078125 -0.140625 0.265625 -0.990702 -0.990702 -0.990702 --0.078125 -0.140625 0.296875 -1.57628 -1.57628 -1.57628 --0.078125 -0.140625 0.328125 1.1834 1.1834 1.1834 --0.046875 -0.140625 0.265625 -0.68252 -0.68252 -0.68252 --0.046875 -0.140625 0.296875 -2.21566 -2.21566 -2.21566 --0.015625 -0.171875 0.265625 -1.27799 -1.27799 -1.27799 --0.015625 -0.171875 0.296875 -1.81949 -1.81949 -1.81949 --0.015625 -0.140625 0.265625 -1.61626 -1.61626 -1.61626 --0.015625 -0.140625 0.296875 -2.09306 -2.09306 -2.09306 --0.046875 -0.140625 0.328125 0.614166 0.614166 0.614166 --0.015625 -0.140625 0.328125 -1.04778 -1.04778 -1.04778 --0.109375 -0.109375 0.265625 -1.15643 -1.15643 -1.15643 --0.109375 -0.109375 0.296875 -1.22733 -1.22733 -1.22733 --0.109375 -0.078125 0.265625 3.19031 3.19031 3.19031 --0.109375 -0.078125 0.296875 -30.1525 -30.1525 -30.1525 --0.078125 -0.109375 0.296875 -1.49007 -1.49007 -1.49007 --0.078125 -0.078125 0.296875 39.7361 39.7361 39.7361 --0.109375 -0.109375 0.328125 -1.10493 -1.10493 -1.10493 --0.109375 -0.078125 0.328125 -37.9239 -37.9239 -37.9239 --0.078125 -0.109375 0.328125 -1.22242 -1.22242 -1.22242 --0.078125 -0.109375 0.359375 -1.37264 -1.37264 -1.37264 --0.078125 -0.078125 0.328125 50.2489 50.2489 50.2489 --0.078125 -0.078125 0.359375 9.71278 9.71278 9.71278 --0.109375 -0.046875 0.296875 -211.726 -211.726 -211.726 --0.109375 -0.015625 0.265625 -12.0224 -12.0224 -12.0224 --0.109375 -0.015625 0.296875 400.183 400.183 400.183 --0.078125 -0.046875 0.265625 25.8843 25.8843 25.8843 --0.078125 -0.046875 0.296875 -396.31 -396.31 -396.31 --0.109375 -0.046875 0.328125 -11.735 -11.735 -11.735 --0.078125 -0.046875 0.328125 93.9444 93.9444 93.9444 --0.078125 -0.046875 0.359375 14.9561 14.9561 14.9561 --0.015625 -0.109375 0.296875 -2.25441 -2.25441 -2.25441 --0.046875 -0.109375 0.328125 -2.07542 -2.07542 -2.07542 --0.046875 -0.109375 0.359375 -1.3557 -1.3557 -1.3557 --0.046875 -0.078125 0.359375 15.3613 15.3613 15.3613 --0.015625 -0.109375 0.328125 -1.25147 -1.25147 -1.25147 --0.015625 -0.109375 0.359375 -1.03345 -1.03345 -1.03345 --0.015625 -0.078125 0.328125 68.4578 68.4578 68.4578 --0.015625 -0.078125 0.359375 20.5969 20.5969 20.5969 --0.046875 -0.046875 0.265625 -792.233 -792.233 -792.233 --0.046875 -0.046875 0.296875 -625.996 -625.996 -625.996 --0.046875 -0.015625 0.265625 -19.5969 -19.5969 -19.5969 --0.046875 -0.015625 0.296875 130.758 130.758 130.758 --0.015625 -0.046875 0.265625 11.4984 11.4984 11.4984 --0.015625 -0.046875 0.296875 -7.64367 -7.64367 -7.64367 --0.015625 -0.015625 0.265625 -64.355 -64.355 -64.355 --0.015625 -0.015625 0.296875 -157.43 -157.43 -157.43 --0.046875 -0.046875 0.328125 -29.2752 -29.2752 -29.2752 --0.046875 -0.046875 0.359375 -2.29077 -2.29077 -2.29077 --0.046875 -0.015625 0.328125 20.2705 20.2705 20.2705 --0.015625 -0.046875 0.328125 50.0373 50.0373 50.0373 --0.015625 -0.046875 0.359375 56.3938 56.3938 56.3938 --0.015625 -0.015625 0.328125 40.3426 40.3426 40.3426 --0.515625 0.078125 -0.171875 -0.833744 -0.833744 -0.833744 --0.515625 0.078125 -0.140625 -0.154405 -0.154405 -0.154405 --0.515625 0.109375 -0.171875 -1.70805 -1.70805 -1.70805 --0.515625 0.109375 -0.140625 -1.89296 -1.89296 -1.89296 --0.515625 0.046875 -0.109375 -1.25277 -1.25277 -1.25277 --0.515625 0.046875 -0.078125 -2.81197 -2.81197 -2.81197 --0.515625 0.078125 -0.109375 -2.01669 -2.01669 -2.01669 --0.515625 0.078125 -0.078125 -2.50578 -2.50578 -2.50578 --0.515625 0.109375 -0.109375 -2.9805 -2.9805 -2.9805 --0.515625 0.109375 -0.078125 -1.24632 -1.24632 -1.24632 --0.515625 0.140625 -0.171875 -1.21386 -1.21386 -1.21386 --0.515625 0.140625 -0.140625 -1.87102 -1.87102 -1.87102 --0.515625 0.140625 -0.109375 -1.88202 -1.88202 -1.88202 --0.328125 0.046875 -0.265625 -18.1208 -18.1208 -18.1208 --0.328125 0.078125 -0.265625 -5.21685 -5.21685 -5.21685 --0.328125 0.109375 -0.296875 -1.60194 -1.60194 -1.60194 --0.328125 0.109375 -0.265625 -1.19594 -1.19594 -1.19594 --0.265625 0.046875 -0.359375 -2.75497 -2.75497 -2.75497 --0.265625 0.046875 -0.328125 -1.75111 -1.75111 -1.75111 --0.296875 0.046875 -0.296875 3.67428 3.67428 3.67428 --0.296875 0.046875 -0.265625 -9.26846 -9.26846 -9.26846 --0.265625 0.015625 -0.296875 3.06198 3.06198 3.06198 --0.265625 0.015625 -0.265625 -9.41128 -9.41128 -9.41128 --0.265625 0.046875 -0.296875 -4.51933 -4.51933 -4.51933 --0.296875 0.078125 -0.328125 -2.82253 -2.82253 -2.82253 --0.265625 0.078125 -0.359375 -5.65424 -5.65424 -5.65424 --0.265625 0.078125 -0.328125 9.59249 9.59249 9.59249 --0.265625 0.109375 -0.359375 -8.36965 -8.36965 -8.36965 --0.265625 0.109375 -0.328125 -11.6806 -11.6806 -11.6806 --0.296875 0.078125 -0.296875 3.69592 3.69592 3.69592 --0.296875 0.109375 -0.296875 -2.64046 -2.64046 -2.64046 --0.265625 0.109375 -0.296875 -3.74278 -3.74278 -3.74278 --0.328125 0.140625 -0.265625 -0.136638 -0.136638 -0.136638 --0.265625 0.140625 -0.328125 1.97279 1.97279 1.97279 --0.296875 0.140625 -0.265625 5.23735 5.23735 5.23735 --0.265625 0.140625 -0.296875 -1.52723 -1.52723 -1.52723 --0.265625 0.140625 -0.265625 2.24735 2.24735 2.24735 --0.453125 0.046875 -0.203125 -1.70585 -1.70585 -1.70585 --0.484375 0.046875 -0.171875 -1.67113 -1.67113 -1.67113 --0.484375 0.046875 -0.140625 -2.01708 -2.01708 -2.01708 --0.453125 0.015625 -0.140625 -1.61035 -1.61035 -1.61035 --0.453125 0.046875 -0.171875 -1.8428 -1.8428 -1.8428 --0.453125 0.046875 -0.140625 -2.08069 -2.08069 -2.08069 --0.484375 0.078125 -0.203125 -2.31866 -2.31866 -2.31866 --0.484375 0.109375 -0.203125 -3.34309 -3.34309 -3.34309 --0.453125 0.078125 -0.234375 -1.52325 -1.52325 -1.52325 --0.453125 0.078125 -0.203125 -2.03138 -2.03138 -2.03138 --0.453125 0.109375 -0.234375 -1.77681 -1.77681 -1.77681 --0.453125 0.109375 -0.203125 -2.15308 -2.15308 -2.15308 --0.484375 0.078125 -0.171875 -2.07287 -2.07287 -2.07287 --0.484375 0.078125 -0.140625 -1.02582 -1.02582 -1.02582 --0.484375 0.109375 -0.171875 -1.73415 -1.73415 -1.73415 --0.421875 0.046875 -0.203125 -1.93616 -1.93616 -1.93616 --0.390625 0.015625 -0.203125 -4.36633 -4.36633 -4.36633 --0.390625 0.046875 -0.203125 -2.66292 -2.66292 -2.66292 --0.421875 0.015625 -0.171875 -1.32134 -1.32134 -1.32134 --0.421875 0.015625 -0.140625 -2.05789 -2.05789 -2.05789 --0.421875 0.046875 -0.171875 -2.09464 -2.09464 -2.09464 --0.421875 0.046875 -0.140625 -2.03444 -2.03444 -2.03444 --0.390625 0.015625 -0.171875 -0.664602 -0.664602 -0.664602 --0.390625 0.015625 -0.140625 -1.8673 -1.8673 -1.8673 --0.421875 0.078125 -0.234375 -1.73421 -1.73421 -1.73421 --0.421875 0.078125 -0.203125 -2.11128 -2.11128 -2.11128 --0.421875 0.109375 -0.234375 -1.66292 -1.66292 -1.66292 --0.421875 0.109375 -0.203125 -2.21491 -2.21491 -2.21491 --0.390625 0.078125 -0.234375 -7.1107 -7.1107 -7.1107 --0.390625 0.078125 -0.203125 -0.408498 -0.408498 -0.408498 --0.390625 0.109375 -0.203125 -2.60475 -2.60475 -2.60475 --0.421875 0.109375 -0.140625 -1.8144 -1.8144 -1.8144 --0.390625 0.109375 -0.140625 -2.01304 -2.01304 -2.01304 --0.484375 0.015625 -0.109375 -1.49291 -1.49291 -1.49291 --0.484375 0.046875 -0.109375 -3.31552 -3.31552 -3.31552 --0.484375 0.046875 -0.078125 -2.85684 -2.85684 -2.85684 --0.453125 0.015625 -0.109375 -1.94368 -1.94368 -1.94368 --0.453125 0.015625 -0.078125 -2.0372 -2.0372 -2.0372 --0.453125 0.046875 -0.078125 -1.88097 -1.88097 -1.88097 --0.484375 0.046875 -0.046875 -0.871017 -0.871017 -0.871017 --0.453125 0.046875 -0.046875 -1.52403 -1.52403 -1.52403 --0.484375 0.078125 -0.078125 -0.910351 -0.910351 -0.910351 --0.484375 0.109375 -0.109375 -1.5086 -1.5086 -1.5086 --0.484375 0.109375 -0.078125 -1.80579 -1.80579 -1.80579 --0.453125 0.109375 -0.078125 -1.87242 -1.87242 -1.87242 --0.484375 0.078125 -0.046875 -0.202078 -0.202078 -0.202078 --0.484375 0.109375 -0.046875 -1.51781 -1.51781 -1.51781 --0.453125 0.078125 -0.046875 -1.93317 -1.93317 -1.93317 --0.453125 0.109375 -0.046875 -1.68731 -1.68731 -1.68731 --0.421875 0.015625 -0.109375 -1.88687 -1.88687 -1.88687 --0.421875 0.015625 -0.078125 -1.9087 -1.9087 -1.9087 --0.390625 0.015625 -0.109375 -1.969 -1.969 -1.969 --0.390625 0.015625 -0.078125 -2.05223 -2.05223 -2.05223 --0.390625 0.046875 -0.078125 -2.10737 -2.10737 -2.10737 --0.421875 0.015625 -0.046875 -1.67563 -1.67563 -1.67563 --0.421875 0.046875 -0.046875 -1.91353 -1.91353 -1.91353 --0.390625 0.046875 -0.046875 -2.40734 -2.40734 -2.40734 --0.421875 0.109375 -0.109375 -1.96596 -1.96596 -1.96596 --0.421875 0.109375 -0.078125 -1.83699 -1.83699 -1.83699 --0.390625 0.078125 -0.078125 -2.00755 -2.00755 -2.00755 --0.390625 0.109375 -0.109375 -2.38697 -2.38697 -2.38697 --0.390625 0.109375 -0.078125 -1.46614 -1.46614 -1.46614 --0.421875 0.078125 -0.046875 -1.91341 -1.91341 -1.91341 --0.390625 0.078125 -0.046875 -2.25557 -2.25557 -2.25557 --0.484375 0.140625 -0.203125 -3.86729 -3.86729 -3.86729 --0.453125 0.140625 -0.203125 -2.00244 -2.00244 -2.00244 --0.484375 0.140625 -0.171875 -0.556712 -0.556712 -0.556712 --0.484375 0.140625 -0.140625 -0.373947 -0.373947 -0.373947 --0.453125 0.140625 -0.171875 -1.82429 -1.82429 -1.82429 --0.453125 0.140625 -0.140625 -2.21237 -2.21237 -2.21237 --0.453125 0.171875 -0.140625 -1.49735 -1.49735 -1.49735 --0.421875 0.140625 -0.203125 -1.69172 -1.69172 -1.69172 --0.390625 0.140625 -0.203125 -3.70794 -3.70794 -3.70794 --0.421875 0.140625 -0.171875 -2.18868 -2.18868 -2.18868 --0.421875 0.140625 -0.140625 -2.15049 -2.15049 -2.15049 --0.421875 0.171875 -0.171875 -1.28872 -1.28872 -1.28872 --0.390625 0.140625 -0.171875 -2.17282 -2.17282 -2.17282 --0.390625 0.140625 -0.140625 -1.33883 -1.33883 -1.33883 --0.484375 0.140625 -0.109375 -2.1396 -2.1396 -2.1396 --0.484375 0.140625 -0.078125 -0.854873 -0.854873 -0.854873 --0.453125 0.140625 -0.109375 -2.21982 -2.21982 -2.21982 --0.453125 0.140625 -0.078125 -1.77007 -1.77007 -1.77007 --0.421875 0.140625 -0.109375 -1.85957 -1.85957 -1.85957 --0.359375 0.015625 -0.203125 -1.24801 -1.24801 -1.24801 --0.359375 0.046875 -0.203125 -19.4636 -19.4636 -19.4636 --0.328125 0.015625 -0.234375 -12.0542 -12.0542 -12.0542 --0.328125 0.015625 -0.203125 -1.12259 -1.12259 -1.12259 --0.328125 0.046875 -0.234375 -7.71414 -7.71414 -7.71414 --0.359375 0.015625 -0.171875 8.49801 8.49801 8.49801 --0.359375 0.046875 -0.171875 -11.8788 -11.8788 -11.8788 --0.328125 0.015625 -0.171875 4.6735 4.6735 4.6735 --0.328125 0.046875 -0.171875 -6.63263 -6.63263 -6.63263 --0.328125 0.046875 -0.140625 -2.15056 -2.15056 -2.15056 --0.359375 0.078125 -0.203125 -2.20459 -2.20459 -2.20459 --0.359375 0.109375 -0.203125 -7.56127 -7.56127 -7.56127 --0.328125 0.078125 -0.234375 1.25393 1.25393 1.25393 --0.328125 0.078125 -0.203125 -1.04707 -1.04707 -1.04707 --0.328125 0.109375 -0.234375 -4.7852 -4.7852 -4.7852 --0.328125 0.109375 -0.203125 -10.003 -10.003 -10.003 --0.359375 0.078125 -0.171875 2.69354 2.69354 2.69354 --0.359375 0.078125 -0.140625 -2.51412 -2.51412 -2.51412 --0.359375 0.109375 -0.171875 -3.56671 -3.56671 -3.56671 --0.359375 0.109375 -0.140625 -2.13971 -2.13971 -2.13971 --0.328125 0.078125 -0.171875 0.422708 0.422708 0.422708 --0.328125 0.078125 -0.140625 -2.35075 -2.35075 -2.35075 --0.328125 0.109375 -0.140625 -1.88609 -1.88609 -1.88609 --0.296875 0.015625 -0.234375 -4.42446 -4.42446 -4.42446 --0.296875 0.015625 -0.203125 -5.24998 -5.24998 -5.24998 --0.296875 0.046875 -0.234375 -3.62462 -3.62462 -3.62462 --0.296875 0.046875 -0.203125 -1.65018 -1.65018 -1.65018 --0.265625 0.015625 -0.234375 -3.1186 -3.1186 -3.1186 --0.265625 0.046875 -0.234375 -2.53203 -2.53203 -2.53203 --0.265625 0.046875 -0.203125 -2.61948 -2.61948 -2.61948 --0.296875 0.015625 -0.171875 3.67329 3.67329 3.67329 --0.296875 0.015625 -0.140625 -2.76241 -2.76241 -2.76241 --0.296875 0.046875 -0.171875 0.264662 0.264662 0.264662 --0.296875 0.046875 -0.140625 -1.31311 -1.31311 -1.31311 --0.265625 0.015625 -0.171875 -1.71591 -1.71591 -1.71591 --0.265625 0.015625 -0.140625 -1.24797 -1.24797 -1.24797 --0.265625 0.046875 -0.171875 -3.02035 -3.02035 -3.02035 --0.265625 0.046875 -0.140625 -1.53293 -1.53293 -1.53293 --0.296875 0.078125 -0.203125 3.87222 3.87222 3.87222 --0.296875 0.109375 -0.203125 1.1596 1.1596 1.1596 --0.265625 0.078125 -0.203125 -1.04909 -1.04909 -1.04909 --0.265625 0.109375 -0.203125 8.11736 8.11736 8.11736 --0.296875 0.078125 -0.140625 -2.07951 -2.07951 -2.07951 --0.296875 0.109375 -0.140625 -2.06308 -2.06308 -2.06308 --0.265625 0.078125 -0.171875 -14.3887 -14.3887 -14.3887 --0.265625 0.078125 -0.140625 -3.52985 -3.52985 -3.52985 --0.265625 0.109375 -0.140625 -2.17974 -2.17974 -2.17974 --0.359375 0.015625 -0.078125 -2.01548 -2.01548 -2.01548 --0.359375 0.046875 -0.078125 -1.92839 -1.92839 -1.92839 --0.328125 0.015625 -0.078125 -1.4496 -1.4496 -1.4496 --0.328125 0.046875 -0.109375 -2.12297 -2.12297 -2.12297 --0.328125 0.046875 -0.078125 -1.80312 -1.80312 -1.80312 --0.359375 0.015625 -0.046875 -0.852984 -0.852984 -0.852984 --0.359375 0.015625 -0.015625 -0.823129 -0.823129 -0.823129 --0.359375 0.046875 -0.046875 -1.3616 -1.3616 -1.3616 --0.359375 0.046875 -0.015625 -1.0169 -1.0169 -1.0169 --0.328125 0.015625 -0.046875 -1.35682 -1.35682 -1.35682 --0.328125 0.046875 -0.046875 -1.21333 -1.21333 -1.21333 --0.359375 0.078125 -0.109375 -2.1029 -2.1029 -2.1029 --0.359375 0.078125 -0.078125 -2.2273 -2.2273 -2.2273 --0.359375 0.109375 -0.109375 -1.89241 -1.89241 -1.89241 --0.359375 0.109375 -0.078125 -0.747063 -0.747063 -0.747063 --0.328125 0.078125 -0.109375 -1.95364 -1.95364 -1.95364 --0.328125 0.078125 -0.078125 -1.94509 -1.94509 -1.94509 --0.359375 0.078125 -0.015625 -2.49357 -2.49357 -2.49357 --0.359375 0.109375 -0.046875 0.0377893 0.0377893 0.0377893 --0.328125 0.078125 -0.046875 -1.42955 -1.42955 -1.42955 --0.328125 0.078125 -0.015625 -2.57399 -2.57399 -2.57399 --0.328125 0.109375 -0.046875 0.288715 0.288715 0.288715 --0.296875 0.015625 -0.109375 -0.463345 -0.463345 -0.463345 --0.296875 0.015625 -0.078125 -1.067 -1.067 -1.067 --0.296875 0.046875 -0.109375 -2.11347 -2.11347 -2.11347 --0.296875 0.046875 -0.078125 -1.07482 -1.07482 -1.07482 --0.265625 0.015625 -0.109375 -1.53585 -1.53585 -1.53585 --0.265625 0.015625 -0.078125 -1.11669 -1.11669 -1.11669 --0.265625 0.046875 -0.109375 -0.226327 -0.226327 -0.226327 --0.265625 0.046875 -0.078125 -0.949925 -0.949925 -0.949925 --0.296875 0.046875 -0.046875 -0.949682 -0.949682 -0.949682 --0.265625 0.015625 -0.046875 -1.01102 -1.01102 -1.01102 --0.265625 0.015625 -0.015625 -1.11795 -1.11795 -1.11795 --0.265625 0.046875 -0.046875 -3.9319 -3.9319 -3.9319 --0.265625 0.046875 -0.015625 -5.48605 -5.48605 -5.48605 --0.296875 0.078125 -0.109375 -1.95816 -1.95816 -1.95816 --0.296875 0.078125 -0.078125 -1.80434 -1.80434 -1.80434 --0.265625 0.078125 -0.109375 -2.46425 -2.46425 -2.46425 --0.265625 0.078125 -0.078125 -1.67883 -1.67883 -1.67883 --0.265625 0.109375 -0.109375 -2.75197 -2.75197 -2.75197 --0.296875 0.078125 -0.046875 -1.70238 -1.70238 -1.70238 --0.296875 0.078125 -0.015625 -2.31126 -2.31126 -2.31126 --0.296875 0.109375 -0.046875 -10.3058 -10.3058 -10.3058 --0.296875 0.109375 -0.015625 -10.725 -10.725 -10.725 --0.265625 0.078125 -0.046875 -1.1023 -1.1023 -1.1023 --0.265625 0.109375 -0.046875 1.2751 1.2751 1.2751 --0.265625 0.109375 -0.015625 -1.33598 -1.33598 -1.33598 --0.328125 0.140625 -0.234375 -0.782376 -0.782376 -0.782376 --0.359375 0.140625 -0.171875 -1.45672 -1.45672 -1.45672 --0.359375 0.140625 -0.140625 -2.21864 -2.21864 -2.21864 --0.328125 0.140625 -0.140625 -2.02238 -2.02238 -2.02238 --0.328125 0.171875 -0.140625 -1.87477 -1.87477 -1.87477 --0.296875 0.140625 -0.234375 2.28036 2.28036 2.28036 --0.296875 0.140625 -0.203125 -3.8584 -3.8584 -3.8584 --0.296875 0.171875 -0.203125 -1.77139 -1.77139 -1.77139 --0.265625 0.140625 -0.234375 -1.75311 -1.75311 -1.75311 --0.265625 0.140625 -0.203125 8.39056 8.39056 8.39056 --0.265625 0.171875 -0.203125 -3.27963 -3.27963 -3.27963 --0.296875 0.140625 -0.171875 -7.10498 -7.10498 -7.10498 --0.296875 0.140625 -0.140625 -2.28824 -2.28824 -2.28824 --0.296875 0.171875 -0.171875 -2.21675 -2.21675 -2.21675 --0.296875 0.171875 -0.140625 -2.23337 -2.23337 -2.23337 --0.265625 0.140625 -0.171875 -5.98486 -5.98486 -5.98486 --0.265625 0.140625 -0.140625 -1.03447 -1.03447 -1.03447 --0.265625 0.171875 -0.171875 -2.29419 -2.29419 -2.29419 --0.296875 0.203125 -0.203125 -0.686858 -0.686858 -0.686858 --0.265625 0.203125 -0.203125 -1.23968 -1.23968 -1.23968 --0.296875 0.203125 -0.171875 -1.94481 -1.94481 -1.94481 --0.296875 0.203125 -0.140625 -1.9323 -1.9323 -1.9323 --0.296875 0.234375 -0.171875 -1.45217 -1.45217 -1.45217 --0.296875 0.234375 -0.140625 -1.85793 -1.85793 -1.85793 --0.265625 0.203125 -0.171875 -1.58037 -1.58037 -1.58037 --0.265625 0.234375 -0.171875 -2.3112 -2.3112 -2.3112 --0.265625 0.234375 -0.140625 -4.01406 -4.01406 -4.01406 --0.359375 0.140625 -0.109375 -1.68146 -1.68146 -1.68146 --0.359375 0.140625 -0.078125 0.361611 0.361611 0.361611 --0.359375 0.171875 -0.109375 -1.11486 -1.11486 -1.11486 --0.359375 0.171875 -0.078125 1.01604 1.01604 1.01604 --0.328125 0.171875 -0.109375 -0.752447 -0.752447 -0.752447 --0.328125 0.171875 -0.078125 0.863047 0.863047 0.863047 --0.359375 0.140625 -0.046875 -0.417819 -0.417819 -0.417819 --0.328125 0.140625 -0.046875 -0.945752 -0.945752 -0.945752 --0.328125 0.171875 -0.046875 -2.67658 -2.67658 -2.67658 --0.296875 0.171875 -0.109375 -2.83798 -2.83798 -2.83798 --0.296875 0.171875 -0.078125 -2.4198 -2.4198 -2.4198 --0.296875 0.140625 -0.046875 0.526697 0.526697 0.526697 --0.296875 0.140625 -0.015625 -8.14938 -8.14938 -8.14938 --0.296875 0.171875 -0.046875 1.20116 1.20116 1.20116 --0.296875 0.171875 -0.015625 -4.55742 -4.55742 -4.55742 --0.265625 0.140625 -0.015625 -0.97227 -0.97227 -0.97227 --0.265625 0.171875 -0.046875 -3.33707 -3.33707 -3.33707 --0.265625 0.171875 -0.015625 -6.78975 -6.78975 -6.78975 --0.296875 0.203125 -0.109375 0.443065 0.443065 0.443065 --0.296875 0.203125 -0.078125 -2.22023 -2.22023 -2.22023 --0.296875 0.234375 -0.109375 0.106541 0.106541 0.106541 --0.296875 0.234375 -0.078125 4.14171 4.14171 4.14171 --0.265625 0.234375 -0.109375 -3.80069 -3.80069 -3.80069 --0.265625 0.234375 -0.078125 -18.4245 -18.4245 -18.4245 --0.296875 0.203125 -0.046875 -1.76238 -1.76238 -1.76238 --0.296875 0.203125 -0.015625 -2.86387 -2.86387 -2.86387 --0.296875 0.234375 -0.046875 -1.34443 -1.34443 -1.34443 --0.296875 0.234375 -0.015625 2.47829 2.47829 2.47829 --0.265625 0.203125 -0.046875 -0.826521 -0.826521 -0.826521 --0.265625 0.203125 -0.015625 -6.05989 -6.05989 -6.05989 --0.265625 0.234375 -0.046875 2.79136 2.79136 2.79136 --0.265625 0.234375 -0.015625 2.34924 2.34924 2.34924 --0.265625 0.265625 -0.046875 -12.616 -12.616 -12.616 --0.265625 0.265625 -0.015625 -4.95762 -4.95762 -4.95762 --0.140625 0.015625 -0.390625 -1.65249 -1.65249 -1.65249 --0.140625 0.109375 -0.390625 7.53156 7.53156 7.53156 --0.234375 0.046875 -0.359375 -1.39679 -1.39679 -1.39679 --0.234375 0.046875 -0.328125 -1.096 -1.096 -1.096 --0.203125 0.046875 -0.359375 -2.06793 -2.06793 -2.06793 --0.203125 0.046875 -0.328125 -0.956313 -0.956313 -0.956313 --0.234375 0.015625 -0.296875 -2.25553 -2.25553 -2.25553 --0.234375 0.015625 -0.265625 -3.49493 -3.49493 -3.49493 --0.234375 0.046875 -0.296875 -2.2609 -2.2609 -2.2609 --0.203125 0.015625 -0.296875 -1.78557 -1.78557 -1.78557 --0.203125 0.015625 -0.265625 -1.59498 -1.59498 -1.59498 --0.203125 0.046875 -0.296875 -1.44802 -1.44802 -1.44802 --0.203125 0.046875 -0.265625 -0.521236 -0.521236 -0.521236 --0.234375 0.078125 -0.359375 -1.5557 -1.5557 -1.5557 --0.234375 0.109375 -0.359375 -1.74284 -1.74284 -1.74284 --0.234375 0.109375 -0.328125 -1.77907 -1.77907 -1.77907 --0.203125 0.078125 -0.359375 -1.47608 -1.47608 -1.47608 --0.203125 0.078125 -0.328125 -1.50731 -1.50731 -1.50731 --0.203125 0.109375 -0.359375 -1.55148 -1.55148 -1.55148 --0.203125 0.109375 -0.328125 -2.22655 -2.22655 -2.22655 --0.234375 0.109375 -0.265625 -0.165442 -0.165442 -0.165442 --0.203125 0.078125 -0.265625 -2.06071 -2.06071 -2.06071 --0.203125 0.109375 -0.296875 -2.32973 -2.32973 -2.32973 --0.203125 0.109375 -0.265625 -2.62934 -2.62934 -2.62934 --0.171875 0.015625 -0.359375 -2.26525 -2.26525 -2.26525 --0.171875 0.015625 -0.328125 -2.82738 -2.82738 -2.82738 --0.140625 0.015625 -0.359375 -3.08822 -3.08822 -3.08822 --0.140625 0.015625 -0.328125 -3.17063 -3.17063 -3.17063 --0.140625 0.046875 -0.328125 -2.57439 -2.57439 -2.57439 --0.171875 0.015625 -0.296875 -3.01298 -3.01298 -3.01298 --0.171875 0.015625 -0.265625 -2.4379 -2.4379 -2.4379 --0.171875 0.046875 -0.296875 -3.36931 -3.36931 -3.36931 --0.171875 0.046875 -0.265625 -1.43498 -1.43498 -1.43498 --0.140625 0.015625 -0.265625 -0.988251 -0.988251 -0.988251 --0.140625 0.046875 -0.296875 -2.77582 -2.77582 -2.77582 --0.140625 0.046875 -0.265625 -1.60738 -1.60738 -1.60738 --0.171875 0.078125 -0.359375 -1.79504 -1.79504 -1.79504 --0.171875 0.078125 -0.328125 -1.98706 -1.98706 -1.98706 --0.171875 0.109375 -0.359375 -2.06998 -2.06998 -2.06998 --0.171875 0.109375 -0.328125 -1.98601 -1.98601 -1.98601 --0.140625 0.078125 -0.359375 -1.92045 -1.92045 -1.92045 --0.140625 0.078125 -0.328125 -1.78255 -1.78255 -1.78255 --0.140625 0.109375 -0.359375 -2.05649 -2.05649 -2.05649 --0.171875 0.078125 -0.296875 -2.50116 -2.50116 -2.50116 --0.171875 0.078125 -0.265625 -2.5779 -2.5779 -2.5779 --0.171875 0.109375 -0.296875 -2.33392 -2.33392 -2.33392 --0.171875 0.109375 -0.265625 -2.25596 -2.25596 -2.25596 --0.140625 0.078125 -0.296875 -1.81234 -1.81234 -1.81234 --0.140625 0.078125 -0.265625 -2.03786 -2.03786 -2.03786 --0.140625 0.109375 -0.296875 -1.95998 -1.95998 -1.95998 --0.140625 0.109375 -0.265625 -2.10569 -2.10569 -2.10569 --0.171875 0.140625 -0.390625 6.31084 6.31084 6.31084 --0.140625 0.140625 -0.390625 14.8583 14.8583 14.8583 --0.140625 0.171875 -0.390625 -20.0038 -20.0038 -20.0038 --0.234375 0.140625 -0.328125 0.578239 0.578239 0.578239 --0.203125 0.140625 -0.328125 -2.04218 -2.04218 -2.04218 --0.234375 0.140625 -0.296875 -2.43937 -2.43937 -2.43937 --0.234375 0.140625 -0.265625 -1.5708 -1.5708 -1.5708 --0.203125 0.140625 -0.296875 -1.628 -1.628 -1.628 --0.171875 0.140625 -0.359375 -2.58114 -2.58114 -2.58114 --0.171875 0.140625 -0.328125 -1.44462 -1.44462 -1.44462 --0.171875 0.171875 -0.359375 -1.78181 -1.78181 -1.78181 --0.171875 0.171875 -0.328125 -2.14559 -2.14559 -2.14559 --0.140625 0.171875 -0.359375 -1.90224 -1.90224 -1.90224 --0.140625 0.171875 -0.328125 0.382792 0.382792 0.382792 --0.171875 0.140625 -0.296875 -1.35413 -1.35413 -1.35413 --0.171875 0.140625 -0.265625 -1.87519 -1.87519 -1.87519 --0.171875 0.171875 -0.296875 -1.38598 -1.38598 -1.38598 --0.171875 0.171875 -0.265625 -1.56597 -1.56597 -1.56597 --0.140625 0.171875 -0.296875 -0.906749 -0.906749 -0.906749 --0.140625 0.171875 -0.265625 -2.61308 -2.61308 -2.61308 --0.140625 0.203125 -0.328125 -2.87563 -2.87563 -2.87563 --0.140625 0.203125 -0.296875 -3.07237 -3.07237 -3.07237 --0.140625 0.203125 -0.265625 -3.20874 -3.20874 -3.20874 --0.109375 0.015625 -0.390625 -2.31667 -2.31667 -2.31667 --0.078125 0.015625 -0.421875 -2.27062 -2.27062 -2.27062 --0.078125 0.015625 -0.390625 -2.62276 -2.62276 -2.62276 --0.078125 0.046875 -0.390625 -2.54021 -2.54021 -2.54021 --0.109375 0.109375 -0.390625 -16.081 -16.081 -16.081 --0.046875 0.015625 -0.421875 -1.98473 -1.98473 -1.98473 --0.046875 0.046875 -0.421875 -1.76084 -1.76084 -1.76084 --0.046875 0.046875 -0.390625 -1.89732 -1.89732 -1.89732 --0.015625 0.015625 -0.421875 -1.81489 -1.81489 -1.81489 --0.015625 0.046875 -0.421875 -1.75453 -1.75453 -1.75453 --0.046875 0.078125 -0.390625 -1.78125 -1.78125 -1.78125 --0.015625 0.078125 -0.421875 -1.56417 -1.56417 -1.56417 --0.015625 0.078125 -0.390625 -1.82679 -1.82679 -1.82679 --0.109375 0.015625 -0.359375 -2.50629 -2.50629 -2.50629 --0.109375 0.046875 -0.359375 -2.28027 -2.28027 -2.28027 --0.109375 0.046875 -0.328125 -2.2594 -2.2594 -2.2594 --0.078125 0.046875 -0.359375 -2.68822 -2.68822 -2.68822 --0.078125 0.046875 -0.328125 -1.56834 -1.56834 -1.56834 --0.109375 0.046875 -0.296875 -1.84696 -1.84696 -1.84696 --0.109375 0.046875 -0.265625 -1.46479 -1.46479 -1.46479 --0.078125 0.046875 -0.296875 -1.31557 -1.31557 -1.31557 --0.078125 0.046875 -0.265625 -1.28154 -1.28154 -1.28154 --0.109375 0.078125 -0.359375 -1.74098 -1.74098 -1.74098 --0.109375 0.078125 -0.328125 -1.74293 -1.74293 -1.74293 --0.109375 0.109375 -0.359375 -2.06037 -2.06037 -2.06037 --0.109375 0.109375 -0.328125 -1.87178 -1.87178 -1.87178 --0.078125 0.078125 -0.359375 -2.29835 -2.29835 -2.29835 --0.078125 0.078125 -0.328125 -1.36206 -1.36206 -1.36206 --0.078125 0.109375 -0.359375 -1.90621 -1.90621 -1.90621 --0.078125 0.109375 -0.328125 -2.06606 -2.06606 -2.06606 --0.109375 0.078125 -0.296875 -1.9545 -1.9545 -1.9545 --0.109375 0.078125 -0.265625 -1.9945 -1.9945 -1.9945 --0.109375 0.109375 -0.296875 -1.77347 -1.77347 -1.77347 --0.078125 0.078125 -0.296875 -1.34277 -1.34277 -1.34277 --0.078125 0.078125 -0.265625 -1.20983 -1.20983 -1.20983 --0.078125 0.109375 -0.296875 -2.97967 -2.97967 -2.97967 --0.078125 0.109375 -0.265625 -1.54444 -1.54444 -1.54444 --0.046875 0.046875 -0.359375 -1.63941 -1.63941 -1.63941 --0.015625 0.015625 -0.328125 -1.44233 -1.44233 -1.44233 --0.015625 0.046875 -0.328125 -0.924479 -0.924479 -0.924479 --0.046875 0.015625 -0.265625 -1.38842 -1.38842 -1.38842 --0.046875 0.046875 -0.265625 -0.864339 -0.864339 -0.864339 --0.015625 0.015625 -0.296875 -0.997197 -0.997197 -0.997197 --0.015625 0.046875 -0.296875 -1.03897 -1.03897 -1.03897 --0.015625 0.046875 -0.265625 -0.815055 -0.815055 -0.815055 --0.046875 0.078125 -0.359375 -0.833701 -0.833701 -0.833701 --0.046875 0.078125 -0.328125 -0.837959 -0.837959 -0.837959 --0.046875 0.109375 -0.359375 -2.49796 -2.49796 -2.49796 --0.046875 0.109375 -0.328125 -2.56982 -2.56982 -2.56982 --0.015625 0.078125 -0.359375 -1.26648 -1.26648 -1.26648 --0.015625 0.078125 -0.328125 -2.0479 -2.0479 -2.0479 --0.015625 0.109375 -0.359375 -2.16858 -2.16858 -2.16858 --0.015625 0.109375 -0.328125 -2.04171 -2.04171 -2.04171 --0.046875 0.078125 -0.296875 -1.83741 -1.83741 -1.83741 --0.046875 0.078125 -0.265625 -1.21363 -1.21363 -1.21363 --0.046875 0.109375 -0.296875 -2.33483 -2.33483 -2.33483 --0.046875 0.109375 -0.265625 -1.68633 -1.68633 -1.68633 --0.015625 0.078125 -0.296875 -1.09102 -1.09102 -1.09102 --0.015625 0.078125 -0.265625 -1.90322 -1.90322 -1.90322 --0.015625 0.109375 -0.296875 -1.62274 -1.62274 -1.62274 --0.015625 0.109375 -0.265625 -2.12289 -2.12289 -2.12289 --0.109375 0.140625 -0.390625 -9.6627 -9.6627 -9.6627 --0.109375 0.171875 -0.390625 -33.6391 -33.6391 -33.6391 --0.046875 0.234375 -0.390625 -1.35439 -1.35439 -1.35439 --0.015625 0.234375 -0.390625 -1.34584 -1.34584 -1.34584 --0.109375 0.140625 -0.359375 -1.89746 -1.89746 -1.89746 --0.109375 0.171875 -0.359375 -2.04936 -2.04936 -2.04936 --0.109375 0.171875 -0.328125 1.30401 1.30401 1.30401 --0.078125 0.140625 -0.359375 -1.79793 -1.79793 -1.79793 --0.078125 0.171875 -0.359375 -1.92309 -1.92309 -1.92309 --0.078125 0.171875 -0.265625 -2.13503 -2.13503 -2.13503 --0.109375 0.203125 -0.328125 -2.22002 -2.22002 -2.22002 --0.078125 0.203125 -0.359375 -1.72167 -1.72167 -1.72167 --0.078125 0.203125 -0.328125 -0.210607 -0.210607 -0.210607 --0.109375 0.203125 -0.296875 -2.66051 -2.66051 -2.66051 --0.109375 0.203125 -0.265625 -4.45823 -4.45823 -4.45823 --0.078125 0.203125 -0.296875 -2.03043 -2.03043 -2.03043 --0.078125 0.203125 -0.265625 -3.16299 -3.16299 -3.16299 --0.046875 0.140625 -0.359375 -2.21219 -2.21219 -2.21219 --0.046875 0.171875 -0.359375 -0.930225 -0.930225 -0.930225 --0.015625 0.140625 -0.359375 0.531187 0.531187 0.531187 --0.015625 0.140625 -0.328125 -4.15629 -4.15629 -4.15629 --0.015625 0.171875 -0.359375 -1.35111 -1.35111 -1.35111 --0.015625 0.171875 -0.328125 -0.344595 -0.344595 -0.344595 --0.046875 0.140625 -0.265625 -1.68287 -1.68287 -1.68287 --0.046875 0.171875 -0.265625 -1.74445 -1.74445 -1.74445 --0.015625 0.140625 -0.296875 -1.75206 -1.75206 -1.75206 --0.015625 0.140625 -0.265625 -1.46107 -1.46107 -1.46107 --0.015625 0.171875 -0.296875 -1.43399 -1.43399 -1.43399 --0.015625 0.171875 -0.265625 -1.7041 -1.7041 -1.7041 --0.046875 0.203125 -0.359375 -1.63843 -1.63843 -1.63843 --0.046875 0.203125 -0.328125 -1.73627 -1.73627 -1.73627 --0.046875 0.234375 -0.359375 -1.80348 -1.80348 -1.80348 --0.046875 0.234375 -0.328125 -2.30318 -2.30318 -2.30318 --0.015625 0.203125 -0.359375 -4.2302 -4.2302 -4.2302 --0.015625 0.203125 -0.328125 -3.20199 -3.20199 -3.20199 --0.015625 0.234375 -0.359375 -1.93093 -1.93093 -1.93093 --0.015625 0.234375 -0.328125 -2.17731 -2.17731 -2.17731 --0.046875 0.203125 -0.296875 -1.95679 -1.95679 -1.95679 --0.046875 0.203125 -0.265625 -1.33696 -1.33696 -1.33696 --0.046875 0.234375 -0.296875 -1.69544 -1.69544 -1.69544 --0.046875 0.234375 -0.265625 -3.92983 -3.92983 -3.92983 --0.015625 0.203125 -0.296875 -1.72905 -1.72905 -1.72905 --0.015625 0.203125 -0.265625 -1.73534 -1.73534 -1.73534 --0.015625 0.234375 -0.296875 -2.42915 -2.42915 -2.42915 --0.015625 0.234375 -0.265625 -3.81676 -3.81676 -3.81676 --0.234375 0.015625 -0.234375 -2.66589 -2.66589 -2.66589 --0.203125 0.015625 -0.234375 -0.546198 -0.546198 -0.546198 --0.234375 0.015625 -0.140625 -1.4253 -1.4253 -1.4253 --0.234375 0.046875 -0.140625 0.425032 0.425032 0.425032 --0.234375 0.109375 -0.234375 -10.8093 -10.8093 -10.8093 --0.234375 0.109375 -0.203125 9.13624 9.13624 9.13624 --0.203125 0.109375 -0.234375 2.84172 2.84172 2.84172 --0.203125 0.109375 -0.203125 3.26443 3.26443 3.26443 --0.234375 0.078125 -0.171875 -22.3848 -22.3848 -22.3848 --0.234375 0.078125 -0.140625 -1.91354 -1.91354 -1.91354 --0.234375 0.109375 -0.171875 -17.2249 -17.2249 -17.2249 --0.203125 0.078125 -0.171875 -1.74451 -1.74451 -1.74451 --0.203125 0.078125 -0.140625 -1.78057 -1.78057 -1.78057 --0.203125 0.109375 -0.171875 -2.15939 -2.15939 -2.15939 --0.171875 0.015625 -0.234375 -1.15643 -1.15643 -1.15643 --0.171875 0.015625 -0.203125 -0.908796 -0.908796 -0.908796 --0.171875 0.046875 -0.234375 -0.256403 -0.256403 -0.256403 --0.171875 0.046875 -0.203125 -1.36327 -1.36327 -1.36327 --0.140625 0.046875 -0.234375 -1.24014 -1.24014 -1.24014 --0.140625 0.046875 -0.203125 -0.921883 -0.921883 -0.921883 --0.171875 0.015625 -0.171875 -0.870949 -0.870949 -0.870949 --0.140625 0.015625 -0.171875 -2.13073 -2.13073 -2.13073 --0.140625 0.015625 -0.140625 -1.80824 -1.80824 -1.80824 --0.140625 0.046875 -0.171875 -0.708508 -0.708508 -0.708508 --0.140625 0.046875 -0.140625 -1.03409 -1.03409 -1.03409 --0.171875 0.078125 -0.234375 -1.53842 -1.53842 -1.53842 --0.171875 0.078125 -0.203125 -1.59975 -1.59975 -1.59975 --0.171875 0.109375 -0.234375 -1.95242 -1.95242 -1.95242 --0.171875 0.109375 -0.203125 -0.36584 -0.36584 -0.36584 --0.140625 0.078125 -0.234375 -1.90974 -1.90974 -1.90974 --0.140625 0.078125 -0.203125 -1.03485 -1.03485 -1.03485 --0.140625 0.109375 -0.234375 -0.286244 -0.286244 -0.286244 --0.140625 0.109375 -0.203125 -2.36534 -2.36534 -2.36534 --0.171875 0.078125 -0.171875 -1.28785 -1.28785 -1.28785 --0.171875 0.078125 -0.140625 -1.75342 -1.75342 -1.75342 --0.171875 0.109375 -0.171875 -1.30363 -1.30363 -1.30363 --0.171875 0.109375 -0.140625 -2.20856 -2.20856 -2.20856 --0.140625 0.078125 -0.140625 -1.14962 -1.14962 -1.14962 --0.140625 0.109375 -0.140625 -1.84003 -1.84003 -1.84003 --0.234375 0.046875 -0.078125 -1.19854 -1.19854 -1.19854 --0.203125 0.015625 -0.078125 -1.33433 -1.33433 -1.33433 --0.203125 0.046875 -0.078125 -1.22274 -1.22274 -1.22274 --0.234375 0.015625 -0.046875 -1.13514 -1.13514 -1.13514 --0.234375 0.015625 -0.015625 -2.10382 -2.10382 -2.10382 --0.234375 0.046875 -0.046875 2.93252 2.93252 2.93252 --0.234375 0.046875 -0.015625 -6.57443 -6.57443 -6.57443 --0.203125 0.015625 -0.046875 -1.36182 -1.36182 -1.36182 --0.203125 0.015625 -0.015625 -1.29277 -1.29277 -1.29277 --0.203125 0.046875 -0.046875 12.3981 12.3981 12.3981 --0.234375 0.078125 -0.109375 -2.34403 -2.34403 -2.34403 --0.234375 0.078125 -0.078125 -1.5156 -1.5156 -1.5156 --0.234375 0.109375 -0.109375 -1.91999 -1.91999 -1.91999 --0.234375 0.109375 -0.078125 -3.58023 -3.58023 -3.58023 --0.203125 0.078125 -0.109375 -0.914368 -0.914368 -0.914368 --0.203125 0.078125 -0.078125 -1.55457 -1.55457 -1.55457 --0.203125 0.109375 -0.078125 -0.0438564 -0.0438564 -0.0438564 --0.234375 0.078125 -0.046875 -16.9433 -16.9433 -16.9433 --0.234375 0.078125 -0.015625 6.75695 6.75695 6.75695 --0.234375 0.109375 -0.046875 1.5209 1.5209 1.5209 --0.234375 0.109375 -0.015625 7.96417 7.96417 7.96417 --0.203125 0.078125 -0.046875 -9.37564 -9.37564 -9.37564 --0.203125 0.078125 -0.015625 -16.381 -16.381 -16.381 --0.203125 0.109375 -0.046875 -15.6112 -15.6112 -15.6112 --0.203125 0.109375 -0.015625 3.68062 3.68062 3.68062 --0.171875 0.015625 -0.015625 -0.791496 -0.791496 -0.791496 --0.140625 0.015625 -0.046875 -0.999384 -0.999384 -0.999384 --0.140625 0.015625 -0.015625 -1.07439 -1.07439 -1.07439 --0.140625 0.046875 -0.015625 -1.79861 -1.79861 -1.79861 --0.171875 0.078125 -0.109375 -5.08259 -5.08259 -5.08259 --0.171875 0.078125 -0.078125 -1.27133 -1.27133 -1.27133 --0.171875 0.109375 -0.078125 -1.45474 -1.45474 -1.45474 --0.140625 0.078125 -0.109375 -2.01684 -2.01684 -2.01684 --0.140625 0.078125 -0.078125 -2.00523 -2.00523 -2.00523 --0.140625 0.109375 -0.109375 -2.26217 -2.26217 -2.26217 --0.140625 0.109375 -0.078125 -0.722202 -0.722202 -0.722202 --0.140625 0.078125 -0.046875 -2.25553 -2.25553 -2.25553 --0.140625 0.109375 -0.015625 0.804793 0.804793 0.804793 --0.234375 0.171875 -0.203125 0.132419 0.132419 0.132419 --0.234375 0.140625 -0.171875 -6.67905 -6.67905 -6.67905 --0.234375 0.140625 -0.140625 -5.40162 -5.40162 -5.40162 --0.234375 0.171875 -0.171875 -1.63832 -1.63832 -1.63832 --0.203125 0.171875 -0.171875 -1.65892 -1.65892 -1.65892 --0.203125 0.171875 -0.140625 -1.65803 -1.65803 -1.65803 --0.234375 0.203125 -0.203125 -3.22166 -3.22166 -3.22166 --0.234375 0.203125 -0.171875 -1.92225 -1.92225 -1.92225 --0.234375 0.234375 -0.171875 -1.40473 -1.40473 -1.40473 --0.234375 0.234375 -0.140625 -1.21031 -1.21031 -1.21031 --0.203125 0.203125 -0.171875 -1.0056 -1.0056 -1.0056 --0.203125 0.203125 -0.140625 -2.76297 -2.76297 -2.76297 --0.203125 0.234375 -0.140625 -2.14733 -2.14733 -2.14733 --0.171875 0.140625 -0.234375 -1.1758 -1.1758 -1.1758 --0.171875 0.140625 -0.203125 -1.97868 -1.97868 -1.97868 --0.171875 0.171875 -0.234375 -1.44511 -1.44511 -1.44511 --0.140625 0.140625 -0.203125 -2.00714 -2.00714 -2.00714 --0.140625 0.171875 -0.234375 -3.07466 -3.07466 -3.07466 --0.140625 0.171875 -0.203125 -3.24883 -3.24883 -3.24883 --0.171875 0.140625 -0.171875 -1.32804 -1.32804 -1.32804 --0.171875 0.140625 -0.140625 -0.584315 -0.584315 -0.584315 --0.171875 0.171875 -0.140625 3.46045 3.46045 3.46045 --0.140625 0.140625 -0.171875 -2.05795 -2.05795 -2.05795 --0.140625 0.140625 -0.140625 -0.561656 -0.561656 -0.561656 --0.140625 0.171875 -0.171875 -2.02424 -2.02424 -2.02424 --0.140625 0.171875 -0.140625 1.18292 1.18292 1.18292 --0.171875 0.234375 -0.203125 -0.605334 -0.605334 -0.605334 --0.140625 0.203125 -0.234375 -1.42264 -1.42264 -1.42264 --0.140625 0.234375 -0.203125 -0.631446 -0.631446 -0.631446 --0.171875 0.203125 -0.171875 -0.249691 -0.249691 -0.249691 --0.171875 0.203125 -0.140625 3.3115 3.3115 3.3115 --0.171875 0.234375 -0.171875 -1.02538 -1.02538 -1.02538 --0.140625 0.203125 -0.171875 -2.18266 -2.18266 -2.18266 --0.140625 0.234375 -0.171875 -1.23401 -1.23401 -1.23401 --0.234375 0.140625 -0.109375 -2.86358 -2.86358 -2.86358 --0.234375 0.171875 -0.109375 -7.23154 -7.23154 -7.23154 --0.203125 0.140625 -0.109375 -3.78453 -3.78453 -3.78453 --0.203125 0.140625 -0.078125 0.596789 0.596789 0.596789 --0.203125 0.171875 -0.109375 0.414785 0.414785 0.414785 --0.234375 0.140625 -0.046875 -6.83342 -6.83342 -6.83342 --0.234375 0.140625 -0.015625 -0.706118 -0.706118 -0.706118 --0.234375 0.171875 -0.046875 3.54163 3.54163 3.54163 --0.234375 0.171875 -0.015625 3.25925 3.25925 3.25925 --0.203125 0.140625 -0.046875 0.390926 0.390926 0.390926 --0.203125 0.140625 -0.015625 -0.619324 -0.619324 -0.619324 --0.203125 0.171875 -0.046875 -0.7391 -0.7391 -0.7391 --0.203125 0.171875 -0.015625 -10.2121 -10.2121 -10.2121 --0.234375 0.234375 -0.109375 -10.6641 -10.6641 -10.6641 --0.203125 0.203125 -0.109375 2.18048 2.18048 2.18048 --0.203125 0.234375 -0.109375 24.8954 24.8954 24.8954 --0.203125 0.234375 -0.015625 9.01308 9.01308 9.01308 --0.171875 0.140625 -0.109375 -2.34126 -2.34126 -2.34126 --0.171875 0.140625 -0.078125 0.56965 0.56965 0.56965 --0.140625 0.140625 -0.109375 -1.05482 -1.05482 -1.05482 --0.140625 0.140625 -0.078125 0.315289 0.315289 0.315289 --0.171875 0.140625 -0.046875 -2.71207 -2.71207 -2.71207 --0.171875 0.140625 -0.015625 -1.22107 -1.22107 -1.22107 --0.171875 0.171875 -0.046875 -3.78855 -3.78855 -3.78855 --0.171875 0.171875 -0.015625 -0.000847667 -0.000847667 -0.000847667 --0.140625 0.140625 -0.046875 2.12362 2.12362 2.12362 --0.140625 0.140625 -0.015625 4.92531 4.92531 4.92531 --0.140625 0.171875 -0.046875 -0.192955 -0.192955 -0.192955 --0.171875 0.234375 -0.078125 -1.35417 -1.35417 -1.35417 --0.140625 0.234375 -0.078125 4.3442 4.3442 4.3442 --0.171875 0.203125 -0.046875 -3.20859 -3.20859 -3.20859 --0.171875 0.203125 -0.015625 -17.364 -17.364 -17.364 --0.171875 0.234375 -0.046875 -16.1363 -16.1363 -16.1363 --0.171875 0.234375 -0.015625 -4.05314 -4.05314 -4.05314 --0.140625 0.203125 -0.046875 -16.336 -16.336 -16.336 --0.140625 0.203125 -0.015625 12.6291 12.6291 12.6291 --0.140625 0.234375 -0.046875 4.16289 4.16289 4.16289 --0.140625 0.234375 -0.015625 -17.1594 -17.1594 -17.1594 --0.109375 0.046875 -0.234375 -0.919547 -0.919547 -0.919547 --0.109375 0.046875 -0.203125 -1.12471 -1.12471 -1.12471 --0.078125 0.015625 -0.234375 -0.874247 -0.874247 -0.874247 --0.078125 0.015625 -0.203125 -2.75935 -2.75935 -2.75935 --0.078125 0.046875 -0.234375 -1.10281 -1.10281 -1.10281 --0.078125 0.046875 -0.203125 -1.08836 -1.08836 -1.08836 --0.109375 0.015625 -0.171875 -4.97524 -4.97524 -4.97524 --0.109375 0.015625 -0.140625 -2.47618 -2.47618 -2.47618 --0.109375 0.046875 -0.171875 -1.30861 -1.30861 -1.30861 --0.109375 0.046875 -0.140625 -1.90236 -1.90236 -1.90236 --0.078125 0.015625 -0.171875 -3.77153 -3.77153 -3.77153 --0.078125 0.015625 -0.140625 -2.05803 -2.05803 -2.05803 --0.078125 0.046875 -0.140625 -2.18307 -2.18307 -2.18307 --0.109375 0.078125 -0.234375 -1.17107 -1.17107 -1.17107 --0.109375 0.078125 -0.203125 -1.4743 -1.4743 -1.4743 --0.109375 0.109375 -0.203125 -1.97749 -1.97749 -1.97749 --0.078125 0.078125 -0.234375 -0.778178 -0.778178 -0.778178 --0.078125 0.078125 -0.203125 -0.882652 -0.882652 -0.882652 --0.109375 0.078125 -0.140625 -1.10963 -1.10963 -1.10963 --0.109375 0.109375 -0.140625 -0.902965 -0.902965 -0.902965 --0.078125 0.078125 -0.171875 -1.08853 -1.08853 -1.08853 --0.078125 0.078125 -0.140625 -1.15581 -1.15581 -1.15581 --0.078125 0.109375 -0.171875 -2.89422 -2.89422 -2.89422 --0.078125 0.109375 -0.140625 -2.15444 -2.15444 -2.15444 --0.046875 0.015625 -0.234375 -1.46409 -1.46409 -1.46409 --0.046875 0.046875 -0.234375 -1.42774 -1.42774 -1.42774 --0.046875 0.046875 -0.203125 -1.35493 -1.35493 -1.35493 --0.046875 0.015625 -0.171875 -1.34956 -1.34956 -1.34956 --0.046875 0.015625 -0.140625 -1.40408 -1.40408 -1.40408 --0.046875 0.046875 -0.171875 -1.50035 -1.50035 -1.50035 --0.046875 0.046875 -0.140625 -1.36455 -1.36455 -1.36455 --0.015625 0.046875 -0.171875 -1.33953 -1.33953 -1.33953 --0.015625 0.046875 -0.140625 -1.21789 -1.21789 -1.21789 --0.046875 0.078125 -0.203125 -1.06978 -1.06978 -1.06978 --0.015625 0.078125 -0.203125 -2.13126 -2.13126 -2.13126 --0.046875 0.078125 -0.171875 -1.27411 -1.27411 -1.27411 --0.046875 0.078125 -0.140625 -1.8283 -1.8283 -1.8283 --0.046875 0.109375 -0.171875 -1.34997 -1.34997 -1.34997 --0.046875 0.109375 -0.140625 -1.98657 -1.98657 -1.98657 --0.015625 0.078125 -0.171875 -2.50995 -2.50995 -2.50995 --0.015625 0.078125 -0.140625 -1.95025 -1.95025 -1.95025 --0.015625 0.109375 -0.171875 -1.84407 -1.84407 -1.84407 --0.015625 0.109375 -0.140625 -2.02932 -2.02932 -2.02932 --0.109375 0.046875 -0.109375 -2.29467 -2.29467 -2.29467 --0.109375 0.046875 -0.078125 -1.84334 -1.84334 -1.84334 --0.078125 0.015625 -0.109375 -2.54395 -2.54395 -2.54395 --0.078125 0.015625 -0.078125 -2.20415 -2.20415 -2.20415 --0.078125 0.046875 -0.109375 -2.43406 -2.43406 -2.43406 --0.078125 0.046875 -0.078125 -2.24338 -2.24338 -2.24338 --0.109375 0.015625 -0.046875 -1.5982 -1.5982 -1.5982 --0.109375 0.015625 -0.015625 -1.68302 -1.68302 -1.68302 --0.109375 0.046875 -0.046875 -1.16963 -1.16963 -1.16963 --0.109375 0.046875 -0.015625 -2.27549 -2.27549 -2.27549 --0.078125 0.015625 -0.046875 -1.97396 -1.97396 -1.97396 --0.078125 0.015625 -0.015625 -2.08319 -2.08319 -2.08319 --0.078125 0.046875 -0.046875 -1.86546 -1.86546 -1.86546 --0.078125 0.046875 -0.015625 -1.95849 -1.95849 -1.95849 --0.109375 0.078125 -0.109375 -1.44078 -1.44078 -1.44078 --0.109375 0.078125 -0.078125 -1.71521 -1.71521 -1.71521 --0.109375 0.109375 -0.109375 -1.79922 -1.79922 -1.79922 --0.109375 0.109375 -0.078125 -2.75447 -2.75447 -2.75447 --0.078125 0.078125 -0.109375 -1.80441 -1.80441 -1.80441 --0.078125 0.109375 -0.109375 -1.73335 -1.73335 -1.73335 --0.109375 0.078125 -0.046875 -1.38237 -1.38237 -1.38237 --0.109375 0.078125 -0.015625 -2.18713 -2.18713 -2.18713 --0.109375 0.109375 -0.046875 -0.441976 -0.441976 -0.441976 --0.109375 0.109375 -0.015625 -2.8545 -2.8545 -2.8545 --0.078125 0.078125 -0.015625 -1.79968 -1.79968 -1.79968 --0.078125 0.109375 -0.015625 -2.37795 -2.37795 -2.37795 --0.046875 0.015625 -0.109375 -1.95959 -1.95959 -1.95959 --0.046875 0.015625 -0.078125 -1.98604 -1.98604 -1.98604 --0.046875 0.046875 -0.109375 -1.96473 -1.96473 -1.96473 --0.046875 0.046875 -0.078125 -2.11121 -2.11121 -2.11121 --0.015625 0.015625 -0.109375 18.7345 18.7345 18.7345 --0.015625 0.015625 -0.078125 -2.87475 -2.87475 -2.87475 --0.015625 0.046875 -0.109375 -1.27116 -1.27116 -1.27116 --0.015625 0.046875 -0.078125 -2.07597 -2.07597 -2.07597 --0.046875 0.015625 -0.046875 -1.70677 -1.70677 -1.70677 --0.046875 0.046875 -0.046875 -1.85396 -1.85396 -1.85396 --0.046875 0.046875 -0.015625 -1.82127 -1.82127 -1.82127 --0.015625 0.015625 -0.046875 -1.03614 -1.03614 -1.03614 --0.015625 0.046875 -0.046875 -0.783408 -0.783408 -0.783408 --0.046875 0.078125 -0.109375 -2.02213 -2.02213 -2.02213 --0.046875 0.109375 -0.109375 -1.74959 -1.74959 -1.74959 --0.015625 0.078125 -0.109375 -2.06889 -2.06889 -2.06889 --0.015625 0.078125 -0.078125 -2.09207 -2.09207 -2.09207 --0.015625 0.109375 -0.078125 -1.1868 -1.1868 -1.1868 --0.046875 0.078125 -0.015625 -1.74022 -1.74022 -1.74022 --0.046875 0.109375 -0.015625 -1.91767 -1.91767 -1.91767 --0.015625 0.078125 -0.046875 -1.12724 -1.12724 -1.12724 --0.015625 0.078125 -0.015625 -1.44585 -1.44585 -1.44585 --0.015625 0.109375 -0.046875 -2.43564 -2.43564 -2.43564 --0.015625 0.109375 -0.015625 -1.40365 -1.40365 -1.40365 --0.109375 0.171875 -0.234375 -1.94168 -1.94168 -1.94168 --0.109375 0.171875 -0.203125 -2.08507 -2.08507 -2.08507 --0.078125 0.171875 -0.234375 -2.40885 -2.40885 -2.40885 --0.078125 0.140625 -0.140625 -2.14839 -2.14839 -2.14839 --0.109375 0.203125 -0.234375 -2.2956 -2.2956 -2.2956 --0.109375 0.203125 -0.203125 -0.883593 -0.883593 -0.883593 --0.109375 0.234375 -0.234375 -1.91173 -1.91173 -1.91173 --0.109375 0.234375 -0.203125 -0.912381 -0.912381 -0.912381 --0.078125 0.203125 -0.234375 -1.30391 -1.30391 -1.30391 --0.078125 0.203125 -0.203125 -0.382063 -0.382063 -0.382063 --0.078125 0.234375 -0.234375 -1.15635 -1.15635 -1.15635 --0.109375 0.203125 -0.171875 -0.979082 -0.979082 -0.979082 --0.109375 0.203125 -0.140625 -1.55374 -1.55374 -1.55374 --0.109375 0.234375 -0.171875 -0.0446317 -0.0446317 -0.0446317 --0.109375 0.234375 -0.140625 -1.89458 -1.89458 -1.89458 --0.078125 0.203125 -0.140625 -0.696502 -0.696502 -0.696502 --0.078125 0.234375 -0.140625 -1.32721 -1.32721 -1.32721 --0.046875 0.140625 -0.203125 -1.29144 -1.29144 -1.29144 --0.046875 0.171875 -0.234375 -1.85303 -1.85303 -1.85303 --0.046875 0.171875 -0.203125 -1.64531 -1.64531 -1.64531 --0.015625 0.171875 -0.234375 -1.3524 -1.3524 -1.3524 --0.015625 0.171875 -0.203125 -1.00081 -1.00081 -1.00081 --0.046875 0.140625 -0.171875 -1.43047 -1.43047 -1.43047 --0.046875 0.171875 -0.171875 -0.819955 -0.819955 -0.819955 --0.046875 0.171875 -0.140625 -1.50595 -1.50595 -1.50595 --0.015625 0.140625 -0.171875 -1.50188 -1.50188 -1.50188 --0.015625 0.171875 -0.171875 -1.84923 -1.84923 -1.84923 --0.015625 0.171875 -0.140625 -1.82006 -1.82006 -1.82006 --0.046875 0.203125 -0.234375 -1.25989 -1.25989 -1.25989 --0.046875 0.203125 -0.203125 -0.860903 -0.860903 -0.860903 --0.046875 0.234375 -0.234375 -2.15873 -2.15873 -2.15873 --0.015625 0.203125 -0.234375 -1.46396 -1.46396 -1.46396 --0.015625 0.203125 -0.203125 -0.80505 -0.80505 -0.80505 --0.015625 0.234375 -0.234375 -1.73294 -1.73294 -1.73294 --0.015625 0.234375 -0.203125 -1.50743 -1.50743 -1.50743 --0.046875 0.203125 -0.171875 -1.65597 -1.65597 -1.65597 --0.046875 0.203125 -0.140625 -1.54942 -1.54942 -1.54942 --0.046875 0.234375 -0.171875 -2.52003 -2.52003 -2.52003 --0.046875 0.234375 -0.140625 -2.68417 -2.68417 -2.68417 --0.015625 0.203125 -0.171875 -1.49874 -1.49874 -1.49874 --0.015625 0.203125 -0.140625 -1.52635 -1.52635 -1.52635 --0.015625 0.234375 -0.171875 -1.90629 -1.90629 -1.90629 --0.015625 0.234375 -0.140625 -1.16463 -1.16463 -1.16463 --0.109375 0.140625 -0.078125 -1.69616 -1.69616 -1.69616 --0.078125 0.140625 -0.109375 -2.78163 -2.78163 -2.78163 --0.109375 0.140625 -0.046875 -0.913265 -0.913265 -0.913265 --0.109375 0.171875 -0.046875 -2.79659 -2.79659 -2.79659 --0.109375 0.171875 -0.015625 6.44435 6.44435 6.44435 --0.078125 0.140625 -0.046875 -0.619231 -0.619231 -0.619231 --0.078125 0.140625 -0.015625 -1.31471 -1.31471 -1.31471 --0.078125 0.171875 -0.015625 0.151666 0.151666 0.151666 --0.109375 0.203125 -0.109375 -1.75931 -1.75931 -1.75931 --0.109375 0.203125 -0.078125 -3.18716 -3.18716 -3.18716 --0.109375 0.234375 -0.109375 -2.5824 -2.5824 -2.5824 --0.109375 0.234375 -0.078125 -5.00247 -5.00247 -5.00247 --0.078125 0.203125 -0.109375 -1.86091 -1.86091 -1.86091 --0.078125 0.234375 -0.109375 -0.897592 -0.897592 -0.897592 --0.078125 0.234375 -0.078125 -0.678423 -0.678423 -0.678423 --0.109375 0.203125 -0.046875 -9.6546 -9.6546 -9.6546 --0.109375 0.203125 -0.015625 -1.27547 -1.27547 -1.27547 --0.109375 0.234375 -0.046875 -10.4059 -10.4059 -10.4059 --0.109375 0.234375 -0.015625 6.73739 6.73739 6.73739 --0.078125 0.203125 -0.046875 -7.3122 -7.3122 -7.3122 --0.078125 0.203125 -0.015625 -4.94945 -4.94945 -4.94945 --0.078125 0.234375 -0.046875 -1.5274 -1.5274 -1.5274 --0.078125 0.234375 -0.015625 0.130569 0.130569 0.130569 --0.015625 0.171875 -0.078125 -2.21837 -2.21837 -2.21837 --0.046875 0.140625 -0.015625 -2.69005 -2.69005 -2.69005 --0.046875 0.171875 -0.046875 -0.0672034 -0.0672034 -0.0672034 --0.046875 0.171875 -0.015625 -2.88696 -2.88696 -2.88696 --0.015625 0.140625 -0.046875 -1.78869 -1.78869 -1.78869 --0.015625 0.140625 -0.015625 -3.1036 -3.1036 -3.1036 --0.015625 0.171875 -0.046875 0.0309043 0.0309043 0.0309043 --0.015625 0.171875 -0.015625 -4.86097 -4.86097 -4.86097 --0.046875 0.203125 -0.109375 -2.72941 -2.72941 -2.72941 --0.046875 0.203125 -0.078125 -1.84019 -1.84019 -1.84019 --0.046875 0.234375 -0.078125 -1.9155 -1.9155 -1.9155 --0.015625 0.203125 -0.109375 -1.93374 -1.93374 -1.93374 --0.015625 0.234375 -0.109375 -1.8589 -1.8589 -1.8589 --0.015625 0.234375 -0.078125 -0.516842 -0.516842 -0.516842 --0.046875 0.203125 -0.046875 -5.36863 -5.36863 -5.36863 --0.046875 0.203125 -0.015625 -2.31922 -2.31922 -2.31922 --0.046875 0.234375 -0.046875 -2.16443 -2.16443 -2.16443 --0.046875 0.234375 -0.015625 -4.0668 -4.0668 -4.0668 --0.015625 0.203125 -0.015625 -1.48631 -1.48631 -1.48631 --0.015625 0.234375 -0.046875 -2.0633 -2.0633 -2.0633 --0.015625 0.234375 -0.015625 -3.23961 -3.23961 -3.23961 --0.046875 0.265625 -0.390625 -1.33084 -1.33084 -1.33084 --0.046875 0.296875 -0.390625 -3.63127 -3.63127 -3.63127 --0.015625 0.265625 -0.390625 -2.01299 -2.01299 -2.01299 --0.015625 0.296875 -0.390625 0.777961 0.777961 0.777961 --0.015625 0.328125 -0.390625 -14.7493 -14.7493 -14.7493 --0.015625 0.359375 -0.390625 19.085 19.085 19.085 --0.078125 0.265625 -0.265625 -1.28957 -1.28957 -1.28957 --0.078125 0.296875 -0.265625 -5.36968 -5.36968 -5.36968 --0.078125 0.328125 -0.265625 -1.24759 -1.24759 -1.24759 --0.046875 0.265625 -0.359375 -1.98845 -1.98845 -1.98845 --0.046875 0.265625 -0.328125 1.78964 1.78964 1.78964 --0.046875 0.296875 -0.359375 0.0380077 0.0380077 0.0380077 --0.046875 0.296875 -0.328125 -13.0212 -13.0212 -13.0212 --0.015625 0.296875 -0.359375 5.81431 5.81431 5.81431 --0.046875 0.265625 -0.296875 -2.15047 -2.15047 -2.15047 --0.046875 0.265625 -0.265625 -1.56136 -1.56136 -1.56136 --0.046875 0.296875 -0.296875 -1.22903 -1.22903 -1.22903 --0.046875 0.296875 -0.265625 0.137875 0.137875 0.137875 --0.015625 0.265625 -0.296875 -1.54096 -1.54096 -1.54096 --0.046875 0.328125 -0.359375 14.5061 14.5061 14.5061 --0.046875 0.328125 -0.328125 -11.3083 -11.3083 -11.3083 --0.015625 0.328125 -0.359375 -5.8112 -5.8112 -5.8112 --0.015625 0.359375 -0.359375 -11.6047 -11.6047 -11.6047 --0.015625 0.359375 -0.328125 -19.4542 -19.4542 -19.4542 --0.046875 0.328125 -0.296875 -1.68445 -1.68445 -1.68445 --0.046875 0.328125 -0.265625 -1.64217 -1.64217 -1.64217 --0.046875 0.359375 -0.265625 -1.83345 -1.83345 -1.83345 --0.015625 0.328125 -0.296875 -2.74039 -2.74039 -2.74039 --0.015625 0.328125 -0.265625 -0.516565 -0.516565 -0.516565 --0.015625 0.359375 -0.296875 -2.34636 -2.34636 -2.34636 --0.015625 0.359375 -0.265625 -1.01243 -1.01243 -1.01243 --0.015625 0.390625 -0.359375 -5.7522 -5.7522 -5.7522 --0.015625 0.390625 -0.328125 -4.07155 -4.07155 -4.07155 --0.203125 0.265625 -0.140625 -0.636807 -0.636807 -0.636807 --0.171875 0.265625 -0.203125 -7.43425 -7.43425 -7.43425 --0.171875 0.296875 -0.234375 0.729996 0.729996 0.729996 --0.171875 0.296875 -0.203125 -1.48878 -1.48878 -1.48878 --0.140625 0.265625 -0.234375 -0.957066 -0.957066 -0.957066 --0.140625 0.265625 -0.203125 -0.169032 -0.169032 -0.169032 --0.140625 0.296875 -0.234375 3.3935 3.3935 3.3935 --0.171875 0.265625 -0.171875 -0.935348 -0.935348 -0.935348 --0.171875 0.265625 -0.140625 -2.86494 -2.86494 -2.86494 --0.171875 0.296875 -0.171875 -1.49972 -1.49972 -1.49972 --0.171875 0.296875 -0.140625 -1.30279 -1.30279 -1.30279 --0.140625 0.265625 -0.140625 -0.80057 -0.80057 -0.80057 --0.140625 0.296875 -0.140625 -1.69825 -1.69825 -1.69825 --0.171875 0.328125 -0.203125 -1.6554 -1.6554 -1.6554 --0.140625 0.328125 -0.234375 27.1427 27.1427 27.1427 --0.140625 0.328125 -0.203125 -0.348276 -0.348276 -0.348276 --0.140625 0.359375 -0.203125 12.7981 12.7981 12.7981 --0.171875 0.328125 -0.171875 -9.57069 -9.57069 -9.57069 --0.171875 0.328125 -0.140625 -5.47547 -5.47547 -5.47547 --0.140625 0.328125 -0.171875 -18.5505 -18.5505 -18.5505 --0.140625 0.328125 -0.140625 -12.3158 -12.3158 -12.3158 --0.140625 0.359375 -0.171875 8.75798 8.75798 8.75798 --0.140625 0.359375 -0.140625 5.80931 5.80931 5.80931 --0.234375 0.265625 -0.109375 36.0886 36.0886 36.0886 --0.234375 0.265625 -0.078125 -33.6492 -33.6492 -33.6492 --0.203125 0.265625 -0.109375 10.2085 10.2085 10.2085 --0.203125 0.265625 -0.078125 18.8026 18.8026 18.8026 --0.234375 0.265625 -0.046875 -14.4513 -14.4513 -14.4513 --0.234375 0.265625 -0.015625 -3.93528 -3.93528 -3.93528 --0.203125 0.265625 -0.046875 -21.3993 -21.3993 -21.3993 --0.203125 0.265625 -0.015625 -14.9032 -14.9032 -14.9032 --0.171875 0.265625 -0.109375 -0.2694 -0.2694 -0.2694 --0.171875 0.265625 -0.078125 13.5568 13.5568 13.5568 --0.140625 0.265625 -0.109375 -3.74856 -3.74856 -3.74856 --0.140625 0.265625 -0.078125 2.54135 2.54135 2.54135 --0.140625 0.296875 -0.078125 -24.5423 -24.5423 -24.5423 --0.171875 0.265625 -0.046875 10.5926 10.5926 10.5926 --0.171875 0.265625 -0.015625 0.106515 0.106515 0.106515 --0.171875 0.296875 -0.046875 -5.47506 -5.47506 -5.47506 --0.171875 0.296875 -0.015625 3.08992 3.08992 3.08992 --0.140625 0.265625 -0.046875 12.0558 12.0558 12.0558 --0.140625 0.296875 -0.046875 -5.05027 -5.05027 -5.05027 --0.140625 0.328125 -0.109375 -6.14283 -6.14283 -6.14283 --0.140625 0.328125 -0.078125 -7.20211 -7.20211 -7.20211 --0.140625 0.359375 -0.109375 -10.8273 -10.8273 -10.8273 --0.140625 0.359375 -0.078125 -10.3889 -10.3889 -10.3889 --0.171875 0.328125 -0.046875 -7.1362 -7.1362 -7.1362 --0.171875 0.328125 -0.015625 -2.4408 -2.4408 -2.4408 --0.140625 0.328125 -0.046875 -2.36695 -2.36695 -2.36695 --0.140625 0.328125 -0.015625 4.62103 4.62103 4.62103 --0.140625 0.359375 -0.046875 -11.1737 -11.1737 -11.1737 --0.140625 0.390625 -0.140625 -3.37391 -3.37391 -3.37391 --0.140625 0.390625 -0.109375 -0.843882 -0.843882 -0.843882 --0.140625 0.390625 -0.078125 1.61785 1.61785 1.61785 --0.140625 0.421875 -0.109375 1.17797 1.17797 1.17797 --0.140625 0.421875 -0.078125 -1.18238 -1.18238 -1.18238 --0.140625 0.390625 -0.046875 -2.85439 -2.85439 -2.85439 --0.140625 0.390625 -0.015625 6.09963 6.09963 6.09963 --0.140625 0.421875 -0.046875 -3.32516 -3.32516 -3.32516 --0.140625 0.421875 -0.015625 -1.76297 -1.76297 -1.76297 --0.140625 0.453125 -0.078125 -3.03215 -3.03215 -3.03215 --0.140625 0.453125 -0.046875 -3.2639 -3.2639 -3.2639 --0.109375 0.265625 -0.234375 -3.04576 -3.04576 -3.04576 --0.109375 0.265625 -0.203125 1.46901 1.46901 1.46901 --0.109375 0.296875 -0.234375 1.1339 1.1339 1.1339 --0.078125 0.265625 -0.234375 -3.76692 -3.76692 -3.76692 --0.078125 0.296875 -0.234375 -4.71546 -4.71546 -4.71546 --0.109375 0.265625 -0.171875 -0.540938 -0.540938 -0.540938 --0.109375 0.265625 -0.140625 -1.91888 -1.91888 -1.91888 --0.109375 0.296875 -0.140625 -5.7005 -5.7005 -5.7005 --0.078125 0.265625 -0.171875 -2.23476 -2.23476 -2.23476 --0.078125 0.265625 -0.140625 -1.92806 -1.92806 -1.92806 --0.109375 0.328125 -0.234375 -3.61019 -3.61019 -3.61019 --0.109375 0.359375 -0.203125 18.8705 18.8705 18.8705 --0.078125 0.328125 -0.234375 -23.4206 -23.4206 -23.4206 --0.078125 0.359375 -0.234375 -18.8824 -18.8824 -18.8824 --0.078125 0.359375 -0.203125 -20.3631 -20.3631 -20.3631 --0.109375 0.359375 -0.171875 7.76946 7.76946 7.76946 --0.078125 0.359375 -0.171875 25.5805 25.5805 25.5805 --0.015625 0.265625 -0.203125 -1.67469 -1.67469 -1.67469 --0.015625 0.296875 -0.203125 -1.01208 -1.01208 -1.01208 --0.046875 0.265625 -0.171875 -1.55445 -1.55445 -1.55445 --0.046875 0.265625 -0.140625 -2.12145 -2.12145 -2.12145 --0.015625 0.265625 -0.171875 -1.8015 -1.8015 -1.8015 --0.015625 0.265625 -0.140625 -1.25318 -1.25318 -1.25318 --0.015625 0.296875 -0.171875 -1.28347 -1.28347 -1.28347 --0.015625 0.296875 -0.140625 -2.68123 -2.68123 -2.68123 --0.046875 0.328125 -0.234375 -0.736799 -0.736799 -0.736799 --0.046875 0.328125 -0.203125 -2.21175 -2.21175 -2.21175 --0.046875 0.359375 -0.234375 -0.286959 -0.286959 -0.286959 --0.046875 0.359375 -0.203125 -2.04346 -2.04346 -2.04346 --0.015625 0.328125 -0.203125 -1.2201 -1.2201 -1.2201 --0.015625 0.359375 -0.234375 -0.307466 -0.307466 -0.307466 --0.015625 0.359375 -0.203125 -0.375355 -0.375355 -0.375355 --0.046875 0.328125 -0.171875 -4.05073 -4.05073 -4.05073 --0.046875 0.359375 -0.171875 -4.47357 -4.47357 -4.47357 --0.046875 0.359375 -0.140625 -7.15436 -7.15436 -7.15436 --0.015625 0.328125 -0.171875 -1.94759 -1.94759 -1.94759 --0.015625 0.328125 -0.140625 -3.15005 -3.15005 -3.15005 --0.015625 0.359375 -0.171875 -3.19102 -3.19102 -3.19102 --0.015625 0.359375 -0.140625 -46.0884 -46.0884 -46.0884 --0.109375 0.265625 -0.109375 -0.194784 -0.194784 -0.194784 --0.109375 0.265625 -0.078125 -6.79804 -6.79804 -6.79804 --0.109375 0.296875 -0.109375 3.84014 3.84014 3.84014 --0.109375 0.296875 -0.078125 -5.74684 -5.74684 -5.74684 --0.078125 0.265625 -0.109375 0.95918 0.95918 0.95918 --0.078125 0.296875 -0.109375 -4.74835 -4.74835 -4.74835 --0.078125 0.296875 -0.078125 -0.343909 -0.343909 -0.343909 --0.109375 0.265625 -0.046875 -3.72737 -3.72737 -3.72737 --0.109375 0.296875 -0.046875 -9.54673 -9.54673 -9.54673 --0.078125 0.265625 -0.046875 -4.19079 -4.19079 -4.19079 --0.078125 0.296875 -0.046875 -4.64841 -4.64841 -4.64841 --0.078125 0.296875 -0.015625 -11.8961 -11.8961 -11.8961 --0.109375 0.328125 -0.078125 1.68548 1.68548 1.68548 --0.109375 0.359375 -0.078125 -16.3133 -16.3133 -16.3133 --0.078125 0.328125 -0.078125 -9.18621 -9.18621 -9.18621 --0.109375 0.328125 -0.046875 0.990407 0.990407 0.990407 --0.109375 0.328125 -0.015625 -8.99548 -8.99548 -8.99548 --0.109375 0.359375 -0.046875 -11.9331 -11.9331 -11.9331 --0.109375 0.359375 -0.015625 -4.33868 -4.33868 -4.33868 --0.078125 0.328125 -0.046875 -1.91741 -1.91741 -1.91741 --0.078125 0.328125 -0.015625 -8.81499 -8.81499 -8.81499 --0.078125 0.359375 -0.046875 -3.4214 -3.4214 -3.4214 --0.078125 0.359375 -0.015625 -3.84488 -3.84488 -3.84488 --0.046875 0.265625 -0.109375 -2.50567 -2.50567 -2.50567 --0.046875 0.265625 -0.078125 0.381824 0.381824 0.381824 --0.046875 0.296875 -0.109375 -4.37451 -4.37451 -4.37451 --0.046875 0.296875 -0.078125 -3.61215 -3.61215 -3.61215 --0.015625 0.265625 -0.109375 -1.27398 -1.27398 -1.27398 --0.015625 0.265625 -0.078125 -2.4338 -2.4338 -2.4338 --0.015625 0.296875 -0.109375 -2.69289 -2.69289 -2.69289 --0.015625 0.296875 -0.078125 -1.38746 -1.38746 -1.38746 --0.046875 0.265625 -0.046875 -1.03461 -1.03461 -1.03461 --0.046875 0.296875 -0.046875 -3.31664 -3.31664 -3.31664 --0.015625 0.265625 -0.046875 -2.98597 -2.98597 -2.98597 --0.015625 0.265625 -0.015625 -3.15614 -3.15614 -3.15614 --0.015625 0.296875 -0.046875 -2.08025 -2.08025 -2.08025 --0.015625 0.296875 -0.015625 1.29041 1.29041 1.29041 --0.046875 0.328125 -0.109375 -4.04766 -4.04766 -4.04766 --0.046875 0.328125 -0.078125 1.03224 1.03224 1.03224 --0.015625 0.328125 -0.109375 -2.48678 -2.48678 -2.48678 --0.015625 0.328125 -0.078125 -1.32077 -1.32077 -1.32077 --0.015625 0.359375 -0.109375 -2.75901 -2.75901 -2.75901 --0.015625 0.359375 -0.078125 -2.23692 -2.23692 -2.23692 --0.046875 0.328125 -0.046875 -3.26328 -3.26328 -3.26328 --0.046875 0.328125 -0.015625 -2.03082 -2.03082 -2.03082 --0.046875 0.359375 -0.046875 -6.56932 -6.56932 -6.56932 --0.046875 0.359375 -0.015625 -6.45785 -6.45785 -6.45785 --0.015625 0.328125 -0.015625 -1.2525 -1.2525 -1.2525 --0.015625 0.359375 -0.046875 -1.38532 -1.38532 -1.38532 --0.015625 0.359375 -0.015625 -1.38125 -1.38125 -1.38125 --0.109375 0.390625 -0.171875 5.17396 5.17396 5.17396 --0.109375 0.390625 -0.140625 11.823 11.823 11.823 --0.078125 0.390625 -0.171875 9.0195 9.0195 9.0195 --0.078125 0.390625 -0.140625 -3.33889 -3.33889 -3.33889 --0.078125 0.421875 -0.140625 -2.03786 -2.03786 -2.03786 --0.046875 0.390625 -0.140625 -2.47584 -2.47584 -2.47584 --0.046875 0.421875 -0.140625 -2.1104 -2.1104 -2.1104 --0.015625 0.390625 -0.140625 -2.24309 -2.24309 -2.24309 --0.109375 0.390625 -0.109375 5.35551 5.35551 5.35551 --0.109375 0.421875 -0.109375 0.256318 0.256318 0.256318 --0.078125 0.421875 -0.109375 -1.92855 -1.92855 -1.92855 --0.109375 0.390625 -0.015625 -1.2339 -1.2339 -1.2339 --0.109375 0.421875 -0.015625 -1.63431 -1.63431 -1.63431 --0.078125 0.390625 -0.015625 8.79306 8.79306 8.79306 --0.109375 0.453125 -0.109375 -3.08971 -3.08971 -3.08971 --0.109375 0.453125 -0.078125 -2.33617 -2.33617 -2.33617 --0.078125 0.453125 -0.109375 -1.67297 -1.67297 -1.67297 --0.078125 0.453125 -0.078125 58.0579 58.0579 58.0579 --0.078125 0.484375 -0.078125 -0.159696 -0.159696 -0.159696 --0.109375 0.453125 -0.046875 -1.84889 -1.84889 -1.84889 --0.109375 0.453125 -0.015625 -2.44865 -2.44865 -2.44865 --0.109375 0.484375 -0.046875 -0.791485 -0.791485 -0.791485 --0.109375 0.484375 -0.015625 -0.693067 -0.693067 -0.693067 --0.078125 0.453125 -0.046875 19.4724 19.4724 19.4724 --0.078125 0.484375 -0.046875 -0.606061 -0.606061 -0.606061 --0.078125 0.484375 -0.015625 -0.395743 -0.395743 -0.395743 --0.046875 0.390625 -0.109375 -1.97255 -1.97255 -1.97255 --0.046875 0.421875 -0.109375 -1.91575 -1.91575 -1.91575 --0.046875 0.421875 -0.078125 -20.1693 -20.1693 -20.1693 --0.015625 0.390625 -0.109375 -2.45645 -2.45645 -2.45645 --0.015625 0.390625 -0.078125 33.4732 33.4732 33.4732 --0.015625 0.421875 -0.109375 -1.9409 -1.9409 -1.9409 --0.015625 0.421875 -0.078125 -33.8938 -33.8938 -33.8938 --0.046875 0.390625 -0.046875 23.5005 23.5005 23.5005 --0.046875 0.390625 -0.015625 16.1697 16.1697 16.1697 --0.015625 0.390625 -0.046875 -14.1215 -14.1215 -14.1215 --0.015625 0.421875 -0.046875 -13.8514 -13.8514 -13.8514 --0.015625 0.421875 -0.015625 3.04231 3.04231 3.04231 --0.046875 0.453125 -0.078125 -16.2221 -16.2221 -16.2221 --0.046875 0.484375 -0.078125 -0.61814 -0.61814 -0.61814 --0.015625 0.453125 -0.078125 -36.5019 -36.5019 -36.5019 --0.015625 0.484375 -0.078125 -0.426189 -0.426189 -0.426189 --0.046875 0.453125 -0.015625 8.67373 8.67373 8.67373 --0.046875 0.484375 -0.046875 -0.707837 -0.707837 -0.707837 --0.046875 0.484375 -0.015625 -0.844795 -0.844795 -0.844795 --0.015625 0.453125 -0.046875 -13.3087 -13.3087 -13.3087 --0.015625 0.453125 -0.015625 2.95537 2.95537 2.95537 --0.015625 0.484375 -0.046875 -0.365338 -0.365338 -0.365338 --0.015625 0.484375 -0.015625 -0.53529 -0.53529 -0.53529 --0.421875 0.046875 0.109375 -7.12895 -7.12895 -7.12895 --0.390625 0.015625 0.109375 -1.48492 -1.48492 -1.48492 --0.390625 0.046875 0.109375 -0.377917 -0.377917 -0.377917 --0.421875 0.078125 0.109375 -3.36791 -3.36791 -3.36791 --0.390625 0.078125 0.109375 -4.55916 -4.55916 -4.55916 --0.421875 0.015625 0.140625 -1.72691 -1.72691 -1.72691 --0.421875 0.015625 0.171875 -2.18724 -2.18724 -2.18724 --0.421875 0.046875 0.140625 -2.79056 -2.79056 -2.79056 --0.421875 0.046875 0.171875 -0.545223 -0.545223 -0.545223 --0.390625 0.015625 0.140625 -1.80669 -1.80669 -1.80669 --0.421875 0.015625 0.203125 -1.76662 -1.76662 -1.76662 --0.421875 0.015625 0.234375 -1.99008 -1.99008 -1.99008 --0.421875 0.046875 0.203125 -1.95702 -1.95702 -1.95702 --0.421875 0.046875 0.234375 -0.658563 -0.658563 -0.658563 --0.390625 0.015625 0.203125 -0.0391235 -0.0391235 -0.0391235 --0.421875 0.078125 0.140625 1.44167 1.44167 1.44167 --0.421875 0.078125 0.171875 -2.68204 -2.68204 -2.68204 --0.421875 0.109375 0.140625 -9.67185 -9.67185 -9.67185 --0.421875 0.109375 0.171875 -2.67568 -2.67568 -2.67568 --0.390625 0.078125 0.140625 -4.24736 -4.24736 -4.24736 --0.390625 0.078125 0.171875 0.00192423 0.00192423 0.00192423 --0.390625 0.109375 0.140625 -3.84885 -3.84885 -3.84885 --0.390625 0.109375 0.171875 -3.84875 -3.84875 -3.84875 --0.421875 0.078125 0.234375 0.435851 0.435851 0.435851 --0.390625 0.078125 0.203125 4.6485 4.6485 4.6485 --0.390625 0.078125 0.234375 -4.69469 -4.69469 -4.69469 --0.390625 0.109375 0.203125 9.9011 9.9011 9.9011 --0.390625 0.109375 0.234375 -4.74102 -4.74102 -4.74102 --0.359375 0.015625 0.015625 -0.81127 -0.81127 -0.81127 --0.359375 0.015625 0.046875 2.07542 2.07542 2.07542 --0.359375 0.046875 0.015625 -1.27412 -1.27412 -1.27412 --0.359375 0.046875 0.046875 3.13989 3.13989 3.13989 --0.328125 0.015625 0.015625 -1.19663 -1.19663 -1.19663 --0.328125 0.015625 0.046875 8.28062 8.28062 8.28062 --0.359375 0.015625 0.078125 -1.05126 -1.05126 -1.05126 --0.359375 0.015625 0.109375 -3.22069 -3.22069 -3.22069 --0.359375 0.046875 0.078125 -1.43442 -1.43442 -1.43442 --0.359375 0.046875 0.109375 -5.94758 -5.94758 -5.94758 --0.328125 0.015625 0.078125 -98.7954 -98.7954 -98.7954 --0.328125 0.046875 0.078125 -32.0726 -32.0726 -32.0726 --0.328125 0.046875 0.109375 -173.026 -173.026 -173.026 --0.359375 0.078125 0.015625 -1.05374 -1.05374 -1.05374 --0.359375 0.078125 0.046875 -0.408719 -0.408719 -0.408719 --0.328125 0.078125 0.015625 -1.66646 -1.66646 -1.66646 --0.328125 0.109375 0.015625 -2.21957 -2.21957 -2.21957 --0.328125 0.109375 0.046875 0.0149913 0.0149913 0.0149913 --0.359375 0.078125 0.078125 -2.50097 -2.50097 -2.50097 --0.359375 0.078125 0.109375 -4.11958 -4.11958 -4.11958 --0.359375 0.109375 0.109375 3.94318 3.94318 3.94318 --0.328125 0.078125 0.078125 -71.6536 -71.6536 -71.6536 --0.328125 0.078125 0.109375 -142.96 -142.96 -142.96 --0.328125 0.109375 0.109375 -6.88274 -6.88274 -6.88274 --0.296875 0.015625 0.046875 25.4345 25.4345 25.4345 --0.265625 0.015625 0.015625 -2.05847 -2.05847 -2.05847 --0.265625 0.015625 0.046875 -143.53 -143.53 -143.53 --0.265625 0.046875 0.046875 168.535 168.535 168.535 --0.296875 0.015625 0.078125 73.151 73.151 73.151 --0.296875 0.015625 0.109375 14.4733 14.4733 14.4733 --0.296875 0.046875 0.078125 159.996 159.996 159.996 --0.296875 0.046875 0.109375 82.1849 82.1849 82.1849 --0.265625 0.046875 0.078125 -64.7579 -64.7579 -64.7579 --0.265625 0.046875 0.109375 11.7747 11.7747 11.7747 --0.296875 0.078125 0.046875 -270.052 -270.052 -270.052 --0.296875 0.109375 0.015625 -1.84619 -1.84619 -1.84619 --0.296875 0.109375 0.046875 -1.97319 -1.97319 -1.97319 --0.265625 0.109375 0.015625 3.91384 3.91384 3.91384 --0.265625 0.109375 0.046875 -3.09638 -3.09638 -3.09638 --0.296875 0.078125 0.078125 -26.7801 -26.7801 -26.7801 --0.296875 0.109375 0.078125 3.37759 3.37759 3.37759 --0.265625 0.078125 0.078125 -12.1075 -12.1075 -12.1075 --0.265625 0.078125 0.109375 -6.94353 -6.94353 -6.94353 --0.265625 0.109375 0.078125 -3.13188 -3.13188 -3.13188 --0.265625 0.109375 0.109375 -1.20276 -1.20276 -1.20276 --0.359375 0.015625 0.140625 -1.30379 -1.30379 -1.30379 --0.359375 0.046875 0.140625 -3.36688 -3.36688 -3.36688 --0.328125 0.015625 0.140625 -1.04886 -1.04886 -1.04886 --0.328125 0.015625 0.171875 -3.12451 -3.12451 -3.12451 --0.328125 0.046875 0.140625 -3.13649 -3.13649 -3.13649 --0.328125 0.046875 0.171875 -3.16136 -3.16136 -3.16136 --0.328125 0.015625 0.234375 -6.57365 -6.57365 -6.57365 --0.328125 0.046875 0.234375 -13.1332 -13.1332 -13.1332 --0.359375 0.078125 0.140625 -3.24615 -3.24615 -3.24615 --0.359375 0.078125 0.171875 0.633374 0.633374 0.633374 --0.359375 0.109375 0.140625 -1.52822 -1.52822 -1.52822 --0.359375 0.109375 0.171875 -3.31843 -3.31843 -3.31843 --0.328125 0.078125 0.140625 -4.33964 -4.33964 -4.33964 --0.359375 0.078125 0.234375 4.34226 4.34226 4.34226 --0.359375 0.109375 0.234375 3.49661 3.49661 3.49661 --0.328125 0.109375 0.234375 0.517968 0.517968 0.517968 --0.296875 0.015625 0.171875 -2.80539 -2.80539 -2.80539 --0.296875 0.046875 0.140625 -2.84842 -2.84842 -2.84842 --0.296875 0.046875 0.171875 -0.841459 -0.841459 -0.841459 --0.265625 0.015625 0.140625 -0.132959 -0.132959 -0.132959 --0.265625 0.015625 0.171875 2.81531 2.81531 2.81531 --0.265625 0.046875 0.140625 3.38484 3.38484 3.38484 --0.265625 0.046875 0.171875 -64.5483 -64.5483 -64.5483 --0.296875 0.015625 0.203125 -3.99687 -3.99687 -3.99687 --0.296875 0.015625 0.234375 -11.1962 -11.1962 -11.1962 --0.296875 0.046875 0.203125 -6.28797 -6.28797 -6.28797 --0.296875 0.046875 0.234375 -11.073 -11.073 -11.073 --0.265625 0.015625 0.203125 0.833977 0.833977 0.833977 --0.265625 0.015625 0.234375 -3.41936 -3.41936 -3.41936 --0.265625 0.046875 0.203125 -38.9494 -38.9494 -38.9494 --0.265625 0.046875 0.234375 7.84237 7.84237 7.84237 --0.296875 0.078125 0.171875 41.7485 41.7485 41.7485 --0.265625 0.078125 0.171875 7.18906 7.18906 7.18906 --0.265625 0.109375 0.171875 46.9155 46.9155 46.9155 --0.296875 0.078125 0.203125 -18.3784 -18.3784 -18.3784 --0.296875 0.078125 0.234375 -34.0854 -34.0854 -34.0854 --0.296875 0.109375 0.203125 -4.29247 -4.29247 -4.29247 --0.296875 0.109375 0.234375 1.89716 1.89716 1.89716 --0.265625 0.078125 0.203125 -58.8653 -58.8653 -58.8653 --0.265625 0.078125 0.234375 -33.5467 -33.5467 -33.5467 --0.265625 0.109375 0.203125 70.6327 70.6327 70.6327 --0.328125 0.140625 0.109375 2.28574 2.28574 2.28574 --0.265625 0.171875 0.015625 2.59153 2.59153 2.59153 --0.265625 0.171875 0.046875 -3.18268 -3.18268 -3.18268 --0.296875 0.140625 0.109375 -2.21887 -2.21887 -2.21887 --0.265625 0.140625 0.109375 2.45707 2.45707 2.45707 --0.265625 0.171875 0.109375 -8.84207 -8.84207 -8.84207 --0.265625 0.203125 0.015625 -0.964213 -0.964213 -0.964213 --0.265625 0.203125 0.046875 4.86569 4.86569 4.86569 --0.265625 0.234375 0.015625 -8.35596 -8.35596 -8.35596 --0.265625 0.234375 0.046875 -7.48244 -7.48244 -7.48244 --0.359375 0.140625 0.140625 2.24423 2.24423 2.24423 --0.359375 0.140625 0.171875 -1.76703 -1.76703 -1.76703 --0.359375 0.171875 0.140625 -6.89422 -6.89422 -6.89422 --0.359375 0.171875 0.171875 -4.43775 -4.43775 -4.43775 --0.328125 0.140625 0.140625 1.45201 1.45201 1.45201 --0.328125 0.171875 0.140625 -12.4712 -12.4712 -12.4712 --0.359375 0.140625 0.203125 -0.472629 -0.472629 -0.472629 --0.359375 0.140625 0.234375 -1.95202 -1.95202 -1.95202 --0.359375 0.171875 0.203125 5.78442 5.78442 5.78442 --0.328125 0.140625 0.203125 -2.83472 -2.83472 -2.83472 --0.328125 0.140625 0.234375 -3.10119 -3.10119 -3.10119 --0.328125 0.171875 0.203125 8.19648 8.19648 8.19648 --0.328125 0.171875 0.234375 -0.456363 -0.456363 -0.456363 --0.328125 0.203125 0.140625 -22.7741 -22.7741 -22.7741 --0.328125 0.203125 0.171875 -5.05954 -5.05954 -5.05954 --0.328125 0.203125 0.203125 7.83481 7.83481 7.83481 --0.296875 0.171875 0.140625 -5.39949 -5.39949 -5.39949 --0.265625 0.140625 0.140625 1.4723 1.4723 1.4723 --0.265625 0.140625 0.171875 16.7399 16.7399 16.7399 --0.265625 0.171875 0.140625 -1.72383 -1.72383 -1.72383 --0.265625 0.171875 0.171875 -13.3011 -13.3011 -13.3011 --0.296875 0.140625 0.234375 -1.086 -1.086 -1.086 --0.296875 0.171875 0.234375 -1.89037 -1.89037 -1.89037 --0.265625 0.140625 0.203125 -3.41702 -3.41702 -3.41702 --0.265625 0.140625 0.234375 8.28771 8.28771 8.28771 --0.265625 0.171875 0.203125 -28.6754 -28.6754 -28.6754 --0.265625 0.171875 0.234375 -13.9385 -13.9385 -13.9385 --0.296875 0.203125 0.140625 -4.04085 -4.04085 -4.04085 --0.296875 0.203125 0.171875 -2.16651 -2.16651 -2.16651 --0.265625 0.203125 0.140625 3.59459 3.59459 3.59459 --0.265625 0.203125 0.171875 3.78543 3.78543 3.78543 --0.296875 0.203125 0.203125 -9.94789 -9.94789 -9.94789 --0.265625 0.203125 0.203125 -10.1574 -10.1574 -10.1574 --0.453125 0.046875 0.265625 2.48129 2.48129 2.48129 --0.421875 0.015625 0.265625 -2.53367 -2.53367 -2.53367 --0.421875 0.015625 0.296875 -1.19814 -1.19814 -1.19814 --0.421875 0.046875 0.265625 1.50509 1.50509 1.50509 --0.421875 0.046875 0.296875 3.15985 3.15985 3.15985 --0.390625 0.015625 0.296875 -6.38349 -6.38349 -6.38349 --0.390625 0.046875 0.296875 0.0230429 0.0230429 0.0230429 --0.421875 0.078125 0.265625 -1.44602 -1.44602 -1.44602 --0.421875 0.078125 0.296875 -1.69106 -1.69106 -1.69106 --0.421875 0.109375 0.265625 -0.189699 -0.189699 -0.189699 --0.390625 0.078125 0.296875 -0.714105 -0.714105 -0.714105 --0.390625 0.109375 0.265625 -4.56464 -4.56464 -4.56464 --0.390625 0.109375 0.296875 -0.541682 -0.541682 -0.541682 --0.359375 0.015625 0.296875 10.2632 10.2632 10.2632 --0.359375 0.046875 0.296875 9.16304 9.16304 9.16304 --0.328125 0.015625 0.265625 -6.45093 -6.45093 -6.45093 --0.328125 0.015625 0.296875 10.9624 10.9624 10.9624 --0.328125 0.046875 0.265625 -14.3039 -14.3039 -14.3039 --0.359375 0.078125 0.265625 -2.21516 -2.21516 -2.21516 --0.359375 0.078125 0.296875 -1.01482 -1.01482 -1.01482 --0.359375 0.109375 0.265625 -4.74441 -4.74441 -4.74441 --0.328125 0.078125 0.265625 4.37781 4.37781 4.37781 --0.328125 0.109375 0.265625 0.149405 0.149405 0.149405 --0.296875 0.015625 0.265625 24.6716 24.6716 24.6716 --0.265625 0.265625 0.015625 -7.82136 -7.82136 -7.82136 --0.234375 0.015625 0.046875 -2.01882 -2.01882 -2.01882 --0.203125 0.015625 0.046875 -1.68476 -1.68476 -1.68476 --0.234375 0.015625 0.078125 -1.69331 -1.69331 -1.69331 --0.234375 0.015625 0.109375 -2.98046 -2.98046 -2.98046 --0.234375 0.046875 0.078125 -4.06157 -4.06157 -4.06157 --0.234375 0.046875 0.109375 -5.04034 -5.04034 -5.04034 --0.203125 0.015625 0.078125 -1.4043 -1.4043 -1.4043 --0.203125 0.015625 0.109375 -1.45753 -1.45753 -1.45753 --0.234375 0.078125 0.046875 -1.50252 -1.50252 -1.50252 --0.234375 0.109375 0.015625 -4.13355 -4.13355 -4.13355 --0.234375 0.109375 0.046875 2.34093 2.34093 2.34093 --0.203125 0.109375 0.015625 -5.97988 -5.97988 -5.97988 --0.234375 0.078125 0.078125 -6.41079 -6.41079 -6.41079 --0.234375 0.078125 0.109375 -1.04172 -1.04172 -1.04172 --0.234375 0.109375 0.078125 -6.61286 -6.61286 -6.61286 --0.234375 0.109375 0.109375 2.92251 2.92251 2.92251 --0.171875 0.015625 0.015625 -1.33385 -1.33385 -1.33385 --0.171875 0.015625 0.046875 -2.44261 -2.44261 -2.44261 --0.140625 0.015625 0.015625 -1.81637 -1.81637 -1.81637 --0.140625 0.015625 0.046875 -2.42864 -2.42864 -2.42864 --0.140625 0.046875 0.015625 -1.40505 -1.40505 -1.40505 --0.140625 0.046875 0.046875 -3.66486 -3.66486 -3.66486 --0.171875 0.015625 0.078125 -2.92201 -2.92201 -2.92201 --0.171875 0.015625 0.109375 -3.42626 -3.42626 -3.42626 --0.171875 0.046875 0.078125 -2.50053 -2.50053 -2.50053 --0.140625 0.015625 0.078125 -2.0794 -2.0794 -2.0794 --0.140625 0.015625 0.109375 0.78215 0.78215 0.78215 --0.140625 0.046875 0.078125 -2.19031 -2.19031 -2.19031 --0.140625 0.046875 0.109375 -3.57027 -3.57027 -3.57027 --0.140625 0.078125 0.015625 -2.98458 -2.98458 -2.98458 --0.140625 0.078125 0.046875 -1.31309 -1.31309 -1.31309 --0.140625 0.109375 0.015625 -2.18127 -2.18127 -2.18127 --0.140625 0.109375 0.046875 -1.45113 -1.45113 -1.45113 --0.140625 0.078125 0.078125 -3.48084 -3.48084 -3.48084 --0.140625 0.078125 0.109375 -529.665 -529.665 -529.665 --0.140625 0.109375 0.078125 -1.74913 -1.74913 -1.74913 --0.140625 0.109375 0.109375 3.88493 3.88493 3.88493 --0.234375 0.015625 0.140625 -0.535877 -0.535877 -0.535877 --0.234375 0.015625 0.171875 -0.958535 -0.958535 -0.958535 --0.234375 0.046875 0.140625 2.5858 2.5858 2.5858 --0.203125 0.015625 0.140625 1.0077 1.0077 1.0077 --0.203125 0.015625 0.171875 -2.14332 -2.14332 -2.14332 --0.203125 0.046875 0.140625 5.73875 5.73875 5.73875 --0.203125 0.046875 0.171875 1.20402 1.20402 1.20402 --0.234375 0.015625 0.234375 -6.53839 -6.53839 -6.53839 --0.234375 0.046875 0.234375 -39.7351 -39.7351 -39.7351 --0.203125 0.015625 0.203125 -4.96949 -4.96949 -4.96949 --0.203125 0.015625 0.234375 -1.15938 -1.15938 -1.15938 --0.203125 0.046875 0.203125 -2.36664 -2.36664 -2.36664 --0.203125 0.046875 0.234375 -8.52621 -8.52621 -8.52621 --0.234375 0.078125 0.140625 8.88293 8.88293 8.88293 --0.234375 0.078125 0.171875 4.64169 4.64169 4.64169 --0.234375 0.109375 0.140625 -1.18649 -1.18649 -1.18649 --0.234375 0.109375 0.171875 6.03561 6.03561 6.03561 --0.203125 0.078125 0.140625 3.56876 3.56876 3.56876 --0.203125 0.078125 0.171875 8.52134 8.52134 8.52134 --0.203125 0.109375 0.171875 -17.4466 -17.4466 -17.4466 --0.234375 0.078125 0.203125 -10.8618 -10.8618 -10.8618 --0.234375 0.078125 0.234375 -15.8323 -15.8323 -15.8323 --0.234375 0.109375 0.203125 43.5344 43.5344 43.5344 --0.234375 0.109375 0.234375 44.5762 44.5762 44.5762 --0.203125 0.078125 0.203125 -12.73 -12.73 -12.73 --0.203125 0.078125 0.234375 -17.7143 -17.7143 -17.7143 --0.171875 0.015625 0.140625 -2.22004 -2.22004 -2.22004 --0.171875 0.046875 0.140625 -1.01775 -1.01775 -1.01775 --0.171875 0.046875 0.171875 2.805 2.805 2.805 --0.140625 0.046875 0.140625 -0.44063 -0.44063 -0.44063 --0.171875 0.015625 0.203125 -4.74056 -4.74056 -4.74056 --0.171875 0.015625 0.234375 -6.42788 -6.42788 -6.42788 --0.171875 0.046875 0.203125 1.02008 1.02008 1.02008 --0.171875 0.046875 0.234375 -7.19242 -7.19242 -7.19242 --0.140625 0.015625 0.203125 -3.311 -3.311 -3.311 --0.140625 0.046875 0.203125 -0.622576 -0.622576 -0.622576 --0.140625 0.046875 0.234375 30.2776 30.2776 30.2776 --0.171875 0.078125 0.140625 -2.02508 -2.02508 -2.02508 --0.171875 0.078125 0.171875 4.26036 4.26036 4.26036 --0.171875 0.109375 0.140625 -1.04006 -1.04006 -1.04006 --0.171875 0.109375 0.171875 -9.81858 -9.81858 -9.81858 --0.140625 0.078125 0.140625 -2.41268 -2.41268 -2.41268 --0.140625 0.109375 0.140625 7.71163 7.71163 7.71163 --0.140625 0.109375 0.171875 -7.39665 -7.39665 -7.39665 --0.171875 0.078125 0.203125 1.787 1.787 1.787 --0.171875 0.078125 0.234375 1.54846 1.54846 1.54846 --0.140625 0.078125 0.203125 3.68402 3.68402 3.68402 --0.140625 0.078125 0.234375 7.65799 7.65799 7.65799 --0.140625 0.109375 0.203125 -13.0695 -13.0695 -13.0695 --0.140625 0.109375 0.234375 -24.4757 -24.4757 -24.4757 --0.234375 0.140625 0.015625 -3.74551 -3.74551 -3.74551 --0.234375 0.171875 0.015625 -3.63971 -3.63971 -3.63971 --0.234375 0.171875 0.046875 0.988302 0.988302 0.988302 --0.203125 0.140625 0.015625 -2.20767 -2.20767 -2.20767 --0.203125 0.140625 0.046875 0.881256 0.881256 0.881256 --0.203125 0.171875 0.015625 -8.23473 -8.23473 -8.23473 --0.203125 0.171875 0.046875 -2.12537 -2.12537 -2.12537 --0.234375 0.140625 0.078125 -2.26581 -2.26581 -2.26581 --0.234375 0.140625 0.109375 -1.02542 -1.02542 -1.02542 --0.234375 0.171875 0.109375 -2.77553 -2.77553 -2.77553 --0.203125 0.140625 0.078125 1.35639 1.35639 1.35639 --0.203125 0.171875 0.078125 -3.39421 -3.39421 -3.39421 --0.203125 0.171875 0.109375 -3.64913 -3.64913 -3.64913 --0.234375 0.203125 0.046875 2.12652 2.12652 2.12652 --0.234375 0.234375 0.015625 -0.353007 -0.353007 -0.353007 --0.234375 0.234375 0.046875 -7.72104 -7.72104 -7.72104 --0.203125 0.203125 0.046875 0.395954 0.395954 0.395954 --0.203125 0.234375 0.015625 12.163 12.163 12.163 --0.203125 0.234375 0.046875 -10.6191 -10.6191 -10.6191 --0.234375 0.203125 0.109375 0.117539 0.117539 0.117539 --0.234375 0.234375 0.078125 -2.65935 -2.65935 -2.65935 --0.234375 0.234375 0.109375 -3.50868 -3.50868 -3.50868 --0.203125 0.203125 0.078125 -1.59794 -1.59794 -1.59794 --0.203125 0.203125 0.109375 -3.04323 -3.04323 -3.04323 --0.203125 0.234375 0.078125 -6.98971 -6.98971 -6.98971 --0.171875 0.140625 0.015625 -2.03098 -2.03098 -2.03098 --0.171875 0.171875 0.015625 7.49243 7.49243 7.49243 --0.171875 0.171875 0.046875 -77.1347 -77.1347 -77.1347 --0.140625 0.140625 0.015625 -1.10063 -1.10063 -1.10063 --0.140625 0.140625 0.046875 -0.36559 -0.36559 -0.36559 --0.140625 0.171875 0.015625 68.2666 68.2666 68.2666 --0.140625 0.171875 0.046875 202.729 202.729 202.729 --0.171875 0.203125 0.015625 -110.489 -110.489 -110.489 --0.171875 0.203125 0.046875 -207.667 -207.667 -207.667 --0.171875 0.234375 0.015625 48.2756 48.2756 48.2756 --0.171875 0.234375 0.046875 -65.7658 -65.7658 -65.7658 --0.140625 0.203125 0.015625 -104.945 -104.945 -104.945 --0.140625 0.203125 0.046875 117.588 117.588 117.588 --0.140625 0.234375 0.015625 80.4246 80.4246 80.4246 --0.140625 0.234375 0.046875 115.487 115.487 115.487 --0.171875 0.203125 0.109375 10.8386 10.8386 10.8386 --0.171875 0.234375 0.078125 -54.3593 -54.3593 -54.3593 --0.171875 0.234375 0.109375 2.28265 2.28265 2.28265 --0.140625 0.203125 0.078125 -159.711 -159.711 -159.711 --0.140625 0.203125 0.109375 -917.517 -917.517 -917.517 --0.140625 0.234375 0.078125 64.0692 64.0692 64.0692 --0.140625 0.234375 0.109375 -1267.56 -1267.56 -1267.56 --0.234375 0.140625 0.171875 11.2728 11.2728 11.2728 --0.234375 0.171875 0.140625 -5.19489 -5.19489 -5.19489 --0.234375 0.171875 0.171875 27.6011 27.6011 27.6011 --0.234375 0.140625 0.203125 10.7079 10.7079 10.7079 --0.234375 0.140625 0.234375 15.1587 15.1587 15.1587 --0.234375 0.171875 0.203125 -11.9487 -11.9487 -11.9487 --0.234375 0.171875 0.234375 11.8408 11.8408 11.8408 --0.234375 0.203125 0.140625 4.89948 4.89948 4.89948 --0.234375 0.203125 0.171875 89.6153 89.6153 89.6153 --0.234375 0.234375 0.140625 -6.555 -6.555 -6.555 --0.234375 0.234375 0.171875 -0.15862 -0.15862 -0.15862 --0.203125 0.203125 0.140625 46.9309 46.9309 46.9309 --0.203125 0.203125 0.171875 18.4953 18.4953 18.4953 --0.203125 0.234375 0.171875 -20.5899 -20.5899 -20.5899 --0.234375 0.203125 0.203125 -18.1868 -18.1868 -18.1868 --0.234375 0.203125 0.234375 -30.5937 -30.5937 -30.5937 --0.234375 0.234375 0.203125 15.4961 15.4961 15.4961 --0.203125 0.234375 0.203125 -67.7064 -67.7064 -67.7064 --0.203125 0.234375 0.234375 -13.2999 -13.2999 -13.2999 --0.171875 0.171875 0.140625 613.984 613.984 613.984 --0.140625 0.140625 0.140625 -12.4899 -12.4899 -12.4899 --0.140625 0.140625 0.171875 -6.53491 -6.53491 -6.53491 --0.140625 0.171875 0.140625 7227.73 7227.73 7227.73 --0.140625 0.171875 0.171875 9444.86 9444.86 9444.86 --0.140625 0.140625 0.203125 5.32298 5.32298 5.32298 --0.140625 0.140625 0.234375 24.9391 24.9391 24.9391 --0.140625 0.171875 0.203125 12.7135 12.7135 12.7135 --0.140625 0.171875 0.234375 -10.383 -10.383 -10.383 --0.171875 0.203125 0.140625 -12.1793 -12.1793 -12.1793 --0.171875 0.203125 0.171875 2.55438 2.55438 2.55438 --0.171875 0.234375 0.140625 36.8356 36.8356 36.8356 --0.171875 0.234375 0.171875 -9.99744 -9.99744 -9.99744 --0.140625 0.203125 0.140625 -5945.68 -5945.68 -5945.68 --0.140625 0.203125 0.171875 -1351.85 -1351.85 -1351.85 --0.140625 0.234375 0.140625 714.889 714.889 714.889 --0.140625 0.234375 0.171875 614.105 614.105 614.105 --0.171875 0.234375 0.203125 41.8536 41.8536 41.8536 --0.171875 0.234375 0.234375 18.6749 18.6749 18.6749 --0.140625 0.203125 0.203125 -26.1572 -26.1572 -26.1572 --0.140625 0.203125 0.234375 -10.7301 -10.7301 -10.7301 --0.140625 0.234375 0.203125 29.3061 29.3061 29.3061 --0.140625 0.234375 0.234375 -3.81758 -3.81758 -3.81758 --0.109375 0.015625 0.015625 -2.30176 -2.30176 -2.30176 --0.109375 0.015625 0.046875 -1.99794 -1.99794 -1.99794 --0.109375 0.046875 0.015625 -2.11352 -2.11352 -2.11352 --0.109375 0.046875 0.046875 -3.43776 -3.43776 -3.43776 --0.078125 0.015625 0.015625 -2.14237 -2.14237 -2.14237 --0.078125 0.046875 0.015625 -2.62679 -2.62679 -2.62679 --0.109375 0.015625 0.078125 -2.38611 -2.38611 -2.38611 --0.109375 0.015625 0.109375 -2.57245 -2.57245 -2.57245 --0.109375 0.046875 0.078125 -2.1713 -2.1713 -2.1713 --0.109375 0.046875 0.109375 -0.59289 -0.59289 -0.59289 --0.078125 0.015625 0.109375 1.94809 1.94809 1.94809 --0.109375 0.078125 0.015625 -2.95708 -2.95708 -2.95708 --0.109375 0.078125 0.046875 -2.67224 -2.67224 -2.67224 --0.109375 0.109375 0.046875 -1.57587 -1.57587 -1.57587 --0.078125 0.078125 0.015625 -2.73273 -2.73273 -2.73273 --0.078125 0.078125 0.046875 -3.2475 -3.2475 -3.2475 --0.078125 0.109375 0.015625 -1.85823 -1.85823 -1.85823 --0.078125 0.109375 0.046875 0.92278 0.92278 0.92278 --0.109375 0.078125 0.078125 -1.45983 -1.45983 -1.45983 --0.109375 0.078125 0.109375 -0.875488 -0.875488 -0.875488 --0.109375 0.109375 0.078125 0.302721 0.302721 0.302721 --0.109375 0.109375 0.109375 -2.09188 -2.09188 -2.09188 --0.078125 0.078125 0.078125 -0.575783 -0.575783 -0.575783 --0.078125 0.078125 0.109375 0.588263 0.588263 0.588263 --0.078125 0.109375 0.078125 0.152527 0.152527 0.152527 --0.078125 0.109375 0.109375 2.97337 2.97337 2.97337 --0.015625 0.015625 0.046875 -1.94911 -1.94911 -1.94911 --0.046875 0.015625 0.109375 -1.94757 -1.94757 -1.94757 --0.046875 0.046875 0.109375 -2.10129 -2.10129 -2.10129 --0.015625 0.015625 0.078125 -2.00868 -2.00868 -2.00868 --0.015625 0.015625 0.109375 -1.62789 -1.62789 -1.62789 --0.015625 0.046875 0.078125 -3.46229 -3.46229 -3.46229 --0.015625 0.046875 0.109375 -0.9957 -0.9957 -0.9957 --0.046875 0.078125 0.015625 -2.14048 -2.14048 -2.14048 --0.046875 0.109375 0.015625 -1.72201 -1.72201 -1.72201 --0.046875 0.078125 0.109375 -1.93255 -1.93255 -1.93255 --0.046875 0.109375 0.078125 -0.035773 -0.035773 -0.035773 --0.046875 0.109375 0.109375 -0.971719 -0.971719 -0.971719 --0.015625 0.078125 0.078125 -3.20869 -3.20869 -3.20869 --0.015625 0.078125 0.109375 -2.96976 -2.96976 -2.96976 --0.015625 0.109375 0.078125 -3.9078 -3.9078 -3.9078 --0.015625 0.109375 0.109375 1.92018 1.92018 1.92018 --0.109375 0.015625 0.171875 6.14358 6.14358 6.14358 --0.109375 0.046875 0.140625 -0.176171 -0.176171 -0.176171 --0.109375 0.046875 0.171875 1.2632 1.2632 1.2632 --0.078125 0.015625 0.171875 132.122 132.122 132.122 --0.078125 0.046875 0.140625 0.519006 0.519006 0.519006 --0.078125 0.046875 0.171875 4.74781 4.74781 4.74781 --0.109375 0.015625 0.203125 -5.22869 -5.22869 -5.22869 --0.109375 0.015625 0.234375 190.365 190.365 190.365 --0.109375 0.046875 0.203125 1.68736 1.68736 1.68736 --0.109375 0.046875 0.234375 -5.19063 -5.19063 -5.19063 --0.078125 0.015625 0.203125 8.92146 8.92146 8.92146 --0.078125 0.015625 0.234375 829.469 829.469 829.469 --0.078125 0.046875 0.203125 2.23422 2.23422 2.23422 --0.078125 0.046875 0.234375 10.747 10.747 10.747 --0.109375 0.078125 0.140625 1.98749 1.98749 1.98749 --0.109375 0.078125 0.171875 -3.4607 -3.4607 -3.4607 --0.109375 0.109375 0.140625 -1.66618 -1.66618 -1.66618 --0.109375 0.109375 0.171875 1.10625 1.10625 1.10625 --0.078125 0.078125 0.140625 -4.13246 -4.13246 -4.13246 --0.078125 0.109375 0.140625 -5.13559 -5.13559 -5.13559 --0.109375 0.078125 0.203125 6.0035 6.0035 6.0035 --0.109375 0.078125 0.234375 -10.6957 -10.6957 -10.6957 --0.109375 0.109375 0.234375 13.0091 13.0091 13.0091 --0.078125 0.078125 0.234375 49.8071 49.8071 49.8071 --0.078125 0.109375 0.234375 28.6926 28.6926 28.6926 --0.046875 0.015625 0.171875 -292.585 -292.585 -292.585 --0.046875 0.046875 0.140625 -0.423079 -0.423079 -0.423079 --0.046875 0.046875 0.171875 -0.887803 -0.887803 -0.887803 --0.015625 0.015625 0.140625 54.076 54.076 54.076 --0.015625 0.015625 0.171875 -306.771 -306.771 -306.771 --0.015625 0.046875 0.140625 -3.61863 -3.61863 -3.61863 --0.015625 0.046875 0.171875 -4.28975 -4.28975 -4.28975 --0.046875 0.015625 0.203125 36.8703 36.8703 36.8703 --0.046875 0.015625 0.234375 176.541 176.541 176.541 --0.046875 0.046875 0.203125 1.35147 1.35147 1.35147 --0.046875 0.046875 0.234375 27.6335 27.6335 27.6335 --0.015625 0.015625 0.203125 217.797 217.797 217.797 --0.015625 0.015625 0.234375 22.708 22.708 22.708 --0.015625 0.046875 0.203125 0.590751 0.590751 0.590751 --0.015625 0.046875 0.234375 11.1106 11.1106 11.1106 --0.046875 0.078125 0.140625 1.02782 1.02782 1.02782 --0.046875 0.109375 0.140625 -2.04483 -2.04483 -2.04483 --0.046875 0.078125 0.203125 -6.52776 -6.52776 -6.52776 --0.046875 0.078125 0.234375 19.4398 19.4398 19.4398 --0.046875 0.109375 0.203125 -4.66459 -4.66459 -4.66459 --0.046875 0.109375 0.234375 37.1685 37.1685 37.1685 --0.015625 0.078125 0.203125 -3.83363 -3.83363 -3.83363 --0.015625 0.078125 0.234375 -36.0056 -36.0056 -36.0056 --0.015625 0.109375 0.203125 -6.85555 -6.85555 -6.85555 --0.015625 0.109375 0.234375 32.3099 32.3099 32.3099 --0.109375 0.140625 0.046875 -8.22097 -8.22097 -8.22097 --0.109375 0.171875 0.015625 235.957 235.957 235.957 --0.109375 0.171875 0.046875 -138.125 -138.125 -138.125 --0.078125 0.140625 0.046875 -29.1174 -29.1174 -29.1174 --0.078125 0.171875 0.015625 2.30489 2.30489 2.30489 --0.078125 0.171875 0.046875 -15.8773 -15.8773 -15.8773 --0.078125 0.140625 0.078125 0.503453 0.503453 0.503453 --0.078125 0.140625 0.109375 -1.96498 -1.96498 -1.96498 --0.078125 0.171875 0.109375 -494.566 -494.566 -494.566 --0.109375 0.203125 0.109375 -5640.08 -5640.08 -5640.08 --0.109375 0.234375 0.109375 -3631.39 -3631.39 -3631.39 --0.078125 0.203125 0.109375 1733.26 1733.26 1733.26 --0.046875 0.140625 0.015625 1.60174 1.60174 1.60174 --0.046875 0.140625 0.046875 -1.09807 -1.09807 -1.09807 --0.046875 0.171875 0.015625 -2.03192 -2.03192 -2.03192 --0.046875 0.171875 0.046875 7.73639 7.73639 7.73639 --0.015625 0.140625 0.015625 -1.20717 -1.20717 -1.20717 --0.015625 0.171875 0.015625 -3.06865 -3.06865 -3.06865 --0.015625 0.171875 0.046875 6.63279 6.63279 6.63279 --0.046875 0.140625 0.078125 -4.17451 -4.17451 -4.17451 --0.046875 0.140625 0.109375 -1.49359 -1.49359 -1.49359 --0.046875 0.171875 0.078125 0.62465 0.62465 0.62465 --0.046875 0.171875 0.109375 -7.82446 -7.82446 -7.82446 --0.015625 0.140625 0.078125 -4.81978 -4.81978 -4.81978 --0.015625 0.140625 0.109375 -10.4907 -10.4907 -10.4907 --0.015625 0.171875 0.078125 -2.20959 -2.20959 -2.20959 --0.015625 0.171875 0.109375 -4.42773 -4.42773 -4.42773 --0.046875 0.203125 0.015625 4.14913 4.14913 4.14913 --0.046875 0.203125 0.046875 3.17322 3.17322 3.17322 --0.046875 0.234375 0.015625 1.25452 1.25452 1.25452 --0.046875 0.234375 0.046875 -1.22253 -1.22253 -1.22253 --0.015625 0.203125 0.015625 -0.689754 -0.689754 -0.689754 --0.015625 0.203125 0.046875 5.70477 5.70477 5.70477 --0.015625 0.234375 0.015625 -0.78561 -0.78561 -0.78561 --0.015625 0.234375 0.046875 3.75389 3.75389 3.75389 --0.015625 0.203125 0.078125 4.8155 4.8155 4.8155 --0.015625 0.203125 0.109375 -2.17902 -2.17902 -2.17902 --0.015625 0.234375 0.078125 -9.37309 -9.37309 -9.37309 --0.109375 0.140625 0.140625 23.2681 23.2681 23.2681 --0.109375 0.140625 0.171875 -3.51185 -3.51185 -3.51185 --0.109375 0.171875 0.140625 1892.66 1892.66 1892.66 --0.109375 0.171875 0.171875 9204.07 9204.07 9204.07 --0.078125 0.140625 0.140625 -13.8399 -13.8399 -13.8399 --0.078125 0.171875 0.140625 3593.36 3593.36 3593.36 --0.078125 0.171875 0.171875 2230 2230 2230 --0.109375 0.140625 0.234375 12.0514 12.0514 12.0514 --0.109375 0.171875 0.203125 -21.0326 -21.0326 -21.0326 --0.109375 0.171875 0.234375 0.512635 0.512635 0.512635 --0.078125 0.140625 0.234375 40.7836 40.7836 40.7836 --0.078125 0.171875 0.234375 0.173708 0.173708 0.173708 --0.109375 0.203125 0.140625 -5402.24 -5402.24 -5402.24 --0.109375 0.203125 0.171875 187.478 187.478 187.478 --0.109375 0.234375 0.140625 -3613.29 -3613.29 -3613.29 --0.078125 0.203125 0.140625 -1277.56 -1277.56 -1277.56 --0.078125 0.203125 0.171875 78.2762 78.2762 78.2762 --0.078125 0.234375 0.140625 -56.5954 -56.5954 -56.5954 --0.078125 0.234375 0.171875 -1399.27 -1399.27 -1399.27 --0.109375 0.203125 0.203125 -11.3724 -11.3724 -11.3724 --0.109375 0.203125 0.234375 -11.807 -11.807 -11.807 --0.078125 0.203125 0.203125 -3.82825 -3.82825 -3.82825 --0.078125 0.203125 0.234375 -1.73087 -1.73087 -1.73087 --0.046875 0.140625 0.140625 3.7134 3.7134 3.7134 --0.046875 0.171875 0.140625 1.40611 1.40611 1.40611 --0.015625 0.171875 0.140625 -1.64668 -1.64668 -1.64668 --0.046875 0.140625 0.234375 55.3949 55.3949 55.3949 --0.046875 0.171875 0.234375 5.08084 5.08084 5.08084 --0.015625 0.140625 0.203125 -4.9849 -4.9849 -4.9849 --0.015625 0.140625 0.234375 -12.202 -12.202 -12.202 --0.015625 0.171875 0.234375 3.81384 3.81384 3.81384 --0.046875 0.203125 0.140625 -0.275984 -0.275984 -0.275984 --0.046875 0.203125 0.171875 -0.0968685 -0.0968685 -0.0968685 --0.046875 0.234375 0.171875 4.21024 4.21024 4.21024 --0.015625 0.234375 0.171875 -87.1937 -87.1937 -87.1937 --0.046875 0.203125 0.203125 -7.03707 -7.03707 -7.03707 --0.046875 0.203125 0.234375 -5.46046 -5.46046 -5.46046 --0.046875 0.234375 0.203125 8.32314 8.32314 8.32314 --0.015625 0.203125 0.234375 -0.301831 -0.301831 -0.301831 --0.015625 0.234375 0.203125 36.502 36.502 36.502 --0.015625 0.234375 0.234375 -1.08012 -1.08012 -1.08012 --0.234375 0.109375 0.265625 -11.6394 -11.6394 -11.6394 --0.203125 0.078125 0.265625 -21.0964 -21.0964 -21.0964 --0.203125 0.109375 0.265625 -30.962 -30.962 -30.962 --0.171875 0.015625 0.265625 6.71099 6.71099 6.71099 --0.171875 0.015625 0.296875 -5.63657 -5.63657 -5.63657 --0.171875 0.046875 0.265625 -6.15019 -6.15019 -6.15019 --0.140625 0.015625 0.296875 2.56026 2.56026 2.56026 --0.140625 0.046875 0.265625 -44.2243 -44.2243 -44.2243 --0.140625 0.046875 0.296875 109.735 109.735 109.735 --0.140625 0.015625 0.328125 2.93909 2.93909 2.93909 --0.140625 0.046875 0.328125 -299.13 -299.13 -299.13 --0.171875 0.078125 0.265625 -9.91944 -9.91944 -9.91944 --0.171875 0.109375 0.265625 -12.3414 -12.3414 -12.3414 --0.171875 0.109375 0.296875 -49.6973 -49.6973 -49.6973 --0.140625 0.078125 0.265625 15.8554 15.8554 15.8554 --0.140625 0.078125 0.296875 -255.484 -255.484 -255.484 --0.140625 0.109375 0.265625 -8.63927 -8.63927 -8.63927 --0.140625 0.109375 0.296875 -24.1691 -24.1691 -24.1691 --0.140625 0.078125 0.328125 17.1097 17.1097 17.1097 --0.140625 0.109375 0.328125 -26.8807 -26.8807 -26.8807 --0.234375 0.140625 0.265625 -12.2587 -12.2587 -12.2587 --0.234375 0.171875 0.265625 -7.81168 -7.81168 -7.81168 --0.203125 0.140625 0.265625 -9.03423 -9.03423 -9.03423 --0.203125 0.140625 0.296875 0.589181 0.589181 0.589181 --0.203125 0.171875 0.265625 -2.16898 -2.16898 -2.16898 --0.203125 0.171875 0.296875 3.54718 3.54718 3.54718 --0.234375 0.203125 0.265625 -23.1879 -23.1879 -23.1879 --0.203125 0.203125 0.265625 -13.008 -13.008 -13.008 --0.203125 0.203125 0.296875 2.88864 2.88864 2.88864 --0.203125 0.234375 0.265625 13.3118 13.3118 13.3118 --0.171875 0.140625 0.296875 -38.9539 -38.9539 -38.9539 --0.171875 0.171875 0.296875 -4.32955 -4.32955 -4.32955 --0.140625 0.140625 0.265625 -9.00565 -9.00565 -9.00565 --0.140625 0.140625 0.296875 -7.06482 -7.06482 -7.06482 --0.140625 0.171875 0.265625 8.8647 8.8647 8.8647 --0.140625 0.171875 0.296875 -2.63736 -2.63736 -2.63736 --0.171875 0.203125 0.296875 -11.0135 -11.0135 -11.0135 --0.171875 0.234375 0.265625 -1.01136 -1.01136 -1.01136 --0.171875 0.234375 0.296875 5.03146 5.03146 5.03146 --0.140625 0.203125 0.265625 -0.729663 -0.729663 -0.729663 --0.140625 0.203125 0.296875 12.871 12.871 12.871 --0.140625 0.234375 0.265625 -1.84272 -1.84272 -1.84272 --0.109375 0.015625 0.265625 -283.07 -283.07 -283.07 --0.109375 0.015625 0.296875 41.3962 41.3962 41.3962 --0.109375 0.046875 0.265625 -24.6791 -24.6791 -24.6791 --0.078125 0.015625 0.265625 287.057 287.057 287.057 --0.078125 0.015625 0.296875 -277.502 -277.502 -277.502 --0.078125 0.046875 0.265625 132.57 132.57 132.57 --0.109375 0.015625 0.328125 -31.6582 -31.6582 -31.6582 --0.109375 0.015625 0.359375 26.1497 26.1497 26.1497 --0.109375 0.046875 0.328125 14.6837 14.6837 14.6837 --0.109375 0.046875 0.359375 28.4596 28.4596 28.4596 --0.078125 0.015625 0.328125 -10.4208 -10.4208 -10.4208 --0.078125 0.015625 0.359375 11.708 11.708 11.708 --0.078125 0.046875 0.359375 -12.2481 -12.2481 -12.2481 --0.109375 0.078125 0.265625 2.66656 2.66656 2.66656 --0.109375 0.109375 0.265625 -22.9625 -22.9625 -22.9625 --0.109375 0.109375 0.296875 101.706 101.706 101.706 --0.078125 0.078125 0.265625 8.26456 8.26456 8.26456 --0.078125 0.109375 0.265625 -22.4977 -22.4977 -22.4977 --0.078125 0.109375 0.296875 -2.33876 -2.33876 -2.33876 --0.109375 0.078125 0.359375 -80.742 -80.742 -80.742 --0.109375 0.109375 0.328125 154.98 154.98 154.98 --0.109375 0.109375 0.359375 -197.379 -197.379 -197.379 --0.078125 0.078125 0.359375 147.681 147.681 147.681 --0.078125 0.109375 0.328125 145.243 145.243 145.243 --0.078125 0.109375 0.359375 32.4239 32.4239 32.4239 --0.046875 0.015625 0.265625 -20.4066 -20.4066 -20.4066 --0.046875 0.015625 0.296875 260.04 260.04 260.04 --0.046875 0.046875 0.265625 -2.75673 -2.75673 -2.75673 --0.015625 0.015625 0.265625 60.245 60.245 60.245 --0.046875 0.015625 0.328125 185.352 185.352 185.352 --0.046875 0.046875 0.328125 -118.715 -118.715 -118.715 --0.046875 0.046875 0.359375 71.3313 71.3313 71.3313 --0.015625 0.015625 0.328125 -30.8675 -30.8675 -30.8675 --0.015625 0.046875 0.328125 -203.202 -203.202 -203.202 --0.015625 0.046875 0.359375 70.7077 70.7077 70.7077 --0.046875 0.109375 0.265625 -28.9839 -28.9839 -28.9839 --0.046875 0.109375 0.296875 37.1139 37.1139 37.1139 --0.015625 0.078125 0.265625 73.2848 73.2848 73.2848 --0.015625 0.109375 0.265625 24.4882 24.4882 24.4882 --0.015625 0.109375 0.296875 28.6437 28.6437 28.6437 --0.046875 0.078125 0.328125 -51.8512 -51.8512 -51.8512 --0.046875 0.078125 0.359375 -45.9231 -45.9231 -45.9231 --0.046875 0.109375 0.328125 57.9146 57.9146 57.9146 --0.015625 0.078125 0.328125 -162.255 -162.255 -162.255 --0.015625 0.109375 0.328125 43.2159 43.2159 43.2159 --0.109375 0.046875 0.390625 -567.283 -567.283 -567.283 --0.078125 0.046875 0.390625 69.0373 69.0373 69.0373 --0.078125 0.078125 0.390625 -159.566 -159.566 -159.566 --0.109375 0.140625 0.296875 176.465 176.465 176.465 --0.109375 0.171875 0.265625 8.39792 8.39792 8.39792 --0.078125 0.140625 0.265625 32.3215 32.3215 32.3215 --0.078125 0.140625 0.296875 -40.9007 -40.9007 -40.9007 --0.109375 0.140625 0.328125 33.9283 33.9283 33.9283 --0.109375 0.203125 0.265625 -66.5178 -66.5178 -66.5178 --0.046875 0.140625 0.265625 -71.9692 -71.9692 -71.9692 --0.046875 0.140625 0.296875 -36.6251 -36.6251 -36.6251 --0.234375 0.265625 0.015625 -8.73467 -8.73467 -8.73467 --0.203125 0.265625 0.015625 -11.3344 -11.3344 -11.3344 --0.234375 0.265625 0.078125 -4.18594 -4.18594 -4.18594 --0.234375 0.265625 0.109375 -15.7297 -15.7297 -15.7297 --0.234375 0.296875 0.109375 -10.4409 -10.4409 -10.4409 --0.203125 0.265625 0.078125 -9.89155 -9.89155 -9.89155 --0.203125 0.296875 0.078125 0.474416 0.474416 0.474416 --0.203125 0.296875 0.109375 -25.8774 -25.8774 -25.8774 --0.171875 0.265625 0.015625 -0.216885 -0.216885 -0.216885 --0.171875 0.296875 0.015625 5.9643 5.9643 5.9643 --0.140625 0.265625 0.015625 -12.9262 -12.9262 -12.9262 --0.140625 0.265625 0.046875 25.3723 25.3723 25.3723 --0.140625 0.296875 0.015625 -5.03102 -5.03102 -5.03102 --0.140625 0.296875 0.046875 -2.3505 -2.3505 -2.3505 --0.171875 0.265625 0.078125 -1.05183 -1.05183 -1.05183 --0.171875 0.265625 0.109375 5.79358 5.79358 5.79358 --0.171875 0.296875 0.078125 -0.634746 -0.634746 -0.634746 --0.171875 0.296875 0.109375 1.7068 1.7068 1.7068 --0.140625 0.265625 0.078125 -3.45785 -3.45785 -3.45785 --0.140625 0.265625 0.109375 -2.38899 -2.38899 -2.38899 --0.171875 0.328125 0.015625 13.1414 13.1414 13.1414 --0.140625 0.328125 0.015625 33.1561 33.1561 33.1561 --0.234375 0.265625 0.140625 7.60803 7.60803 7.60803 --0.234375 0.296875 0.140625 26.9658 26.9658 26.9658 --0.203125 0.265625 0.171875 5.28436 5.28436 5.28436 --0.203125 0.296875 0.140625 7.95941 7.95941 7.95941 --0.171875 0.265625 0.140625 14.7973 14.7973 14.7973 --0.171875 0.265625 0.171875 3.92201 3.92201 3.92201 --0.171875 0.296875 0.140625 7.19801 7.19801 7.19801 --0.140625 0.265625 0.140625 14.9166 14.9166 14.9166 --0.109375 0.296875 0.046875 -0.166996 -0.166996 -0.166996 --0.078125 0.296875 0.046875 6.91845 6.91845 6.91845 --0.109375 0.265625 0.078125 -6.85657 -6.85657 -6.85657 --0.109375 0.265625 0.109375 -6.3058 -6.3058 -6.3058 --0.109375 0.296875 0.078125 -5.05185 -5.05185 -5.05185 --0.109375 0.296875 0.109375 -3.88149 -3.88149 -3.88149 --0.078125 0.265625 0.078125 -2.91238 -2.91238 -2.91238 --0.078125 0.265625 0.109375 -3.40055 -3.40055 -3.40055 --0.078125 0.296875 0.078125 -1.64314 -1.64314 -1.64314 --0.078125 0.296875 0.109375 5.38446 5.38446 5.38446 --0.109375 0.328125 0.015625 0.045336 0.045336 0.045336 --0.109375 0.328125 0.046875 6.71271 6.71271 6.71271 --0.078125 0.328125 0.015625 -7.62513 -7.62513 -7.62513 --0.078125 0.328125 0.046875 7.27627 7.27627 7.27627 --0.078125 0.328125 0.109375 27.4149 27.4149 27.4149 --0.046875 0.265625 0.046875 -2.22302 -2.22302 -2.22302 --0.046875 0.296875 0.046875 0.647117 0.647117 0.647117 --0.015625 0.265625 0.015625 -2.33989 -2.33989 -2.33989 --0.015625 0.265625 0.046875 -1.55132 -1.55132 -1.55132 --0.015625 0.296875 0.015625 -1.03587 -1.03587 -1.03587 --0.015625 0.296875 0.046875 -7.74857 -7.74857 -7.74857 --0.046875 0.265625 0.078125 -3.99543 -3.99543 -3.99543 --0.046875 0.296875 0.078125 -5.08978 -5.08978 -5.08978 --0.046875 0.296875 0.109375 5.51457 5.51457 5.51457 --0.015625 0.265625 0.078125 -3.14513 -3.14513 -3.14513 --0.015625 0.265625 0.109375 -4.8596 -4.8596 -4.8596 --0.015625 0.296875 0.109375 7.86916 7.86916 7.86916 --0.046875 0.328125 0.015625 -1.73397 -1.73397 -1.73397 --0.046875 0.328125 0.046875 -3.00792 -3.00792 -3.00792 --0.046875 0.359375 0.015625 -0.933465 -0.933465 -0.933465 --0.046875 0.359375 0.046875 -5.01863 -5.01863 -5.01863 --0.015625 0.328125 0.015625 -1.97092 -1.97092 -1.97092 --0.015625 0.328125 0.046875 -3.97988 -3.97988 -3.97988 --0.015625 0.359375 0.015625 -2.33104 -2.33104 -2.33104 --0.015625 0.359375 0.046875 -5.69075 -5.69075 -5.69075 --0.046875 0.328125 0.109375 13.4011 13.4011 13.4011 --0.046875 0.359375 0.078125 -9.61472 -9.61472 -9.61472 --0.015625 0.328125 0.078125 -3.80955 -3.80955 -3.80955 --0.015625 0.359375 0.078125 4.61981 4.61981 4.61981 --0.015625 0.359375 0.109375 -5.69317 -5.69317 -5.69317 --0.109375 0.265625 0.140625 4.12196 4.12196 4.12196 --0.109375 0.265625 0.171875 23.9772 23.9772 23.9772 --0.109375 0.296875 0.140625 -14.2644 -14.2644 -14.2644 --0.078125 0.265625 0.171875 3.14159 3.14159 3.14159 --0.078125 0.296875 0.140625 -15.8492 -15.8492 -15.8492 --0.078125 0.296875 0.171875 -6.72501 -6.72501 -6.72501 --0.078125 0.328125 0.140625 13.1891 13.1891 13.1891 --0.046875 0.265625 0.171875 -1.21658 -1.21658 -1.21658 --0.046875 0.296875 0.140625 -0.985448 -0.985448 -0.985448 --0.046875 0.296875 0.171875 -0.0685778 -0.0685778 -0.0685778 --0.015625 0.265625 0.171875 20.3498 20.3498 20.3498 --0.015625 0.296875 0.140625 -2.00843 -2.00843 -2.00843 --0.015625 0.296875 0.171875 0.281443 0.281443 0.281443 --0.015625 0.265625 0.203125 -7.2825 -7.2825 -7.2825 --0.015625 0.296875 0.203125 2.90187 2.90187 2.90187 --0.015625 0.296875 0.234375 0.207731 0.207731 0.207731 --0.046875 0.328125 0.140625 -14.4454 -14.4454 -14.4454 --0.015625 0.328125 0.171875 -4.76415 -4.76415 -4.76415 --0.015625 0.328125 0.203125 -3.77793 -3.77793 -3.77793 --0.015625 0.328125 0.234375 -4.0232 -4.0232 -4.0232 --0.015625 0.359375 0.203125 0.752921 0.752921 0.752921 --0.109375 0.421875 0.015625 -1.4382 -1.4382 -1.4382 --0.078125 0.390625 0.015625 -0.6386 -0.6386 -0.6386 --0.078125 0.421875 0.015625 0.42759 0.42759 0.42759 --0.109375 0.453125 0.015625 -1.9702 -1.9702 -1.9702 --0.109375 0.484375 0.015625 -1.61592 -1.61592 -1.61592 --0.078125 0.453125 0.015625 -1.32509 -1.32509 -1.32509 --0.078125 0.484375 0.015625 -0.965061 -0.965061 -0.965061 --0.046875 0.390625 0.015625 -1.37473 -1.37473 -1.37473 --0.046875 0.390625 0.046875 -1.08812 -1.08812 -1.08812 --0.046875 0.421875 0.015625 -1.1743 -1.1743 -1.1743 --0.046875 0.421875 0.046875 1.06064 1.06064 1.06064 --0.015625 0.421875 0.015625 -0.914277 -0.914277 -0.914277 --0.046875 0.390625 0.078125 -2.98697 -2.98697 -2.98697 --0.046875 0.390625 0.109375 -5.72141 -5.72141 -5.72141 --0.046875 0.421875 0.078125 -0.788439 -0.788439 -0.788439 --0.046875 0.421875 0.109375 -3.95593 -3.95593 -3.95593 --0.015625 0.390625 0.109375 0.941874 0.941874 0.941874 --0.015625 0.421875 0.109375 0.726675 0.726675 0.726675 --0.046875 0.453125 0.015625 -0.652483 -0.652483 -0.652483 --0.046875 0.453125 0.046875 -4.68994 -4.68994 -4.68994 --0.046875 0.484375 0.015625 -0.748902 -0.748902 -0.748902 --0.015625 0.453125 0.015625 -1.37867 -1.37867 -1.37867 --0.015625 0.453125 0.046875 -1.05559 -1.05559 -1.05559 --0.046875 0.453125 0.078125 3.24035 3.24035 3.24035 --0.015625 0.453125 0.078125 -1.25795 -1.25795 -1.25795 -0.109375 -0.265625 -0.140625 32.565 32.565 32.565 -0.015625 -0.296875 -0.046875 -2.05256 -2.05256 -2.05256 -0.015625 -0.296875 -0.015625 -0.810359 -0.810359 -0.810359 -0.015625 -0.265625 -0.046875 -1.67151 -1.67151 -1.67151 -0.015625 -0.265625 -0.015625 0.374223 0.374223 0.374223 -0.109375 -0.265625 -0.109375 -27.8651 -27.8651 -27.8651 -0.140625 -0.265625 -0.140625 21.4017 21.4017 21.4017 -0.140625 -0.265625 -0.109375 -34.1735 -34.1735 -34.1735 -0.171875 -0.265625 -0.109375 20.7698 20.7698 20.7698 -0.109375 -0.140625 -0.390625 -4.29162 -4.29162 -4.29162 -0.046875 -0.140625 -0.359375 -493.968 -493.968 -493.968 -0.046875 -0.140625 -0.328125 146.863 146.863 146.863 -0.046875 -0.140625 -0.296875 -2.50973 -2.50973 -2.50973 -0.046875 -0.140625 -0.265625 -3.3652 -3.3652 -3.3652 -0.078125 -0.140625 -0.359375 1.35494 1.35494 1.35494 -0.078125 -0.140625 -0.328125 -0.137542 -0.137542 -0.137542 -0.109375 -0.171875 -0.359375 0.0335234 0.0335234 0.0335234 -0.109375 -0.171875 -0.328125 0.120891 0.120891 0.120891 -0.109375 -0.140625 -0.359375 0.614452 0.614452 0.614452 -0.109375 -0.140625 -0.328125 -0.33983 -0.33983 -0.33983 -0.078125 -0.140625 -0.296875 -1.92554 -1.92554 -1.92554 -0.078125 -0.140625 -0.265625 -0.649583 -0.649583 -0.649583 -0.109375 -0.140625 -0.296875 -0.535498 -0.535498 -0.535498 -0.109375 -0.140625 -0.265625 -3.13958 -3.13958 -3.13958 -0.015625 -0.109375 -0.390625 10.4875 10.4875 10.4875 -0.015625 -0.078125 -0.421875 -11.7796 -11.7796 -11.7796 -0.015625 -0.078125 -0.390625 2.42416 2.42416 2.42416 -0.046875 -0.109375 -0.390625 7.96237 7.96237 7.96237 -0.046875 -0.078125 -0.390625 17.7794 17.7794 17.7794 -0.015625 -0.046875 -0.421875 -15.1277 -15.1277 -15.1277 -0.015625 -0.046875 -0.390625 0.982938 0.982938 0.982938 -0.015625 -0.015625 -0.421875 -1.77155 -1.77155 -1.77155 -0.015625 -0.015625 -0.390625 -2.34997 -2.34997 -2.34997 -0.046875 -0.046875 -0.390625 2.00682 2.00682 2.00682 -0.046875 -0.015625 -0.390625 -2.07987 -2.07987 -2.07987 -0.078125 -0.109375 -0.390625 -0.571105 -0.571105 -0.571105 -0.078125 -0.078125 -0.390625 -0.366724 -0.366724 -0.366724 -0.109375 -0.109375 -0.390625 4.48915 4.48915 4.48915 -0.078125 -0.046875 -0.390625 -2.58048 -2.58048 -2.58048 -0.015625 -0.109375 -0.359375 -1.61171 -1.61171 -1.61171 -0.015625 -0.109375 -0.328125 -3.54158 -3.54158 -3.54158 -0.015625 -0.078125 -0.328125 -1.68355 -1.68355 -1.68355 -0.046875 -0.109375 -0.359375 -1.87373 -1.87373 -1.87373 -0.046875 -0.109375 -0.328125 -4.75346 -4.75346 -4.75346 -0.015625 -0.109375 -0.296875 -3.11454 -3.11454 -3.11454 -0.015625 -0.109375 -0.265625 -2.36302 -2.36302 -2.36302 -0.015625 -0.078125 -0.296875 -2.10667 -2.10667 -2.10667 -0.015625 -0.078125 -0.265625 -2.33371 -2.33371 -2.33371 -0.046875 -0.109375 -0.296875 -5.06729 -5.06729 -5.06729 -0.046875 -0.109375 -0.265625 -2.37102 -2.37102 -2.37102 -0.046875 -0.078125 -0.265625 -2.84907 -2.84907 -2.84907 -0.046875 -0.015625 -0.359375 -2.02378 -2.02378 -2.02378 -0.046875 -0.015625 -0.328125 -1.91068 -1.91068 -1.91068 -0.015625 -0.046875 -0.296875 -2.23165 -2.23165 -2.23165 -0.015625 -0.046875 -0.265625 -1.73625 -1.73625 -1.73625 -0.015625 -0.015625 -0.296875 -1.95971 -1.95971 -1.95971 -0.015625 -0.015625 -0.265625 -1.21875 -1.21875 -1.21875 -0.046875 -0.046875 -0.296875 -0.695459 -0.695459 -0.695459 -0.046875 -0.046875 -0.265625 -2.07942 -2.07942 -2.07942 -0.046875 -0.015625 -0.296875 -1.95126 -1.95126 -1.95126 -0.046875 -0.015625 -0.265625 -3.15041 -3.15041 -3.15041 -0.078125 -0.109375 -0.359375 -2.64906 -2.64906 -2.64906 -0.109375 -0.109375 -0.359375 -2.1859 -2.1859 -2.1859 -0.109375 -0.078125 -0.359375 -0.810485 -0.810485 -0.810485 -0.078125 -0.109375 -0.265625 -2.34505 -2.34505 -2.34505 -0.078125 -0.078125 -0.265625 -2.91502 -2.91502 -2.91502 -0.109375 -0.109375 -0.265625 0.50442 0.50442 0.50442 -0.109375 -0.078125 -0.265625 -0.543122 -0.543122 -0.543122 -0.078125 -0.046875 -0.359375 -2.11462 -2.11462 -2.11462 -0.078125 -0.046875 -0.328125 -1.99905 -1.99905 -1.99905 -0.078125 -0.015625 -0.359375 -1.87343 -1.87343 -1.87343 -0.078125 -0.015625 -0.328125 -1.31786 -1.31786 -1.31786 -0.109375 -0.046875 -0.359375 -0.377456 -0.377456 -0.377456 -0.109375 -0.046875 -0.328125 0.410659 0.410659 0.410659 -0.109375 -0.015625 -0.328125 -0.915358 -0.915358 -0.915358 -0.078125 -0.046875 -0.296875 -0.770801 -0.770801 -0.770801 -0.078125 -0.046875 -0.265625 -1.98339 -1.98339 -1.98339 -0.078125 -0.015625 -0.296875 -1.1738 -1.1738 -1.1738 -0.078125 -0.015625 -0.265625 -1.46903 -1.46903 -1.46903 -0.109375 -0.046875 -0.296875 0.0377302 0.0377302 0.0377302 -0.109375 -0.046875 -0.265625 -0.741291 -0.741291 -0.741291 -0.109375 -0.015625 -0.296875 -0.863138 -0.863138 -0.863138 -0.109375 -0.015625 -0.265625 -0.437725 -0.437725 -0.437725 -0.140625 -0.140625 -0.390625 -5.45935 -5.45935 -5.45935 -0.140625 -0.171875 -0.359375 2.05724 2.05724 2.05724 -0.140625 -0.171875 -0.328125 -4.44302 -4.44302 -4.44302 -0.140625 -0.140625 -0.359375 -1.75239 -1.75239 -1.75239 -0.140625 -0.140625 -0.328125 -1.80382 -1.80382 -1.80382 -0.140625 -0.140625 -0.296875 0.381719 0.381719 0.381719 -0.140625 -0.140625 -0.265625 -1.35761 -1.35761 -1.35761 -0.171875 -0.140625 -0.296875 7.01497 7.01497 7.01497 -0.171875 -0.140625 -0.265625 0.387572 0.387572 0.387572 -0.234375 -0.203125 -0.296875 -1.7179 -1.7179 -1.7179 -0.234375 -0.203125 -0.265625 -1.44476 -1.44476 -1.44476 -0.234375 -0.171875 -0.328125 -1.78839 -1.78839 -1.78839 -0.234375 -0.140625 -0.328125 -2.23097 -2.23097 -2.23097 -0.203125 -0.171875 -0.296875 -3.51893 -3.51893 -3.51893 -0.203125 -0.171875 -0.265625 -0.957909 -0.957909 -0.957909 -0.203125 -0.140625 -0.296875 -2.37703 -2.37703 -2.37703 -0.203125 -0.140625 -0.265625 -1.18877 -1.18877 -1.18877 -0.234375 -0.171875 -0.296875 -2.34922 -2.34922 -2.34922 -0.234375 -0.171875 -0.265625 -1.20787 -1.20787 -1.20787 -0.140625 -0.109375 -0.390625 -1.81355 -1.81355 -1.81355 -0.140625 -0.109375 -0.359375 -2.95656 -2.95656 -2.95656 -0.140625 -0.078125 -0.359375 -0.763509 -0.763509 -0.763509 -0.171875 -0.109375 -0.359375 -3.7524 -3.7524 -3.7524 -0.171875 -0.109375 -0.328125 1.07408 1.07408 1.07408 -0.171875 -0.078125 -0.359375 -1.27194 -1.27194 -1.27194 -0.171875 -0.078125 -0.328125 -0.90043 -0.90043 -0.90043 -0.140625 -0.109375 -0.265625 -2.19952 -2.19952 -2.19952 -0.140625 -0.078125 -0.296875 -1.90129 -1.90129 -1.90129 -0.140625 -0.078125 -0.265625 -0.657147 -0.657147 -0.657147 -0.171875 -0.109375 -0.296875 -4.34897 -4.34897 -4.34897 -0.171875 -0.109375 -0.265625 -1.48091 -1.48091 -1.48091 -0.171875 -0.078125 -0.296875 -2.34572 -2.34572 -2.34572 -0.171875 -0.078125 -0.265625 -2.46321 -2.46321 -2.46321 -0.140625 -0.046875 -0.359375 -0.848512 -0.848512 -0.848512 -0.140625 -0.046875 -0.328125 -1.35545 -1.35545 -1.35545 -0.140625 -0.015625 -0.328125 -2.48285 -2.48285 -2.48285 -0.171875 -0.046875 -0.359375 -0.447095 -0.447095 -0.447095 -0.171875 -0.046875 -0.328125 -2.02485 -2.02485 -2.02485 -0.140625 -0.046875 -0.296875 -1.32248 -1.32248 -1.32248 -0.140625 -0.015625 -0.296875 -1.75849 -1.75849 -1.75849 -0.140625 -0.015625 -0.265625 -0.696148 -0.696148 -0.696148 -0.171875 -0.015625 -0.296875 -0.94105 -0.94105 -0.94105 -0.171875 -0.015625 -0.265625 -1.46315 -1.46315 -1.46315 -0.203125 -0.109375 -0.265625 -4.42997 -4.42997 -4.42997 -0.203125 -0.078125 -0.296875 -2.5255 -2.5255 -2.5255 -0.203125 -0.078125 -0.265625 -0.435024 -0.435024 -0.435024 -0.234375 -0.109375 -0.296875 -0.755466 -0.755466 -0.755466 -0.234375 -0.109375 -0.265625 -4.01515 -4.01515 -4.01515 -0.234375 -0.078125 -0.296875 -1.74421 -1.74421 -1.74421 -0.203125 -0.046875 -0.265625 -1.09606 -1.09606 -1.09606 -0.203125 -0.015625 -0.265625 -1.20697 -1.20697 -1.20697 -0.234375 -0.046875 -0.296875 -2.21801 -2.21801 -2.21801 -0.234375 -0.046875 -0.265625 -0.672044 -0.672044 -0.672044 -0.234375 -0.015625 -0.265625 -0.556277 -0.556277 -0.556277 -0.015625 -0.140625 -0.234375 -0.843354 -0.843354 -0.843354 -0.046875 -0.171875 -0.140625 -1.47606 -1.47606 -1.47606 -0.046875 -0.140625 -0.140625 -2.09861 -2.09861 -2.09861 -0.109375 -0.234375 -0.203125 -0.89643 -0.89643 -0.89643 -0.109375 -0.203125 -0.203125 -1.88763 -1.88763 -1.88763 -0.078125 -0.234375 -0.140625 -0.984998 -0.984998 -0.984998 -0.078125 -0.203125 -0.140625 -1.35915 -1.35915 -1.35915 -0.109375 -0.234375 -0.171875 -1.29859 -1.29859 -1.29859 -0.109375 -0.234375 -0.140625 -2.06973 -2.06973 -2.06973 -0.109375 -0.203125 -0.171875 -2.34941 -2.34941 -2.34941 -0.109375 -0.203125 -0.140625 -1.03113 -1.03113 -1.03113 -0.109375 -0.171875 -0.234375 -1.9925 -1.9925 -1.9925 -0.109375 -0.171875 -0.203125 -1.1485 -1.1485 -1.1485 -0.109375 -0.140625 -0.203125 -2.17374 -2.17374 -2.17374 -0.078125 -0.171875 -0.140625 -1.93025 -1.93025 -1.93025 -0.078125 -0.140625 -0.171875 2.44085 2.44085 2.44085 -0.078125 -0.140625 -0.140625 -2.33529 -2.33529 -2.33529 -0.109375 -0.171875 -0.171875 -2.2443 -2.2443 -2.2443 -0.109375 -0.171875 -0.140625 -1.55321 -1.55321 -1.55321 -0.109375 -0.140625 -0.171875 -1.88995 -1.88995 -1.88995 -0.109375 -0.140625 -0.140625 -2.09243 -2.09243 -2.09243 -0.015625 -0.234375 -0.046875 -2.06652 -2.06652 -2.06652 -0.015625 -0.234375 -0.015625 -3.22924 -3.22924 -3.22924 -0.015625 -0.203125 -0.046875 -1.64737 -1.64737 -1.64737 -0.015625 -0.203125 -0.015625 -2.73561 -2.73561 -2.73561 -0.046875 -0.171875 -0.109375 -1.63005 -1.63005 -1.63005 -0.046875 -0.171875 -0.078125 -1.62393 -1.62393 -1.62393 -0.046875 -0.140625 -0.109375 -2.0844 -2.0844 -2.0844 -0.046875 -0.140625 -0.078125 -1.8619 -1.8619 -1.8619 -0.015625 -0.140625 -0.015625 -3.46372 -3.46372 -3.46372 -0.046875 -0.140625 -0.015625 -0.885685 -0.885685 -0.885685 -0.078125 -0.234375 -0.109375 -2.47899 -2.47899 -2.47899 -0.078125 -0.203125 -0.109375 -3.61769 -3.61769 -3.61769 -0.109375 -0.234375 -0.109375 -0.30067 -0.30067 -0.30067 -0.109375 -0.234375 -0.078125 -1.25558 -1.25558 -1.25558 -0.109375 -0.203125 -0.109375 1.00869 1.00869 1.00869 -0.109375 -0.203125 -0.078125 -3.28046 -3.28046 -3.28046 -0.078125 -0.171875 -0.109375 -1.92053 -1.92053 -1.92053 -0.078125 -0.171875 -0.078125 -1.37807 -1.37807 -1.37807 -0.078125 -0.140625 -0.078125 -1.71477 -1.71477 -1.71477 -0.109375 -0.171875 -0.109375 -2.07487 -2.07487 -2.07487 -0.109375 -0.171875 -0.078125 -0.58817 -0.58817 -0.58817 -0.109375 -0.140625 -0.078125 -0.913664 -0.913664 -0.913664 -0.078125 -0.171875 -0.046875 -1.53373 -1.53373 -1.53373 -0.078125 -0.171875 -0.015625 -1.92907 -1.92907 -1.92907 -0.078125 -0.140625 -0.046875 -1.9711 -1.9711 -1.9711 -0.078125 -0.140625 -0.015625 -2.07043 -2.07043 -2.07043 -0.109375 -0.171875 -0.046875 -1.06862 -1.06862 -1.06862 -0.109375 -0.171875 -0.015625 2.63528 2.63528 2.63528 -0.109375 -0.140625 -0.046875 -1.15226 -1.15226 -1.15226 -0.015625 -0.109375 -0.234375 -2.21456 -2.21456 -2.21456 -0.015625 -0.109375 -0.203125 6.90221 6.90221 6.90221 -0.015625 -0.078125 -0.234375 -1.96515 -1.96515 -1.96515 -0.015625 -0.078125 -0.203125 -0.613911 -0.613911 -0.613911 -0.046875 -0.078125 -0.203125 6.7624 6.7624 6.7624 -0.015625 -0.109375 -0.171875 -3.61226 -3.61226 -3.61226 -0.015625 -0.078125 -0.171875 -9.37172 -9.37172 -9.37172 -0.046875 -0.109375 -0.140625 -2.84624 -2.84624 -2.84624 -0.046875 -0.078125 -0.171875 -16.1822 -16.1822 -16.1822 -0.015625 -0.046875 -0.234375 -2.10076 -2.10076 -2.10076 -0.015625 -0.046875 -0.203125 -2.03947 -2.03947 -2.03947 -0.015625 -0.015625 -0.234375 -2.01892 -2.01892 -2.01892 -0.015625 -0.015625 -0.203125 -1.83079 -1.83079 -1.83079 -0.046875 -0.046875 -0.234375 -2.12589 -2.12589 -2.12589 -0.046875 -0.046875 -0.203125 0.47553 0.47553 0.47553 -0.046875 -0.015625 -0.234375 -1.38388 -1.38388 -1.38388 -0.046875 -0.015625 -0.203125 -2.27975 -2.27975 -2.27975 -0.015625 -0.046875 -0.171875 -5.27491 -5.27491 -5.27491 -0.015625 -0.046875 -0.140625 -23.4942 -23.4942 -23.4942 -0.015625 -0.015625 -0.171875 -0.401479 -0.401479 -0.401479 -0.015625 -0.015625 -0.140625 -35.0799 -35.0799 -35.0799 -0.046875 -0.046875 -0.171875 -10.7148 -10.7148 -10.7148 -0.046875 -0.015625 -0.171875 -1.21877 -1.21877 -1.21877 -0.046875 -0.015625 -0.140625 -60.5072 -60.5072 -60.5072 -0.078125 -0.078125 -0.234375 -1.2626 -1.2626 -1.2626 -0.078125 -0.078125 -0.203125 0.221526 0.221526 0.221526 -0.109375 -0.078125 -0.234375 -2.31 -2.31 -2.31 -0.109375 -0.078125 -0.203125 -1.80435 -1.80435 -1.80435 -0.078125 -0.109375 -0.171875 0.947684 0.947684 0.947684 -0.078125 -0.109375 -0.140625 -0.259673 -0.259673 -0.259673 -0.078125 -0.078125 -0.171875 -0.229901 -0.229901 -0.229901 -0.078125 -0.078125 -0.140625 11.2579 11.2579 11.2579 -0.109375 -0.109375 -0.171875 0.0711059 0.0711059 0.0711059 -0.109375 -0.109375 -0.140625 -2.22078 -2.22078 -2.22078 -0.109375 -0.078125 -0.171875 -2.26768 -2.26768 -2.26768 -0.109375 -0.078125 -0.140625 -1.8751 -1.8751 -1.8751 -0.078125 -0.046875 -0.234375 -1.50909 -1.50909 -1.50909 -0.078125 -0.015625 -0.234375 -1.53919 -1.53919 -1.53919 -0.078125 -0.015625 -0.203125 -1.4828 -1.4828 -1.4828 -0.109375 -0.046875 -0.234375 -2.02064 -2.02064 -2.02064 -0.109375 -0.015625 -0.234375 -1.76375 -1.76375 -1.76375 -0.109375 -0.015625 -0.203125 -1.96159 -1.96159 -1.96159 -0.078125 -0.046875 -0.171875 -5.66852 -5.66852 -5.66852 -0.078125 -0.046875 -0.140625 6.55795 6.55795 6.55795 -0.078125 -0.015625 -0.171875 -1.91325 -1.91325 -1.91325 -0.078125 -0.015625 -0.140625 -0.747134 -0.747134 -0.747134 -0.109375 -0.046875 -0.171875 -2.20361 -2.20361 -2.20361 -0.109375 -0.046875 -0.140625 -1.86129 -1.86129 -1.86129 -0.109375 -0.015625 -0.171875 -1.7801 -1.7801 -1.7801 -0.109375 -0.015625 -0.140625 -0.748152 -0.748152 -0.748152 -0.015625 -0.078125 -0.109375 -2.05798 -2.05798 -2.05798 -0.015625 -0.078125 -0.078125 -1.72795 -1.72795 -1.72795 -0.046875 -0.109375 -0.109375 -2.13122 -2.13122 -2.13122 -0.046875 -0.109375 -0.078125 -1.82858 -1.82858 -1.82858 -0.015625 -0.109375 -0.015625 -2.62171 -2.62171 -2.62171 -0.015625 -0.078125 -0.015625 -1.35282 -1.35282 -1.35282 -0.046875 -0.109375 -0.046875 -0.874916 -0.874916 -0.874916 -0.046875 -0.109375 -0.015625 -0.972409 -0.972409 -0.972409 -0.046875 -0.078125 -0.015625 -1.4178 -1.4178 -1.4178 -0.015625 -0.046875 -0.109375 15.2029 15.2029 15.2029 -0.015625 -0.046875 -0.078125 -1.30983 -1.30983 -1.30983 -0.015625 -0.015625 -0.109375 81.5945 81.5945 81.5945 -0.015625 -0.015625 -0.078125 0.0108929 0.0108929 0.0108929 -0.046875 -0.015625 -0.078125 18.0678 18.0678 18.0678 -0.015625 -0.046875 -0.046875 -0.885973 -0.885973 -0.885973 -0.015625 -0.046875 -0.015625 -0.305204 -0.305204 -0.305204 -0.015625 -0.015625 -0.046875 -1.0466 -1.0466 -1.0466 -0.015625 -0.015625 -0.015625 -1.31069 -1.31069 -1.31069 -0.046875 -0.046875 -0.015625 -0.37903 -0.37903 -0.37903 -0.046875 -0.015625 -0.046875 -0.725899 -0.725899 -0.725899 -0.046875 -0.015625 -0.015625 -0.944495 -0.944495 -0.944495 -0.078125 -0.109375 -0.109375 -2.02818 -2.02818 -2.02818 -0.078125 -0.109375 -0.078125 -2.00074 -2.00074 -2.00074 -0.078125 -0.078125 -0.109375 -2.01454 -2.01454 -2.01454 -0.078125 -0.078125 -0.078125 -1.94934 -1.94934 -1.94934 -0.109375 -0.109375 -0.109375 -1.80525 -1.80525 -1.80525 -0.109375 -0.109375 -0.078125 -0.821115 -0.821115 -0.821115 -0.109375 -0.078125 -0.109375 -1.70381 -1.70381 -1.70381 -0.109375 -0.078125 -0.078125 -1.52823 -1.52823 -1.52823 -0.078125 -0.109375 -0.046875 -1.94991 -1.94991 -1.94991 -0.078125 -0.078125 -0.046875 -1.85609 -1.85609 -1.85609 -0.078125 -0.078125 -0.015625 -2.07045 -2.07045 -2.07045 -0.109375 -0.109375 -0.046875 -1.3911 -1.3911 -1.3911 -0.109375 -0.078125 -0.046875 -1.80444 -1.80444 -1.80444 -0.109375 -0.078125 -0.015625 -2.08882 -2.08882 -2.08882 -0.078125 -0.046875 -0.109375 -0.73365 -0.73365 -0.73365 -0.078125 -0.015625 -0.109375 -0.79093 -0.79093 -0.79093 -0.078125 -0.015625 -0.078125 -0.965632 -0.965632 -0.965632 -0.109375 -0.046875 -0.109375 -0.891174 -0.891174 -0.891174 -0.109375 -0.046875 -0.078125 -0.980643 -0.980643 -0.980643 -0.109375 -0.015625 -0.078125 -1.25213 -1.25213 -1.25213 -0.078125 -0.046875 -0.046875 -0.741106 -0.741106 -0.741106 -0.078125 -0.046875 -0.015625 -1.25458 -1.25458 -1.25458 -0.078125 -0.015625 -0.046875 -1.33645 -1.33645 -1.33645 -0.109375 -0.046875 -0.046875 -0.770018 -0.770018 -0.770018 -0.109375 -0.046875 -0.015625 -0.982389 -0.982389 -0.982389 -0.109375 -0.015625 -0.046875 -0.79547 -0.79547 -0.79547 -0.109375 -0.015625 -0.015625 -1.86598 -1.86598 -1.86598 -0.140625 -0.234375 -0.203125 -1.55059 -1.55059 -1.55059 -0.140625 -0.203125 -0.234375 -45.9678 -45.9678 -45.9678 -0.140625 -0.203125 -0.203125 -1.39907 -1.39907 -1.39907 -0.171875 -0.234375 -0.203125 -0.175079 -0.175079 -0.175079 -0.171875 -0.203125 -0.234375 -1.27039 -1.27039 -1.27039 -0.171875 -0.203125 -0.203125 -1.80415 -1.80415 -1.80415 -0.140625 -0.234375 -0.171875 -0.356602 -0.356602 -0.356602 -0.140625 -0.234375 -0.140625 0.0752969 0.0752969 0.0752969 -0.171875 -0.234375 -0.171875 -3.52962 -3.52962 -3.52962 -0.171875 -0.234375 -0.140625 -1.35206 -1.35206 -1.35206 -0.140625 -0.171875 -0.234375 7.06217 7.06217 7.06217 -0.140625 -0.140625 -0.203125 -1.5478 -1.5478 -1.5478 -0.171875 -0.171875 -0.234375 -1.92421 -1.92421 -1.92421 -0.171875 -0.171875 -0.203125 -1.52077 -1.52077 -1.52077 -0.171875 -0.140625 -0.203125 -1.53978 -1.53978 -1.53978 -0.140625 -0.140625 -0.171875 0.730128 0.730128 0.730128 -0.140625 -0.140625 -0.140625 0.0382702 0.0382702 0.0382702 -0.171875 -0.171875 -0.171875 -2.56049 -2.56049 -2.56049 -0.171875 -0.140625 -0.171875 -1.38147 -1.38147 -1.38147 -0.171875 -0.140625 -0.140625 -1.66841 -1.66841 -1.66841 -0.203125 -0.203125 -0.203125 -1.77394 -1.77394 -1.77394 -0.234375 -0.203125 -0.234375 -1.22503 -1.22503 -1.22503 -0.203125 -0.234375 -0.171875 -2.95671 -2.95671 -2.95671 -0.203125 -0.234375 -0.140625 -2.19951 -2.19951 -2.19951 -0.203125 -0.203125 -0.171875 -3.20516 -3.20516 -3.20516 -0.234375 -0.234375 -0.171875 -1.62934 -1.62934 -1.62934 -0.234375 -0.234375 -0.140625 -3.54212 -3.54212 -3.54212 -0.234375 -0.203125 -0.171875 -2.04859 -2.04859 -2.04859 -0.234375 -0.203125 -0.140625 -3.37451 -3.37451 -3.37451 -0.203125 -0.171875 -0.203125 -1.17458 -1.17458 -1.17458 -0.203125 -0.140625 -0.203125 -1.243 -1.243 -1.243 -0.234375 -0.171875 -0.234375 -1.35581 -1.35581 -1.35581 -0.234375 -0.140625 -0.234375 1.19876 1.19876 1.19876 -0.234375 -0.140625 -0.203125 -1.3667 -1.3667 -1.3667 -0.203125 -0.171875 -0.171875 -3.34521 -3.34521 -3.34521 -0.203125 -0.140625 -0.171875 -3.18467 -3.18467 -3.18467 -0.203125 -0.140625 -0.140625 -0.0680038 -0.0680038 -0.0680038 -0.234375 -0.171875 -0.171875 -1.8098 -1.8098 -1.8098 -0.234375 -0.171875 -0.140625 -3.02054 -3.02054 -3.02054 -0.234375 -0.140625 -0.171875 -0.970195 -0.970195 -0.970195 -0.234375 -0.140625 -0.140625 -1.40255 -1.40255 -1.40255 -0.140625 -0.234375 -0.078125 -0.0215722 -0.0215722 -0.0215722 -0.140625 -0.203125 -0.078125 -1.14655 -1.14655 -1.14655 -0.171875 -0.234375 -0.109375 -0.796488 -0.796488 -0.796488 -0.171875 -0.234375 -0.078125 -2.83199 -2.83199 -2.83199 -0.171875 -0.203125 -0.078125 1.37082 1.37082 1.37082 -0.171875 -0.203125 -0.046875 1.25103 1.25103 1.25103 -0.140625 -0.171875 -0.109375 -1.11043 -1.11043 -1.11043 -0.140625 -0.171875 -0.078125 -1.24784 -1.24784 -1.24784 -0.140625 -0.140625 -0.109375 -1.00128 -1.00128 -1.00128 -0.171875 -0.171875 -0.109375 -0.620675 -0.620675 -0.620675 -0.171875 -0.171875 -0.078125 -1.6325 -1.6325 -1.6325 -0.171875 -0.140625 -0.109375 -2.35289 -2.35289 -2.35289 -0.140625 -0.171875 -0.046875 -1.91037 -1.91037 -1.91037 -0.140625 -0.171875 -0.015625 -2.38039 -2.38039 -2.38039 -0.171875 -0.171875 -0.046875 -1.88608 -1.88608 -1.88608 -0.171875 -0.171875 -0.015625 -1.6343 -1.6343 -1.6343 -0.203125 -0.234375 -0.109375 -0.705903 -0.705903 -0.705903 -0.203125 -0.234375 -0.078125 -3.20746 -3.20746 -3.20746 -0.234375 -0.234375 -0.109375 -1.78758 -1.78758 -1.78758 -0.234375 -0.234375 -0.078125 1.59204 1.59204 1.59204 -0.234375 -0.203125 -0.109375 -2.66126 -2.66126 -2.66126 -0.234375 -0.203125 -0.078125 -2.93068 -2.93068 -2.93068 -0.203125 -0.234375 -0.046875 -3.01705 -3.01705 -3.01705 -0.203125 -0.203125 -0.046875 -2.56061 -2.56061 -2.56061 -0.234375 -0.203125 -0.046875 -5.17885 -5.17885 -5.17885 -0.234375 -0.171875 -0.109375 -2.36919 -2.36919 -2.36919 -0.234375 -0.140625 -0.109375 -2.19695 -2.19695 -2.19695 -0.234375 -0.140625 -0.078125 -2.55413 -2.55413 -2.55413 -0.203125 -0.171875 -0.046875 -2.0459 -2.0459 -2.0459 -0.203125 -0.171875 -0.015625 -1.46979 -1.46979 -1.46979 -0.203125 -0.140625 -0.015625 -1.88126 -1.88126 -1.88126 -0.234375 -0.171875 -0.046875 -0.323112 -0.323112 -0.323112 -0.234375 -0.140625 -0.046875 -1.73978 -1.73978 -1.73978 -0.234375 -0.140625 -0.015625 3.47254 3.47254 3.47254 -0.140625 -0.078125 -0.203125 -2.17108 -2.17108 -2.17108 -0.140625 -0.109375 -0.171875 -1.44031 -1.44031 -1.44031 -0.140625 -0.109375 -0.140625 -1.56409 -1.56409 -1.56409 -0.140625 -0.078125 -0.171875 -1.83482 -1.83482 -1.83482 -0.140625 -0.078125 -0.140625 -1.39805 -1.39805 -1.39805 -0.171875 -0.109375 -0.171875 -1.57075 -1.57075 -1.57075 -0.171875 -0.078125 -0.171875 -1.10519 -1.10519 -1.10519 -0.140625 -0.046875 -0.234375 -2.02805 -2.02805 -2.02805 -0.140625 -0.046875 -0.203125 -2.15694 -2.15694 -2.15694 -0.140625 -0.015625 -0.234375 -1.88606 -1.88606 -1.88606 -0.140625 -0.015625 -0.203125 -1.7561 -1.7561 -1.7561 -0.171875 -0.015625 -0.234375 -1.73474 -1.73474 -1.73474 -0.171875 -0.015625 -0.203125 -1.77061 -1.77061 -1.77061 -0.140625 -0.046875 -0.171875 -2.03975 -2.03975 -2.03975 -0.140625 -0.046875 -0.140625 -1.28679 -1.28679 -1.28679 -0.140625 -0.015625 -0.171875 -1.66023 -1.66023 -1.66023 -0.140625 -0.015625 -0.140625 -0.721076 -0.721076 -0.721076 -0.171875 -0.046875 -0.171875 -0.371463 -0.371463 -0.371463 -0.171875 -0.046875 -0.140625 0.773232 0.773232 0.773232 -0.171875 -0.015625 -0.171875 0.67313 0.67313 0.67313 -0.171875 -0.015625 -0.140625 -1.05674 -1.05674 -1.05674 -0.203125 -0.109375 -0.203125 -1.24234 -1.24234 -1.24234 -0.203125 -0.078125 -0.234375 -2.61563 -2.61563 -2.61563 -0.203125 -0.078125 -0.203125 -1.64361 -1.64361 -1.64361 -0.234375 -0.109375 -0.234375 0.0261398 0.0261398 0.0261398 -0.234375 -0.109375 -0.203125 -1.64149 -1.64149 -1.64149 -0.234375 -0.078125 -0.234375 -0.0373033 -0.0373033 -0.0373033 -0.234375 -0.078125 -0.203125 -1.64328 -1.64328 -1.64328 -0.203125 -0.109375 -0.171875 -1.27362 -1.27362 -1.27362 -0.203125 -0.078125 -0.171875 -1.52003 -1.52003 -1.52003 -0.234375 -0.109375 -0.140625 -0.965813 -0.965813 -0.965813 -0.203125 -0.015625 -0.234375 -0.789733 -0.789733 -0.789733 -0.203125 -0.015625 -0.203125 -1.29045 -1.29045 -1.29045 -0.234375 -0.046875 -0.234375 -1.11261 -1.11261 -1.11261 -0.234375 -0.046875 -0.203125 -2.96304 -2.96304 -2.96304 -0.234375 -0.015625 -0.234375 -1.71246 -1.71246 -1.71246 -0.234375 -0.015625 -0.203125 -6.56209 -6.56209 -6.56209 -0.203125 -0.046875 -0.171875 -4.09591 -4.09591 -4.09591 -0.203125 -0.046875 -0.140625 -0.753279 -0.753279 -0.753279 -0.203125 -0.015625 -0.171875 -1.94057 -1.94057 -1.94057 -0.203125 -0.015625 -0.140625 -0.569119 -0.569119 -0.569119 -0.234375 -0.015625 -0.171875 2.11381 2.11381 2.11381 -0.140625 -0.109375 -0.109375 -1.08016 -1.08016 -1.08016 -0.140625 -0.109375 -0.078125 -1.20078 -1.20078 -1.20078 -0.140625 -0.078125 -0.109375 -1.44771 -1.44771 -1.44771 -0.140625 -0.078125 -0.078125 -1.39095 -1.39095 -1.39095 -0.171875 -0.078125 -0.078125 -2.31323 -2.31323 -2.31323 -0.140625 -0.078125 -0.046875 -1.64607 -1.64607 -1.64607 -0.140625 -0.078125 -0.015625 -2.52416 -2.52416 -2.52416 -0.171875 -0.078125 -0.046875 -1.79276 -1.79276 -1.79276 -0.171875 -0.078125 -0.015625 -2.93495 -2.93495 -2.93495 -0.140625 -0.046875 -0.109375 -1.14784 -1.14784 -1.14784 -0.140625 -0.046875 -0.078125 -0.823866 -0.823866 -0.823866 -0.171875 -0.046875 -0.109375 -0.525238 -0.525238 -0.525238 -0.171875 -0.046875 -0.078125 -0.956608 -0.956608 -0.956608 -0.171875 -0.015625 -0.109375 -0.766774 -0.766774 -0.766774 -0.171875 -0.015625 -0.078125 -1.19695 -1.19695 -1.19695 -0.140625 -0.046875 -0.046875 -0.758471 -0.758471 -0.758471 -0.140625 -0.015625 -0.046875 -0.703393 -0.703393 -0.703393 -0.140625 -0.015625 -0.015625 -1.37965 -1.37965 -1.37965 -0.171875 -0.046875 -0.046875 -0.985199 -0.985199 -0.985199 -0.171875 -0.046875 -0.015625 -2.20659 -2.20659 -2.20659 -0.171875 -0.015625 -0.046875 -0.905014 -0.905014 -0.905014 -0.234375 -0.109375 -0.109375 -2.85772 -2.85772 -2.85772 -0.234375 -0.109375 -0.078125 -5.2557 -5.2557 -5.2557 -0.203125 -0.109375 -0.046875 -1.52548 -1.52548 -1.52548 -0.203125 -0.109375 -0.015625 -1.52322 -1.52322 -1.52322 -0.203125 -0.078125 -0.046875 -1.6868 -1.6868 -1.6868 -0.203125 -0.078125 -0.015625 -0.874925 -0.874925 -0.874925 -0.234375 -0.109375 -0.046875 -7.12839 -7.12839 -7.12839 -0.234375 -0.109375 -0.015625 -2.21255 -2.21255 -2.21255 -0.234375 -0.078125 -0.046875 -1.24634 -1.24634 -1.24634 -0.234375 -0.078125 -0.015625 -2.26659 -2.26659 -2.26659 -0.203125 -0.046875 -0.109375 -0.936434 -0.936434 -0.936434 -0.203125 -0.046875 -0.078125 -1.65836 -1.65836 -1.65836 -0.203125 -0.015625 -0.109375 -2.5696 -2.5696 -2.5696 -0.203125 -0.015625 -0.078125 -1.31364 -1.31364 -1.31364 -0.234375 -0.046875 -0.078125 -0.992984 -0.992984 -0.992984 -0.234375 -0.015625 -0.109375 -1.99191 -1.99191 -1.99191 -0.234375 -0.015625 -0.078125 -1.48754 -1.48754 -1.48754 -0.203125 -0.046875 -0.046875 -1.77249 -1.77249 -1.77249 -0.203125 -0.046875 -0.015625 -1.70064 -1.70064 -1.70064 -0.203125 -0.015625 -0.046875 -1.86604 -1.86604 -1.86604 -0.234375 -0.046875 -0.046875 0.364104 0.364104 0.364104 -0.234375 -0.046875 -0.015625 -0.2928 -0.2928 -0.2928 -0.234375 -0.015625 -0.046875 -1.93018 -1.93018 -1.93018 -0.234375 -0.015625 -0.015625 -1.73248 -1.73248 -1.73248 -0.265625 -0.203125 -0.328125 -1.73236 -1.73236 -1.73236 -0.265625 -0.203125 -0.296875 0.0283677 0.0283677 0.0283677 -0.265625 -0.203125 -0.265625 -0.474187 -0.474187 -0.474187 -0.296875 -0.203125 -0.296875 -0.809238 -0.809238 -0.809238 -0.296875 -0.203125 -0.265625 -0.134867 -0.134867 -0.134867 -0.265625 -0.171875 -0.328125 -0.48196 -0.48196 -0.48196 -0.265625 -0.140625 -0.328125 -1.65608 -1.65608 -1.65608 -0.296875 -0.171875 -0.328125 -2.47632 -2.47632 -2.47632 -0.296875 -0.140625 -0.328125 -0.0830811 -0.0830811 -0.0830811 -0.296875 -0.171875 -0.296875 -3.52749 -3.52749 -3.52749 -0.296875 -0.171875 -0.265625 -3.02297 -3.02297 -3.02297 -0.296875 -0.140625 -0.296875 -2.64804 -2.64804 -2.64804 -0.328125 -0.140625 -0.296875 -3.00841 -3.00841 -3.00841 -0.328125 -0.140625 -0.265625 -5.07044 -5.07044 -5.07044 -0.359375 -0.171875 -0.265625 -1.04413 -1.04413 -1.04413 -0.359375 -0.140625 -0.265625 -1.27722 -1.27722 -1.27722 -0.265625 -0.109375 -0.328125 1.04964 1.04964 1.04964 -0.296875 -0.109375 -0.328125 -2.2476 -2.2476 -2.2476 -0.265625 -0.109375 -0.296875 0.711057 0.711057 0.711057 -0.265625 -0.078125 -0.296875 -3.22922 -3.22922 -3.22922 -0.296875 -0.109375 -0.296875 -2.95865 -2.95865 -2.95865 -0.296875 -0.078125 -0.296875 -1.54022 -1.54022 -1.54022 -0.296875 -0.078125 -0.265625 3.4201 3.4201 3.4201 -0.265625 -0.046875 -0.296875 -2.25804 -2.25804 -2.25804 -0.265625 -0.015625 -0.265625 -1.63889 -1.63889 -1.63889 -0.296875 -0.046875 -0.296875 -1.28741 -1.28741 -1.28741 -0.296875 -0.046875 -0.265625 -4.47402 -4.47402 -4.47402 -0.296875 -0.015625 -0.265625 -1.02432 -1.02432 -1.02432 -0.328125 -0.109375 -0.296875 -2.5445 -2.5445 -2.5445 -0.328125 -0.109375 -0.265625 -1.83904 -1.83904 -1.83904 -0.328125 -0.078125 -0.296875 -2.3501 -2.3501 -2.3501 -0.328125 -0.078125 -0.265625 -4.71802 -4.71802 -4.71802 -0.359375 -0.109375 -0.265625 -2.72417 -2.72417 -2.72417 -0.359375 -0.015625 -0.328125 -1.74709 -1.74709 -1.74709 -0.328125 -0.015625 -0.296875 -1.83949 -1.83949 -1.83949 -0.328125 -0.015625 -0.265625 -3.21543 -3.21543 -3.21543 -0.359375 -0.046875 -0.296875 -1.66623 -1.66623 -1.66623 -0.359375 -0.046875 -0.265625 -53.1258 -53.1258 -53.1258 -0.359375 -0.015625 -0.296875 -2.14233 -2.14233 -2.14233 -0.359375 -0.015625 -0.265625 -1.55208 -1.55208 -1.55208 -0.390625 -0.140625 -0.265625 -0.48725 -0.48725 -0.48725 -0.390625 -0.015625 -0.328125 -1.96114 -1.96114 -1.96114 -0.421875 -0.015625 -0.328125 -1.79026 -1.79026 -1.79026 -0.390625 -0.046875 -0.296875 -1.70706 -1.70706 -1.70706 -0.390625 -0.046875 -0.265625 -1.73338 -1.73338 -1.73338 -0.390625 -0.015625 -0.296875 -2.08152 -2.08152 -2.08152 -0.421875 -0.046875 -0.296875 -1.55404 -1.55404 -1.55404 -0.421875 -0.046875 -0.265625 -1.60538 -1.60538 -1.60538 -0.421875 -0.015625 -0.296875 -2.0948 -2.0948 -2.0948 -0.453125 -0.046875 -0.265625 -1.86982 -1.86982 -1.86982 -0.453125 -0.015625 -0.296875 -1.89226 -1.89226 -1.89226 -0.453125 -0.015625 -0.265625 -2.05385 -2.05385 -2.05385 -0.265625 -0.203125 -0.234375 -1.30032 -1.30032 -1.30032 -0.296875 -0.203125 -0.234375 -1.99533 -1.99533 -1.99533 -0.265625 -0.203125 -0.140625 -0.498952 -0.498952 -0.498952 -0.265625 -0.171875 -0.234375 -1.51964 -1.51964 -1.51964 -0.265625 -0.171875 -0.203125 -2.38954 -2.38954 -2.38954 -0.265625 -0.140625 -0.203125 -2.25185 -2.25185 -2.25185 -0.296875 -0.171875 -0.234375 -1.91271 -1.91271 -1.91271 -0.296875 -0.171875 -0.203125 -2.71193 -2.71193 -2.71193 -0.265625 -0.171875 -0.171875 -2.44853 -2.44853 -2.44853 -0.265625 -0.171875 -0.140625 -1.85384 -1.85384 -1.85384 -0.265625 -0.140625 -0.171875 -1.18602 -1.18602 -1.18602 -0.265625 -0.140625 -0.140625 -0.97491 -0.97491 -0.97491 -0.296875 -0.171875 -0.171875 -2.67955 -2.67955 -2.67955 -0.296875 -0.140625 -0.171875 -2.56871 -2.56871 -2.56871 -0.296875 -0.140625 -0.140625 -1.43855 -1.43855 -1.43855 -0.328125 -0.203125 -0.234375 -0.998818 -0.998818 -0.998818 -0.328125 -0.203125 -0.203125 -1.17845 -1.17845 -1.17845 -0.359375 -0.203125 -0.234375 -0.891188 -0.891188 -0.891188 -0.359375 -0.203125 -0.203125 -1.49658 -1.49658 -1.49658 -0.328125 -0.203125 -0.171875 -1.46225 -1.46225 -1.46225 -0.359375 -0.203125 -0.171875 -1.42438 -1.42438 -1.42438 -0.328125 -0.171875 -0.234375 -1.15402 -1.15402 -1.15402 -0.328125 -0.171875 -0.203125 -1.33307 -1.33307 -1.33307 -0.328125 -0.140625 -0.234375 -2.68397 -2.68397 -2.68397 -0.359375 -0.171875 -0.234375 -1.58648 -1.58648 -1.58648 -0.328125 -0.171875 -0.171875 -1.50214 -1.50214 -1.50214 -0.328125 -0.140625 -0.171875 -2.60771 -2.60771 -2.60771 -0.328125 -0.140625 -0.140625 -1.48021 -1.48021 -1.48021 -0.359375 -0.171875 -0.171875 -1.62507 -1.62507 -1.62507 -0.359375 -0.140625 -0.171875 -1.43505 -1.43505 -1.43505 -0.359375 -0.140625 -0.140625 -0.716753 -0.716753 -0.716753 -0.265625 -0.203125 -0.109375 -1.06044 -1.06044 -1.06044 -0.265625 -0.203125 -0.078125 5.73429 5.73429 5.73429 -0.265625 -0.203125 -0.046875 -13.7197 -13.7197 -13.7197 -0.265625 -0.171875 -0.109375 -2.58046 -2.58046 -2.58046 -0.265625 -0.171875 -0.078125 -4.43225 -4.43225 -4.43225 -0.265625 -0.140625 -0.109375 -0.797379 -0.797379 -0.797379 -0.265625 -0.140625 -0.078125 -5.58209 -5.58209 -5.58209 -0.296875 -0.140625 -0.109375 -1.3662 -1.3662 -1.3662 -0.296875 -0.140625 -0.078125 24.1243 24.1243 24.1243 -0.265625 -0.171875 -0.046875 -8.04235 -8.04235 -8.04235 -0.265625 -0.140625 -0.046875 -7.31224 -7.31224 -7.31224 -0.265625 -0.140625 -0.015625 -63.8344 -63.8344 -63.8344 -0.296875 -0.140625 -0.046875 -24.4461 -24.4461 -24.4461 -0.296875 -0.140625 -0.015625 -68.4695 -68.4695 -68.4695 -0.328125 -0.140625 -0.109375 -2.00117 -2.00117 -2.00117 -0.328125 -0.140625 -0.078125 9.17856 9.17856 9.17856 -0.359375 -0.171875 -0.109375 -2.82986 -2.82986 -2.82986 -0.359375 -0.140625 -0.109375 -1.26923 -1.26923 -1.26923 -0.359375 -0.140625 -0.078125 -12.8146 -12.8146 -12.8146 -0.328125 -0.140625 -0.046875 20.8514 20.8514 20.8514 -0.328125 -0.140625 -0.015625 33.9299 33.9299 33.9299 -0.359375 -0.140625 -0.046875 16.6643 16.6643 16.6643 -0.359375 -0.140625 -0.015625 -48.4173 -48.4173 -48.4173 -0.296875 -0.078125 -0.234375 1.63183 1.63183 1.63183 -0.265625 -0.109375 -0.140625 -0.738471 -0.738471 -0.738471 -0.296875 -0.109375 -0.171875 -1.88213 -1.88213 -1.88213 -0.296875 -0.109375 -0.140625 -2.49056 -2.49056 -2.49056 -0.296875 -0.078125 -0.140625 -3.04787 -3.04787 -3.04787 -0.265625 -0.046875 -0.234375 -4.18964 -4.18964 -4.18964 -0.265625 -0.015625 -0.234375 -1.89746 -1.89746 -1.89746 -0.265625 -0.015625 -0.203125 11.4679 11.4679 11.4679 -0.296875 -0.046875 -0.234375 -3.23097 -3.23097 -3.23097 -0.296875 -0.015625 -0.234375 -0.782079 -0.782079 -0.782079 -0.265625 -0.015625 -0.171875 5.54988 5.54988 5.54988 -0.265625 -0.015625 -0.140625 -13.4173 -13.4173 -13.4173 -0.296875 -0.046875 -0.140625 -1.76778 -1.76778 -1.76778 -0.296875 -0.015625 -0.171875 -2.42151 -2.42151 -2.42151 -0.296875 -0.015625 -0.140625 7.51038 7.51038 7.51038 -0.328125 -0.109375 -0.234375 0.189513 0.189513 0.189513 -0.328125 -0.078125 -0.234375 0.845487 0.845487 0.845487 -0.359375 -0.109375 -0.234375 -2.1039 -2.1039 -2.1039 -0.359375 -0.078125 -0.234375 -1.90498 -1.90498 -1.90498 -0.328125 -0.109375 -0.171875 -2.82072 -2.82072 -2.82072 -0.328125 -0.109375 -0.140625 -1.77227 -1.77227 -1.77227 -0.328125 -0.078125 -0.171875 -1.4783 -1.4783 -1.4783 -0.328125 -0.078125 -0.140625 -1.52359 -1.52359 -1.52359 -0.359375 -0.109375 -0.140625 -2.90296 -2.90296 -2.90296 -0.328125 -0.046875 -0.234375 -4.89069 -4.89069 -4.89069 -0.328125 -0.015625 -0.234375 -4.26832 -4.26832 -4.26832 -0.359375 -0.046875 -0.234375 4.50612 4.50612 4.50612 -0.328125 -0.046875 -0.171875 -1.93625 -1.93625 -1.93625 -0.328125 -0.046875 -0.140625 -1.07534 -1.07534 -1.07534 -0.328125 -0.015625 -0.171875 -2.70144 -2.70144 -2.70144 -0.328125 -0.015625 -0.140625 -1.26549 -1.26549 -1.26549 -0.359375 -0.046875 -0.171875 -4.2997 -4.2997 -4.2997 -0.359375 -0.046875 -0.140625 -0.896493 -0.896493 -0.896493 -0.359375 -0.015625 -0.171875 0.0441806 0.0441806 0.0441806 -0.359375 -0.015625 -0.140625 -1.09591 -1.09591 -1.09591 -0.265625 -0.109375 -0.109375 -1.10556 -1.10556 -1.10556 -0.265625 -0.109375 -0.078125 -9.92929 -9.92929 -9.92929 -0.265625 -0.078125 -0.109375 -2.1913 -2.1913 -2.1913 -0.296875 -0.109375 -0.109375 -1.89261 -1.89261 -1.89261 -0.296875 -0.078125 -0.109375 -1.24826 -1.24826 -1.24826 -0.296875 -0.078125 -0.078125 3.50427 3.50427 3.50427 -0.265625 -0.109375 -0.046875 -4.99865 -4.99865 -4.99865 -0.265625 -0.109375 -0.015625 1.02569 1.02569 1.02569 -0.265625 -0.078125 -0.046875 -8.20846 -8.20846 -8.20846 -0.265625 -0.078125 -0.015625 -11.6629 -11.6629 -11.6629 -0.296875 -0.078125 -0.015625 -3.49749 -3.49749 -3.49749 -0.265625 -0.046875 -0.109375 -0.691113 -0.691113 -0.691113 -0.265625 -0.046875 -0.078125 -1.42463 -1.42463 -1.42463 -0.265625 -0.015625 -0.109375 -2.15898 -2.15898 -2.15898 -0.296875 -0.046875 -0.109375 -1.16372 -1.16372 -1.16372 -0.296875 -0.046875 -0.078125 -4.48236 -4.48236 -4.48236 -0.296875 -0.015625 -0.109375 -1.96082 -1.96082 -1.96082 -0.296875 -0.015625 -0.078125 -1.91224 -1.91224 -1.91224 -0.265625 -0.046875 -0.046875 -2.98152 -2.98152 -2.98152 -0.265625 -0.046875 -0.015625 -4.56136 -4.56136 -4.56136 -0.265625 -0.015625 -0.015625 -1.61735 -1.61735 -1.61735 -0.296875 -0.046875 -0.046875 -7.09385 -7.09385 -7.09385 -0.296875 -0.046875 -0.015625 -7.13801 -7.13801 -7.13801 -0.328125 -0.109375 -0.109375 -1.55518 -1.55518 -1.55518 -0.328125 -0.109375 -0.078125 -12.1305 -12.1305 -12.1305 -0.328125 -0.078125 -0.109375 -1.33092 -1.33092 -1.33092 -0.359375 -0.109375 -0.109375 -1.33014 -1.33014 -1.33014 -0.359375 -0.109375 -0.078125 -25.3877 -25.3877 -25.3877 -0.359375 -0.109375 -0.046875 -36.7782 -36.7782 -36.7782 -0.359375 -0.109375 -0.015625 7.139 7.139 7.139 -0.359375 -0.078125 -0.015625 -13.7333 -13.7333 -13.7333 -0.328125 -0.046875 -0.109375 -1.16499 -1.16499 -1.16499 -0.328125 -0.046875 -0.078125 -3.64152 -3.64152 -3.64152 -0.328125 -0.015625 -0.109375 -1.32428 -1.32428 -1.32428 -0.328125 -0.015625 -0.078125 -1.49351 -1.49351 -1.49351 -0.359375 -0.015625 -0.109375 -1.06411 -1.06411 -1.06411 -0.359375 -0.015625 -0.078125 -1.68824 -1.68824 -1.68824 -0.328125 -0.046875 -0.046875 -0.336952 -0.336952 -0.336952 -0.328125 -0.046875 -0.015625 1.09233 1.09233 1.09233 -0.328125 -0.015625 -0.046875 -2.16526 -2.16526 -2.16526 -0.359375 -0.046875 -0.015625 -1.53868 -1.53868 -1.53868 -0.359375 -0.015625 -0.046875 -2.15542 -2.15542 -2.15542 -0.359375 -0.015625 -0.015625 -1.59353 -1.59353 -1.59353 -0.390625 -0.203125 -0.234375 -1.10617 -1.10617 -1.10617 -0.390625 -0.203125 -0.203125 -1.19032 -1.19032 -1.19032 -0.390625 -0.203125 -0.171875 -0.111231 -0.111231 -0.111231 -0.390625 -0.171875 -0.234375 -0.936456 -0.936456 -0.936456 -0.390625 -0.171875 -0.203125 -1.75795 -1.75795 -1.75795 -0.390625 -0.140625 -0.234375 -0.973663 -0.973663 -0.973663 -0.390625 -0.140625 -0.203125 -1.33973 -1.33973 -1.33973 -0.421875 -0.171875 -0.203125 -1.34373 -1.34373 -1.34373 -0.421875 -0.140625 -0.203125 -1.35367 -1.35367 -1.35367 -0.390625 -0.171875 -0.171875 0.236882 0.236882 0.236882 -0.390625 -0.171875 -0.140625 -2.59259 -2.59259 -2.59259 -0.390625 -0.140625 -0.171875 -1.41894 -1.41894 -1.41894 -0.390625 -0.140625 -0.140625 -0.0671174 -0.0671174 -0.0671174 -0.421875 -0.171875 -0.140625 -3.93855 -3.93855 -3.93855 -0.421875 -0.140625 -0.171875 -2.08772 -2.08772 -2.08772 -0.421875 -0.140625 -0.140625 -1.43356 -1.43356 -1.43356 -0.453125 -0.140625 -0.140625 -1.61118 -1.61118 -1.61118 -0.390625 -0.171875 -0.109375 -3.98463 -3.98463 -3.98463 -0.390625 -0.171875 -0.078125 9.79682 9.79682 9.79682 -0.390625 -0.140625 -0.078125 9.81888 9.81888 9.81888 -0.421875 -0.171875 -0.109375 1.9906 1.9906 1.9906 -0.421875 -0.171875 -0.078125 -1.09119 -1.09119 -1.09119 -0.421875 -0.140625 -0.078125 -3.13087 -3.13087 -3.13087 -0.453125 -0.171875 -0.109375 1.92026 1.92026 1.92026 -0.453125 -0.140625 -0.109375 -1.56927 -1.56927 -1.56927 -0.453125 -0.140625 -0.078125 0.828904 0.828904 0.828904 -0.390625 -0.109375 -0.234375 -1.84304 -1.84304 -1.84304 -0.390625 -0.109375 -0.203125 -1.42067 -1.42067 -1.42067 -0.390625 -0.078125 -0.234375 -1.44135 -1.44135 -1.44135 -0.421875 -0.109375 -0.234375 -2.23868 -2.23868 -2.23868 -0.421875 -0.109375 -0.203125 -2.86219 -2.86219 -2.86219 -0.421875 -0.078125 -0.234375 -2.04914 -2.04914 -2.04914 -0.421875 -0.078125 -0.203125 -2.39583 -2.39583 -2.39583 -0.421875 -0.109375 -0.171875 -2.36225 -2.36225 -2.36225 -0.421875 -0.109375 -0.140625 -2.71363 -2.71363 -2.71363 -0.421875 -0.078125 -0.140625 -2.5603 -2.5603 -2.5603 -0.390625 -0.046875 -0.234375 -4.78488 -4.78488 -4.78488 -0.421875 -0.046875 -0.234375 -1.72444 -1.72444 -1.72444 -0.390625 -0.046875 -0.140625 -1.77377 -1.77377 -1.77377 -0.390625 -0.015625 -0.140625 -1.83095 -1.83095 -1.83095 -0.421875 -0.046875 -0.140625 -2.04498 -2.04498 -2.04498 -0.421875 -0.015625 -0.140625 -2.21219 -2.21219 -2.21219 -0.453125 -0.109375 -0.203125 -2.41719 -2.41719 -2.41719 -0.453125 -0.078125 -0.203125 -2.4374 -2.4374 -2.4374 -0.453125 -0.109375 -0.171875 -2.31659 -2.31659 -2.31659 -0.453125 -0.109375 -0.140625 -1.67645 -1.67645 -1.67645 -0.453125 -0.078125 -0.171875 -2.21693 -2.21693 -2.21693 -0.453125 -0.078125 -0.140625 -2.66224 -2.66224 -2.66224 -0.453125 -0.046875 -0.234375 -1.88098 -1.88098 -1.88098 -0.453125 -0.046875 -0.203125 -2.0927 -2.0927 -2.0927 -0.453125 -0.015625 -0.234375 -1.94918 -1.94918 -1.94918 -0.453125 -0.015625 -0.203125 -2.19388 -2.19388 -2.19388 -0.453125 -0.046875 -0.171875 -2.19376 -2.19376 -2.19376 -0.453125 -0.046875 -0.140625 -2.20845 -2.20845 -2.20845 -0.453125 -0.015625 -0.171875 -1.99347 -1.99347 -1.99347 -0.453125 -0.015625 -0.140625 -2.47113 -2.47113 -2.47113 -0.484375 -0.015625 -0.140625 -1.96407 -1.96407 -1.96407 -0.390625 -0.109375 -0.078125 5.88991 5.88991 5.88991 -0.421875 -0.109375 -0.078125 3.38218 3.38218 3.38218 -0.421875 -0.078125 -0.109375 -2.86351 -2.86351 -2.86351 -0.421875 -0.078125 -0.078125 -0.896733 -0.896733 -0.896733 -0.390625 -0.109375 -0.046875 -0.996851 -0.996851 -0.996851 -0.390625 -0.109375 -0.015625 -20.8133 -20.8133 -20.8133 -0.390625 -0.078125 -0.046875 -6.76083 -6.76083 -6.76083 -0.390625 -0.078125 -0.015625 3.22215 3.22215 3.22215 -0.421875 -0.109375 -0.046875 10.0136 10.0136 10.0136 -0.421875 -0.078125 -0.046875 11.6289 11.6289 11.6289 -0.421875 -0.078125 -0.015625 3.52477 3.52477 3.52477 -0.390625 -0.046875 -0.109375 -1.60381 -1.60381 -1.60381 -0.390625 -0.046875 -0.078125 -2.6722 -2.6722 -2.6722 -0.390625 -0.015625 -0.109375 -1.50631 -1.50631 -1.50631 -0.390625 -0.015625 -0.078125 -2.19767 -2.19767 -2.19767 -0.421875 -0.046875 -0.109375 -2.16217 -2.16217 -2.16217 -0.421875 -0.046875 -0.078125 -4.69695 -4.69695 -4.69695 -0.421875 -0.015625 -0.078125 -2.81612 -2.81612 -2.81612 -0.390625 -0.046875 -0.046875 -6.33451 -6.33451 -6.33451 -0.390625 -0.046875 -0.015625 10.0909 10.0909 10.0909 -0.390625 -0.015625 -0.046875 -2.08746 -2.08746 -2.08746 -0.390625 -0.015625 -0.015625 -1.23017 -1.23017 -1.23017 -0.421875 -0.046875 -0.046875 -1.11866 -1.11866 -1.11866 -0.421875 -0.046875 -0.015625 -1.27513 -1.27513 -1.27513 -0.421875 -0.015625 -0.046875 -2.74533 -2.74533 -2.74533 -0.421875 -0.015625 -0.015625 -1.74118 -1.74118 -1.74118 -0.453125 -0.109375 -0.109375 -1.61086 -1.61086 -1.61086 -0.453125 -0.109375 -0.078125 0.450536 0.450536 0.450536 -0.453125 -0.078125 -0.109375 -2.27984 -2.27984 -2.27984 -0.484375 -0.078125 -0.078125 -1.53421 -1.53421 -1.53421 -0.453125 -0.078125 -0.046875 0.411925 0.411925 0.411925 -0.453125 -0.078125 -0.015625 -1.88 -1.88 -1.88 -0.484375 -0.078125 -0.046875 -2.42049 -2.42049 -2.42049 -0.484375 -0.078125 -0.015625 -1.05624 -1.05624 -1.05624 -0.453125 -0.046875 -0.078125 -3.82269 -3.82269 -3.82269 -0.453125 -0.015625 -0.109375 -2.22355 -2.22355 -2.22355 -0.453125 -0.015625 -0.078125 -2.36373 -2.36373 -2.36373 -0.484375 -0.046875 -0.078125 -1.69291 -1.69291 -1.69291 -0.484375 -0.015625 -0.109375 -2.34226 -2.34226 -2.34226 -0.484375 -0.015625 -0.078125 -1.35297 -1.35297 -1.35297 -0.453125 -0.046875 -0.046875 -1.29638 -1.29638 -1.29638 -0.453125 -0.046875 -0.015625 -2.16477 -2.16477 -2.16477 -0.515625 -0.015625 -0.140625 -1.73667 -1.73667 -1.73667 -0.515625 -0.078125 -0.078125 -1.62575 -1.62575 -1.62575 -0.515625 -0.078125 -0.046875 -1.71507 -1.71507 -1.71507 -0.515625 -0.078125 -0.015625 -1.87202 -1.87202 -1.87202 -0.546875 -0.078125 -0.046875 0.910518 0.910518 0.910518 -0.546875 -0.078125 -0.015625 -0.585269 -0.585269 -0.585269 -0.515625 -0.046875 -0.078125 -1.92401 -1.92401 -1.92401 -0.515625 -0.015625 -0.109375 -1.66917 -1.66917 -1.66917 -0.515625 -0.015625 -0.078125 -1.60505 -1.60505 -1.60505 -0.546875 -0.046875 -0.078125 -0.921826 -0.921826 -0.921826 -0.546875 -0.015625 -0.109375 -1.39902 -1.39902 -1.39902 -0.546875 -0.015625 -0.078125 -0.772701 -0.772701 -0.772701 -0.546875 -0.046875 -0.046875 -1.5595 -1.5595 -1.5595 -0.546875 -0.015625 -0.046875 -0.808189 -0.808189 -0.808189 -0.578125 -0.046875 -0.046875 -2.04509 -2.04509 -2.04509 -0.578125 -0.046875 -0.015625 -0.86405 -0.86405 -0.86405 -0.578125 -0.015625 -0.046875 -1.58141 -1.58141 -1.58141 -0.578125 -0.015625 -0.015625 -2.45932 -2.45932 -2.45932 -0.015625 -0.296875 0.015625 -2.22468 -2.22468 -2.22468 -0.015625 -0.265625 0.015625 -1.81851 -1.81851 -1.81851 -0.015625 -0.265625 0.046875 -1.81374 -1.81374 -1.81374 -0.109375 -0.265625 0.109375 -1.22822 -1.22822 -1.22822 -0.140625 -0.328125 0.046875 6.0461 6.0461 6.0461 -0.171875 -0.328125 0.015625 31.6797 31.6797 31.6797 -0.171875 -0.328125 0.046875 6590.58 6590.58 6590.58 -0.171875 -0.328125 0.078125 -1.66212 -1.66212 -1.66212 -0.171875 -0.328125 0.109375 -1.15413 -1.15413 -1.15413 -0.140625 -0.296875 0.046875 -1.54472 -1.54472 -1.54472 -0.140625 -0.265625 0.046875 -1.02917 -1.02917 -1.02917 -0.171875 -0.296875 0.015625 -0.130236 -0.130236 -0.130236 -0.171875 -0.265625 0.015625 0.548619 0.548619 0.548619 -0.171875 -0.265625 0.046875 -0.989648 -0.989648 -0.989648 -0.140625 -0.296875 0.078125 -0.981949 -0.981949 -0.981949 -0.140625 -0.296875 0.109375 -1.85136 -1.85136 -1.85136 -0.140625 -0.265625 0.078125 -2.18864 -2.18864 -2.18864 -0.140625 -0.265625 0.109375 -1.94037 -1.94037 -1.94037 -0.171875 -0.296875 0.078125 -1.00264 -1.00264 -1.00264 -0.171875 -0.296875 0.109375 -1.49401 -1.49401 -1.49401 -0.171875 -0.265625 0.078125 -0.889575 -0.889575 -0.889575 -0.203125 -0.328125 0.015625 0.0100096 0.0100096 0.0100096 -0.203125 -0.328125 0.046875 -0.571194 -0.571194 -0.571194 -0.234375 -0.328125 0.015625 -0.337326 -0.337326 -0.337326 -0.234375 -0.328125 0.046875 -1.18216 -1.18216 -1.18216 -0.203125 -0.328125 0.078125 -1.26256 -1.26256 -1.26256 -0.203125 -0.328125 0.109375 -0.995554 -0.995554 -0.995554 -0.234375 -0.328125 0.078125 -0.579332 -0.579332 -0.579332 -0.234375 -0.328125 0.109375 -1.22936 -1.22936 -1.22936 -0.203125 -0.296875 0.015625 -0.806267 -0.806267 -0.806267 -0.203125 -0.265625 0.015625 0.513804 0.513804 0.513804 -0.234375 -0.296875 0.015625 -0.870062 -0.870062 -0.870062 -0.234375 -0.265625 0.015625 -7.10584 -7.10584 -7.10584 -0.234375 -0.265625 0.046875 -3.93768 -3.93768 -3.93768 -0.203125 -0.296875 0.109375 -1.03434 -1.03434 -1.03434 -0.203125 -0.265625 0.109375 -1.82271 -1.82271 -1.82271 -0.234375 -0.296875 0.109375 -1.08666 -1.08666 -1.08666 -0.234375 -0.265625 0.109375 -7.50098 -7.50098 -7.50098 -0.140625 -0.296875 0.140625 -1.77343 -1.77343 -1.77343 -0.140625 -0.265625 0.140625 -2.12069 -2.12069 -2.12069 -0.140625 -0.265625 0.171875 -1.88164 -1.88164 -1.88164 -0.171875 -0.296875 0.140625 -2.04656 -2.04656 -2.04656 -0.171875 -0.265625 0.140625 -2.17611 -2.17611 -2.17611 -0.171875 -0.265625 0.171875 -2.09881 -2.09881 -2.09881 -0.203125 -0.328125 0.140625 -1.16213 -1.16213 -1.16213 -0.234375 -0.328125 0.140625 -0.679249 -0.679249 -0.679249 -0.203125 -0.296875 0.140625 -1.06869 -1.06869 -1.06869 -0.203125 -0.265625 0.140625 -2.05609 -2.05609 -2.05609 -0.203125 -0.265625 0.171875 -2.01981 -2.01981 -2.01981 -0.234375 -0.296875 0.140625 -0.889589 -0.889589 -0.889589 -0.234375 -0.265625 0.140625 -3.891 -3.891 -3.891 -0.015625 -0.234375 0.015625 -1.98247 -1.98247 -1.98247 -0.015625 -0.234375 0.046875 -1.21 -1.21 -1.21 -0.015625 -0.203125 0.015625 -1.55827 -1.55827 -1.55827 -0.015625 -0.203125 0.109375 -1.51817 -1.51817 -1.51817 -0.046875 -0.203125 0.109375 -0.891884 -0.891884 -0.891884 -0.015625 -0.140625 0.015625 -3.15177 -3.15177 -3.15177 -0.015625 -0.140625 0.046875 -1.7511 -1.7511 -1.7511 -0.046875 -0.140625 0.015625 -3.27162 -3.27162 -3.27162 -0.046875 -0.140625 0.046875 -2.37998 -2.37998 -2.37998 -0.015625 -0.171875 0.109375 -1.49561 -1.49561 -1.49561 -0.015625 -0.140625 0.078125 -2.42417 -2.42417 -2.42417 -0.015625 -0.140625 0.109375 -1.64631 -1.64631 -1.64631 -0.046875 -0.171875 0.109375 -1.23625 -1.23625 -1.23625 -0.046875 -0.140625 0.078125 -2.38131 -2.38131 -2.38131 -0.046875 -0.140625 0.109375 -2.27483 -2.27483 -2.27483 -0.078125 -0.203125 0.109375 -0.400864 -0.400864 -0.400864 -0.109375 -0.234375 0.109375 -2.44997 -2.44997 -2.44997 -0.109375 -0.203125 0.078125 -2.95795 -2.95795 -2.95795 -0.109375 -0.203125 0.109375 -2.72358 -2.72358 -2.72358 -0.078125 -0.171875 0.015625 -1.53818 -1.53818 -1.53818 -0.078125 -0.171875 0.046875 -1.32359 -1.32359 -1.32359 -0.078125 -0.140625 0.015625 -2.13903 -2.13903 -2.13903 -0.109375 -0.171875 0.015625 -1.41021 -1.41021 -1.41021 -0.109375 -0.171875 0.046875 -1.31311 -1.31311 -1.31311 -0.109375 -0.140625 0.015625 -1.85146 -1.85146 -1.85146 -0.078125 -0.171875 0.078125 -1.0112 -1.0112 -1.0112 -0.078125 -0.171875 0.109375 -2.0982 -2.0982 -2.0982 -0.078125 -0.140625 0.078125 -1.33299 -1.33299 -1.33299 -0.078125 -0.140625 0.109375 -2.36783 -2.36783 -2.36783 -0.109375 -0.171875 0.078125 -1.03214 -1.03214 -1.03214 -0.109375 -0.171875 0.109375 -2.13736 -2.13736 -2.13736 -0.109375 -0.140625 0.078125 -1.09867 -1.09867 -1.09867 -0.109375 -0.140625 0.109375 -1.40019 -1.40019 -1.40019 -0.015625 -0.203125 0.140625 -1.52582 -1.52582 -1.52582 -0.015625 -0.203125 0.171875 -1.15653 -1.15653 -1.15653 -0.046875 -0.203125 0.140625 -0.41135 -0.41135 -0.41135 -0.046875 -0.203125 0.171875 -1.09577 -1.09577 -1.09577 -0.015625 -0.171875 0.140625 -1.86821 -1.86821 -1.86821 -0.015625 -0.171875 0.171875 -1.43331 -1.43331 -1.43331 -0.015625 -0.140625 0.140625 -1.42242 -1.42242 -1.42242 -0.015625 -0.140625 0.171875 -1.36511 -1.36511 -1.36511 -0.046875 -0.140625 0.171875 -1.51819 -1.51819 -1.51819 -0.015625 -0.171875 0.203125 -1.13044 -1.13044 -1.13044 -0.015625 -0.171875 0.234375 -1.82551 -1.82551 -1.82551 -0.015625 -0.140625 0.203125 -1.17526 -1.17526 -1.17526 -0.015625 -0.140625 0.234375 1.58384 1.58384 1.58384 -0.046875 -0.171875 0.203125 -1.25636 -1.25636 -1.25636 -0.046875 -0.171875 0.234375 -1.01054 -1.01054 -1.01054 -0.046875 -0.140625 0.203125 -1.10249 -1.10249 -1.10249 -0.046875 -0.140625 0.234375 -0.695787 -0.695787 -0.695787 -0.078125 -0.234375 0.171875 -1.58797 -1.58797 -1.58797 -0.078125 -0.203125 0.140625 -1.53107 -1.53107 -1.53107 -0.078125 -0.203125 0.171875 -1.41376 -1.41376 -1.41376 -0.109375 -0.234375 0.140625 -3.04296 -3.04296 -3.04296 -0.109375 -0.234375 0.171875 -1.68641 -1.68641 -1.68641 -0.109375 -0.203125 0.140625 -4.49701 -4.49701 -4.49701 -0.078125 -0.203125 0.203125 -1.6847 -1.6847 -1.6847 -0.078125 -0.203125 0.234375 -1.66032 -1.66032 -1.66032 -0.109375 -0.234375 0.203125 -1.7679 -1.7679 -1.7679 -0.109375 -0.203125 0.203125 -0.780794 -0.780794 -0.780794 -0.109375 -0.203125 0.234375 -0.705411 -0.705411 -0.705411 -0.078125 -0.171875 0.140625 -2.72739 -2.72739 -2.72739 -0.078125 -0.171875 0.171875 -1.6961 -1.6961 -1.6961 -0.078125 -0.171875 0.203125 -0.881738 -0.881738 -0.881738 -0.046875 -0.078125 0.015625 -1.49797 -1.49797 -1.49797 -0.015625 -0.109375 0.078125 -2.4091 -2.4091 -2.4091 -0.015625 -0.109375 0.109375 -2.20854 -2.20854 -2.20854 -0.015625 -0.078125 0.078125 -2.37058 -2.37058 -2.37058 -0.015625 -0.046875 0.015625 -1.19657 -1.19657 -1.19657 -0.015625 -0.046875 0.046875 -1.46339 -1.46339 -1.46339 -0.015625 -0.015625 0.015625 -2.88688 -2.88688 -2.88688 -0.015625 -0.015625 0.046875 -2.43029 -2.43029 -2.43029 -0.046875 -0.046875 0.015625 -1.03926 -1.03926 -1.03926 -0.046875 -0.046875 0.046875 -1.90688 -1.90688 -1.90688 -0.046875 -0.015625 0.015625 -1.24887 -1.24887 -1.24887 -0.046875 -0.015625 0.046875 -1.92662 -1.92662 -1.92662 -0.015625 -0.015625 0.078125 -2.35697 -2.35697 -2.35697 -0.015625 -0.015625 0.109375 -2.57093 -2.57093 -2.57093 -0.078125 -0.078125 0.015625 -1.72613 -1.72613 -1.72613 -0.078125 -0.078125 0.046875 -2.67713 -2.67713 -2.67713 -0.109375 -0.078125 0.015625 -1.7834 -1.7834 -1.7834 -0.109375 -0.078125 0.046875 -1.53277 -1.53277 -1.53277 -0.078125 -0.078125 0.078125 -2.06411 -2.06411 -2.06411 -0.109375 -0.109375 0.078125 -0.895142 -0.895142 -0.895142 -0.109375 -0.109375 0.109375 -1.88273 -1.88273 -1.88273 -0.109375 -0.078125 0.078125 -0.999871 -0.999871 -0.999871 -0.078125 -0.046875 0.015625 -0.00332471 -0.00332471 -0.00332471 -0.078125 -0.046875 0.046875 -2.32044 -2.32044 -2.32044 -0.078125 -0.015625 0.015625 -0.583354 -0.583354 -0.583354 -0.078125 -0.015625 0.046875 -2.17424 -2.17424 -2.17424 -0.109375 -0.046875 0.046875 -2.27227 -2.27227 -2.27227 -0.109375 -0.015625 0.015625 -0.556237 -0.556237 -0.556237 -0.109375 -0.015625 0.046875 -2.88003 -2.88003 -2.88003 -0.078125 -0.046875 0.078125 -2.19492 -2.19492 -2.19492 -0.078125 -0.046875 0.109375 -0.72578 -0.72578 -0.72578 -0.109375 -0.046875 0.078125 -1.82644 -1.82644 -1.82644 -0.109375 -0.046875 0.109375 -0.931628 -0.931628 -0.931628 -0.109375 -0.015625 0.078125 -2.32821 -2.32821 -2.32821 -0.109375 -0.015625 0.109375 -2.1395 -2.1395 -2.1395 -0.015625 -0.109375 0.140625 -1.51366 -1.51366 -1.51366 -0.015625 -0.109375 0.171875 -0.952902 -0.952902 -0.952902 -0.015625 -0.078125 0.140625 -4.27768 -4.27768 -4.27768 -0.015625 -0.078125 0.171875 -1.1318 -1.1318 -1.1318 -0.046875 -0.109375 0.140625 -2.84672 -2.84672 -2.84672 -0.046875 -0.109375 0.171875 -2.55678 -2.55678 -2.55678 -0.046875 -0.078125 0.140625 0.571945 0.571945 0.571945 -0.046875 -0.078125 0.171875 -0.816445 -0.816445 -0.816445 -0.015625 -0.109375 0.203125 -2.3262 -2.3262 -2.3262 -0.015625 -0.109375 0.234375 -2.16999 -2.16999 -2.16999 -0.015625 -0.078125 0.203125 -1.87086 -1.87086 -1.87086 -0.015625 -0.078125 0.234375 -16.3303 -16.3303 -16.3303 -0.046875 -0.109375 0.203125 -2.28609 -2.28609 -2.28609 -0.046875 -0.109375 0.234375 3.54368 3.54368 3.54368 -0.046875 -0.078125 0.203125 -0.984814 -0.984814 -0.984814 -0.046875 -0.078125 0.234375 -9.91939 -9.91939 -9.91939 -0.015625 -0.015625 0.171875 -2.1243 -2.1243 -2.1243 -0.046875 -0.046875 0.171875 -1.70762 -1.70762 -1.70762 -0.046875 -0.015625 0.171875 -0.567372 -0.567372 -0.567372 -0.015625 -0.046875 0.203125 -2.7994 -2.7994 -2.7994 -0.015625 -0.046875 0.234375 -61.9423 -61.9423 -61.9423 -0.015625 -0.015625 0.203125 -1.50226 -1.50226 -1.50226 -0.015625 -0.015625 0.234375 -67.2295 -67.2295 -67.2295 -0.046875 -0.046875 0.203125 -3.1979 -3.1979 -3.1979 -0.046875 -0.046875 0.234375 -17.2194 -17.2194 -17.2194 -0.046875 -0.015625 0.203125 -1.00708 -1.00708 -1.00708 -0.046875 -0.015625 0.234375 -11.8012 -11.8012 -11.8012 -0.078125 -0.109375 0.171875 -2.97444 -2.97444 -2.97444 -0.078125 -0.078125 0.171875 -0.961629 -0.961629 -0.961629 -0.109375 -0.109375 0.140625 -1.24486 -1.24486 -1.24486 -0.109375 -0.109375 0.171875 -2.03973 -2.03973 -2.03973 -0.109375 -0.078125 0.140625 -1.01419 -1.01419 -1.01419 -0.109375 -0.078125 0.171875 -1.16218 -1.16218 -1.16218 -0.078125 -0.109375 0.203125 -0.910449 -0.910449 -0.910449 -0.078125 -0.078125 0.203125 -0.81343 -0.81343 -0.81343 -0.078125 -0.046875 0.140625 -1.84791 -1.84791 -1.84791 -0.078125 -0.046875 0.171875 -0.968946 -0.968946 -0.968946 -0.078125 -0.015625 0.140625 -0.890611 -0.890611 -0.890611 -0.078125 -0.015625 0.171875 0.118502 0.118502 0.118502 -0.109375 -0.046875 0.140625 -0.981796 -0.981796 -0.981796 -0.109375 -0.046875 0.171875 -0.292524 -0.292524 -0.292524 -0.109375 -0.015625 0.140625 -2.32241 -2.32241 -2.32241 -0.109375 -0.015625 0.171875 -0.958171 -0.958171 -0.958171 -0.078125 -0.046875 0.203125 -1.62464 -1.62464 -1.62464 -0.078125 -0.046875 0.234375 -15.358 -15.358 -15.358 -0.078125 -0.015625 0.234375 -7.65226 -7.65226 -7.65226 -0.109375 -0.046875 0.234375 -0.917901 -0.917901 -0.917901 -0.109375 -0.015625 0.234375 -2.39556 -2.39556 -2.39556 -0.171875 -0.234375 0.046875 -1.5646 -1.5646 -1.5646 -0.171875 -0.203125 0.046875 -2.21169 -2.21169 -2.21169 -0.140625 -0.234375 0.078125 -1.55742 -1.55742 -1.55742 -0.140625 -0.203125 0.078125 -1.8405 -1.8405 -1.8405 -0.171875 -0.203125 0.078125 -1.81783 -1.81783 -1.81783 -0.140625 -0.171875 0.015625 -1.09478 -1.09478 -1.09478 -0.140625 -0.171875 0.046875 -0.931027 -0.931027 -0.931027 -0.140625 -0.140625 0.046875 -0.993185 -0.993185 -0.993185 -0.171875 -0.171875 0.015625 -1.47602 -1.47602 -1.47602 -0.171875 -0.171875 0.046875 -1.43102 -1.43102 -1.43102 -0.171875 -0.140625 0.046875 -1.57798 -1.57798 -1.57798 -0.140625 -0.171875 0.078125 -3.07026 -3.07026 -3.07026 -0.140625 -0.171875 0.109375 -2.01444 -2.01444 -2.01444 -0.140625 -0.140625 0.078125 -0.840705 -0.840705 -0.840705 -0.140625 -0.140625 0.109375 -1.56957 -1.56957 -1.56957 -0.171875 -0.171875 0.078125 -2.22391 -2.22391 -2.22391 -0.171875 -0.171875 0.109375 -2.28052 -2.28052 -2.28052 -0.171875 -0.140625 0.078125 -1.64845 -1.64845 -1.64845 -0.171875 -0.140625 0.109375 -2.3354 -2.3354 -2.3354 -0.203125 -0.234375 0.015625 -4.40969 -4.40969 -4.40969 -0.203125 -0.234375 0.046875 -2.8325 -2.8325 -2.8325 -0.203125 -0.203125 0.046875 -2.43161 -2.43161 -2.43161 -0.234375 -0.234375 0.015625 0.0605361 0.0605361 0.0605361 -0.234375 -0.234375 0.046875 6.35018 6.35018 6.35018 -0.234375 -0.203125 0.046875 1.52374 1.52374 1.52374 -0.203125 -0.203125 0.078125 -1.90919 -1.90919 -1.90919 -0.203125 -0.203125 0.109375 -1.9751 -1.9751 -1.9751 -0.234375 -0.234375 0.109375 -5.17806 -5.17806 -5.17806 -0.234375 -0.203125 0.078125 29.5668 29.5668 29.5668 -0.234375 -0.203125 0.109375 2.22075 2.22075 2.22075 -0.203125 -0.171875 0.015625 -1.45044 -1.45044 -1.45044 -0.203125 -0.171875 0.046875 -1.55902 -1.55902 -1.55902 -0.203125 -0.140625 0.015625 -1.52037 -1.52037 -1.52037 -0.203125 -0.140625 0.046875 -1.25349 -1.25349 -1.25349 -0.234375 -0.171875 0.046875 10.8534 10.8534 10.8534 -0.234375 -0.140625 0.015625 10.8823 10.8823 10.8823 -0.234375 -0.140625 0.046875 8.25838 8.25838 8.25838 -0.203125 -0.171875 0.078125 -2.40346 -2.40346 -2.40346 -0.203125 -0.171875 0.109375 -2.37619 -2.37619 -2.37619 -0.203125 -0.140625 0.078125 -1.79952 -1.79952 -1.79952 -0.203125 -0.140625 0.109375 -2.01737 -2.01737 -2.01737 -0.234375 -0.171875 0.078125 -16.7245 -16.7245 -16.7245 -0.234375 -0.171875 0.109375 1.31383 1.31383 1.31383 -0.234375 -0.140625 0.078125 -0.63474 -0.63474 -0.63474 -0.234375 -0.140625 0.109375 -2.1101 -2.1101 -2.1101 -0.140625 -0.234375 0.140625 -1.87699 -1.87699 -1.87699 -0.140625 -0.234375 0.171875 -1.84165 -1.84165 -1.84165 -0.171875 -0.234375 0.171875 -2.20659 -2.20659 -2.20659 -0.171875 -0.203125 0.171875 -2.14428 -2.14428 -2.14428 -0.140625 -0.234375 0.203125 -1.94914 -1.94914 -1.94914 -0.140625 -0.203125 0.203125 -2.11085 -2.11085 -2.11085 -0.140625 -0.203125 0.234375 -0.786224 -0.786224 -0.786224 -0.171875 -0.234375 0.203125 -2.05465 -2.05465 -2.05465 -0.171875 -0.203125 0.203125 -2.29096 -2.29096 -2.29096 -0.140625 -0.140625 0.140625 -2.82509 -2.82509 -2.82509 -0.171875 -0.171875 0.171875 -2.08897 -2.08897 -2.08897 -0.171875 -0.140625 0.140625 -2.1882 -2.1882 -2.1882 -0.171875 -0.140625 0.171875 -2.26575 -2.26575 -2.26575 -0.140625 -0.171875 0.203125 -2.01485 -2.01485 -2.01485 -0.140625 -0.171875 0.234375 -1.26123 -1.26123 -1.26123 -0.140625 -0.140625 0.203125 -2.25235 -2.25235 -2.25235 -0.140625 -0.140625 0.234375 -1.65658 -1.65658 -1.65658 -0.171875 -0.171875 0.203125 -2.21575 -2.21575 -2.21575 -0.171875 -0.140625 0.203125 -2.08232 -2.08232 -2.08232 -0.171875 -0.140625 0.234375 -2.08198 -2.08198 -2.08198 -0.203125 -0.234375 0.140625 -2.31631 -2.31631 -2.31631 -0.203125 -0.234375 0.171875 -1.86095 -1.86095 -1.86095 -0.203125 -0.203125 0.140625 -2.06818 -2.06818 -2.06818 -0.203125 -0.203125 0.171875 -2.20901 -2.20901 -2.20901 -0.234375 -0.234375 0.140625 -2.99606 -2.99606 -2.99606 -0.234375 -0.203125 0.140625 -4.32314 -4.32314 -4.32314 -0.234375 -0.203125 0.171875 -0.949336 -0.949336 -0.949336 -0.203125 -0.203125 0.203125 -1.24375 -1.24375 -1.24375 -0.203125 -0.203125 0.234375 -1.64565 -1.64565 -1.64565 -0.234375 -0.203125 0.203125 -1.02732 -1.02732 -1.02732 -0.234375 -0.203125 0.234375 -1.49478 -1.49478 -1.49478 -0.203125 -0.171875 0.140625 -2.2301 -2.2301 -2.2301 -0.203125 -0.171875 0.171875 -2.55062 -2.55062 -2.55062 -0.203125 -0.140625 0.140625 -2.1904 -2.1904 -2.1904 -0.203125 -0.140625 0.171875 -2.11297 -2.11297 -2.11297 -0.234375 -0.171875 0.140625 2.21144 2.21144 2.21144 -0.234375 -0.171875 0.171875 -2.45321 -2.45321 -2.45321 -0.234375 -0.140625 0.140625 -15.0809 -15.0809 -15.0809 -0.234375 -0.140625 0.171875 -2.097 -2.097 -2.097 -0.203125 -0.171875 0.203125 -2.01999 -2.01999 -2.01999 -0.203125 -0.171875 0.234375 -1.81642 -1.81642 -1.81642 -0.203125 -0.140625 0.203125 -1.92973 -1.92973 -1.92973 -0.203125 -0.140625 0.234375 -2.06612 -2.06612 -2.06612 -0.140625 -0.109375 0.046875 -0.930381 -0.930381 -0.930381 -0.140625 -0.078125 0.015625 -2.20087 -2.20087 -2.20087 -0.140625 -0.078125 0.046875 -1.11184 -1.11184 -1.11184 -0.171875 -0.109375 0.046875 -1.09328 -1.09328 -1.09328 -0.171875 -0.078125 0.015625 -1.27734 -1.27734 -1.27734 -0.171875 -0.078125 0.046875 -1.03881 -1.03881 -1.03881 -0.140625 -0.109375 0.078125 -1.16111 -1.16111 -1.16111 -0.140625 -0.109375 0.109375 -0.956095 -0.956095 -0.956095 -0.140625 -0.078125 0.078125 -1.19233 -1.19233 -1.19233 -0.171875 -0.109375 0.078125 -1.38874 -1.38874 -1.38874 -0.171875 -0.109375 0.109375 -1.44015 -1.44015 -1.44015 -0.140625 -0.046875 0.015625 -2.82371 -2.82371 -2.82371 -0.140625 -0.046875 0.046875 -1.51104 -1.51104 -1.51104 -0.140625 -0.015625 0.015625 -3.30579 -3.30579 -3.30579 -0.140625 -0.015625 0.046875 -2.78798 -2.78798 -2.78798 -0.171875 -0.046875 0.015625 -2.61027 -2.61027 -2.61027 -0.171875 -0.046875 0.046875 -2.99142 -2.99142 -2.99142 -0.140625 -0.046875 0.078125 -1.25016 -1.25016 -1.25016 -0.140625 -0.046875 0.109375 -1.16588 -1.16588 -1.16588 -0.140625 -0.015625 0.078125 -2.42309 -2.42309 -2.42309 -0.140625 -0.015625 0.109375 -2.29436 -2.29436 -2.29436 -0.203125 -0.109375 0.015625 -1.50639 -1.50639 -1.50639 -0.203125 -0.109375 0.046875 -1.07692 -1.07692 -1.07692 -0.203125 -0.078125 0.015625 -1.22531 -1.22531 -1.22531 -0.203125 -0.078125 0.046875 -1.30219 -1.30219 -1.30219 -0.234375 -0.109375 0.015625 1.30614 1.30614 1.30614 -0.234375 -0.109375 0.046875 -0.989582 -0.989582 -0.989582 -0.234375 -0.078125 0.015625 -1.93563 -1.93563 -1.93563 -0.203125 -0.109375 0.078125 -1.36088 -1.36088 -1.36088 -0.203125 -0.109375 0.109375 -1.36644 -1.36644 -1.36644 -0.203125 -0.078125 0.078125 -1.36122 -1.36122 -1.36122 -0.203125 -0.078125 0.109375 -2.19611 -2.19611 -2.19611 -0.234375 -0.109375 0.078125 -11.1245 -11.1245 -11.1245 -0.234375 -0.109375 0.109375 -4.62154 -4.62154 -4.62154 -0.234375 -0.078125 0.078125 0.34643 0.34643 0.34643 -0.234375 -0.078125 0.109375 -6.64345 -6.64345 -6.64345 -0.203125 -0.046875 0.015625 -1.5574 -1.5574 -1.5574 -0.234375 -0.046875 0.015625 -0.492419 -0.492419 -0.492419 -0.234375 -0.015625 0.015625 -1.83393 -1.83393 -1.83393 -0.234375 -0.046875 0.109375 26.0132 26.0132 26.0132 -0.234375 -0.015625 0.109375 -1.65183 -1.65183 -1.65183 -0.140625 -0.109375 0.140625 -1.54857 -1.54857 -1.54857 -0.140625 -0.109375 0.171875 -2.69185 -2.69185 -2.69185 -0.140625 -0.078125 0.140625 -0.929414 -0.929414 -0.929414 -0.140625 -0.078125 0.171875 -1.72783 -1.72783 -1.72783 -0.171875 -0.109375 0.140625 -1.292 -1.292 -1.292 -0.171875 -0.109375 0.171875 -2.21862 -2.21862 -2.21862 -0.171875 -0.078125 0.140625 -1.48504 -1.48504 -1.48504 -0.171875 -0.078125 0.171875 -2.34101 -2.34101 -2.34101 -0.140625 -0.109375 0.203125 -1.93775 -1.93775 -1.93775 -0.140625 -0.109375 0.234375 -2.22749 -2.22749 -2.22749 -0.140625 -0.078125 0.203125 -1.69868 -1.69868 -1.69868 -0.140625 -0.078125 0.234375 -1.36756 -1.36756 -1.36756 -0.171875 -0.109375 0.203125 -1.9149 -1.9149 -1.9149 -0.171875 -0.109375 0.234375 -1.93239 -1.93239 -1.93239 -0.171875 -0.078125 0.203125 -2.40107 -2.40107 -2.40107 -0.171875 -0.078125 0.234375 -1.8922 -1.8922 -1.8922 -0.140625 -0.046875 0.140625 -1.59533 -1.59533 -1.59533 -0.140625 -0.046875 0.171875 -2.7045 -2.7045 -2.7045 -0.140625 -0.015625 0.140625 -2.776 -2.776 -2.776 -0.140625 -0.046875 0.203125 -1.79649 -1.79649 -1.79649 -0.140625 -0.046875 0.234375 -0.975229 -0.975229 -0.975229 -0.140625 -0.015625 0.234375 -2.41602 -2.41602 -2.41602 -0.171875 -0.046875 0.234375 -3.09398 -3.09398 -3.09398 -0.171875 -0.015625 0.234375 -2.20706 -2.20706 -2.20706 -0.203125 -0.109375 0.171875 -2.03317 -2.03317 -2.03317 -0.203125 -0.078125 0.140625 -2.07644 -2.07644 -2.07644 -0.203125 -0.078125 0.171875 -2.10572 -2.10572 -2.10572 -0.234375 -0.109375 0.140625 -6.63883 -6.63883 -6.63883 -0.234375 -0.109375 0.171875 -1.94936 -1.94936 -1.94936 -0.234375 -0.078125 0.140625 -1.19135 -1.19135 -1.19135 -0.203125 -0.046875 0.140625 -1.6145 -1.6145 -1.6145 -0.234375 -0.046875 0.140625 -2.60854 -2.60854 -2.60854 -0.234375 -0.046875 0.171875 -1.39166 -1.39166 -1.39166 -0.234375 -0.015625 0.140625 -1.02531 -1.02531 -1.02531 -0.234375 -0.015625 0.171875 -1.43653 -1.43653 -1.43653 -0.234375 -0.046875 0.234375 -1.37429 -1.37429 -1.37429 -0.234375 -0.015625 0.203125 -2.09423 -2.09423 -2.09423 -0.234375 -0.015625 0.234375 -2.18785 -2.18785 -2.18785 -0.015625 -0.171875 0.265625 -1.75215 -1.75215 -1.75215 -0.015625 -0.171875 0.296875 -1.84015 -1.84015 -1.84015 -0.046875 -0.171875 0.265625 -2.6196 -2.6196 -2.6196 -0.046875 -0.171875 0.296875 -1.72579 -1.72579 -1.72579 -0.015625 -0.171875 0.328125 -1.63555 -1.63555 -1.63555 -0.015625 -0.140625 0.328125 -1.92444 -1.92444 -1.92444 -0.046875 -0.171875 0.328125 -1.19098 -1.19098 -1.19098 -0.046875 -0.140625 0.328125 -1.63421 -1.63421 -1.63421 -0.078125 -0.203125 0.265625 -0.644594 -0.644594 -0.644594 -0.109375 -0.203125 0.265625 -1.44951 -1.44951 -1.44951 -0.078125 -0.171875 0.265625 -1.32774 -1.32774 -1.32774 -0.078125 -0.171875 0.296875 -2.40318 -2.40318 -2.40318 -0.109375 -0.171875 0.265625 -0.676406 -0.676406 -0.676406 -0.109375 -0.171875 0.296875 -1.98252 -1.98252 -1.98252 -0.109375 -0.140625 0.265625 -2.75787 -2.75787 -2.75787 -0.109375 -0.140625 0.296875 -2.97483 -2.97483 -2.97483 -0.078125 -0.140625 0.328125 -3.04971 -3.04971 -3.04971 -0.109375 -0.140625 0.328125 -2.6219 -2.6219 -2.6219 -0.015625 -0.078125 0.296875 -43.2646 -43.2646 -43.2646 -0.046875 -0.078125 0.265625 -39.4215 -39.4215 -39.4215 -0.046875 -0.078125 0.296875 -36.3014 -36.3014 -36.3014 -0.015625 -0.109375 0.328125 -2.20973 -2.20973 -2.20973 -0.015625 -0.078125 0.328125 111.214 111.214 111.214 -0.046875 -0.109375 0.328125 -2.59542 -2.59542 -2.59542 -0.046875 -0.109375 0.359375 -1.36086 -1.36086 -1.36086 -0.046875 -0.078125 0.328125 11.6144 11.6144 11.6144 -0.046875 -0.078125 0.359375 -11.6605 -11.6605 -11.6605 -0.015625 -0.046875 0.265625 -94.4614 -94.4614 -94.4614 -0.015625 -0.046875 0.296875 -24.5456 -24.5456 -24.5456 -0.015625 -0.015625 0.265625 -233.969 -233.969 -233.969 -0.015625 -0.015625 0.296875 -89.4841 -89.4841 -89.4841 -0.046875 -0.046875 0.265625 -78.727 -78.727 -78.727 -0.046875 -0.046875 0.296875 23.188 23.188 23.188 -0.046875 -0.015625 0.265625 -69.3688 -69.3688 -69.3688 -0.046875 -0.015625 0.296875 -19.2415 -19.2415 -19.2415 -0.046875 -0.046875 0.328125 -18.5926 -18.5926 -18.5926 -0.046875 -0.046875 0.359375 57.5445 57.5445 57.5445 -0.078125 -0.078125 0.265625 11.7853 11.7853 11.7853 -0.109375 -0.078125 0.265625 -0.492281 -0.492281 -0.492281 -0.078125 -0.109375 0.328125 -1.57234 -1.57234 -1.57234 -0.078125 -0.109375 0.359375 -1.15562 -1.15562 -1.15562 -0.078125 -0.078125 0.359375 8.11996 8.11996 8.11996 -0.109375 -0.109375 0.328125 -1.85744 -1.85744 -1.85744 -0.109375 -0.109375 0.359375 -1.8993 -1.8993 -1.8993 -0.109375 -0.078125 0.359375 -1.46776 -1.46776 -1.46776 -0.078125 -0.046875 0.265625 -1.27412 -1.27412 -1.27412 -0.078125 -0.046875 0.296875 60.8924 60.8924 60.8924 -0.078125 -0.015625 0.265625 -65.6968 -65.6968 -65.6968 -0.078125 -0.015625 0.296875 -48.5606 -48.5606 -48.5606 -0.109375 -0.046875 0.265625 -0.704356 -0.704356 -0.704356 -0.109375 -0.015625 0.265625 -1.10087 -1.10087 -1.10087 -0.078125 -0.046875 0.328125 -14.6795 -14.6795 -14.6795 -0.078125 -0.046875 0.359375 -29.7701 -29.7701 -29.7701 -0.078125 -0.015625 0.328125 -83.8263 -83.8263 -83.8263 -0.109375 -0.046875 0.328125 -0.76141 -0.76141 -0.76141 -0.109375 -0.046875 0.359375 -1.55041 -1.55041 -1.55041 -0.109375 -0.015625 0.328125 0.333847 0.333847 0.333847 -0.140625 -0.171875 0.265625 -1.03938 -1.03938 -1.03938 -0.140625 -0.140625 0.265625 -2.12983 -2.12983 -2.12983 -0.140625 -0.140625 0.296875 -2.12613 -2.12613 -2.12613 -0.171875 -0.140625 0.265625 -2.0815 -2.0815 -2.0815 -0.203125 -0.171875 0.265625 -1.47418 -1.47418 -1.47418 -0.203125 -0.140625 0.265625 -2.16796 -2.16796 -2.16796 -0.234375 -0.171875 0.265625 -1.59074 -1.59074 -1.59074 -0.234375 -0.140625 0.265625 -1.90326 -1.90326 -1.90326 -0.140625 -0.109375 0.265625 -2.9982 -2.9982 -2.9982 -0.140625 -0.109375 0.296875 -2.02877 -2.02877 -2.02877 -0.140625 -0.078125 0.265625 -1.16511 -1.16511 -1.16511 -0.140625 -0.078125 0.296875 -1.5415 -1.5415 -1.5415 -0.171875 -0.109375 0.265625 -2.00821 -2.00821 -2.00821 -0.171875 -0.078125 0.265625 -1.87023 -1.87023 -1.87023 -0.140625 -0.109375 0.328125 -1.13089 -1.13089 -1.13089 -0.140625 -0.078125 0.328125 -1.57117 -1.57117 -1.57117 -0.140625 -0.078125 0.359375 -1.81799 -1.81799 -1.81799 -0.140625 -0.046875 0.265625 -0.773946 -0.773946 -0.773946 -0.140625 -0.046875 0.296875 -0.591723 -0.591723 -0.591723 -0.140625 -0.015625 0.265625 -1.18442 -1.18442 -1.18442 -0.140625 -0.015625 0.296875 -1.13909 -1.13909 -1.13909 -0.171875 -0.046875 0.265625 -1.9854 -1.9854 -1.9854 -0.171875 -0.015625 0.265625 -1.51714 -1.51714 -1.51714 -0.171875 -0.015625 0.296875 -0.818251 -0.818251 -0.818251 -0.140625 -0.046875 0.328125 -0.829775 -0.829775 -0.829775 -0.140625 -0.015625 0.328125 -1.23418 -1.23418 -1.23418 -0.171875 -0.015625 0.328125 -1.11026 -1.11026 -1.11026 -0.203125 -0.109375 0.265625 -1.93629 -1.93629 -1.93629 -0.203125 -0.078125 0.265625 -1.83316 -1.83316 -1.83316 -0.234375 -0.109375 0.265625 -2.06605 -2.06605 -2.06605 -0.234375 -0.078125 0.265625 -2.49639 -2.49639 -2.49639 -0.203125 -0.046875 0.265625 -1.98969 -1.98969 -1.98969 -0.203125 -0.015625 0.265625 -0.390459 -0.390459 -0.390459 -0.234375 -0.046875 0.265625 -2.74459 -2.74459 -2.74459 -0.234375 -0.015625 0.265625 1.16878 1.16878 1.16878 -0.265625 -0.328125 0.046875 -0.714085 -0.714085 -0.714085 -0.265625 -0.328125 0.078125 -1.01062 -1.01062 -1.01062 -0.265625 -0.328125 0.109375 -1.01285 -1.01285 -1.01285 -0.265625 -0.296875 0.015625 -0.370519 -0.370519 -0.370519 -0.265625 -0.296875 0.046875 -1.49242 -1.49242 -1.49242 -0.265625 -0.265625 0.015625 -8.27535 -8.27535 -8.27535 -0.265625 -0.265625 0.046875 -1.25011 -1.25011 -1.25011 -0.265625 -0.296875 0.078125 -1.11575 -1.11575 -1.11575 -0.265625 -0.296875 0.109375 -0.968596 -0.968596 -0.968596 -0.265625 -0.265625 0.078125 -15.764 -15.764 -15.764 -0.265625 -0.265625 0.109375 12.2364 12.2364 12.2364 -0.265625 -0.234375 0.046875 19.5326 19.5326 19.5326 -0.265625 -0.203125 0.046875 43.0976 43.0976 43.0976 -0.296875 -0.203125 0.046875 82.4562 82.4562 82.4562 -0.265625 -0.234375 0.078125 -26.9787 -26.9787 -26.9787 -0.265625 -0.234375 0.109375 8.25542 8.25542 8.25542 -0.265625 -0.203125 0.078125 10.3098 10.3098 10.3098 -0.265625 -0.203125 0.109375 16.1183 16.1183 16.1183 -0.296875 -0.203125 0.078125 -14.3504 -14.3504 -14.3504 -0.296875 -0.203125 0.109375 14.0664 14.0664 14.0664 -0.265625 -0.171875 0.015625 -2.65784 -2.65784 -2.65784 -0.265625 -0.171875 0.046875 18.6476 18.6476 18.6476 -0.265625 -0.140625 0.015625 -25.0953 -25.0953 -25.0953 -0.265625 -0.140625 0.046875 -36.4466 -36.4466 -36.4466 -0.296875 -0.171875 0.015625 1.83597 1.83597 1.83597 -0.296875 -0.171875 0.046875 90.784 90.784 90.784 -0.296875 -0.171875 0.109375 14.69 14.69 14.69 -0.296875 -0.140625 0.109375 -85.1263 -85.1263 -85.1263 -0.328125 -0.203125 0.046875 -53.1368 -53.1368 -53.1368 -0.328125 -0.203125 0.078125 -89.2529 -89.2529 -89.2529 -0.328125 -0.171875 0.015625 49.4875 49.4875 49.4875 -0.328125 -0.171875 0.046875 100.538 100.538 100.538 -0.328125 -0.140625 0.015625 14.0355 14.0355 14.0355 -0.359375 -0.171875 0.046875 22.7475 22.7475 22.7475 -0.359375 -0.140625 0.015625 -26.623 -26.623 -26.623 -0.359375 -0.140625 0.046875 5.76663 5.76663 5.76663 -0.328125 -0.171875 0.078125 -78.2413 -78.2413 -78.2413 -0.328125 -0.171875 0.109375 -17.7659 -17.7659 -17.7659 -0.359375 -0.171875 0.078125 -2.51519 -2.51519 -2.51519 -0.359375 -0.171875 0.109375 -15.9328 -15.9328 -15.9328 -0.359375 -0.140625 0.109375 -33.1529 -33.1529 -33.1529 -0.265625 -0.234375 0.171875 -0.703567 -0.703567 -0.703567 -0.265625 -0.203125 0.140625 0.91456 0.91456 0.91456 -0.265625 -0.203125 0.171875 -1.27095 -1.27095 -1.27095 -0.296875 -0.234375 0.171875 -0.86443 -0.86443 -0.86443 -0.296875 -0.203125 0.140625 3.32382 3.32382 3.32382 -0.265625 -0.234375 0.203125 -0.715417 -0.715417 -0.715417 -0.265625 -0.234375 0.234375 -0.646125 -0.646125 -0.646125 -0.265625 -0.203125 0.203125 -1.79484 -1.79484 -1.79484 -0.265625 -0.203125 0.234375 -1.02976 -1.02976 -1.02976 -0.296875 -0.234375 0.203125 -1.02241 -1.02241 -1.02241 -0.296875 -0.234375 0.234375 -1.04665 -1.04665 -1.04665 -0.296875 -0.203125 0.234375 -1.09668 -1.09668 -1.09668 -0.265625 -0.171875 0.140625 10.1432 10.1432 10.1432 -0.265625 -0.171875 0.171875 -1.64785 -1.64785 -1.64785 -0.265625 -0.140625 0.140625 -8.13036 -8.13036 -8.13036 -0.296875 -0.171875 0.140625 10.552 10.552 10.552 -0.296875 -0.140625 0.140625 8.25445 8.25445 8.25445 -0.265625 -0.171875 0.234375 -1.41582 -1.41582 -1.41582 -0.296875 -0.171875 0.234375 -2.6695 -2.6695 -2.6695 -0.296875 -0.140625 0.234375 -2.60038 -2.60038 -2.60038 -0.328125 -0.234375 0.171875 -1.31194 -1.31194 -1.31194 -0.328125 -0.203125 0.140625 13.2848 13.2848 13.2848 -0.328125 -0.203125 0.171875 -1.65722 -1.65722 -1.65722 -0.328125 -0.234375 0.203125 -0.746948 -0.746948 -0.746948 -0.328125 -0.203125 0.203125 -1.62411 -1.62411 -1.62411 -0.328125 -0.203125 0.234375 -1.10248 -1.10248 -1.10248 -0.328125 -0.171875 0.140625 6.4956 6.4956 6.4956 -0.328125 -0.171875 0.171875 -1.56481 -1.56481 -1.56481 -0.328125 -0.140625 0.140625 -1.90485 -1.90485 -1.90485 -0.328125 -0.140625 0.171875 -1.02071 -1.02071 -1.02071 -0.359375 -0.171875 0.171875 -1.20227 -1.20227 -1.20227 -0.359375 -0.140625 0.140625 -2.93725 -2.93725 -2.93725 -0.359375 -0.140625 0.171875 -1.23784 -1.23784 -1.23784 -0.328125 -0.171875 0.203125 -1.34929 -1.34929 -1.34929 -0.328125 -0.171875 0.234375 -0.452808 -0.452808 -0.452808 -0.328125 -0.140625 0.203125 -1.36992 -1.36992 -1.36992 -0.328125 -0.140625 0.234375 -1.39189 -1.39189 -1.39189 -0.359375 -0.171875 0.203125 -0.65275 -0.65275 -0.65275 -0.359375 -0.171875 0.234375 -1.45244 -1.45244 -1.45244 -0.359375 -0.140625 0.234375 -0.975885 -0.975885 -0.975885 -0.265625 -0.109375 0.078125 82.9924 82.9924 82.9924 -0.265625 -0.109375 0.109375 1.95786 1.95786 1.95786 -0.265625 -0.078125 0.078125 8.65373 8.65373 8.65373 -0.265625 -0.078125 0.109375 12.9765 12.9765 12.9765 -0.296875 -0.109375 0.078125 16.8859 16.8859 16.8859 -0.296875 -0.109375 0.109375 -21.8928 -21.8928 -21.8928 -0.296875 -0.078125 0.078125 25.3748 25.3748 25.3748 -0.296875 -0.078125 0.109375 -11.3431 -11.3431 -11.3431 -0.265625 -0.046875 0.015625 -14.1745 -14.1745 -14.1745 -0.265625 -0.015625 0.015625 -1.8173 -1.8173 -1.8173 -0.265625 -0.015625 0.046875 -1.75665 -1.75665 -1.75665 -0.296875 -0.046875 0.015625 -1.20979 -1.20979 -1.20979 -0.296875 -0.015625 0.015625 -1.26335 -1.26335 -1.26335 -0.296875 -0.015625 0.046875 -1.50505 -1.50505 -1.50505 -0.265625 -0.046875 0.078125 33.997 33.997 33.997 -0.265625 -0.046875 0.109375 3.97775 3.97775 3.97775 -0.265625 -0.015625 0.078125 -1.2385 -1.2385 -1.2385 -0.265625 -0.015625 0.109375 -1.51169 -1.51169 -1.51169 -0.296875 -0.046875 0.109375 15.418 15.418 15.418 -0.296875 -0.015625 0.078125 -1.11504 -1.11504 -1.11504 -0.296875 -0.015625 0.109375 -0.563653 -0.563653 -0.563653 -0.328125 -0.078125 0.046875 -14.4622 -14.4622 -14.4622 -0.359375 -0.109375 0.046875 24.5634 24.5634 24.5634 -0.359375 -0.078125 0.015625 -7.79607 -7.79607 -7.79607 -0.359375 -0.078125 0.046875 -4.65845 -4.65845 -4.65845 -0.328125 -0.078125 0.078125 -22.6428 -22.6428 -22.6428 -0.328125 -0.078125 0.109375 -7.11447 -7.11447 -7.11447 -0.359375 -0.078125 0.078125 -2.49743 -2.49743 -2.49743 -0.359375 -0.078125 0.109375 -11.8479 -11.8479 -11.8479 -0.328125 -0.046875 0.015625 -2.04336 -2.04336 -2.04336 -0.328125 -0.046875 0.046875 70.8553 70.8553 70.8553 -0.328125 -0.015625 0.015625 -1.25506 -1.25506 -1.25506 -0.328125 -0.015625 0.046875 -0.950223 -0.950223 -0.950223 -0.359375 -0.046875 0.015625 2.99718 2.99718 2.99718 -0.359375 -0.046875 0.046875 4.9924 4.9924 4.9924 -0.359375 -0.015625 0.015625 -0.936482 -0.936482 -0.936482 -0.359375 -0.015625 0.046875 -1.34303 -1.34303 -1.34303 -0.328125 -0.046875 0.078125 1.34713 1.34713 1.34713 -0.328125 -0.046875 0.109375 1.77241 1.77241 1.77241 -0.328125 -0.015625 0.078125 -1.1181 -1.1181 -1.1181 -0.328125 -0.015625 0.109375 -0.655092 -0.655092 -0.655092 -0.359375 -0.046875 0.078125 16.3652 16.3652 16.3652 -0.359375 -0.046875 0.109375 8.78623 8.78623 8.78623 -0.359375 -0.015625 0.078125 -1.65273 -1.65273 -1.65273 -0.265625 -0.109375 0.140625 -2.42426 -2.42426 -2.42426 -0.265625 -0.078125 0.140625 -3.79883 -3.79883 -3.79883 -0.296875 -0.078125 0.140625 3.22646 3.22646 3.22646 -0.265625 -0.109375 0.234375 -1.98447 -1.98447 -1.98447 -0.265625 -0.078125 0.234375 -1.69633 -1.69633 -1.69633 -0.296875 -0.109375 0.234375 -1.24655 -1.24655 -1.24655 -0.296875 -0.078125 0.203125 -2.74539 -2.74539 -2.74539 -0.296875 -0.078125 0.234375 -2.02328 -2.02328 -2.02328 -0.265625 -0.046875 0.140625 -2.94554 -2.94554 -2.94554 -0.265625 -0.015625 0.140625 -1.47755 -1.47755 -1.47755 -0.265625 -0.015625 0.171875 -1.98521 -1.98521 -1.98521 -0.296875 -0.046875 0.140625 -2.50282 -2.50282 -2.50282 -0.296875 -0.046875 0.171875 -2.21573 -2.21573 -2.21573 -0.296875 -0.015625 0.171875 -2.35509 -2.35509 -2.35509 -0.265625 -0.046875 0.203125 -1.84217 -1.84217 -1.84217 -0.265625 -0.046875 0.234375 -2.27445 -2.27445 -2.27445 -0.265625 -0.015625 0.203125 -2.07272 -2.07272 -2.07272 -0.265625 -0.015625 0.234375 -1.97302 -1.97302 -1.97302 -0.296875 -0.046875 0.203125 -2.61586 -2.61586 -2.61586 -0.296875 -0.046875 0.234375 -0.686795 -0.686795 -0.686795 -0.296875 -0.015625 0.203125 -2.00808 -2.00808 -2.00808 -0.328125 -0.109375 0.140625 12.2665 12.2665 12.2665 -0.328125 -0.109375 0.171875 -1.41639 -1.41639 -1.41639 -0.328125 -0.078125 0.140625 1.57212 1.57212 1.57212 -0.328125 -0.078125 0.171875 -1.5389 -1.5389 -1.5389 -0.359375 -0.109375 0.140625 5.6405 5.6405 5.6405 -0.359375 -0.109375 0.171875 -0.866243 -0.866243 -0.866243 -0.359375 -0.078125 0.140625 -0.68394 -0.68394 -0.68394 -0.328125 -0.109375 0.203125 -1.20078 -1.20078 -1.20078 -0.328125 -0.109375 0.234375 -1.84449 -1.84449 -1.84449 -0.328125 -0.078125 0.203125 -1.55926 -1.55926 -1.55926 -0.328125 -0.078125 0.234375 -1.79138 -1.79138 -1.79138 -0.359375 -0.078125 0.234375 -1.33469 -1.33469 -1.33469 -0.328125 -0.046875 0.140625 -5.43709 -5.43709 -5.43709 -0.328125 -0.046875 0.171875 -1.91797 -1.91797 -1.91797 -0.328125 -0.015625 0.140625 -1.94838 -1.94838 -1.94838 -0.328125 -0.015625 0.171875 -2.39309 -2.39309 -2.39309 -0.359375 -0.015625 0.171875 -1.83339 -1.83339 -1.83339 -0.328125 -0.046875 0.203125 -1.64717 -1.64717 -1.64717 -0.328125 -0.046875 0.234375 -2.2915 -2.2915 -2.2915 -0.328125 -0.015625 0.203125 -2.11407 -2.11407 -2.11407 -0.359375 -0.046875 0.234375 -2.94912 -2.94912 -2.94912 -0.359375 -0.015625 0.203125 -1.81096 -1.81096 -1.81096 -0.359375 -0.015625 0.234375 -1.23263 -1.23263 -1.23263 -0.390625 -0.140625 0.015625 -114.704 -114.704 -114.704 -0.390625 -0.140625 0.046875 52.9377 52.9377 52.9377 -0.390625 -0.171875 0.078125 98.0029 98.0029 98.0029 -0.390625 -0.140625 0.078125 57.65 57.65 57.65 -0.390625 -0.140625 0.109375 -38.9887 -38.9887 -38.9887 -0.390625 -0.140625 0.171875 -0.802939 -0.802939 -0.802939 -0.421875 -0.140625 0.171875 -1.23994 -1.23994 -1.23994 -0.390625 -0.171875 0.203125 -1.0465 -1.0465 -1.0465 -0.390625 -0.171875 0.234375 -1.38742 -1.38742 -1.38742 -0.390625 -0.140625 0.203125 -1.13476 -1.13476 -1.13476 -0.390625 -0.140625 0.234375 -1.23511 -1.23511 -1.23511 -0.421875 -0.171875 0.203125 -0.620738 -0.620738 -0.620738 -0.421875 -0.171875 0.234375 -1.14079 -1.14079 -1.14079 -0.421875 -0.140625 0.203125 -1.3038 -1.3038 -1.3038 -0.421875 -0.140625 0.234375 -1.25866 -1.25866 -1.25866 -0.453125 -0.140625 0.203125 -0.971402 -0.971402 -0.971402 -0.453125 -0.140625 0.234375 -1.16273 -1.16273 -1.16273 -0.390625 -0.109375 0.015625 -98.9561 -98.9561 -98.9561 -0.390625 -0.109375 0.046875 -17.5873 -17.5873 -17.5873 -0.390625 -0.078125 0.015625 -2.61663 -2.61663 -2.61663 -0.390625 -0.078125 0.046875 -1.88012 -1.88012 -1.88012 -0.421875 -0.078125 0.015625 5.29943 5.29943 5.29943 -0.421875 -0.078125 0.046875 4.80604 4.80604 4.80604 -0.390625 -0.109375 0.078125 14.0353 14.0353 14.0353 -0.390625 -0.109375 0.109375 -30.8668 -30.8668 -30.8668 -0.390625 -0.078125 0.078125 -23.1222 -23.1222 -23.1222 -0.390625 -0.078125 0.109375 -68.0692 -68.0692 -68.0692 -0.421875 -0.078125 0.109375 -19.0075 -19.0075 -19.0075 -0.390625 -0.046875 0.046875 -8.45761 -8.45761 -8.45761 -0.390625 -0.015625 0.015625 -2.30718 -2.30718 -2.30718 -0.390625 -0.015625 0.046875 -1.50157 -1.50157 -1.50157 -0.421875 -0.046875 0.046875 5.87772 5.87772 5.87772 -0.390625 -0.046875 0.078125 5.09625 5.09625 5.09625 -0.421875 -0.046875 0.078125 -6.56959 -6.56959 -6.56959 -0.453125 -0.078125 0.015625 -1.38837 -1.38837 -1.38837 -0.453125 -0.078125 0.046875 0.982839 0.982839 0.982839 -0.484375 -0.078125 0.015625 -1.66715 -1.66715 -1.66715 -0.453125 -0.046875 0.015625 0.211621 0.211621 0.211621 -0.453125 -0.046875 0.046875 3.60357 3.60357 3.60357 -0.484375 -0.046875 0.015625 -0.561858 -0.561858 -0.561858 -0.484375 -0.046875 0.046875 -1.70337 -1.70337 -1.70337 -0.484375 -0.015625 0.015625 -0.813981 -0.813981 -0.813981 -0.484375 -0.015625 0.046875 -0.598384 -0.598384 -0.598384 -0.453125 -0.046875 0.078125 -0.364606 -0.364606 -0.364606 -0.453125 -0.046875 0.109375 0.0725343 0.0725343 0.0725343 -0.453125 -0.015625 0.078125 -1.72715 -1.72715 -1.72715 -0.484375 -0.015625 0.109375 -1.26601 -1.26601 -1.26601 -0.390625 -0.109375 0.140625 -19.6117 -19.6117 -19.6117 -0.390625 -0.109375 0.171875 -1.64704 -1.64704 -1.64704 -0.421875 -0.109375 0.140625 8.94317 8.94317 8.94317 -0.421875 -0.109375 0.171875 -1.73502 -1.73502 -1.73502 -0.421875 -0.078125 0.140625 -10.2503 -10.2503 -10.2503 -0.421875 -0.078125 0.171875 -2.17879 -2.17879 -2.17879 -0.390625 -0.078125 0.234375 -1.93362 -1.93362 -1.93362 -0.421875 -0.109375 0.203125 -1.20149 -1.20149 -1.20149 -0.421875 -0.109375 0.234375 -0.954603 -0.954603 -0.954603 -0.421875 -0.078125 0.203125 -1.41481 -1.41481 -1.41481 -0.421875 -0.078125 0.234375 -0.940119 -0.940119 -0.940119 -0.390625 -0.015625 0.171875 -1.64108 -1.64108 -1.64108 -0.421875 -0.046875 0.140625 -6.56997 -6.56997 -6.56997 -0.421875 -0.046875 0.171875 -2.87833 -2.87833 -2.87833 -0.421875 -0.015625 0.171875 -0.777797 -0.777797 -0.777797 -0.390625 -0.046875 0.234375 -1.94097 -1.94097 -1.94097 -0.390625 -0.015625 0.203125 -0.427855 -0.427855 -0.427855 -0.390625 -0.015625 0.234375 -1.1177 -1.1177 -1.1177 -0.421875 -0.046875 0.203125 -1.90583 -1.90583 -1.90583 -0.421875 -0.046875 0.234375 -1.35368 -1.35368 -1.35368 -0.421875 -0.015625 0.203125 -1.01676 -1.01676 -1.01676 -0.453125 -0.078125 0.140625 -0.319493 -0.319493 -0.319493 -0.453125 -0.078125 0.171875 -1.42711 -1.42711 -1.42711 -0.453125 -0.109375 0.203125 -0.800266 -0.800266 -0.800266 -0.453125 -0.109375 0.234375 -0.857092 -0.857092 -0.857092 -0.453125 -0.046875 0.140625 -0.987376 -0.987376 -0.987376 -0.453125 -0.046875 0.171875 -1.78465 -1.78465 -1.78465 -0.453125 -0.015625 0.140625 -8.47744 -8.47744 -8.47744 -0.265625 -0.171875 0.265625 -1.56943 -1.56943 -1.56943 -0.265625 -0.140625 0.265625 -1.52639 -1.52639 -1.52639 -0.328125 -0.140625 0.265625 -1.15917 -1.15917 -1.15917 -0.359375 -0.140625 0.265625 -1.45515 -1.45515 -1.45515 -0.359375 -0.140625 0.296875 -1.80624 -1.80624 -1.80624 -0.265625 -0.109375 0.265625 -1.59232 -1.59232 -1.59232 -0.265625 -0.078125 0.265625 -2.793 -2.793 -2.793 -0.265625 -0.046875 0.265625 -4.23431 -4.23431 -4.23431 -0.328125 -0.109375 0.265625 -2.1211 -2.1211 -2.1211 -0.328125 -0.078125 0.265625 -2.10913 -2.10913 -2.10913 -0.359375 -0.109375 0.265625 -0.616026 -0.616026 -0.616026 -0.359375 -0.109375 0.296875 -0.722095 -0.722095 -0.722095 -0.359375 -0.078125 0.265625 -0.73675 -0.73675 -0.73675 -0.359375 -0.078125 0.296875 -0.122394 -0.122394 -0.122394 -0.359375 -0.046875 0.265625 -0.6864 -0.6864 -0.6864 -0.390625 -0.140625 0.265625 -1.21287 -1.21287 -1.21287 -0.390625 -0.140625 0.296875 -0.984279 -0.984279 -0.984279 -0.421875 -0.140625 0.265625 -1.75555 -1.75555 -1.75555 -0.390625 -0.109375 0.265625 -0.799772 -0.799772 -0.799772 -0.390625 -0.109375 0.296875 -0.716759 -0.716759 -0.716759 -0.390625 -0.078125 0.265625 -0.576372 -0.576372 -0.576372 -0.390625 -0.078125 0.296875 -0.573371 -0.573371 -0.573371 -0.421875 -0.109375 0.265625 -1.40694 -1.40694 -1.40694 -0.421875 -0.078125 0.265625 -1.86976 -1.86976 -1.86976 -0.390625 -0.046875 0.265625 -1.06875 -1.06875 -1.06875 -0.515625 -0.078125 0.015625 -6.42603 -6.42603 -6.42603 -0.546875 -0.078125 0.015625 0.593186 0.593186 0.593186 -0.515625 -0.046875 0.015625 -6.48379 -6.48379 -6.48379 -0.515625 -0.046875 0.046875 2.67429 2.67429 2.67429 -0.515625 -0.015625 0.015625 0.668579 0.668579 0.668579 -0.515625 -0.015625 0.046875 -1.86586 -1.86586 -1.86586 -0.546875 -0.046875 0.015625 -7.99185 -7.99185 -7.99185 -0.546875 -0.046875 0.046875 3.02186 3.02186 3.02186 -0.546875 -0.015625 0.015625 -3.29605 -3.29605 -3.29605 -0.546875 -0.015625 0.046875 -1.07259 -1.07259 -1.07259 -0.578125 -0.046875 0.015625 -3.58556 -3.58556 -3.58556 -0.578125 -0.015625 0.015625 -2.96978 -2.96978 -2.96978 -0.015625 0.015625 -0.421875 -1.44263 -1.44263 -1.44263 -0.015625 0.015625 -0.390625 -1.61726 -1.61726 -1.61726 -0.015625 0.046875 -0.421875 -1.72231 -1.72231 -1.72231 -0.046875 0.015625 -0.390625 -1.73279 -1.73279 -1.73279 -0.046875 0.046875 -0.390625 -1.65232 -1.65232 -1.65232 -0.015625 0.078125 -0.421875 -1.42139 -1.42139 -1.42139 -0.015625 0.078125 -0.390625 -1.58247 -1.58247 -1.58247 -0.046875 0.078125 -0.390625 -1.77218 -1.77218 -1.77218 -0.015625 0.015625 -0.359375 -1.84163 -1.84163 -1.84163 -0.015625 0.015625 -0.328125 -1.63069 -1.63069 -1.63069 -0.015625 0.046875 -0.359375 -1.19843 -1.19843 -1.19843 -0.015625 0.046875 -0.328125 -1.09411 -1.09411 -1.09411 -0.046875 0.015625 -0.359375 -1.64693 -1.64693 -1.64693 -0.046875 0.015625 -0.328125 -1.29774 -1.29774 -1.29774 -0.046875 0.046875 -0.359375 -0.828023 -0.828023 -0.828023 -0.046875 0.046875 -0.328125 -1.09697 -1.09697 -1.09697 -0.015625 0.015625 -0.296875 -0.987677 -0.987677 -0.987677 -0.015625 0.015625 -0.265625 -1.46978 -1.46978 -1.46978 -0.015625 0.046875 -0.296875 -1.65628 -1.65628 -1.65628 -0.046875 0.015625 -0.296875 -1.78109 -1.78109 -1.78109 -0.046875 0.015625 -0.265625 -2.37037 -2.37037 -2.37037 -0.046875 0.046875 -0.296875 -1.4293 -1.4293 -1.4293 -0.015625 0.078125 -0.359375 -0.910137 -0.910137 -0.910137 -0.015625 0.078125 -0.328125 -0.948235 -0.948235 -0.948235 -0.015625 0.109375 -0.359375 -0.389074 -0.389074 -0.389074 -0.046875 0.078125 -0.359375 -0.908136 -0.908136 -0.908136 -0.046875 0.078125 -0.328125 -1.50731 -1.50731 -1.50731 -0.015625 0.078125 -0.296875 1.18191 1.18191 1.18191 -0.015625 0.109375 -0.296875 1.32991 1.32991 1.32991 -0.015625 0.109375 -0.265625 -1.75065 -1.75065 -1.75065 -0.046875 0.109375 -0.296875 -2.10614 -2.10614 -2.10614 -0.046875 0.109375 -0.265625 -2.16031 -2.16031 -2.16031 -0.078125 0.015625 -0.359375 -0.922094 -0.922094 -0.922094 -0.078125 0.015625 -0.328125 -0.996038 -0.996038 -0.996038 -0.078125 0.046875 -0.359375 -0.889961 -0.889961 -0.889961 -0.109375 0.015625 -0.359375 -0.868298 -0.868298 -0.868298 -0.109375 0.015625 -0.328125 -1.35679 -1.35679 -1.35679 -0.109375 0.046875 -0.359375 -0.954573 -0.954573 -0.954573 -0.109375 0.046875 -0.328125 -1.0087 -1.0087 -1.0087 -0.109375 0.015625 -0.265625 -0.503006 -0.503006 -0.503006 -0.078125 0.078125 -0.359375 -0.730509 -0.730509 -0.730509 -0.078125 0.078125 -0.328125 -0.984193 -0.984193 -0.984193 -0.109375 0.078125 -0.359375 -0.873857 -0.873857 -0.873857 -0.109375 0.078125 -0.328125 -1.12854 -1.12854 -1.12854 -0.078125 0.078125 -0.296875 -1.64978 -1.64978 -1.64978 -0.078125 0.078125 -0.265625 -2.89305 -2.89305 -2.89305 -0.078125 0.109375 -0.296875 -1.78771 -1.78771 -1.78771 -0.078125 0.109375 -0.265625 -1.62114 -1.62114 -1.62114 -0.109375 0.078125 -0.296875 -1.89578 -1.89578 -1.89578 -0.109375 0.078125 -0.265625 -2.18879 -2.18879 -2.18879 -0.109375 0.109375 -0.265625 -0.843505 -0.843505 -0.843505 -0.015625 0.234375 -0.390625 -2.05587 -2.05587 -2.05587 -0.046875 0.234375 -0.390625 -1.39617 -1.39617 -1.39617 -0.015625 0.140625 -0.296875 -0.0945606 -0.0945606 -0.0945606 -0.015625 0.140625 -0.265625 -1.59007 -1.59007 -1.59007 -0.015625 0.171875 -0.265625 -1.08617 -1.08617 -1.08617 -0.046875 0.140625 -0.265625 -1.65354 -1.65354 -1.65354 -0.046875 0.171875 -0.265625 -0.928478 -0.928478 -0.928478 -0.015625 0.203125 -0.359375 -3.80009 -3.80009 -3.80009 -0.015625 0.203125 -0.328125 -2.48406 -2.48406 -2.48406 -0.015625 0.234375 -0.359375 -2.30752 -2.30752 -2.30752 -0.015625 0.234375 -0.328125 -2.18242 -2.18242 -2.18242 -0.046875 0.234375 -0.359375 -1.58033 -1.58033 -1.58033 -0.046875 0.234375 -0.328125 -1.72345 -1.72345 -1.72345 -0.015625 0.203125 -0.265625 -0.821863 -0.821863 -0.821863 -0.015625 0.234375 -0.296875 -1.84902 -1.84902 -1.84902 -0.015625 0.234375 -0.265625 -2.46577 -2.46577 -2.46577 -0.046875 0.203125 -0.265625 -0.987139 -0.987139 -0.987139 -0.046875 0.234375 -0.296875 -1.87523 -1.87523 -1.87523 -0.046875 0.234375 -0.265625 -2.10625 -2.10625 -2.10625 -0.078125 0.140625 -0.296875 -1.17788 -1.17788 -1.17788 -0.078125 0.140625 -0.265625 -1.20415 -1.20415 -1.20415 -0.078125 0.171875 -0.296875 -1.37697 -1.37697 -1.37697 -0.078125 0.171875 -0.265625 -1.33117 -1.33117 -1.33117 -0.109375 0.140625 -0.296875 -1.32916 -1.32916 -1.32916 -0.109375 0.171875 -0.296875 -1.03654 -1.03654 -1.03654 -0.078125 0.203125 -0.265625 -1.33256 -1.33256 -1.33256 -0.078125 0.234375 -0.265625 -1.69077 -1.69077 -1.69077 -0.109375 0.203125 -0.265625 -3.67657 -3.67657 -3.67657 -0.109375 0.234375 -0.296875 -2.06336 -2.06336 -2.06336 -0.109375 0.234375 -0.265625 -1.99585 -1.99585 -1.99585 -0.140625 0.015625 -0.328125 -1.32113 -1.32113 -1.32113 -0.140625 0.046875 -0.328125 -1.51299 -1.51299 -1.51299 -0.140625 0.015625 -0.265625 -0.921648 -0.921648 -0.921648 -0.140625 0.046875 -0.296875 -0.812933 -0.812933 -0.812933 -0.140625 0.046875 -0.265625 -0.716661 -0.716661 -0.716661 -0.171875 0.015625 -0.296875 -0.926525 -0.926525 -0.926525 -0.171875 0.015625 -0.265625 -2.78148 -2.78148 -2.78148 -0.171875 0.046875 -0.265625 -2.38001 -2.38001 -2.38001 -0.171875 0.109375 -0.328125 -4.02517 -4.02517 -4.02517 -0.140625 0.078125 -0.296875 -1.52686 -1.52686 -1.52686 -0.140625 0.078125 -0.265625 -3.79146 -3.79146 -3.79146 -0.140625 0.109375 -0.265625 15.3624 15.3624 15.3624 -0.171875 0.078125 -0.296875 -2.04869 -2.04869 -2.04869 -0.171875 0.078125 -0.265625 -2.78415 -2.78415 -2.78415 -0.171875 0.109375 -0.296875 -0.13599 -0.13599 -0.13599 -0.171875 0.109375 -0.265625 -3.77589 -3.77589 -3.77589 -0.203125 0.015625 -0.265625 -1.41323 -1.41323 -1.41323 -0.203125 0.046875 -0.265625 -2.08842 -2.08842 -2.08842 -0.234375 0.046875 -0.265625 -3.19608 -3.19608 -3.19608 -0.203125 0.109375 -0.328125 -1.03115 -1.03115 -1.03115 -0.234375 0.109375 -0.328125 -4.05002 -4.05002 -4.05002 -0.203125 0.078125 -0.296875 -2.38207 -2.38207 -2.38207 -0.203125 0.078125 -0.265625 -2.57355 -2.57355 -2.57355 -0.234375 0.078125 -0.296875 -1.46446 -1.46446 -1.46446 -0.234375 0.078125 -0.265625 -0.28987 -0.28987 -0.28987 -0.234375 0.109375 -0.296875 -1.38418 -1.38418 -1.38418 -0.234375 0.109375 -0.265625 -4.42371 -4.42371 -4.42371 -0.171875 0.140625 -0.328125 -2.11689 -2.11689 -2.11689 -0.171875 0.171875 -0.359375 -2.02679 -2.02679 -2.02679 -0.171875 0.171875 -0.328125 -3.44399 -3.44399 -3.44399 -0.140625 0.140625 -0.296875 -3.06373 -3.06373 -3.06373 -0.140625 0.140625 -0.265625 -9.30628 -9.30628 -9.30628 -0.140625 0.171875 -0.296875 -1.44151 -1.44151 -1.44151 -0.140625 0.171875 -0.265625 0.462205 0.462205 0.462205 -0.171875 0.140625 -0.296875 -0.43719 -0.43719 -0.43719 -0.171875 0.140625 -0.265625 -4.20772 -4.20772 -4.20772 -0.171875 0.171875 -0.296875 -0.17545 -0.17545 -0.17545 -0.171875 0.171875 -0.265625 -1.29951 -1.29951 -1.29951 -0.140625 0.203125 -0.328125 -1.62737 -1.62737 -1.62737 -0.140625 0.234375 -0.328125 -2.35669 -2.35669 -2.35669 -0.171875 0.203125 -0.359375 -1.70975 -1.70975 -1.70975 -0.171875 0.203125 -0.328125 -1.7682 -1.7682 -1.7682 -0.171875 0.234375 -0.359375 -1.75821 -1.75821 -1.75821 -0.171875 0.234375 -0.328125 -2.14856 -2.14856 -2.14856 -0.140625 0.203125 -0.296875 -1.75168 -1.75168 -1.75168 -0.140625 0.203125 -0.265625 -1.71789 -1.71789 -1.71789 -0.140625 0.234375 -0.296875 -1.93489 -1.93489 -1.93489 -0.140625 0.234375 -0.265625 -2.19251 -2.19251 -2.19251 -0.171875 0.203125 -0.296875 -1.68797 -1.68797 -1.68797 -0.171875 0.203125 -0.265625 -0.756821 -0.756821 -0.756821 -0.171875 0.234375 -0.296875 -1.78547 -1.78547 -1.78547 -0.171875 0.234375 -0.265625 -2.05222 -2.05222 -2.05222 -0.203125 0.140625 -0.328125 -1.7292 -1.7292 -1.7292 -0.203125 0.171875 -0.359375 -1.69 -1.69 -1.69 -0.203125 0.171875 -0.328125 -0.643216 -0.643216 -0.643216 -0.234375 0.140625 -0.328125 -5.19482 -5.19482 -5.19482 -0.234375 0.171875 -0.359375 -1.9018 -1.9018 -1.9018 -0.234375 0.171875 -0.328125 -2.64706 -2.64706 -2.64706 -0.203125 0.140625 -0.296875 -2.222 -2.222 -2.222 -0.203125 0.171875 -0.296875 -1.54474 -1.54474 -1.54474 -0.234375 0.140625 -0.296875 26.0956 26.0956 26.0956 -0.234375 0.140625 -0.265625 -4.32909 -4.32909 -4.32909 -0.203125 0.203125 -0.359375 -1.55353 -1.55353 -1.55353 -0.203125 0.234375 -0.359375 -1.68499 -1.68499 -1.68499 -0.234375 0.203125 -0.359375 -1.79717 -1.79717 -1.79717 -0.234375 0.234375 -0.359375 -1.76748 -1.76748 -1.76748 -0.234375 0.234375 -0.328125 -2.31187 -2.31187 -2.31187 -0.203125 0.234375 -0.265625 -1.34361 -1.34361 -1.34361 -0.234375 0.234375 -0.265625 -1.54614 -1.54614 -1.54614 -0.015625 0.015625 -0.203125 -1.87227 -1.87227 -1.87227 -0.046875 0.015625 -0.234375 -1.06537 -1.06537 -1.06537 -0.046875 0.015625 -0.203125 -1.90256 -1.90256 -1.90256 -0.046875 0.046875 -0.203125 -1.94255 -1.94255 -1.94255 -0.015625 0.015625 -0.140625 27.8899 27.8899 27.8899 -0.015625 0.046875 -0.171875 -1.04558 -1.04558 -1.04558 -0.015625 0.046875 -0.140625 -1.29718 -1.29718 -1.29718 -0.046875 0.015625 -0.171875 -1.33095 -1.33095 -1.33095 -0.046875 0.015625 -0.140625 -53.5268 -53.5268 -53.5268 -0.046875 0.046875 -0.171875 -1.36219 -1.36219 -1.36219 -0.046875 0.046875 -0.140625 -1.29689 -1.29689 -1.29689 -0.015625 0.109375 -0.203125 -2.39999 -2.39999 -2.39999 -0.046875 0.078125 -0.203125 -2.30943 -2.30943 -2.30943 -0.046875 0.109375 -0.234375 -1.85376 -1.85376 -1.85376 -0.046875 0.109375 -0.203125 -2.6774 -2.6774 -2.6774 -0.015625 0.078125 -0.171875 -2.28903 -2.28903 -2.28903 -0.015625 0.109375 -0.171875 -2.44511 -2.44511 -2.44511 -0.015625 0.109375 -0.140625 -2.04759 -2.04759 -2.04759 -0.046875 0.078125 -0.171875 -2.16349 -2.16349 -2.16349 -0.078125 0.015625 -0.203125 -1.54202 -1.54202 -1.54202 -0.078125 0.046875 -0.203125 -1.36713 -1.36713 -1.36713 -0.109375 0.015625 -0.234375 -0.725639 -0.725639 -0.725639 -0.109375 0.015625 -0.203125 -2.34917 -2.34917 -2.34917 -0.109375 0.046875 -0.203125 -1.82715 -1.82715 -1.82715 -0.078125 0.015625 -0.171875 -1.44971 -1.44971 -1.44971 -0.078125 0.015625 -0.140625 -0.523076 -0.523076 -0.523076 -0.078125 0.046875 -0.171875 -1.17112 -1.17112 -1.17112 -0.109375 0.015625 -0.171875 -7.34528 -7.34528 -7.34528 -0.109375 0.015625 -0.140625 6.69011 6.69011 6.69011 -0.109375 0.046875 -0.171875 -13.8289 -13.8289 -13.8289 -0.078125 0.078125 -0.234375 -1.54521 -1.54521 -1.54521 -0.078125 0.078125 -0.203125 -1.48569 -1.48569 -1.48569 -0.078125 0.109375 -0.234375 -1.99476 -1.99476 -1.99476 -0.078125 0.109375 -0.203125 -1.42496 -1.42496 -1.42496 -0.109375 0.078125 -0.234375 -1.69983 -1.69983 -1.69983 -0.109375 0.078125 -0.203125 -0.711452 -0.711452 -0.711452 -0.109375 0.109375 -0.234375 -0.738155 -0.738155 -0.738155 -0.109375 0.109375 -0.203125 -2.56603 -2.56603 -2.56603 -0.109375 0.078125 -0.171875 18.0723 18.0723 18.0723 -0.109375 0.109375 -0.171875 -2.69718 -2.69718 -2.69718 -0.015625 0.015625 -0.109375 36.6007 36.6007 36.6007 -0.015625 0.015625 -0.078125 -30.7206 -30.7206 -30.7206 -0.015625 0.046875 -0.078125 -0.449569 -0.449569 -0.449569 -0.046875 0.015625 -0.109375 -22.2507 -22.2507 -22.2507 -0.046875 0.015625 -0.078125 -21.3341 -21.3341 -21.3341 -0.046875 0.046875 -0.078125 -0.979559 -0.979559 -0.979559 -0.015625 0.015625 -0.046875 -0.858397 -0.858397 -0.858397 -0.015625 0.015625 -0.015625 -1.31872 -1.31872 -1.31872 -0.015625 0.046875 -0.046875 -0.828981 -0.828981 -0.828981 -0.046875 0.046875 -0.046875 -1.52116 -1.52116 -1.52116 -0.015625 0.078125 -0.109375 -1.87046 -1.87046 -1.87046 -0.015625 0.109375 -0.109375 -2.16981 -2.16981 -2.16981 -0.015625 0.109375 -0.078125 -1.6402 -1.6402 -1.6402 -0.046875 0.078125 -0.078125 -1.8384 -1.8384 -1.8384 -0.015625 0.078125 -0.046875 -0.770544 -0.770544 -0.770544 -0.015625 0.078125 -0.015625 -0.712831 -0.712831 -0.712831 -0.015625 0.109375 -0.046875 -2.88948 -2.88948 -2.88948 -0.015625 0.109375 -0.015625 -3.31917 -3.31917 -3.31917 -0.046875 0.078125 -0.046875 -1.17265 -1.17265 -1.17265 -0.046875 0.109375 -0.046875 -2.3543 -2.3543 -2.3543 -0.078125 0.015625 -0.109375 -0.809236 -0.809236 -0.809236 -0.078125 0.015625 -0.078125 -0.8086 -0.8086 -0.8086 -0.078125 0.046875 -0.109375 -1.95699 -1.95699 -1.95699 -0.078125 0.046875 -0.078125 -2.27445 -2.27445 -2.27445 -0.109375 0.015625 -0.109375 15.9276 15.9276 15.9276 -0.109375 0.046875 -0.109375 -0.906853 -0.906853 -0.906853 -0.109375 0.015625 -0.046875 -1.39687 -1.39687 -1.39687 -0.109375 0.015625 -0.015625 -1.37336 -1.37336 -1.37336 -0.078125 0.078125 -0.109375 -3.66532 -3.66532 -3.66532 -0.078125 0.078125 -0.078125 -3.24832 -3.24832 -3.24832 -0.078125 0.109375 -0.078125 -2.17203 -2.17203 -2.17203 -0.109375 0.078125 -0.109375 -9.26898 -9.26898 -9.26898 -0.109375 0.078125 -0.078125 -2.85505 -2.85505 -2.85505 -0.109375 0.109375 -0.109375 -3.51115 -3.51115 -3.51115 -0.109375 0.109375 -0.078125 -2.06439 -2.06439 -2.06439 -0.015625 0.140625 -0.203125 -1.35683 -1.35683 -1.35683 -0.015625 0.171875 -0.203125 -1.2821 -1.2821 -1.2821 -0.046875 0.140625 -0.234375 -1.44275 -1.44275 -1.44275 -0.046875 0.140625 -0.203125 -1.46755 -1.46755 -1.46755 -0.046875 0.171875 -0.234375 -1.03396 -1.03396 -1.03396 -0.046875 0.171875 -0.203125 -1.48909 -1.48909 -1.48909 -0.015625 0.140625 -0.171875 -1.40999 -1.40999 -1.40999 -0.015625 0.140625 -0.140625 -1.89075 -1.89075 -1.89075 -0.015625 0.171875 -0.171875 -1.88925 -1.88925 -1.88925 -0.015625 0.171875 -0.140625 -1.4923 -1.4923 -1.4923 -0.046875 0.140625 -0.171875 -1.78372 -1.78372 -1.78372 -0.046875 0.140625 -0.140625 -2.37433 -2.37433 -2.37433 -0.046875 0.171875 -0.171875 -1.58891 -1.58891 -1.58891 -0.015625 0.203125 -0.234375 -0.962211 -0.962211 -0.962211 -0.015625 0.203125 -0.203125 -1.29431 -1.29431 -1.29431 -0.015625 0.234375 -0.234375 -2.15168 -2.15168 -2.15168 -0.015625 0.234375 -0.203125 -3.02508 -3.02508 -3.02508 -0.015625 0.203125 -0.171875 -1.29924 -1.29924 -1.29924 -0.015625 0.203125 -0.140625 -1.85489 -1.85489 -1.85489 -0.015625 0.234375 -0.171875 -4.24279 -4.24279 -4.24279 -0.015625 0.234375 -0.140625 -5.66613 -5.66613 -5.66613 -0.046875 0.203125 -0.140625 -1.3964 -1.3964 -1.3964 -0.046875 0.234375 -0.171875 -2.06537 -2.06537 -2.06537 -0.046875 0.234375 -0.140625 -3.76225 -3.76225 -3.76225 -0.078125 0.140625 -0.234375 -1.26921 -1.26921 -1.26921 -0.078125 0.140625 -0.203125 -2.07053 -2.07053 -2.07053 -0.078125 0.171875 -0.234375 -1.35455 -1.35455 -1.35455 -0.078125 0.171875 -0.203125 -2.09639 -2.09639 -2.09639 -0.078125 0.140625 -0.171875 -1.91458 -1.91458 -1.91458 -0.078125 0.140625 -0.140625 -2.10136 -2.10136 -2.10136 -0.109375 0.140625 -0.171875 -1.43545 -1.43545 -1.43545 -0.109375 0.140625 -0.140625 -2.61365 -2.61365 -2.61365 -0.109375 0.171875 -0.171875 -1.01243 -1.01243 -1.01243 -0.109375 0.171875 -0.140625 -2.41502 -2.41502 -2.41502 -0.078125 0.234375 -0.234375 -1.61633 -1.61633 -1.61633 -0.109375 0.203125 -0.234375 -4.77307 -4.77307 -4.77307 -0.109375 0.234375 -0.234375 -2.48909 -2.48909 -2.48909 -0.109375 0.234375 -0.203125 -2.79281 -2.79281 -2.79281 -0.078125 0.234375 -0.171875 -0.0511763 -0.0511763 -0.0511763 -0.078125 0.234375 -0.140625 -2.42026 -2.42026 -2.42026 -0.109375 0.203125 -0.140625 -1.99177 -1.99177 -1.99177 -0.109375 0.234375 -0.171875 -2.65717 -2.65717 -2.65717 -0.109375 0.234375 -0.140625 -8.7444 -8.7444 -8.7444 -0.015625 0.140625 -0.109375 -2.15413 -2.15413 -2.15413 -0.015625 0.140625 -0.078125 -1.9521 -1.9521 -1.9521 -0.015625 0.171875 -0.109375 -2.28536 -2.28536 -2.28536 -0.015625 0.171875 -0.078125 -2.40404 -2.40404 -2.40404 -0.046875 0.140625 -0.109375 -1.46183 -1.46183 -1.46183 -0.046875 0.171875 -0.109375 -1.15099 -1.15099 -1.15099 -0.015625 0.140625 -0.046875 -3.92336 -3.92336 -3.92336 -0.015625 0.140625 -0.015625 -6.17524 -6.17524 -6.17524 -0.015625 0.171875 -0.015625 -2.85521 -2.85521 -2.85521 -0.046875 0.140625 -0.046875 -3.34323 -3.34323 -3.34323 -0.046875 0.171875 -0.046875 -2.61015 -2.61015 -2.61015 -0.015625 0.203125 -0.109375 -2.1048 -2.1048 -2.1048 -0.015625 0.203125 -0.078125 -2.7566 -2.7566 -2.7566 -0.015625 0.234375 -0.109375 -1.77642 -1.77642 -1.77642 -0.015625 0.234375 -0.078125 -3.22656 -3.22656 -3.22656 -0.046875 0.203125 -0.109375 -1.77099 -1.77099 -1.77099 -0.046875 0.234375 -0.109375 -2.29471 -2.29471 -2.29471 -0.046875 0.234375 -0.078125 -1.76071 -1.76071 -1.76071 -0.015625 0.203125 -0.015625 -2.94978 -2.94978 -2.94978 -0.015625 0.234375 -0.046875 -1.7218 -1.7218 -1.7218 -0.046875 0.203125 -0.015625 -1.56089 -1.56089 -1.56089 -0.046875 0.234375 -0.046875 -1.88518 -1.88518 -1.88518 -0.046875 0.234375 -0.015625 -1.62719 -1.62719 -1.62719 -0.078125 0.140625 -0.109375 -1.73377 -1.73377 -1.73377 -0.078125 0.171875 -0.109375 -1.35643 -1.35643 -1.35643 -0.109375 0.140625 -0.109375 -2.79095 -2.79095 -2.79095 -0.109375 0.140625 -0.078125 -2.25155 -2.25155 -2.25155 -0.109375 0.171875 -0.109375 -2.71874 -2.71874 -2.71874 -0.109375 0.171875 -0.078125 -1.93707 -1.93707 -1.93707 -0.078125 0.140625 -0.046875 -2.28982 -2.28982 -2.28982 -0.078125 0.171875 -0.046875 -1.38403 -1.38403 -1.38403 -0.109375 0.140625 -0.046875 -1.88267 -1.88267 -1.88267 -0.109375 0.171875 -0.046875 -0.846965 -0.846965 -0.846965 -0.078125 0.203125 -0.109375 -1.23647 -1.23647 -1.23647 -0.078125 0.234375 -0.109375 -2.31953 -2.31953 -2.31953 -0.078125 0.234375 -0.078125 -2.27562 -2.27562 -2.27562 -0.109375 0.203125 -0.109375 -1.16911 -1.16911 -1.16911 -0.109375 0.203125 -0.078125 -1.08303 -1.08303 -1.08303 -0.109375 0.234375 -0.109375 -11.1384 -11.1384 -11.1384 -0.109375 0.234375 -0.078125 6.44949 6.44949 6.44949 -0.078125 0.203125 -0.046875 -0.927422 -0.927422 -0.927422 -0.078125 0.203125 -0.015625 -1.00585 -1.00585 -1.00585 -0.078125 0.234375 -0.046875 -1.69624 -1.69624 -1.69624 -0.078125 0.234375 -0.015625 -1.27869 -1.27869 -1.27869 -0.109375 0.203125 -0.046875 -0.181185 -0.181185 -0.181185 -0.109375 0.203125 -0.015625 -1.10193 -1.10193 -1.10193 -0.109375 0.234375 -0.046875 -3.24268 -3.24268 -3.24268 -0.109375 0.234375 -0.015625 -1.72834 -1.72834 -1.72834 -0.140625 0.015625 -0.234375 -0.794902 -0.794902 -0.794902 -0.140625 0.015625 -0.203125 -0.707787 -0.707787 -0.707787 -0.140625 0.046875 -0.234375 -0.834509 -0.834509 -0.834509 -0.140625 0.046875 -0.203125 0.239504 0.239504 0.239504 -0.140625 0.015625 -0.171875 -4.85651 -4.85651 -4.85651 -0.140625 0.015625 -0.140625 -9.01362 -9.01362 -9.01362 -0.140625 0.046875 -0.171875 -5.75638 -5.75638 -5.75638 -0.140625 0.046875 -0.140625 3.80025 3.80025 3.80025 -0.171875 0.015625 -0.171875 -1.7978 -1.7978 -1.7978 -0.171875 0.015625 -0.140625 -0.835468 -0.835468 -0.835468 -0.171875 0.046875 -0.171875 -26.8156 -26.8156 -26.8156 -0.171875 0.046875 -0.140625 -8.92582 -8.92582 -8.92582 -0.140625 0.078125 -0.234375 -5.15663 -5.15663 -5.15663 -0.140625 0.109375 -0.234375 -0.927547 -0.927547 -0.927547 -0.171875 0.078125 -0.234375 -1.91335 -1.91335 -1.91335 -0.140625 0.078125 -0.171875 -5.41403 -5.41403 -5.41403 -0.140625 0.078125 -0.140625 9.71519 9.71519 9.71519 -0.140625 0.109375 -0.171875 -2.77599 -2.77599 -2.77599 -0.140625 0.109375 -0.140625 -0.293584 -0.293584 -0.293584 -0.171875 0.078125 -0.171875 -4.21258 -4.21258 -4.21258 -0.171875 0.078125 -0.140625 4.33519 4.33519 4.33519 -0.171875 0.109375 -0.171875 -7.82771 -7.82771 -7.82771 -0.171875 0.109375 -0.140625 0.441465 0.441465 0.441465 -0.203125 0.015625 -0.234375 -1.19044 -1.19044 -1.19044 -0.203125 0.015625 -0.203125 -1.0424 -1.0424 -1.0424 -0.234375 0.015625 -0.234375 -1.71344 -1.71344 -1.71344 -0.234375 0.015625 -0.203125 -2.21363 -2.21363 -2.21363 -0.234375 0.046875 -0.234375 -0.771349 -0.771349 -0.771349 -0.203125 0.015625 -0.171875 -1.05924 -1.05924 -1.05924 -0.203125 0.015625 -0.140625 -0.823724 -0.823724 -0.823724 -0.203125 0.046875 -0.171875 -4.23867 -4.23867 -4.23867 -0.203125 0.046875 -0.140625 -0.867567 -0.867567 -0.867567 -0.234375 0.015625 -0.171875 -2.02558 -2.02558 -2.02558 -0.234375 0.015625 -0.140625 3.27617 3.27617 3.27617 -0.234375 0.046875 -0.171875 -2.67088 -2.67088 -2.67088 -0.234375 0.046875 -0.140625 -8.52256 -8.52256 -8.52256 -0.234375 0.078125 -0.234375 -1.15511 -1.15511 -1.15511 -0.234375 0.109375 -0.234375 0.74401 0.74401 0.74401 -0.234375 0.109375 -0.203125 -0.0870736 -0.0870736 -0.0870736 -0.203125 0.078125 -0.171875 -1.87875 -1.87875 -1.87875 -0.203125 0.078125 -0.140625 0.0159744 0.0159744 0.0159744 -0.203125 0.109375 -0.171875 0.167498 0.167498 0.167498 -0.203125 0.109375 -0.140625 -2.01368 -2.01368 -2.01368 -0.234375 0.078125 -0.171875 1.58685 1.58685 1.58685 -0.234375 0.078125 -0.140625 0.55206 0.55206 0.55206 -0.234375 0.109375 -0.171875 -3.71337 -3.71337 -3.71337 -0.234375 0.109375 -0.140625 -0.388675 -0.388675 -0.388675 -0.140625 0.046875 -0.109375 -10.5135 -10.5135 -10.5135 -0.171875 0.015625 -0.078125 -1.71818 -1.71818 -1.71818 -0.171875 0.046875 -0.109375 -8.94209 -8.94209 -8.94209 -0.171875 0.046875 -0.078125 -3.51275 -3.51275 -3.51275 -0.140625 0.015625 -0.046875 -0.699512 -0.699512 -0.699512 -0.140625 0.015625 -0.015625 -1.55716 -1.55716 -1.55716 -0.140625 0.046875 -0.015625 -2.23738 -2.23738 -2.23738 -0.171875 0.015625 -0.046875 -1.46642 -1.46642 -1.46642 -0.171875 0.046875 -0.046875 -2.23983 -2.23983 -2.23983 -0.171875 0.046875 -0.015625 -1.37377 -1.37377 -1.37377 -0.140625 0.078125 -0.109375 -2.26333 -2.26333 -2.26333 -0.140625 0.109375 -0.109375 -1.78096 -1.78096 -1.78096 -0.171875 0.109375 -0.109375 -1.85837 -1.85837 -1.85837 -0.140625 0.078125 -0.015625 -2.1447 -2.1447 -2.1447 -0.171875 0.078125 -0.046875 -2.92477 -2.92477 -2.92477 -0.171875 0.078125 -0.015625 -2.41656 -2.41656 -2.41656 -0.171875 0.109375 -0.015625 -2.20495 -2.20495 -2.20495 -0.203125 0.015625 -0.109375 -1.31653 -1.31653 -1.31653 -0.203125 0.015625 -0.078125 -0.9972 -0.9972 -0.9972 -0.203125 0.046875 -0.109375 -1.06052 -1.06052 -1.06052 -0.203125 0.046875 -0.078125 -1.07817 -1.07817 -1.07817 -0.234375 0.015625 -0.109375 -1.31852 -1.31852 -1.31852 -0.234375 0.046875 -0.109375 -1.20261 -1.20261 -1.20261 -0.234375 0.046875 -0.078125 -1.19248 -1.19248 -1.19248 -0.203125 0.015625 -0.046875 -1.85548 -1.85548 -1.85548 -0.203125 0.046875 -0.046875 -1.69746 -1.69746 -1.69746 -0.203125 0.046875 -0.015625 -1.8277 -1.8277 -1.8277 -0.234375 0.015625 -0.046875 -2.03275 -2.03275 -2.03275 -0.234375 0.015625 -0.015625 -2.09072 -2.09072 -2.09072 -0.234375 0.046875 -0.046875 -1.81324 -1.81324 -1.81324 -0.234375 0.046875 -0.015625 -2.04108 -2.04108 -2.04108 -0.203125 0.078125 -0.109375 -0.187582 -0.187582 -0.187582 -0.203125 0.109375 -0.109375 -4.7703 -4.7703 -4.7703 -0.203125 0.109375 -0.078125 -1.44238 -1.44238 -1.44238 -0.234375 0.078125 -0.109375 -1.23263 -1.23263 -1.23263 -0.234375 0.078125 -0.078125 -1.15436 -1.15436 -1.15436 -0.234375 0.109375 -0.109375 -1.0111 -1.0111 -1.0111 -0.234375 0.109375 -0.078125 -1.23677 -1.23677 -1.23677 -0.203125 0.078125 -0.046875 -1.73462 -1.73462 -1.73462 -0.203125 0.109375 -0.046875 -1.87131 -1.87131 -1.87131 -0.203125 0.109375 -0.015625 -2.64231 -2.64231 -2.64231 -0.234375 0.078125 -0.046875 -2.00737 -2.00737 -2.00737 -0.140625 0.140625 -0.234375 -3.83694 -3.83694 -3.83694 -0.140625 0.171875 -0.234375 0.481652 0.481652 0.481652 -0.171875 0.171875 -0.234375 -4.20046 -4.20046 -4.20046 -0.140625 0.140625 -0.171875 -1.20395 -1.20395 -1.20395 -0.140625 0.140625 -0.140625 -1.78879 -1.78879 -1.78879 -0.140625 0.171875 -0.140625 -0.943359 -0.943359 -0.943359 -0.171875 0.140625 -0.140625 -3.54497 -3.54497 -3.54497 -0.171875 0.171875 -0.140625 -0.602375 -0.602375 -0.602375 -0.140625 0.203125 -0.234375 -1.67294 -1.67294 -1.67294 -0.140625 0.203125 -0.203125 -1.51232 -1.51232 -1.51232 -0.140625 0.234375 -0.234375 -2.07575 -2.07575 -2.07575 -0.140625 0.234375 -0.203125 -1.86157 -1.86157 -1.86157 -0.171875 0.203125 -0.234375 -2.44004 -2.44004 -2.44004 -0.171875 0.203125 -0.203125 -2.85825 -2.85825 -2.85825 -0.171875 0.234375 -0.234375 -1.95811 -1.95811 -1.95811 -0.171875 0.234375 -0.203125 -0.993352 -0.993352 -0.993352 -0.140625 0.203125 -0.171875 -0.865051 -0.865051 -0.865051 -0.140625 0.203125 -0.140625 -0.896039 -0.896039 -0.896039 -0.140625 0.234375 -0.171875 -1.32759 -1.32759 -1.32759 -0.140625 0.234375 -0.140625 1.54406 1.54406 1.54406 -0.171875 0.234375 -0.171875 -1.07094 -1.07094 -1.07094 -0.171875 0.234375 -0.140625 9.06312 9.06312 9.06312 -0.203125 0.171875 -0.203125 -5.85797 -5.85797 -5.85797 -0.234375 0.140625 -0.203125 2.93461 2.93461 2.93461 -0.234375 0.171875 -0.203125 -2.05651 -2.05651 -2.05651 -0.203125 0.140625 -0.171875 -4.26797 -4.26797 -4.26797 -0.203125 0.140625 -0.140625 -4.49317 -4.49317 -4.49317 -0.203125 0.171875 -0.171875 -3.2679 -3.2679 -3.2679 -0.203125 0.171875 -0.140625 -1.84948 -1.84948 -1.84948 -0.234375 0.140625 -0.171875 -3.79788 -3.79788 -3.79788 -0.234375 0.171875 -0.171875 -5.11682 -5.11682 -5.11682 -0.203125 0.203125 -0.234375 -0.731255 -0.731255 -0.731255 -0.203125 0.203125 -0.203125 -0.664261 -0.664261 -0.664261 -0.203125 0.234375 -0.234375 -1.0439 -1.0439 -1.0439 -0.203125 0.234375 -0.203125 -1.21383 -1.21383 -1.21383 -0.234375 0.203125 -0.203125 -0.977194 -0.977194 -0.977194 -0.234375 0.234375 -0.234375 -0.93044 -0.93044 -0.93044 -0.234375 0.234375 -0.203125 -1.40866 -1.40866 -1.40866 -0.203125 0.203125 -0.171875 -1.27765 -1.27765 -1.27765 -0.203125 0.203125 -0.140625 -1.01283 -1.01283 -1.01283 -0.203125 0.234375 -0.140625 -2.44542 -2.44542 -2.44542 -0.234375 0.203125 -0.171875 -1.22503 -1.22503 -1.22503 -0.234375 0.203125 -0.140625 -1.96202 -1.96202 -1.96202 -0.234375 0.234375 -0.140625 -2.29019 -2.29019 -2.29019 -0.140625 0.140625 -0.109375 -2.84291 -2.84291 -2.84291 -0.140625 0.171875 -0.109375 -2.11927 -2.11927 -2.11927 -0.140625 0.171875 -0.078125 -1.88708 -1.88708 -1.88708 -0.171875 0.140625 -0.109375 -4.92066 -4.92066 -4.92066 -0.171875 0.140625 -0.078125 -2.658 -2.658 -2.658 -0.171875 0.171875 -0.109375 -1.72378 -1.72378 -1.72378 -0.171875 0.171875 -0.078125 -2.59557 -2.59557 -2.59557 -0.140625 0.140625 -0.015625 -1.53524 -1.53524 -1.53524 -0.140625 0.171875 -0.046875 -1.97966 -1.97966 -1.97966 -0.140625 0.171875 -0.015625 -1.07773 -1.07773 -1.07773 -0.171875 0.140625 -0.015625 -2.49106 -2.49106 -2.49106 -0.171875 0.171875 -0.046875 -5.08207 -5.08207 -5.08207 -0.171875 0.171875 -0.015625 -0.072283 -0.072283 -0.072283 -0.140625 0.203125 -0.078125 -1.84676 -1.84676 -1.84676 -0.140625 0.234375 -0.109375 -3.72028 -3.72028 -3.72028 -0.140625 0.234375 -0.078125 -5.14023 -5.14023 -5.14023 -0.171875 0.203125 -0.078125 -2.37781 -2.37781 -2.37781 -0.171875 0.234375 -0.078125 -4.18627 -4.18627 -4.18627 -0.140625 0.203125 -0.015625 -1.73519 -1.73519 -1.73519 -0.140625 0.234375 -0.046875 -1.64291 -1.64291 -1.64291 -0.140625 0.234375 -0.015625 -2.36787 -2.36787 -2.36787 -0.171875 0.203125 -0.046875 1.63304 1.63304 1.63304 -0.171875 0.203125 -0.015625 -2.91791 -2.91791 -2.91791 -0.171875 0.234375 -0.046875 -1.74075 -1.74075 -1.74075 -0.203125 0.140625 -0.078125 -2.73006 -2.73006 -2.73006 -0.203125 0.171875 -0.109375 -1.1371 -1.1371 -1.1371 -0.203125 0.171875 -0.078125 3.14386 3.14386 3.14386 -0.234375 0.140625 -0.078125 -1.83907 -1.83907 -1.83907 -0.234375 0.171875 -0.109375 -1.94792 -1.94792 -1.94792 -0.234375 0.171875 -0.078125 -1.46084 -1.46084 -1.46084 -0.203125 0.140625 -0.046875 -2.48629 -2.48629 -2.48629 -0.203125 0.140625 -0.015625 -1.69921 -1.69921 -1.69921 -0.203125 0.171875 -0.046875 -7.17154 -7.17154 -7.17154 -0.203125 0.171875 -0.015625 -9.05343 -9.05343 -9.05343 -0.234375 0.140625 -0.046875 -1.74917 -1.74917 -1.74917 -0.234375 0.140625 -0.015625 -1.45085 -1.45085 -1.45085 -0.203125 0.203125 -0.109375 -1.70897 -1.70897 -1.70897 -0.203125 0.203125 -0.078125 2.11963 2.11963 2.11963 -0.203125 0.234375 -0.109375 -1.5148 -1.5148 -1.5148 -0.234375 0.203125 -0.109375 -1.72612 -1.72612 -1.72612 -0.234375 0.234375 -0.109375 -1.36569 -1.36569 -1.36569 -0.203125 0.203125 -0.046875 -5.41408 -5.41408 -5.41408 -0.015625 0.265625 -0.390625 -1.5863 -1.5863 -1.5863 -0.015625 0.296875 -0.390625 -1.75831 -1.75831 -1.75831 -0.046875 0.265625 -0.390625 -1.50915 -1.50915 -1.50915 -0.046875 0.296875 -0.390625 -1.92077 -1.92077 -1.92077 -0.015625 0.328125 -0.390625 -1.73459 -1.73459 -1.73459 -0.015625 0.359375 -0.390625 -1.32446 -1.32446 -1.32446 -0.046875 0.328125 -0.390625 -1.91547 -1.91547 -1.91547 -0.046875 0.359375 -0.390625 -1.94191 -1.94191 -1.94191 -0.078125 0.328125 -0.390625 -1.57495 -1.57495 -1.57495 -0.046875 0.265625 -0.359375 -1.50811 -1.50811 -1.50811 -0.046875 0.265625 -0.328125 -2.11663 -2.11663 -2.11663 -0.046875 0.296875 -0.359375 -1.94775 -1.94775 -1.94775 -0.046875 0.296875 -0.328125 -2.13613 -2.13613 -2.13613 -0.015625 0.359375 -0.328125 -1.863 -1.863 -1.863 -0.046875 0.359375 -0.359375 -1.87253 -1.87253 -1.87253 -0.046875 0.359375 -0.328125 -1.8028 -1.8028 -1.8028 -0.015625 0.328125 -0.296875 -1.84086 -1.84086 -1.84086 -0.015625 0.328125 -0.265625 -1.4179 -1.4179 -1.4179 -0.015625 0.359375 -0.296875 -2.00246 -2.00246 -2.00246 -0.046875 0.328125 -0.296875 -1.82969 -1.82969 -1.82969 -0.046875 0.328125 -0.265625 -1.85626 -1.85626 -1.85626 -0.046875 0.359375 -0.296875 -1.5506 -1.5506 -1.5506 -0.078125 0.265625 -0.328125 -1.76653 -1.76653 -1.76653 -0.078125 0.296875 -0.359375 -1.86086 -1.86086 -1.86086 -0.078125 0.296875 -0.328125 -2.17106 -2.17106 -2.17106 -0.109375 0.296875 -0.328125 -2.08593 -2.08593 -2.08593 -0.078125 0.265625 -0.296875 -1.85214 -1.85214 -1.85214 -0.078125 0.265625 -0.265625 -2.18743 -2.18743 -2.18743 -0.078125 0.296875 -0.296875 -2.24178 -2.24178 -2.24178 -0.078125 0.296875 -0.265625 -2.16484 -2.16484 -2.16484 -0.109375 0.265625 -0.296875 -2.02624 -2.02624 -2.02624 -0.109375 0.265625 -0.265625 -2.04358 -2.04358 -2.04358 -0.109375 0.296875 -0.296875 -2.16317 -2.16317 -2.16317 -0.109375 0.296875 -0.265625 -1.99029 -1.99029 -1.99029 -0.078125 0.328125 -0.359375 -1.8579 -1.8579 -1.8579 -0.078125 0.328125 -0.328125 -2.01523 -2.01523 -2.01523 -0.078125 0.359375 -0.359375 -1.61958 -1.61958 -1.61958 -0.078125 0.359375 -0.328125 -1.77286 -1.77286 -1.77286 -0.109375 0.328125 -0.328125 -2.96621 -2.96621 -2.96621 -0.109375 0.359375 -0.328125 -1.20684 -1.20684 -1.20684 -0.078125 0.328125 -0.296875 -2.1633 -2.1633 -2.1633 -0.078125 0.328125 -0.265625 -2.21199 -2.21199 -2.21199 -0.109375 0.328125 -0.296875 -1.87509 -1.87509 -1.87509 -0.109375 0.328125 -0.265625 -2.06144 -2.06144 -2.06144 -0.109375 0.359375 -0.296875 -1.30801 -1.30801 -1.30801 -0.109375 0.359375 -0.265625 -1.51462 -1.51462 -1.51462 -0.015625 0.390625 -0.390625 -1.10347 -1.10347 -1.10347 -0.046875 0.390625 -0.390625 -1.58162 -1.58162 -1.58162 -0.015625 0.390625 -0.359375 -1.04083 -1.04083 -1.04083 -0.015625 0.390625 -0.328125 -2.46021 -2.46021 -2.46021 -0.046875 0.390625 -0.359375 -1.5311 -1.5311 -1.5311 -0.046875 0.390625 -0.328125 -1.47109 -1.47109 -1.47109 -0.015625 0.390625 -0.296875 -1.72638 -1.72638 -1.72638 -0.046875 0.390625 -0.296875 -1.11721 -1.11721 -1.11721 -0.171875 0.265625 -0.390625 -1.67577 -1.67577 -1.67577 -0.171875 0.296875 -0.390625 -2.02091 -2.02091 -2.02091 -0.171875 0.328125 -0.390625 -2.00296 -2.00296 -2.00296 -0.203125 0.265625 -0.390625 -1.75333 -1.75333 -1.75333 -0.203125 0.296875 -0.390625 -2.08596 -2.08596 -2.08596 -0.234375 0.265625 -0.390625 -1.54206 -1.54206 -1.54206 -0.234375 0.296875 -0.390625 -1.74023 -1.74023 -1.74023 -0.203125 0.328125 -0.390625 -2.08653 -2.08653 -2.08653 -0.203125 0.359375 -0.390625 -1.75486 -1.75486 -1.75486 -0.234375 0.328125 -0.390625 -1.89156 -1.89156 -1.89156 -0.140625 0.265625 -0.328125 -2.19223 -2.19223 -2.19223 -0.140625 0.296875 -0.359375 -1.96282 -1.96282 -1.96282 -0.140625 0.296875 -0.328125 -2.42655 -2.42655 -2.42655 -0.171875 0.265625 -0.359375 -1.91627 -1.91627 -1.91627 -0.171875 0.265625 -0.328125 0.279772 0.279772 0.279772 -0.171875 0.296875 -0.359375 -1.96298 -1.96298 -1.96298 -0.140625 0.265625 -0.296875 -1.737 -1.737 -1.737 -0.140625 0.328125 -0.359375 -0.973535 -0.973535 -0.973535 -0.140625 0.328125 -0.328125 -0.786756 -0.786756 -0.786756 -0.140625 0.359375 -0.359375 -2.8634 -2.8634 -2.8634 -0.140625 0.359375 -0.328125 1.24878 1.24878 1.24878 -0.171875 0.359375 -0.359375 -2.66488 -2.66488 -2.66488 -0.171875 0.359375 -0.328125 -6.04034 -6.04034 -6.04034 -0.140625 0.359375 -0.296875 -1.1294 -1.1294 -1.1294 -0.140625 0.359375 -0.265625 -1.00306 -1.00306 -1.00306 -0.171875 0.359375 -0.265625 -0.095806 -0.095806 -0.095806 -0.203125 0.265625 -0.359375 -1.80457 -1.80457 -1.80457 -0.234375 0.265625 -0.359375 -2.04184 -2.04184 -2.04184 -0.234375 0.265625 -0.328125 -1.07444 -1.07444 -1.07444 -0.234375 0.296875 -0.359375 -1.99824 -1.99824 -1.99824 -0.203125 0.296875 -0.296875 -2.86623 -2.86623 -2.86623 -0.203125 0.296875 -0.265625 -2.21403 -2.21403 -2.21403 -0.234375 0.265625 -0.296875 -1.33176 -1.33176 -1.33176 -0.234375 0.265625 -0.265625 -1.59836 -1.59836 -1.59836 -0.234375 0.296875 -0.296875 -2.84283 -2.84283 -2.84283 -0.234375 0.296875 -0.265625 1.72748 1.72748 1.72748 -0.203125 0.359375 -0.359375 -2.14873 -2.14873 -2.14873 -0.234375 0.328125 -0.359375 -2.16703 -2.16703 -2.16703 -0.234375 0.328125 -0.328125 -5.57572 -5.57572 -5.57572 -0.234375 0.359375 -0.359375 -1.89012 -1.89012 -1.89012 -0.234375 0.359375 -0.328125 -1.87012 -1.87012 -1.87012 -0.203125 0.328125 -0.296875 -2.84617 -2.84617 -2.84617 -0.203125 0.328125 -0.265625 -1.96873 -1.96873 -1.96873 -0.203125 0.359375 -0.296875 -2.05012 -2.05012 -2.05012 -0.203125 0.359375 -0.265625 -6.07865 -6.07865 -6.07865 -0.234375 0.328125 -0.296875 -1.36454 -1.36454 -1.36454 -0.234375 0.359375 -0.296875 -1.80986 -1.80986 -1.80986 -0.140625 0.390625 -0.328125 0.707526 0.707526 0.707526 -0.171875 0.390625 -0.328125 0.0227119 0.0227119 0.0227119 -0.140625 0.390625 -0.296875 -0.628657 -0.628657 -0.628657 -0.140625 0.390625 -0.265625 -2.0097 -2.0097 -2.0097 -0.171875 0.390625 -0.296875 -5.81813 -5.81813 -5.81813 -0.171875 0.390625 -0.265625 -6.33412 -6.33412 -6.33412 -0.203125 0.390625 -0.359375 -1.64587 -1.64587 -1.64587 -0.203125 0.390625 -0.328125 -1.60507 -1.60507 -1.60507 -0.203125 0.390625 -0.296875 -0.557559 -0.557559 -0.557559 -0.015625 0.296875 -0.203125 -0.891756 -0.891756 -0.891756 -0.046875 0.296875 -0.234375 -1.64599 -1.64599 -1.64599 -0.015625 0.265625 -0.171875 0.0887906 0.0887906 0.0887906 -0.015625 0.265625 -0.140625 -7.09793 -7.09793 -7.09793 -0.015625 0.296875 -0.171875 -5.01089 -5.01089 -5.01089 -0.015625 0.296875 -0.140625 -6.67406 -6.67406 -6.67406 -0.046875 0.265625 -0.140625 -2.50253 -2.50253 -2.50253 -0.046875 0.296875 -0.140625 -0.585188 -0.585188 -0.585188 -0.015625 0.328125 -0.234375 -0.877541 -0.877541 -0.877541 -0.015625 0.328125 -0.203125 0.466952 0.466952 0.466952 -0.046875 0.328125 -0.234375 -3.49184 -3.49184 -3.49184 -0.046875 0.328125 -0.203125 -0.0149475 -0.0149475 -0.0149475 -0.015625 0.328125 -0.171875 -0.926646 -0.926646 -0.926646 -0.015625 0.328125 -0.140625 -5.11896 -5.11896 -5.11896 -0.015625 0.359375 -0.171875 -1.41288 -1.41288 -1.41288 -0.015625 0.359375 -0.140625 -2.4063 -2.4063 -2.4063 -0.046875 0.359375 -0.171875 2.61225 2.61225 2.61225 -0.078125 0.265625 -0.234375 -3.01601 -3.01601 -3.01601 -0.078125 0.265625 -0.203125 0.703663 0.703663 0.703663 -0.078125 0.296875 -0.234375 -1.5293 -1.5293 -1.5293 -0.078125 0.296875 -0.203125 3.40576 3.40576 3.40576 -0.109375 0.265625 -0.234375 -1.95489 -1.95489 -1.95489 -0.109375 0.265625 -0.203125 -1.5956 -1.5956 -1.5956 -0.109375 0.296875 -0.234375 -2.0039 -2.0039 -2.0039 -0.109375 0.296875 -0.203125 -1.569 -1.569 -1.569 -0.078125 0.265625 -0.171875 -0.248134 -0.248134 -0.248134 -0.078125 0.265625 -0.140625 0.684477 0.684477 0.684477 -0.078125 0.296875 -0.171875 -0.637775 -0.637775 -0.637775 -0.078125 0.296875 -0.140625 -2.24583 -2.24583 -2.24583 -0.109375 0.265625 -0.171875 -1.4806 -1.4806 -1.4806 -0.109375 0.296875 -0.171875 -1.47885 -1.47885 -1.47885 -0.078125 0.328125 -0.234375 -1.18739 -1.18739 -1.18739 -0.078125 0.328125 -0.203125 1.47442 1.47442 1.47442 -0.109375 0.328125 -0.234375 -1.88873 -1.88873 -1.88873 -0.078125 0.328125 -0.171875 -0.963535 -0.963535 -0.963535 -0.078125 0.328125 -0.140625 18.8082 18.8082 18.8082 -0.078125 0.359375 -0.171875 -0.512817 -0.512817 -0.512817 -0.078125 0.359375 -0.140625 -11.1827 -11.1827 -11.1827 -0.109375 0.328125 -0.140625 -50.5044 -50.5044 -50.5044 -0.109375 0.359375 -0.140625 -15.1585 -15.1585 -15.1585 -0.015625 0.265625 -0.046875 -2.83534 -2.83534 -2.83534 -0.015625 0.265625 -0.015625 -2.30457 -2.30457 -2.30457 -0.015625 0.296875 -0.046875 -2.17901 -2.17901 -2.17901 -0.015625 0.296875 -0.015625 -1.74662 -1.74662 -1.74662 -0.046875 0.265625 -0.015625 -1.97776 -1.97776 -1.97776 -0.046875 0.296875 -0.046875 -1.64189 -1.64189 -1.64189 -0.046875 0.296875 -0.015625 -1.82355 -1.82355 -1.82355 -0.015625 0.328125 -0.109375 -2.18035 -2.18035 -2.18035 -0.015625 0.328125 -0.078125 -1.20886 -1.20886 -1.20886 -0.015625 0.359375 -0.109375 -2.12917 -2.12917 -2.12917 -0.015625 0.359375 -0.078125 -2.64176 -2.64176 -2.64176 -0.015625 0.328125 -0.046875 -1.84426 -1.84426 -1.84426 -0.015625 0.328125 -0.015625 -3.44091 -3.44091 -3.44091 -0.015625 0.359375 -0.046875 -0.915498 -0.915498 -0.915498 -0.015625 0.359375 -0.015625 -1.38835 -1.38835 -1.38835 -0.046875 0.328125 -0.046875 -1.41087 -1.41087 -1.41087 -0.046875 0.328125 -0.015625 -1.39108 -1.39108 -1.39108 -0.046875 0.359375 -0.046875 -0.979984 -0.979984 -0.979984 -0.046875 0.359375 -0.015625 -0.867071 -0.867071 -0.867071 -0.078125 0.265625 -0.109375 -1.9452 -1.9452 -1.9452 -0.109375 0.265625 -0.109375 2.5016 2.5016 2.5016 -0.109375 0.265625 -0.078125 -0.925265 -0.925265 -0.925265 -0.109375 0.296875 -0.109375 -0.769643 -0.769643 -0.769643 -0.109375 0.296875 -0.078125 0.405885 0.405885 0.405885 -0.109375 0.265625 -0.015625 -0.944955 -0.944955 -0.944955 -0.109375 0.296875 -0.015625 -0.585253 -0.585253 -0.585253 -0.109375 0.328125 -0.109375 8.43785 8.43785 8.43785 -0.078125 0.328125 -0.046875 -1.79424 -1.79424 -1.79424 -0.078125 0.328125 -0.015625 -0.633073 -0.633073 -0.633073 -0.078125 0.359375 -0.015625 -1.22517 -1.22517 -1.22517 -0.109375 0.328125 -0.046875 -2.12952 -2.12952 -2.12952 -0.109375 0.328125 -0.015625 0.209015 0.209015 0.209015 -0.109375 0.359375 -0.015625 -2.31692 -2.31692 -2.31692 -0.015625 0.390625 -0.171875 -2.0783 -2.0783 -2.0783 -0.015625 0.390625 -0.140625 -2.03888 -2.03888 -2.03888 -0.046875 0.390625 -0.171875 -1.00208 -1.00208 -1.00208 -0.046875 0.390625 -0.140625 -1.03422 -1.03422 -1.03422 -0.078125 0.390625 -0.171875 -2.44015 -2.44015 -2.44015 -0.078125 0.390625 -0.140625 7.82652 7.82652 7.82652 -0.109375 0.390625 -0.140625 8.57909 8.57909 8.57909 -0.015625 0.390625 -0.109375 -1.8701 -1.8701 -1.8701 -0.015625 0.390625 -0.078125 -3.18163 -3.18163 -3.18163 -0.046875 0.390625 -0.109375 3.31858 3.31858 3.31858 -0.046875 0.390625 -0.078125 -2.78445 -2.78445 -2.78445 -0.015625 0.390625 -0.046875 -1.6312 -1.6312 -1.6312 -0.015625 0.421875 -0.046875 -1.51574 -1.51574 -1.51574 -0.015625 0.421875 -0.015625 -1.42672 -1.42672 -1.42672 -0.046875 0.390625 -0.046875 -1.07611 -1.07611 -1.07611 -0.046875 0.390625 -0.015625 -0.682386 -0.682386 -0.682386 -0.046875 0.421875 -0.046875 -1.44181 -1.44181 -1.44181 -0.046875 0.421875 -0.015625 -1.36896 -1.36896 -1.36896 -0.046875 0.453125 -0.015625 -2.61321 -2.61321 -2.61321 -0.078125 0.390625 -0.109375 368.314 368.314 368.314 -0.078125 0.390625 -0.078125 46.5224 46.5224 46.5224 -0.078125 0.421875 -0.078125 -2.26576 -2.26576 -2.26576 -0.109375 0.390625 -0.109375 -6.02411 -6.02411 -6.02411 -0.109375 0.390625 -0.078125 1.2678 1.2678 1.2678 -0.109375 0.421875 -0.078125 -3.18837 -3.18837 -3.18837 -0.078125 0.421875 -0.046875 -1.94262 -1.94262 -1.94262 -0.078125 0.421875 -0.015625 -1.17246 -1.17246 -1.17246 -0.109375 0.453125 -0.078125 -2.88338 -2.88338 -2.88338 -0.078125 0.453125 -0.046875 -3.37499 -3.37499 -3.37499 -0.078125 0.453125 -0.015625 -2.02585 -2.02585 -2.02585 -0.078125 0.484375 -0.046875 -4.9602 -4.9602 -4.9602 -0.078125 0.484375 -0.015625 -1.90905 -1.90905 -1.90905 -0.109375 0.453125 -0.046875 -13.8706 -13.8706 -13.8706 -0.109375 0.484375 -0.046875 -0.486026 -0.486026 -0.486026 -0.109375 0.484375 -0.015625 -2.33048 -2.33048 -2.33048 -0.140625 0.265625 -0.234375 -2.09292 -2.09292 -2.09292 -0.140625 0.296875 -0.234375 -1.95116 -1.95116 -1.95116 -0.140625 0.296875 -0.203125 -1.6468 -1.6468 -1.6468 -0.171875 0.265625 -0.234375 -1.81996 -1.81996 -1.81996 -0.171875 0.296875 -0.234375 -1.99627 -1.99627 -1.99627 -0.140625 0.265625 -0.140625 7.87053 7.87053 7.87053 -0.171875 0.265625 -0.171875 -2.30276 -2.30276 -2.30276 -0.171875 0.265625 -0.140625 12.1759 12.1759 12.1759 -0.171875 0.296875 -0.171875 -2.03119 -2.03119 -2.03119 -0.171875 0.296875 -0.140625 6.90978 6.90978 6.90978 -0.140625 0.328125 -0.234375 -2.10003 -2.10003 -2.10003 -0.140625 0.359375 -0.234375 -1.42823 -1.42823 -1.42823 -0.171875 0.328125 -0.234375 -1.86163 -1.86163 -1.86163 -0.171875 0.359375 -0.234375 -1.5642 -1.5642 -1.5642 -0.140625 0.328125 -0.140625 13.1077 13.1077 13.1077 -0.140625 0.359375 -0.140625 -14.1255 -14.1255 -14.1255 -0.171875 0.328125 -0.171875 7.07399 7.07399 7.07399 -0.171875 0.328125 -0.140625 4.52098 4.52098 4.52098 -0.171875 0.359375 -0.171875 -1.76708 -1.76708 -1.76708 -0.171875 0.359375 -0.140625 22.2086 22.2086 22.2086 -0.203125 0.265625 -0.234375 -1.73556 -1.73556 -1.73556 -0.203125 0.265625 -0.203125 -1.95535 -1.95535 -1.95535 -0.203125 0.296875 -0.234375 -1.88369 -1.88369 -1.88369 -0.203125 0.296875 -0.203125 -1.69687 -1.69687 -1.69687 -0.234375 0.265625 -0.234375 -1.05205 -1.05205 -1.05205 -0.234375 0.265625 -0.203125 -1.83051 -1.83051 -1.83051 -0.234375 0.296875 -0.234375 -0.390061 -0.390061 -0.390061 -0.234375 0.296875 -0.203125 -2.6718 -2.6718 -2.6718 -0.203125 0.265625 -0.171875 -2.54679 -2.54679 -2.54679 -0.203125 0.265625 -0.140625 -3.05014 -3.05014 -3.05014 -0.203125 0.296875 -0.171875 -1.84061 -1.84061 -1.84061 -0.203125 0.296875 -0.140625 -1.39139 -1.39139 -1.39139 -0.234375 0.265625 -0.140625 -2.3411 -2.3411 -2.3411 -0.234375 0.296875 -0.171875 -2.52981 -2.52981 -2.52981 -0.234375 0.296875 -0.140625 -1.92952 -1.92952 -1.92952 -0.203125 0.328125 -0.234375 -1.79454 -1.79454 -1.79454 -0.203125 0.328125 -0.203125 -1.54097 -1.54097 -1.54097 -0.203125 0.359375 -0.203125 -2.00051 -2.00051 -2.00051 -0.234375 0.328125 -0.203125 -1.1765 -1.1765 -1.1765 -0.203125 0.328125 -0.171875 9.03504 9.03504 9.03504 -0.203125 0.359375 -0.171875 13.0704 13.0704 13.0704 -0.234375 0.328125 -0.171875 -2.10454 -2.10454 -2.10454 -0.234375 0.328125 -0.140625 -2.07944 -2.07944 -2.07944 -0.234375 0.359375 -0.171875 -1.35632 -1.35632 -1.35632 -0.234375 0.359375 -0.140625 -2.82149 -2.82149 -2.82149 -0.140625 0.265625 -0.109375 -14.8707 -14.8707 -14.8707 -0.140625 0.265625 -0.078125 -4.79481 -4.79481 -4.79481 -0.140625 0.296875 -0.109375 -9.89546 -9.89546 -9.89546 -0.140625 0.296875 -0.078125 0.421573 0.421573 0.421573 -0.171875 0.265625 -0.109375 3.34364 3.34364 3.34364 -0.171875 0.265625 -0.078125 -12.52 -12.52 -12.52 -0.171875 0.296875 -0.109375 0.38722 0.38722 0.38722 -0.171875 0.296875 -0.078125 -4.42058 -4.42058 -4.42058 -0.140625 0.265625 -0.046875 -2.55147 -2.55147 -2.55147 -0.140625 0.265625 -0.015625 -1.26286 -1.26286 -1.26286 -0.140625 0.296875 -0.046875 -2.40586 -2.40586 -2.40586 -0.140625 0.296875 -0.015625 -1.21312 -1.21312 -1.21312 -0.171875 0.296875 -0.046875 -2.19471 -2.19471 -2.19471 -0.171875 0.296875 -0.015625 -6.13505 -6.13505 -6.13505 -0.140625 0.328125 -0.109375 -12.372 -12.372 -12.372 -0.171875 0.328125 -0.109375 -1.61036 -1.61036 -1.61036 -0.171875 0.328125 -0.078125 -0.780943 -0.780943 -0.780943 -0.171875 0.359375 -0.109375 -8.67908 -8.67908 -8.67908 -0.171875 0.359375 -0.078125 -1.76021 -1.76021 -1.76021 -0.140625 0.328125 -0.046875 -1.66212 -1.66212 -1.66212 -0.140625 0.328125 -0.015625 -0.468148 -0.468148 -0.468148 -0.140625 0.359375 -0.046875 -1.3043 -1.3043 -1.3043 -0.140625 0.359375 -0.015625 -2.15444 -2.15444 -2.15444 -0.171875 0.328125 -0.046875 -0.64965 -0.64965 -0.64965 -0.171875 0.328125 -0.015625 -1.17981 -1.17981 -1.17981 -0.171875 0.359375 -0.046875 -0.98698 -0.98698 -0.98698 -0.171875 0.359375 -0.015625 -2.85805 -2.85805 -2.85805 -0.203125 0.265625 -0.109375 -1.50298 -1.50298 -1.50298 -0.203125 0.296875 -0.109375 -0.940478 -0.940478 -0.940478 -0.203125 0.296875 -0.078125 -1.42509 -1.42509 -1.42509 -0.234375 0.265625 -0.109375 -1.77242 -1.77242 -1.77242 -0.234375 0.296875 -0.109375 -1.01467 -1.01467 -1.01467 -0.234375 0.296875 -0.078125 -1.00059 -1.00059 -1.00059 -0.203125 0.296875 -0.046875 -3.17688 -3.17688 -3.17688 -0.203125 0.296875 -0.015625 -3.21559 -3.21559 -3.21559 -0.234375 0.265625 -0.015625 -5.82949 -5.82949 -5.82949 -0.234375 0.296875 -0.046875 -2.69663 -2.69663 -2.69663 -0.234375 0.296875 -0.015625 0.994859 0.994859 0.994859 -0.203125 0.328125 -0.109375 -8.7427 -8.7427 -8.7427 -0.203125 0.359375 -0.109375 -24.5404 -24.5404 -24.5404 -0.234375 0.328125 -0.109375 -1.3425 -1.3425 -1.3425 -0.234375 0.359375 -0.109375 -1.30189 -1.30189 -1.30189 -0.203125 0.328125 -0.046875 2.34374 2.34374 2.34374 -0.203125 0.328125 -0.015625 -1.19563 -1.19563 -1.19563 -0.203125 0.359375 -0.046875 0.28402 0.28402 0.28402 -0.203125 0.359375 -0.015625 -1.27446 -1.27446 -1.27446 -0.140625 0.390625 -0.140625 -24.747 -24.747 -24.747 -0.171875 0.390625 -0.171875 -4.37005 -4.37005 -4.37005 -0.171875 0.390625 -0.140625 20.8803 20.8803 20.8803 -0.203125 0.390625 -0.171875 5.84761 5.84761 5.84761 -0.203125 0.390625 -0.140625 -2.76657 -2.76657 -2.76657 -0.234375 0.390625 -0.171875 0.489009 0.489009 0.489009 -0.234375 0.390625 -0.140625 -2.8766 -2.8766 -2.8766 -0.140625 0.390625 -0.109375 -14.4081 -14.4081 -14.4081 -0.140625 0.390625 -0.078125 14.2569 14.2569 14.2569 -0.140625 0.421875 -0.078125 -2.25051 -2.25051 -2.25051 -0.171875 0.390625 -0.109375 -11.5812 -11.5812 -11.5812 -0.171875 0.390625 -0.078125 -2.23089 -2.23089 -2.23089 -0.171875 0.421875 -0.078125 -2.97528 -2.97528 -2.97528 -0.171875 0.390625 -0.046875 0.490835 0.490835 0.490835 -0.171875 0.421875 -0.046875 5.44528 5.44528 5.44528 -0.171875 0.421875 -0.015625 6.3916 6.3916 6.3916 -0.140625 0.453125 -0.078125 0.599336 0.599336 0.599336 -0.140625 0.453125 -0.046875 -4.97393 -4.97393 -4.97393 -0.140625 0.453125 -0.015625 -0.889588 -0.889588 -0.889588 -0.140625 0.484375 -0.046875 -1.84317 -1.84317 -1.84317 -0.140625 0.484375 -0.015625 -2.34628 -2.34628 -2.34628 -0.171875 0.453125 -0.046875 4.34698 4.34698 4.34698 -0.171875 0.453125 -0.015625 -1.58781 -1.58781 -1.58781 -0.171875 0.484375 -0.046875 -0.157926 -0.157926 -0.157926 -0.171875 0.484375 -0.015625 -2.31593 -2.31593 -2.31593 -0.203125 0.390625 -0.109375 -12.2711 -12.2711 -12.2711 -0.234375 0.390625 -0.109375 0.8976 0.8976 0.8976 -0.203125 0.390625 -0.046875 -6.83836 -6.83836 -6.83836 -0.203125 0.390625 -0.015625 2.86499 2.86499 2.86499 -0.203125 0.421875 -0.046875 -6.11171 -6.11171 -6.11171 -0.203125 0.421875 -0.015625 -2.32055 -2.32055 -2.32055 -0.203125 0.484375 -0.015625 -4.14467 -4.14467 -4.14467 -0.265625 0.046875 -0.328125 -1.90333 -1.90333 -1.90333 -0.296875 0.015625 -0.359375 -0.612081 -0.612081 -0.612081 -0.296875 0.015625 -0.328125 -0.80829 -0.80829 -0.80829 -0.296875 0.046875 -0.359375 -0.710847 -0.710847 -0.710847 -0.296875 0.046875 -0.328125 -2.39071 -2.39071 -2.39071 -0.265625 0.015625 -0.296875 -0.0937162 -0.0937162 -0.0937162 -0.265625 0.046875 -0.296875 -3.68328 -3.68328 -3.68328 -0.265625 0.046875 -0.265625 -0.453432 -0.453432 -0.453432 -0.296875 0.015625 -0.296875 -1.63572 -1.63572 -1.63572 -0.296875 0.015625 -0.265625 -0.697887 -0.697887 -0.697887 -0.296875 0.046875 -0.265625 -0.148451 -0.148451 -0.148451 -0.265625 0.078125 -0.328125 0.11443 0.11443 0.11443 -0.296875 0.078125 -0.359375 4.59723 4.59723 4.59723 -0.296875 0.078125 -0.328125 -1.70434 -1.70434 -1.70434 -0.296875 0.109375 -0.328125 0.0716966 0.0716966 0.0716966 -0.265625 0.078125 -0.296875 -4.78439 -4.78439 -4.78439 -0.265625 0.078125 -0.265625 -1.0536 -1.0536 -1.0536 -0.265625 0.109375 -0.265625 -2.60793 -2.60793 -2.60793 -0.296875 0.078125 -0.296875 -2.8022 -2.8022 -2.8022 -0.296875 0.078125 -0.265625 -2.37515 -2.37515 -2.37515 -0.296875 0.109375 -0.296875 -3.05632 -3.05632 -3.05632 -0.296875 0.109375 -0.265625 -3.26192 -3.26192 -3.26192 -0.328125 0.015625 -0.359375 -0.702416 -0.702416 -0.702416 -0.328125 0.015625 -0.328125 -0.520402 -0.520402 -0.520402 -0.328125 0.046875 -0.359375 -0.682509 -0.682509 -0.682509 -0.359375 0.015625 -0.328125 -0.984791 -0.984791 -0.984791 -0.359375 0.046875 -0.359375 -1.30847 -1.30847 -1.30847 -0.359375 0.046875 -0.328125 -0.93966 -0.93966 -0.93966 -0.328125 0.015625 -0.296875 -1.88076 -1.88076 -1.88076 -0.328125 0.078125 -0.359375 -0.707125 -0.707125 -0.707125 -0.328125 0.078125 -0.328125 -0.790194 -0.790194 -0.790194 -0.328125 0.109375 -0.328125 -1.65134 -1.65134 -1.65134 -0.359375 0.078125 -0.359375 -0.803495 -0.803495 -0.803495 -0.359375 0.078125 -0.328125 -1.22985 -1.22985 -1.22985 -0.359375 0.109375 -0.328125 -1.4146 -1.4146 -1.4146 -0.328125 0.078125 -0.296875 -3.21662 -3.21662 -3.21662 -0.328125 0.078125 -0.265625 -5.17494 -5.17494 -5.17494 -0.328125 0.109375 -0.296875 -1.28771 -1.28771 -1.28771 -0.328125 0.109375 -0.265625 3.89369 3.89369 3.89369 -0.359375 0.078125 -0.296875 -1.72052 -1.72052 -1.72052 -0.359375 0.078125 -0.265625 -1.87784 -1.87784 -1.87784 -0.359375 0.109375 -0.296875 -0.947611 -0.947611 -0.947611 -0.359375 0.109375 -0.265625 -1.20529 -1.20529 -1.20529 -0.265625 0.171875 -0.328125 -1.73228 -1.73228 -1.73228 -0.296875 0.171875 -0.328125 -1.85407 -1.85407 -1.85407 -0.265625 0.140625 -0.296875 3.58712 3.58712 3.58712 -0.265625 0.140625 -0.265625 1.21723 1.21723 1.21723 -0.265625 0.171875 -0.296875 -1.79081 -1.79081 -1.79081 -0.265625 0.171875 -0.265625 -2.77701 -2.77701 -2.77701 -0.296875 0.140625 -0.265625 -2.26416 -2.26416 -2.26416 -0.296875 0.171875 -0.296875 -2.62693 -2.62693 -2.62693 -0.296875 0.171875 -0.265625 -1.26369 -1.26369 -1.26369 -0.265625 0.203125 -0.328125 -1.90357 -1.90357 -1.90357 -0.265625 0.234375 -0.328125 5.00984 5.00984 5.00984 -0.296875 0.203125 -0.328125 -1.05304 -1.05304 -1.05304 -0.296875 0.234375 -0.328125 41.0137 41.0137 41.0137 -0.296875 0.203125 -0.296875 -2.06323 -2.06323 -2.06323 -0.359375 0.140625 -0.328125 -1.74159 -1.74159 -1.74159 -0.359375 0.171875 -0.328125 -1.5792 -1.5792 -1.5792 -0.328125 0.140625 -0.296875 -2.39165 -2.39165 -2.39165 -0.328125 0.140625 -0.265625 -1.13938 -1.13938 -1.13938 -0.328125 0.171875 -0.296875 -1.83849 -1.83849 -1.83849 -0.328125 0.171875 -0.265625 -1.24464 -1.24464 -1.24464 -0.359375 0.140625 -0.296875 -1.95688 -1.95688 -1.95688 -0.359375 0.171875 -0.296875 -1.62199 -1.62199 -1.62199 -0.328125 0.203125 -0.328125 -1.49766 -1.49766 -1.49766 -0.328125 0.234375 -0.328125 40.2088 40.2088 40.2088 -0.359375 0.203125 -0.328125 -1.73028 -1.73028 -1.73028 -0.328125 0.203125 -0.296875 -1.4983 -1.4983 -1.4983 -0.328125 0.234375 -0.296875 -1.56486 -1.56486 -1.56486 -0.328125 0.234375 -0.265625 -1.64113 -1.64113 -1.64113 -0.359375 0.203125 -0.296875 -2.05676 -2.05676 -2.05676 -0.359375 0.234375 -0.296875 -1.99499 -1.99499 -1.99499 -0.359375 0.234375 -0.265625 -2.18071 -2.18071 -2.18071 -0.390625 0.015625 -0.328125 -2.10068 -2.10068 -2.10068 -0.390625 0.046875 -0.328125 -2.29191 -2.29191 -2.29191 -0.421875 0.015625 -0.328125 -1.70805 -1.70805 -1.70805 -0.421875 0.046875 -0.328125 -2.87094 -2.87094 -2.87094 -0.390625 0.046875 -0.296875 -2.22203 -2.22203 -2.22203 -0.390625 0.046875 -0.265625 -2.17409 -2.17409 -2.17409 -0.421875 0.015625 -0.296875 -2.12498 -2.12498 -2.12498 -0.421875 0.015625 -0.265625 -2.37881 -2.37881 -2.37881 -0.421875 0.046875 -0.296875 -2.21081 -2.21081 -2.21081 -0.421875 0.046875 -0.265625 -1.98834 -1.98834 -1.98834 -0.390625 0.078125 -0.328125 -1.59398 -1.59398 -1.59398 -0.390625 0.109375 -0.328125 -1.99759 -1.99759 -1.99759 -0.421875 0.109375 -0.328125 -1.5782 -1.5782 -1.5782 -0.390625 0.078125 -0.296875 -2.1967 -2.1967 -2.1967 -0.390625 0.078125 -0.265625 -2.07153 -2.07153 -2.07153 -0.390625 0.109375 -0.265625 -1.35313 -1.35313 -1.35313 -0.421875 0.078125 -0.296875 -1.44917 -1.44917 -1.44917 -0.421875 0.078125 -0.265625 -1.84004 -1.84004 -1.84004 -0.421875 0.109375 -0.296875 -0.848512 -0.848512 -0.848512 -0.421875 0.109375 -0.265625 -1.52836 -1.52836 -1.52836 -0.453125 0.015625 -0.296875 -1.73503 -1.73503 -1.73503 -0.453125 0.015625 -0.265625 -2.01705 -2.01705 -2.01705 -0.453125 0.109375 -0.328125 0.605421 0.605421 0.605421 -0.484375 0.109375 -0.328125 -2.04038 -2.04038 -2.04038 -0.453125 0.078125 -0.296875 -0.122367 -0.122367 -0.122367 -0.453125 0.078125 -0.265625 -1.13874 -1.13874 -1.13874 -0.453125 0.109375 -0.296875 -0.885312 -0.885312 -0.885312 -0.453125 0.109375 -0.265625 -1.36558 -1.36558 -1.36558 -0.484375 0.109375 -0.296875 -1.23799 -1.23799 -1.23799 -0.484375 0.109375 -0.265625 -0.729699 -0.729699 -0.729699 -0.390625 0.140625 -0.328125 -1.99179 -1.99179 -1.99179 -0.390625 0.171875 -0.328125 -1.67071 -1.67071 -1.67071 -0.421875 0.140625 -0.328125 -2.02534 -2.02534 -2.02534 -0.421875 0.171875 -0.328125 3.73749 3.73749 3.73749 -0.390625 0.171875 -0.296875 -1.45575 -1.45575 -1.45575 -0.421875 0.171875 -0.296875 0.120553 0.120553 0.120553 -0.421875 0.171875 -0.265625 -1.61717 -1.61717 -1.61717 -0.390625 0.203125 -0.296875 -1.86671 -1.86671 -1.86671 -0.390625 0.203125 -0.265625 -2.25308 -2.25308 -2.25308 -0.390625 0.234375 -0.296875 -1.81773 -1.81773 -1.81773 -0.390625 0.234375 -0.265625 -1.93903 -1.93903 -1.93903 -0.421875 0.203125 -0.265625 -2.10012 -2.10012 -2.10012 -0.453125 0.140625 -0.328125 -3.0235 -3.0235 -3.0235 -0.453125 0.171875 -0.328125 0.701552 0.701552 0.701552 -0.484375 0.140625 -0.328125 -0.248356 -0.248356 -0.248356 -0.484375 0.171875 -0.328125 -1.76387 -1.76387 -1.76387 -0.453125 0.171875 -0.296875 -17.916 -17.916 -17.916 -0.453125 0.171875 -0.265625 -1.01892 -1.01892 -1.01892 -0.484375 0.140625 -0.296875 -7.1427 -7.1427 -7.1427 -0.484375 0.140625 -0.265625 -1.05273 -1.05273 -1.05273 -0.484375 0.171875 -0.296875 -3.95628 -3.95628 -3.95628 -0.484375 0.171875 -0.265625 -0.772936 -0.772936 -0.772936 -0.265625 0.015625 -0.234375 -1.45659 -1.45659 -1.45659 -0.265625 0.015625 -0.203125 -6.16918 -6.16918 -6.16918 -0.265625 0.046875 -0.234375 -2.28552 -2.28552 -2.28552 -0.265625 0.046875 -0.203125 -12.8071 -12.8071 -12.8071 -0.296875 0.015625 -0.234375 -0.00513715 -0.00513715 -0.00513715 -0.296875 0.015625 -0.203125 -5.71512 -5.71512 -5.71512 -0.296875 0.046875 -0.234375 1.60535 1.60535 1.60535 -0.296875 0.046875 -0.203125 4.81136 4.81136 4.81136 -0.265625 0.015625 -0.171875 0.0711456 0.0711456 0.0711456 -0.265625 0.015625 -0.140625 3.77883 3.77883 3.77883 -0.296875 0.015625 -0.171875 -3.86362 -3.86362 -3.86362 -0.296875 0.015625 -0.140625 2.93899 2.93899 2.93899 -0.296875 0.046875 -0.171875 -9.72322 -9.72322 -9.72322 -0.296875 0.046875 -0.140625 -0.289356 -0.289356 -0.289356 -0.265625 0.078125 -0.234375 -2.34059 -2.34059 -2.34059 -0.265625 0.078125 -0.203125 -0.836421 -0.836421 -0.836421 -0.265625 0.109375 -0.234375 -6.07001 -6.07001 -6.07001 -0.265625 0.109375 -0.203125 -3.45556 -3.45556 -3.45556 -0.296875 0.078125 -0.234375 4.41291 4.41291 4.41291 -0.296875 0.078125 -0.203125 0.457957 0.457957 0.457957 -0.296875 0.109375 -0.234375 -4.55102 -4.55102 -4.55102 -0.296875 0.109375 -0.203125 -2.02959 -2.02959 -2.02959 -0.265625 0.078125 -0.171875 -1.5839 -1.5839 -1.5839 -0.265625 0.109375 -0.171875 0.063711 0.063711 0.063711 -0.265625 0.109375 -0.140625 0.420787 0.420787 0.420787 -0.296875 0.078125 -0.171875 -0.948656 -0.948656 -0.948656 -0.359375 0.046875 -0.234375 -2.95273 -2.95273 -2.95273 -0.359375 0.046875 -0.203125 -2.05879 -2.05879 -2.05879 -0.328125 0.015625 -0.171875 -4.04498 -4.04498 -4.04498 -0.328125 0.015625 -0.140625 -2.10787 -2.10787 -2.10787 -0.328125 0.046875 -0.171875 -0.428852 -0.428852 -0.428852 -0.328125 0.046875 -0.140625 -1.92765 -1.92765 -1.92765 -0.359375 0.015625 -0.140625 -1.97974 -1.97974 -1.97974 -0.359375 0.046875 -0.171875 -1.85287 -1.85287 -1.85287 -0.359375 0.046875 -0.140625 -1.94477 -1.94477 -1.94477 -0.328125 0.078125 -0.234375 -4.48488 -4.48488 -4.48488 -0.328125 0.078125 -0.203125 -3.53746 -3.53746 -3.53746 -0.328125 0.109375 -0.234375 -2.23101 -2.23101 -2.23101 -0.359375 0.078125 -0.234375 -0.913548 -0.913548 -0.913548 -0.359375 0.078125 -0.203125 -3.05154 -3.05154 -3.05154 -0.328125 0.078125 -0.171875 -2.11841 -2.11841 -2.11841 -0.328125 0.078125 -0.140625 -1.45279 -1.45279 -1.45279 -0.359375 0.078125 -0.171875 -1.25278 -1.25278 -1.25278 -0.359375 0.078125 -0.140625 -1.00429 -1.00429 -1.00429 -0.359375 0.109375 -0.171875 -3.74404 -3.74404 -3.74404 -0.359375 0.109375 -0.140625 -0.696062 -0.696062 -0.696062 -0.265625 0.015625 -0.109375 -2.70539 -2.70539 -2.70539 -0.265625 0.015625 -0.078125 -1.97198 -1.97198 -1.97198 -0.265625 0.046875 -0.078125 -1.77995 -1.77995 -1.77995 -0.265625 0.015625 -0.046875 -2.03285 -2.03285 -2.03285 -0.265625 0.015625 -0.015625 -2.20175 -2.20175 -2.20175 -0.265625 0.046875 -0.046875 -1.98875 -1.98875 -1.98875 -0.265625 0.046875 -0.015625 -2.17615 -2.17615 -2.17615 -0.296875 0.015625 -0.046875 -1.97101 -1.97101 -1.97101 -0.296875 0.015625 -0.015625 -2.27928 -2.27928 -2.27928 -0.265625 0.078125 -0.078125 -1.19367 -1.19367 -1.19367 -0.265625 0.109375 -0.109375 -1.33384 -1.33384 -1.33384 -0.265625 0.109375 -0.078125 -2.3219 -2.3219 -2.3219 -0.296875 0.109375 -0.109375 -1.50289 -1.50289 -1.50289 -0.296875 0.109375 -0.078125 -2.08522 -2.08522 -2.08522 -0.265625 0.078125 -0.046875 -2.05516 -2.05516 -2.05516 -0.265625 0.078125 -0.015625 -2.19718 -2.19718 -2.19718 -0.265625 0.109375 -0.046875 -2.17121 -2.17121 -2.17121 -0.265625 0.109375 -0.015625 -2.36692 -2.36692 -2.36692 -0.296875 0.109375 -0.046875 -2.41909 -2.41909 -2.41909 -0.296875 0.109375 -0.015625 -2.22227 -2.22227 -2.22227 -0.328125 0.015625 -0.109375 -2.10013 -2.10013 -2.10013 -0.328125 0.015625 -0.078125 -2.07747 -2.07747 -2.07747 -0.328125 0.046875 -0.109375 -1.97542 -1.97542 -1.97542 -0.328125 0.046875 -0.078125 -2.13585 -2.13585 -2.13585 -0.359375 0.015625 -0.109375 -1.97858 -1.97858 -1.97858 -0.359375 0.046875 -0.109375 -1.82186 -1.82186 -1.82186 -0.359375 0.046875 -0.078125 -2.38165 -2.38165 -2.38165 -0.328125 0.015625 -0.046875 -2.14683 -2.14683 -2.14683 -0.328125 0.015625 -0.015625 -2.30461 -2.30461 -2.30461 -0.328125 0.046875 -0.046875 -2.28588 -2.28588 -2.28588 -0.359375 0.015625 -0.015625 -1.81417 -1.81417 -1.81417 -0.359375 0.046875 -0.046875 -2.38282 -2.38282 -2.38282 -0.359375 0.046875 -0.015625 -6.64366 -6.64366 -6.64366 -0.328125 0.078125 -0.109375 -1.94059 -1.94059 -1.94059 -0.328125 0.078125 -0.078125 -2.17298 -2.17298 -2.17298 -0.328125 0.109375 -0.109375 -1.95724 -1.95724 -1.95724 -0.328125 0.109375 -0.078125 -2.44421 -2.44421 -2.44421 -0.359375 0.078125 -0.078125 -2.68115 -2.68115 -2.68115 -0.328125 0.109375 -0.046875 -2.14733 -2.14733 -2.14733 -0.328125 0.109375 -0.015625 -2.30987 -2.30987 -2.30987 -0.359375 0.078125 -0.046875 -2.31434 -2.31434 -2.31434 -0.359375 0.078125 -0.015625 -0.226512 -0.226512 -0.226512 -0.359375 0.109375 -0.015625 -1.81223 -1.81223 -1.81223 -0.265625 0.140625 -0.234375 -3.01753 -3.01753 -3.01753 -0.265625 0.140625 -0.203125 -2.74162 -2.74162 -2.74162 -0.265625 0.171875 -0.234375 -2.92048 -2.92048 -2.92048 -0.265625 0.171875 -0.203125 -1.50245 -1.50245 -1.50245 -0.296875 0.140625 -0.234375 -0.357856 -0.357856 -0.357856 -0.296875 0.140625 -0.203125 -4.435 -4.435 -4.435 -0.296875 0.171875 -0.234375 0.137011 0.137011 0.137011 -0.265625 0.140625 -0.171875 -3.66235 -3.66235 -3.66235 -0.265625 0.140625 -0.140625 -1.61993 -1.61993 -1.61993 -0.265625 0.171875 -0.171875 -3.59298 -3.59298 -3.59298 -0.265625 0.171875 -0.140625 -3.29259 -3.29259 -3.29259 -0.296875 0.140625 -0.140625 -0.97699 -0.97699 -0.97699 -0.296875 0.171875 -0.140625 -1.69661 -1.69661 -1.69661 -0.265625 0.203125 -0.234375 -2.34796 -2.34796 -2.34796 -0.265625 0.203125 -0.203125 -1.5203 -1.5203 -1.5203 -0.265625 0.234375 -0.203125 -1.51792 -1.51792 -1.51792 -0.296875 0.203125 -0.234375 -1.28662 -1.28662 -1.28662 -0.296875 0.203125 -0.203125 -1.24122 -1.24122 -1.24122 -0.296875 0.234375 -0.234375 -1.17507 -1.17507 -1.17507 -0.296875 0.234375 -0.203125 -1.19315 -1.19315 -1.19315 -0.265625 0.203125 -0.171875 -2.09221 -2.09221 -2.09221 -0.265625 0.203125 -0.140625 -1.52302 -1.52302 -1.52302 -0.265625 0.234375 -0.171875 -1.91141 -1.91141 -1.91141 -0.265625 0.234375 -0.140625 -2.5024 -2.5024 -2.5024 -0.296875 0.203125 -0.140625 -1.73766 -1.73766 -1.73766 -0.296875 0.234375 -0.171875 -1.47026 -1.47026 -1.47026 -0.296875 0.234375 -0.140625 -1.68391 -1.68391 -1.68391 -0.328125 0.171875 -0.234375 -1.72573 -1.72573 -1.72573 -0.359375 0.171875 -0.203125 -1.93934 -1.93934 -1.93934 -0.328125 0.140625 -0.140625 -0.914812 -0.914812 -0.914812 -0.328125 0.171875 -0.140625 -1.49975 -1.49975 -1.49975 -0.359375 0.140625 -0.140625 -0.756936 -0.756936 -0.756936 -0.359375 0.171875 -0.171875 -1.65375 -1.65375 -1.65375 -0.359375 0.171875 -0.140625 -2.32385 -2.32385 -2.32385 -0.328125 0.203125 -0.234375 -0.920938 -0.920938 -0.920938 -0.328125 0.234375 -0.234375 -1.2991 -1.2991 -1.2991 -0.328125 0.234375 -0.203125 -2.01984 -2.01984 -2.01984 -0.359375 0.203125 -0.234375 -1.95361 -1.95361 -1.95361 -0.359375 0.203125 -0.203125 -2.43748 -2.43748 -2.43748 -0.359375 0.234375 -0.234375 -1.72576 -1.72576 -1.72576 -0.359375 0.234375 -0.203125 -0.976584 -0.976584 -0.976584 -0.328125 0.203125 -0.140625 -1.78358 -1.78358 -1.78358 -0.328125 0.234375 -0.171875 -2.00556 -2.00556 -2.00556 -0.328125 0.234375 -0.140625 -1.769 -1.769 -1.769 -0.359375 0.203125 -0.171875 -2.47833 -2.47833 -2.47833 -0.359375 0.203125 -0.140625 -1.71387 -1.71387 -1.71387 -0.359375 0.234375 -0.171875 -1.53535 -1.53535 -1.53535 -0.265625 0.140625 -0.078125 -2.40785 -2.40785 -2.40785 -0.265625 0.171875 -0.109375 -1.08721 -1.08721 -1.08721 -0.265625 0.171875 -0.078125 -1.27235 -1.27235 -1.27235 -0.296875 0.140625 -0.109375 -0.499302 -0.499302 -0.499302 -0.296875 0.140625 -0.078125 4.25951 4.25951 4.25951 -0.296875 0.171875 -0.078125 -2.44881 -2.44881 -2.44881 -0.265625 0.140625 -0.046875 -2.13136 -2.13136 -2.13136 -0.265625 0.140625 -0.015625 -2.54434 -2.54434 -2.54434 -0.296875 0.140625 -0.046875 -2.07273 -2.07273 -2.07273 -0.296875 0.140625 -0.015625 -2.10917 -2.10917 -2.10917 -0.296875 0.171875 -0.046875 -2.82603 -2.82603 -2.82603 -0.296875 0.171875 -0.015625 -1.47404 -1.47404 -1.47404 -0.265625 0.203125 -0.109375 -0.777581 -0.777581 -0.777581 -0.265625 0.234375 -0.109375 -1.46585 -1.46585 -1.46585 -0.296875 0.203125 -0.109375 -1.52864 -1.52864 -1.52864 -0.296875 0.203125 -0.078125 -3.24111 -3.24111 -3.24111 -0.296875 0.234375 -0.109375 -1.51688 -1.51688 -1.51688 -0.296875 0.234375 -0.078125 -3.08342 -3.08342 -3.08342 -0.265625 0.234375 -0.015625 -3.29742 -3.29742 -3.29742 -0.296875 0.203125 -0.046875 -2.56657 -2.56657 -2.56657 -0.296875 0.203125 -0.015625 -1.34135 -1.34135 -1.34135 -0.296875 0.234375 -0.046875 -1.84987 -1.84987 -1.84987 -0.296875 0.234375 -0.015625 -1.96112 -1.96112 -1.96112 -0.328125 0.140625 -0.109375 -1.81112 -1.81112 -1.81112 -0.328125 0.140625 -0.078125 -1.93063 -1.93063 -1.93063 -0.328125 0.171875 -0.109375 -1.48507 -1.48507 -1.48507 -0.328125 0.171875 -0.078125 -2.25207 -2.25207 -2.25207 -0.359375 0.140625 -0.109375 -2.01121 -2.01121 -2.01121 -0.359375 0.140625 -0.078125 -1.80786 -1.80786 -1.80786 -0.359375 0.171875 -0.109375 -0.863629 -0.863629 -0.863629 -0.328125 0.140625 -0.015625 -2.24906 -2.24906 -2.24906 -0.328125 0.171875 -0.046875 -2.69465 -2.69465 -2.69465 -0.328125 0.171875 -0.015625 -2.01339 -2.01339 -2.01339 -0.359375 0.140625 -0.046875 -1.82057 -1.82057 -1.82057 -0.359375 0.140625 -0.015625 -2.31122 -2.31122 -2.31122 -0.359375 0.171875 -0.046875 -2.75334 -2.75334 -2.75334 -0.328125 0.203125 -0.109375 -1.19314 -1.19314 -1.19314 -0.328125 0.203125 -0.078125 -2.07304 -2.07304 -2.07304 -0.328125 0.234375 -0.109375 -1.49618 -1.49618 -1.49618 -0.328125 0.234375 -0.078125 -1.74106 -1.74106 -1.74106 -0.359375 0.203125 -0.109375 -1.40096 -1.40096 -1.40096 -0.359375 0.234375 -0.109375 -1.07967 -1.07967 -1.07967 -0.359375 0.234375 -0.078125 -2.55983 -2.55983 -2.55983 -0.328125 0.203125 -0.046875 -2.70132 -2.70132 -2.70132 -0.328125 0.234375 -0.046875 -2.59007 -2.59007 -2.59007 -0.328125 0.234375 -0.015625 -2.50016 -2.50016 -2.50016 -0.359375 0.234375 -0.046875 -1.61301 -1.61301 -1.61301 -0.359375 0.234375 -0.015625 -2.26372 -2.26372 -2.26372 -0.390625 0.046875 -0.234375 -2.11446 -2.11446 -2.11446 -0.390625 0.046875 -0.203125 -2.27053 -2.27053 -2.27053 -0.421875 0.015625 -0.234375 -2.14769 -2.14769 -2.14769 -0.421875 0.015625 -0.203125 -2.833 -2.833 -2.833 -0.421875 0.046875 -0.234375 -1.96559 -1.96559 -1.96559 -0.421875 0.046875 -0.203125 -2.45661 -2.45661 -2.45661 -0.390625 0.015625 -0.171875 -0.27904 -0.27904 -0.27904 -0.390625 0.015625 -0.140625 -2.13216 -2.13216 -2.13216 -0.390625 0.046875 -0.171875 -1.88636 -1.88636 -1.88636 -0.421875 0.015625 -0.171875 -1.88306 -1.88306 -1.88306 -0.421875 0.015625 -0.140625 -1.85328 -1.85328 -1.85328 -0.390625 0.078125 -0.234375 -0.556881 -0.556881 -0.556881 -0.390625 0.078125 -0.203125 -2.37742 -2.37742 -2.37742 -0.390625 0.109375 -0.234375 -0.31014 -0.31014 -0.31014 -0.390625 0.109375 -0.203125 -4.23166 -4.23166 -4.23166 -0.421875 0.109375 -0.234375 -0.107385 -0.107385 -0.107385 -0.390625 0.109375 -0.171875 -1.29668 -1.29668 -1.29668 -0.421875 0.078125 -0.140625 -2.20416 -2.20416 -2.20416 -0.421875 0.109375 -0.140625 -2.32178 -2.32178 -2.32178 -0.453125 0.015625 -0.234375 -1.94352 -1.94352 -1.94352 -0.453125 0.015625 -0.203125 -2.17786 -2.17786 -2.17786 -0.453125 0.015625 -0.171875 -1.47657 -1.47657 -1.47657 -0.453125 0.015625 -0.140625 -2.12759 -2.12759 -2.12759 -0.453125 0.046875 -0.140625 -1.87375 -1.87375 -1.87375 -0.484375 0.015625 -0.140625 -1.88162 -1.88162 -1.88162 -0.484375 0.046875 -0.140625 -1.7896 -1.7896 -1.7896 -0.453125 0.109375 -0.234375 -0.568585 -0.568585 -0.568585 -0.453125 0.109375 -0.140625 -1.68161 -1.68161 -1.68161 -0.484375 0.078125 -0.140625 -2.23519 -2.23519 -2.23519 -0.390625 0.015625 -0.078125 -1.92385 -1.92385 -1.92385 -0.390625 0.046875 -0.109375 -1.94038 -1.94038 -1.94038 -0.390625 0.046875 -0.078125 -2.5143 -2.5143 -2.5143 -0.421875 0.015625 -0.109375 -2.21925 -2.21925 -2.21925 -0.421875 0.015625 -0.078125 -2.2521 -2.2521 -2.2521 -0.421875 0.046875 -0.109375 -33.1389 -33.1389 -33.1389 -0.390625 0.015625 -0.015625 -2.4805 -2.4805 -2.4805 -0.390625 0.046875 -0.046875 -2.01058 -2.01058 -2.01058 -0.421875 0.015625 -0.046875 -2.27709 -2.27709 -2.27709 -0.421875 0.015625 -0.015625 -2.07698 -2.07698 -2.07698 -0.421875 0.046875 -0.015625 -3.57013 -3.57013 -3.57013 -0.390625 0.078125 -0.109375 -2.27651 -2.27651 -2.27651 -0.390625 0.078125 -0.078125 -2.69438 -2.69438 -2.69438 -0.390625 0.109375 -0.109375 -1.66366 -1.66366 -1.66366 -0.390625 0.109375 -0.078125 -1.85215 -1.85215 -1.85215 -0.421875 0.078125 -0.109375 43.5905 43.5905 43.5905 -0.421875 0.109375 -0.109375 49.3906 49.3906 49.3906 -0.390625 0.078125 -0.046875 -2.05602 -2.05602 -2.05602 -0.390625 0.109375 -0.046875 -1.97892 -1.97892 -1.97892 -0.421875 0.078125 -0.015625 -2.87321 -2.87321 -2.87321 -0.421875 0.109375 -0.015625 -4.62216 -4.62216 -4.62216 -0.453125 0.015625 -0.109375 -2.043 -2.043 -2.043 -0.453125 0.015625 -0.078125 -2.46682 -2.46682 -2.46682 -0.453125 0.046875 -0.109375 75.1882 75.1882 75.1882 -0.453125 0.046875 -0.015625 -1.31476 -1.31476 -1.31476 -0.484375 0.046875 -0.015625 -0.8458 -0.8458 -0.8458 -0.453125 0.078125 -0.109375 -76.5695 -76.5695 -76.5695 -0.453125 0.109375 -0.109375 135.714 135.714 135.714 -0.484375 0.078125 -0.109375 7.15635 7.15635 7.15635 -0.484375 0.078125 -0.078125 -19.8162 -19.8162 -19.8162 -0.484375 0.109375 -0.109375 -3.03533 -3.03533 -3.03533 -0.484375 0.109375 -0.078125 26.0338 26.0338 26.0338 -0.453125 0.078125 -0.015625 -1.28993 -1.28993 -1.28993 -0.453125 0.109375 -0.015625 -1.61321 -1.61321 -1.61321 -0.484375 0.078125 -0.046875 -93.965 -93.965 -93.965 -0.484375 0.078125 -0.015625 -1.95254 -1.95254 -1.95254 -0.484375 0.109375 -0.046875 -34.1623 -34.1623 -34.1623 -0.484375 0.109375 -0.015625 -1.34069 -1.34069 -1.34069 -0.390625 0.140625 -0.203125 -3.57987 -3.57987 -3.57987 -0.390625 0.171875 -0.203125 -2.1807 -2.1807 -2.1807 -0.421875 0.140625 -0.234375 -0.541133 -0.541133 -0.541133 -0.421875 0.140625 -0.203125 -3.45644 -3.45644 -3.45644 -0.421875 0.171875 -0.234375 -1.87048 -1.87048 -1.87048 -0.421875 0.171875 -0.203125 -2.76779 -2.76779 -2.76779 -0.390625 0.140625 -0.171875 -1.95034 -1.95034 -1.95034 -0.390625 0.140625 -0.140625 -1.85287 -1.85287 -1.85287 -0.390625 0.171875 -0.171875 -1.25377 -1.25377 -1.25377 -0.390625 0.203125 -0.234375 -1.60363 -1.60363 -1.60363 -0.390625 0.203125 -0.203125 -2.77293 -2.77293 -2.77293 -0.390625 0.234375 -0.234375 -1.61928 -1.61928 -1.61928 -0.421875 0.203125 -0.234375 -1.9867 -1.9867 -1.9867 -0.390625 0.203125 -0.140625 -1.50242 -1.50242 -1.50242 -0.453125 0.140625 -0.234375 -0.553019 -0.553019 -0.553019 -0.453125 0.171875 -0.234375 -0.992946 -0.992946 -0.992946 -0.390625 0.140625 -0.109375 -2.68597 -2.68597 -2.68597 -0.390625 0.140625 -0.078125 -1.80676 -1.80676 -1.80676 -0.390625 0.171875 -0.109375 -1.67547 -1.67547 -1.67547 -0.421875 0.140625 -0.109375 -1.96362 -1.96362 -1.96362 -0.421875 0.140625 -0.078125 -1.81247 -1.81247 -1.81247 -0.421875 0.171875 -0.109375 -2.16798 -2.16798 -2.16798 -0.421875 0.171875 -0.078125 -3.87402 -3.87402 -3.87402 -0.390625 0.140625 -0.046875 -2.10101 -2.10101 -2.10101 -0.390625 0.140625 -0.015625 -2.38628 -2.38628 -2.38628 -0.421875 0.140625 -0.046875 -1.89772 -1.89772 -1.89772 -0.421875 0.140625 -0.015625 -2.61389 -2.61389 -2.61389 -0.421875 0.171875 -0.046875 -2.03169 -2.03169 -2.03169 -0.421875 0.171875 -0.015625 -1.49496 -1.49496 -1.49496 -0.390625 0.203125 -0.109375 -1.15644 -1.15644 -1.15644 -0.390625 0.234375 -0.109375 -0.374271 -0.374271 -0.374271 -0.390625 0.234375 -0.078125 -2.36342 -2.36342 -2.36342 -0.421875 0.203125 -0.109375 -2.14352 -2.14352 -2.14352 -0.421875 0.203125 -0.078125 -4.19423 -4.19423 -4.19423 -0.421875 0.234375 -0.109375 -1.39256 -1.39256 -1.39256 -0.421875 0.234375 -0.078125 -1.93072 -1.93072 -1.93072 -0.421875 0.203125 -0.046875 -1.80279 -1.80279 -1.80279 -0.421875 0.203125 -0.015625 -0.83447 -0.83447 -0.83447 -0.453125 0.140625 -0.109375 -2.354 -2.354 -2.354 -0.453125 0.140625 -0.078125 -1.91206 -1.91206 -1.91206 -0.453125 0.171875 -0.109375 -2.33299 -2.33299 -2.33299 -0.453125 0.171875 -0.078125 -2.21251 -2.21251 -2.21251 -0.484375 0.140625 -0.109375 -2.12323 -2.12323 -2.12323 -0.484375 0.140625 -0.078125 -2.19672 -2.19672 -2.19672 -0.453125 0.140625 -0.046875 -1.74155 -1.74155 -1.74155 -0.453125 0.140625 -0.015625 -1.80131 -1.80131 -1.80131 -0.453125 0.171875 -0.046875 -1.7906 -1.7906 -1.7906 -0.453125 0.171875 -0.015625 -2.49326 -2.49326 -2.49326 -0.484375 0.140625 -0.046875 -1.57864 -1.57864 -1.57864 -0.453125 0.234375 -0.078125 -1.47691 -1.47691 -1.47691 -0.453125 0.203125 -0.046875 -3.26769 -3.26769 -3.26769 -0.453125 0.203125 -0.015625 -2.11934 -2.11934 -2.11934 -0.453125 0.234375 -0.046875 -3.27573 -3.27573 -3.27573 -0.453125 0.234375 -0.015625 -1.93602 -1.93602 -1.93602 -0.265625 0.265625 -0.359375 -28.0967 -28.0967 -28.0967 -0.265625 0.265625 -0.328125 -2.19827 -2.19827 -2.19827 -0.265625 0.296875 -0.359375 -31.8754 -31.8754 -31.8754 -0.265625 0.296875 -0.328125 -17.9478 -17.9478 -17.9478 -0.296875 0.265625 -0.328125 20.8349 20.8349 20.8349 -0.265625 0.265625 -0.296875 -1.54605 -1.54605 -1.54605 -0.265625 0.296875 -0.296875 -0.902493 -0.902493 -0.902493 -0.265625 0.296875 -0.265625 -2.13901 -2.13901 -2.13901 -0.296875 0.265625 -0.296875 -1.36063 -1.36063 -1.36063 -0.296875 0.265625 -0.265625 -1.11722 -1.11722 -1.11722 -0.296875 0.296875 -0.296875 -1.12456 -1.12456 -1.12456 -0.296875 0.296875 -0.265625 -2.85025 -2.85025 -2.85025 -0.265625 0.328125 -0.328125 -1.1567 -1.1567 -1.1567 -0.328125 0.265625 -0.296875 -1.21384 -1.21384 -1.21384 -0.328125 0.265625 -0.265625 3.71732 3.71732 3.71732 -0.265625 0.265625 -0.203125 -2.12845 -2.12845 -2.12845 -0.265625 0.296875 -0.234375 -1.84379 -1.84379 -1.84379 -0.265625 0.296875 -0.203125 -3.73745 -3.73745 -3.73745 -0.296875 0.265625 -0.234375 0.603798 0.603798 0.603798 -0.296875 0.265625 -0.203125 -1.57288 -1.57288 -1.57288 -0.296875 0.296875 -0.234375 1.8222 1.8222 1.8222 -0.296875 0.296875 -0.203125 -2.93919 -2.93919 -2.93919 -0.265625 0.265625 -0.171875 -2.02283 -2.02283 -2.02283 -0.265625 0.265625 -0.140625 -2.25637 -2.25637 -2.25637 -0.265625 0.296875 -0.171875 -40.4034 -40.4034 -40.4034 -0.265625 0.296875 -0.140625 -31.4336 -31.4336 -31.4336 -0.265625 0.328125 -0.171875 17.5064 17.5064 17.5064 -0.265625 0.328125 -0.140625 7.70203 7.70203 7.70203 -0.265625 0.359375 -0.171875 -12.1266 -12.1266 -12.1266 -0.265625 0.359375 -0.140625 7.20387 7.20387 7.20387 -0.328125 0.265625 -0.234375 -3.91338 -3.91338 -3.91338 -0.265625 0.265625 -0.109375 -1.89736 -1.89736 -1.89736 -0.265625 0.265625 -0.078125 -1.80466 -1.80466 -1.80466 -0.265625 0.296875 -0.109375 13.866 13.866 13.866 -0.265625 0.296875 -0.078125 -0.621126 -0.621126 -0.621126 -0.296875 0.265625 -0.078125 -2.06284 -2.06284 -2.06284 -0.265625 0.265625 -0.046875 -3.15109 -3.15109 -3.15109 -0.265625 0.265625 -0.015625 -1.8847 -1.8847 -1.8847 -0.265625 0.296875 -0.046875 -1.98889 -1.98889 -1.98889 -0.296875 0.265625 -0.046875 -1.86641 -1.86641 -1.86641 -0.328125 0.265625 -0.015625 -2.22321 -2.22321 -2.22321 -0.359375 0.265625 -0.046875 -1.71962 -1.71962 -1.71962 -0.359375 0.265625 -0.015625 -1.84526 -1.84526 -1.84526 -0.390625 0.265625 -0.078125 -1.00936 -1.00936 -1.00936 -0.421875 0.265625 -0.078125 -0.678702 -0.678702 -0.678702 -0.390625 0.265625 -0.046875 -1.72794 -1.72794 -1.72794 -0.390625 0.265625 -0.015625 -1.71099 -1.71099 -1.71099 -0.390625 0.296875 -0.046875 -1.20434 -1.20434 -1.20434 -0.390625 0.296875 -0.015625 -1.52279 -1.52279 -1.52279 -0.421875 0.265625 -0.046875 -2.85271 -2.85271 -2.85271 -0.421875 0.296875 -0.046875 -1.074 -1.074 -1.074 -0.421875 0.296875 -0.015625 -1.55974 -1.55974 -1.55974 -0.453125 0.265625 -0.078125 -1.16259 -1.16259 -1.16259 -0.453125 0.265625 -0.046875 -1.16368 -1.16368 -1.16368 -0.453125 0.265625 -0.015625 -2.06709 -2.06709 -2.06709 -0.453125 0.296875 -0.046875 -2.40464 -2.40464 -2.40464 -0.453125 0.296875 -0.015625 -1.64572 -1.64572 -1.64572 -0.109375 0.515625 -0.015625 0.169131 0.169131 0.169131 -0.109375 0.546875 -0.015625 2.81695 2.81695 2.81695 -0.140625 0.515625 -0.046875 2.31039 2.31039 2.31039 -0.140625 0.515625 -0.015625 -2.21584 -2.21584 -2.21584 -0.140625 0.546875 -0.015625 -4.68292 -4.68292 -4.68292 -0.171875 0.515625 -0.046875 12.6671 12.6671 12.6671 -0.171875 0.515625 -0.015625 2.89083 2.89083 2.89083 -0.171875 0.546875 -0.015625 -4.50947 -4.50947 -4.50947 -0.140625 0.578125 -0.015625 3.74817 3.74817 3.74817 -0.140625 0.609375 -0.015625 -0.67608 -0.67608 -0.67608 -0.171875 0.578125 -0.015625 1.46963 1.46963 1.46963 -0.171875 0.609375 -0.015625 -0.836493 -0.836493 -0.836493 -0.203125 0.515625 -0.015625 -6.06033 -6.06033 -6.06033 -0.203125 0.546875 -0.015625 1.74366 1.74366 1.74366 -0.234375 0.515625 -0.015625 -9.88965 -9.88965 -9.88965 -0.234375 0.546875 -0.015625 0.780739 0.780739 0.780739 -0.203125 0.578125 -0.015625 -1.68546 -1.68546 -1.68546 -0.203125 0.609375 -0.015625 -0.705057 -0.705057 -0.705057 -0.234375 0.578125 -0.015625 0.0419807 0.0419807 0.0419807 -0.234375 0.609375 -0.015625 -0.700982 -0.700982 -0.700982 -0.265625 0.546875 -0.015625 -35.6645 -35.6645 -35.6645 -0.515625 0.015625 -0.140625 -1.4803 -1.4803 -1.4803 -0.515625 0.046875 -0.140625 -2.26202 -2.26202 -2.26202 -0.546875 0.015625 -0.140625 -0.800072 -0.800072 -0.800072 -0.546875 0.046875 -0.140625 -0.950537 -0.950537 -0.950537 -0.515625 0.078125 -0.140625 -3.07293 -3.07293 -3.07293 -0.546875 0.015625 -0.109375 -1.53369 -1.53369 -1.53369 -0.546875 0.015625 -0.078125 -1.33652 -1.33652 -1.33652 -0.546875 0.046875 -0.109375 -0.836134 -0.836134 -0.836134 -0.546875 0.046875 -0.078125 0.727329 0.727329 0.727329 -0.515625 0.015625 -0.046875 -1.38507 -1.38507 -1.38507 -0.515625 0.015625 -0.015625 -1.4655 -1.4655 -1.4655 -0.515625 0.046875 -0.046875 -2.13164 -2.13164 -2.13164 -0.515625 0.046875 -0.015625 -2.43437 -2.43437 -2.43437 -0.546875 0.015625 -0.046875 -1.4136 -1.4136 -1.4136 -0.546875 0.015625 -0.015625 -1.51737 -1.51737 -1.51737 -0.546875 0.046875 -0.046875 -1.62901 -1.62901 -1.62901 -0.515625 0.078125 -0.109375 -2.95199 -2.95199 -2.95199 -0.515625 0.078125 -0.078125 -1.44355 -1.44355 -1.44355 -0.546875 0.078125 -0.109375 -2.30329 -2.30329 -2.30329 -0.546875 0.078125 -0.078125 -0.785485 -0.785485 -0.785485 -0.515625 0.078125 -0.046875 -2.0619 -2.0619 -2.0619 -0.515625 0.078125 -0.015625 -2.43463 -2.43463 -2.43463 -0.578125 0.015625 -0.015625 0.077538 0.077538 0.077538 -0.015625 0.015625 0.015625 -1.26778 -1.26778 -1.26778 -0.015625 0.015625 0.046875 -1.80889 -1.80889 -1.80889 -0.015625 0.046875 0.015625 -1.10108 -1.10108 -1.10108 -0.015625 0.046875 0.046875 -1.44841 -1.44841 -1.44841 -0.046875 0.015625 0.015625 -0.797266 -0.797266 -0.797266 -0.046875 0.015625 0.046875 -2.03298 -2.03298 -2.03298 -0.046875 0.046875 0.015625 -0.725671 -0.725671 -0.725671 -0.046875 0.046875 0.046875 -1.69528 -1.69528 -1.69528 -0.015625 0.015625 0.078125 -1.58876 -1.58876 -1.58876 -0.015625 0.015625 0.109375 -1.85416 -1.85416 -1.85416 -0.015625 0.046875 0.078125 -2.10295 -2.10295 -2.10295 -0.015625 0.046875 0.109375 -2.18388 -2.18388 -2.18388 -0.015625 0.078125 0.046875 -5.50046 -5.50046 -5.50046 -0.046875 0.078125 0.046875 -2.91342 -2.91342 -2.91342 -0.046875 0.109375 0.046875 -4.19923 -4.19923 -4.19923 -0.015625 0.078125 0.078125 -3.40363 -3.40363 -3.40363 -0.015625 0.078125 0.109375 -5.1943 -5.1943 -5.1943 -0.015625 0.109375 0.078125 -6.39952 -6.39952 -6.39952 -0.015625 0.109375 0.109375 -2.1049 -2.1049 -2.1049 -0.046875 0.078125 0.078125 -2.25724 -2.25724 -2.25724 -0.046875 0.078125 0.109375 -3.00403 -3.00403 -3.00403 -0.046875 0.109375 0.078125 -4.50913 -4.50913 -4.50913 -0.078125 0.015625 0.015625 -1.23346 -1.23346 -1.23346 -0.078125 0.015625 0.046875 -1.95406 -1.95406 -1.95406 -0.078125 0.046875 0.015625 -1.06121 -1.06121 -1.06121 -0.078125 0.046875 0.046875 -1.997 -1.997 -1.997 -0.109375 0.015625 0.015625 -1.05586 -1.05586 -1.05586 -0.109375 0.015625 0.046875 -1.77081 -1.77081 -1.77081 -0.109375 0.046875 0.015625 -1.9967 -1.9967 -1.9967 -0.109375 0.046875 0.046875 -1.69273 -1.69273 -1.69273 -0.078125 0.015625 0.078125 -2.05456 -2.05456 -2.05456 -0.078125 0.046875 0.078125 -2.1315 -2.1315 -2.1315 -0.078125 0.046875 0.109375 -1.56963 -1.56963 -1.56963 -0.109375 0.015625 0.078125 -2.45123 -2.45123 -2.45123 -0.109375 0.015625 0.109375 -2.0756 -2.0756 -2.0756 -0.109375 0.046875 0.078125 -2.0588 -2.0588 -2.0588 -0.109375 0.046875 0.109375 -2.09986 -2.09986 -2.09986 -0.078125 0.078125 0.015625 -1.72126 -1.72126 -1.72126 -0.078125 0.078125 0.046875 -2.50738 -2.50738 -2.50738 -0.078125 0.109375 0.046875 -1.99218 -1.99218 -1.99218 -0.109375 0.078125 0.015625 -2.38012 -2.38012 -2.38012 -0.109375 0.078125 0.046875 -2.66908 -2.66908 -2.66908 -0.109375 0.109375 0.015625 -2.30872 -2.30872 -2.30872 -0.109375 0.109375 0.046875 -2.1059 -2.1059 -2.1059 -0.078125 0.078125 0.078125 -1.87309 -1.87309 -1.87309 -0.078125 0.078125 0.109375 -2.33107 -2.33107 -2.33107 -0.078125 0.109375 0.078125 -1.76442 -1.76442 -1.76442 -0.078125 0.109375 0.109375 -1.63393 -1.63393 -1.63393 -0.109375 0.078125 0.078125 -2.28153 -2.28153 -2.28153 -0.109375 0.078125 0.109375 -2.14366 -2.14366 -2.14366 -0.109375 0.109375 0.078125 -1.96442 -1.96442 -1.96442 -0.109375 0.109375 0.109375 -1.79115 -1.79115 -1.79115 -0.015625 0.015625 0.140625 -2.34644 -2.34644 -2.34644 -0.015625 0.015625 0.171875 -5.17798 -5.17798 -5.17798 -0.015625 0.046875 0.140625 -0.805559 -0.805559 -0.805559 -0.015625 0.046875 0.171875 0.0505003 0.0505003 0.0505003 -0.046875 0.015625 0.140625 -0.168078 -0.168078 -0.168078 -0.046875 0.015625 0.171875 1.11189 1.11189 1.11189 -0.046875 0.046875 0.140625 -1.00398 -1.00398 -1.00398 -0.015625 0.015625 0.203125 1.35904 1.35904 1.35904 -0.015625 0.046875 0.203125 -0.839611 -0.839611 -0.839611 -0.015625 0.046875 0.234375 13.6968 13.6968 13.6968 -0.046875 0.015625 0.203125 0.830932 0.830932 0.830932 -0.046875 0.046875 0.203125 -2.06 -2.06 -2.06 -0.015625 0.078125 0.140625 -3.04553 -3.04553 -3.04553 -0.015625 0.078125 0.171875 -3.34302 -3.34302 -3.34302 -0.015625 0.109375 0.140625 -14.9397 -14.9397 -14.9397 -0.046875 0.078125 0.140625 -2.32467 -2.32467 -2.32467 -0.046875 0.078125 0.171875 -1.49349 -1.49349 -1.49349 -0.046875 0.109375 0.140625 4.10613 4.10613 4.10613 -0.046875 0.109375 0.171875 -3.48381 -3.48381 -3.48381 -0.015625 0.078125 0.203125 -1.78035 -1.78035 -1.78035 -0.015625 0.078125 0.234375 -4.70534 -4.70534 -4.70534 -0.015625 0.109375 0.203125 -5.30036 -5.30036 -5.30036 -0.015625 0.109375 0.234375 3.63471 3.63471 3.63471 -0.046875 0.078125 0.203125 -4.63889 -4.63889 -4.63889 -0.046875 0.078125 0.234375 7.73758 7.73758 7.73758 -0.046875 0.109375 0.203125 -2.39205 -2.39205 -2.39205 -0.046875 0.109375 0.234375 -15.4024 -15.4024 -15.4024 -0.078125 0.015625 0.140625 -3.37293 -3.37293 -3.37293 -0.078125 0.015625 0.171875 -2.4207 -2.4207 -2.4207 -0.078125 0.046875 0.140625 -2.28542 -2.28542 -2.28542 -0.078125 0.046875 0.171875 -10.8399 -10.8399 -10.8399 -0.109375 0.015625 0.140625 -3.0069 -3.0069 -3.0069 -0.109375 0.015625 0.171875 -1.17838 -1.17838 -1.17838 -0.109375 0.046875 0.140625 -2.55998 -2.55998 -2.55998 -0.109375 0.046875 0.171875 -2.10424 -2.10424 -2.10424 -0.078125 0.046875 0.203125 -2.72089 -2.72089 -2.72089 -0.078125 0.078125 0.140625 -3.0132 -3.0132 -3.0132 -0.078125 0.109375 0.140625 -9.91933 -9.91933 -9.91933 -0.109375 0.078125 0.140625 -2.55891 -2.55891 -2.55891 -0.109375 0.078125 0.171875 -1.37359 -1.37359 -1.37359 -0.109375 0.109375 0.140625 -2.3552 -2.3552 -2.3552 -0.109375 0.109375 0.171875 -1.7114 -1.7114 -1.7114 -0.078125 0.078125 0.203125 -3.95005 -3.95005 -3.95005 -0.078125 0.078125 0.234375 -16.1425 -16.1425 -16.1425 -0.078125 0.109375 0.203125 -4.66424 -4.66424 -4.66424 -0.078125 0.109375 0.234375 -28.9251 -28.9251 -28.9251 -0.109375 0.078125 0.203125 -2.13093 -2.13093 -2.13093 -0.109375 0.078125 0.234375 -1.17442 -1.17442 -1.17442 -0.109375 0.109375 0.203125 -2.05913 -2.05913 -2.05913 -0.109375 0.109375 0.234375 -0.824081 -0.824081 -0.824081 -0.046875 0.140625 0.046875 -2.65194 -2.65194 -2.65194 -0.015625 0.140625 0.078125 -5.23324 -5.23324 -5.23324 -0.015625 0.140625 0.109375 -3.65375 -3.65375 -3.65375 -0.015625 0.171875 0.078125 -2.34609 -2.34609 -2.34609 -0.015625 0.171875 0.109375 -2.01177 -2.01177 -2.01177 -0.046875 0.140625 0.078125 -2.74143 -2.74143 -2.74143 -0.046875 0.140625 0.109375 -1.78403 -1.78403 -1.78403 -0.046875 0.171875 0.078125 -2.41444 -2.41444 -2.41444 -0.046875 0.171875 0.109375 -2.1808 -2.1808 -2.1808 -0.015625 0.203125 0.015625 -1.69605 -1.69605 -1.69605 -0.015625 0.203125 0.046875 -1.5722 -1.5722 -1.5722 -0.015625 0.234375 0.015625 -1.04038 -1.04038 -1.04038 -0.015625 0.234375 0.046875 -1.34169 -1.34169 -1.34169 -0.046875 0.203125 0.046875 -0.686969 -0.686969 -0.686969 -0.046875 0.234375 0.015625 -0.710956 -0.710956 -0.710956 -0.046875 0.234375 0.046875 -0.541895 -0.541895 -0.541895 -0.015625 0.203125 0.078125 -1.59451 -1.59451 -1.59451 -0.015625 0.203125 0.109375 -1.84583 -1.84583 -1.84583 -0.015625 0.234375 0.078125 -0.863482 -0.863482 -0.863482 -0.046875 0.203125 0.078125 -1.10761 -1.10761 -1.10761 -0.046875 0.203125 0.109375 -2.20454 -2.20454 -2.20454 -0.046875 0.234375 0.078125 -0.578345 -0.578345 -0.578345 -0.046875 0.234375 0.109375 -23.2606 -23.2606 -23.2606 -0.078125 0.140625 0.046875 -1.99474 -1.99474 -1.99474 -0.078125 0.171875 0.046875 -1.71579 -1.71579 -1.71579 -0.109375 0.140625 0.015625 -1.79939 -1.79939 -1.79939 -0.109375 0.140625 0.046875 -1.85899 -1.85899 -1.85899 -0.109375 0.171875 0.015625 -1.00799 -1.00799 -1.00799 -0.109375 0.171875 0.046875 -1.50328 -1.50328 -1.50328 -0.078125 0.140625 0.078125 -1.56804 -1.56804 -1.56804 -0.078125 0.140625 0.109375 -1.89455 -1.89455 -1.89455 -0.078125 0.171875 0.078125 -1.64381 -1.64381 -1.64381 -0.078125 0.171875 0.109375 -1.29191 -1.29191 -1.29191 -0.109375 0.171875 0.078125 -1.57654 -1.57654 -1.57654 -0.078125 0.203125 0.015625 -1.02774 -1.02774 -1.02774 -0.078125 0.203125 0.046875 -1.19814 -1.19814 -1.19814 -0.078125 0.234375 0.015625 -0.758252 -0.758252 -0.758252 -0.078125 0.234375 0.046875 -1.01698 -1.01698 -1.01698 -0.109375 0.203125 0.015625 -0.81552 -0.81552 -0.81552 -0.109375 0.203125 0.046875 -1.98351 -1.98351 -1.98351 -0.109375 0.234375 0.015625 -1.97576 -1.97576 -1.97576 -0.109375 0.234375 0.046875 -0.963114 -0.963114 -0.963114 -0.078125 0.203125 0.078125 -1.09654 -1.09654 -1.09654 -0.078125 0.203125 0.109375 -1.10824 -1.10824 -1.10824 -0.078125 0.234375 0.109375 -12.0098 -12.0098 -12.0098 -0.109375 0.203125 0.078125 -1.52207 -1.52207 -1.52207 -0.109375 0.203125 0.109375 -3.68366 -3.68366 -3.68366 -0.109375 0.234375 0.078125 -0.183494 -0.183494 -0.183494 -0.109375 0.234375 0.109375 -2.78849 -2.78849 -2.78849 -0.015625 0.140625 0.140625 -5.62095 -5.62095 -5.62095 -0.015625 0.171875 0.140625 -18.8532 -18.8532 -18.8532 -0.046875 0.140625 0.140625 -1.12905 -1.12905 -1.12905 -0.046875 0.140625 0.171875 10.862 10.862 10.862 -0.046875 0.171875 0.140625 -8.69323 -8.69323 -8.69323 -0.046875 0.171875 0.171875 -5.63976 -5.63976 -5.63976 -0.015625 0.140625 0.203125 -10.8427 -10.8427 -10.8427 -0.015625 0.140625 0.234375 13.9351 13.9351 13.9351 -0.015625 0.171875 0.203125 -13.3606 -13.3606 -13.3606 -0.015625 0.171875 0.234375 -12.7037 -12.7037 -12.7037 -0.046875 0.140625 0.203125 -3.61669 -3.61669 -3.61669 -0.046875 0.140625 0.234375 8.17113 8.17113 8.17113 -0.046875 0.171875 0.203125 13.6539 13.6539 13.6539 -0.046875 0.171875 0.234375 3.36633 3.36633 3.36633 -0.046875 0.203125 0.140625 -153.654 -153.654 -153.654 -0.046875 0.203125 0.171875 47.4669 47.4669 47.4669 -0.046875 0.234375 0.171875 -105.272 -105.272 -105.272 -0.015625 0.203125 0.234375 -5.06816 -5.06816 -5.06816 -0.015625 0.234375 0.203125 34.7786 34.7786 34.7786 -0.015625 0.234375 0.234375 12.806 12.806 12.806 -0.046875 0.203125 0.203125 175.673 175.673 175.673 -0.046875 0.203125 0.234375 -8.01713 -8.01713 -8.01713 -0.046875 0.234375 0.203125 217.447 217.447 217.447 -0.046875 0.234375 0.234375 -4.89343 -4.89343 -4.89343 -0.078125 0.140625 0.140625 -6.239 -6.239 -6.239 -0.078125 0.140625 0.171875 21.1238 21.1238 21.1238 -0.078125 0.171875 0.140625 -8.216 -8.216 -8.216 -0.078125 0.171875 0.171875 -18.028 -18.028 -18.028 -0.078125 0.140625 0.203125 -6.25444 -6.25444 -6.25444 -0.078125 0.140625 0.234375 -5.7363 -5.7363 -5.7363 -0.078125 0.171875 0.203125 0.274434 0.274434 0.274434 -0.078125 0.171875 0.234375 3.38445 3.38445 3.38445 -0.078125 0.203125 0.140625 -1.34934 -1.34934 -1.34934 -0.078125 0.203125 0.171875 2.29483 2.29483 2.29483 -0.078125 0.234375 0.140625 -4.62728 -4.62728 -4.62728 -0.078125 0.234375 0.171875 -13.1138 -13.1138 -13.1138 -0.109375 0.234375 0.140625 -1.13094 -1.13094 -1.13094 -0.109375 0.234375 0.171875 -3.67965 -3.67965 -3.67965 -0.078125 0.203125 0.203125 -0.924043 -0.924043 -0.924043 -0.078125 0.234375 0.203125 -0.693147 -0.693147 -0.693147 -0.140625 0.015625 0.015625 -1.59988 -1.59988 -1.59988 -0.140625 0.015625 0.046875 -1.42056 -1.42056 -1.42056 -0.140625 0.046875 0.015625 -1.58802 -1.58802 -1.58802 -0.140625 0.015625 0.078125 -2.02388 -2.02388 -2.02388 -0.140625 0.015625 0.109375 -1.58263 -1.58263 -1.58263 -0.140625 0.046875 0.078125 -2.01665 -2.01665 -2.01665 -0.140625 0.046875 0.109375 -2.08223 -2.08223 -2.08223 -0.171875 0.015625 0.078125 -1.72381 -1.72381 -1.72381 -0.171875 0.015625 0.109375 -1.33331 -1.33331 -1.33331 -0.171875 0.046875 0.109375 -1.51453 -1.51453 -1.51453 -0.140625 0.078125 0.015625 -1.73411 -1.73411 -1.73411 -0.140625 0.078125 0.046875 -1.85844 -1.85844 -1.85844 -0.140625 0.109375 0.015625 -2.19007 -2.19007 -2.19007 -0.140625 0.109375 0.046875 -1.82505 -1.82505 -1.82505 -0.171875 0.078125 0.015625 -1.79656 -1.79656 -1.79656 -0.171875 0.078125 0.046875 -1.8481 -1.8481 -1.8481 -0.171875 0.109375 0.015625 -2.43709 -2.43709 -2.43709 -0.140625 0.078125 0.078125 -2.0967 -2.0967 -2.0967 -0.140625 0.078125 0.109375 -1.87005 -1.87005 -1.87005 -0.140625 0.109375 0.078125 -2.13195 -2.13195 -2.13195 -0.140625 0.109375 0.109375 -1.92067 -1.92067 -1.92067 -0.171875 0.078125 0.078125 -1.81667 -1.81667 -1.81667 -0.171875 0.078125 0.109375 -1.16183 -1.16183 -1.16183 -0.171875 0.109375 0.078125 -1.85051 -1.85051 -1.85051 -0.171875 0.109375 0.109375 -2.30321 -2.30321 -2.30321 -0.203125 0.046875 0.015625 -1.80071 -1.80071 -1.80071 -0.234375 0.015625 0.015625 -2.01287 -2.01287 -2.01287 -0.234375 0.015625 0.046875 -2.50869 -2.50869 -2.50869 -0.234375 0.046875 0.015625 -1.95883 -1.95883 -1.95883 -0.234375 0.046875 0.046875 -1.73287 -1.73287 -1.73287 -0.203125 0.015625 0.078125 -1.71302 -1.71302 -1.71302 -0.203125 0.015625 0.109375 -0.915794 -0.915794 -0.915794 -0.203125 0.046875 0.078125 -1.56304 -1.56304 -1.56304 -0.203125 0.046875 0.109375 -0.908926 -0.908926 -0.908926 -0.234375 0.015625 0.078125 -2.01052 -2.01052 -2.01052 -0.234375 0.015625 0.109375 -1.11085 -1.11085 -1.11085 -0.234375 0.046875 0.078125 -1.58719 -1.58719 -1.58719 -0.234375 0.046875 0.109375 -1.24657 -1.24657 -1.24657 -0.203125 0.078125 0.015625 -1.74775 -1.74775 -1.74775 -0.203125 0.078125 0.046875 -1.73487 -1.73487 -1.73487 -0.234375 0.078125 0.015625 -2.6842 -2.6842 -2.6842 -0.234375 0.078125 0.046875 -1.67953 -1.67953 -1.67953 -0.234375 0.109375 0.015625 -1.83993 -1.83993 -1.83993 -0.203125 0.078125 0.078125 -1.81733 -1.81733 -1.81733 -0.203125 0.078125 0.109375 -1.89298 -1.89298 -1.89298 -0.203125 0.109375 0.078125 -2.49879 -2.49879 -2.49879 -0.203125 0.109375 0.109375 -1.60354 -1.60354 -1.60354 -0.234375 0.078125 0.078125 -2.27566 -2.27566 -2.27566 -0.234375 0.078125 0.109375 -2.60034 -2.60034 -2.60034 -0.234375 0.109375 0.078125 -1.80116 -1.80116 -1.80116 -0.234375 0.109375 0.109375 -2.54987 -2.54987 -2.54987 -0.140625 0.015625 0.140625 -2.72946 -2.72946 -2.72946 -0.140625 0.046875 0.140625 -1.14413 -1.14413 -1.14413 -0.171875 0.015625 0.140625 -1.66784 -1.66784 -1.66784 -0.171875 0.046875 0.140625 -1.14936 -1.14936 -1.14936 -0.140625 0.015625 0.234375 -1.49679 -1.49679 -1.49679 -0.140625 0.046875 0.234375 -1.26191 -1.26191 -1.26191 -0.171875 0.015625 0.234375 -1.96762 -1.96762 -1.96762 -0.171875 0.046875 0.234375 -0.343625 -0.343625 -0.343625 -0.140625 0.078125 0.140625 -1.80512 -1.80512 -1.80512 -0.140625 0.078125 0.171875 -1.23047 -1.23047 -1.23047 -0.140625 0.109375 0.140625 -0.909129 -0.909129 -0.909129 -0.140625 0.109375 0.171875 -1.5059 -1.5059 -1.5059 -0.171875 0.078125 0.140625 -1.00581 -1.00581 -1.00581 -0.171875 0.109375 0.171875 -0.882309 -0.882309 -0.882309 -0.140625 0.078125 0.203125 -1.81535 -1.81535 -1.81535 -0.140625 0.078125 0.234375 -1.60154 -1.60154 -1.60154 -0.140625 0.109375 0.203125 -2.14339 -2.14339 -2.14339 -0.140625 0.109375 0.234375 -1.94312 -1.94312 -1.94312 -0.171875 0.078125 0.203125 -1.09384 -1.09384 -1.09384 -0.171875 0.078125 0.234375 -1.20663 -1.20663 -1.20663 -0.171875 0.109375 0.203125 -1.00284 -1.00284 -1.00284 -0.203125 0.015625 0.171875 -0.772874 -0.772874 -0.772874 -0.203125 0.046875 0.140625 -0.89147 -0.89147 -0.89147 -0.203125 0.046875 0.171875 -1.22157 -1.22157 -1.22157 -0.234375 0.015625 0.171875 -0.841262 -0.841262 -0.841262 -0.234375 0.046875 0.140625 -1.31625 -1.31625 -1.31625 -0.234375 0.046875 0.171875 -1.46632 -1.46632 -1.46632 -0.203125 0.015625 0.203125 -2.56907 -2.56907 -2.56907 -0.203125 0.015625 0.234375 -2.62212 -2.62212 -2.62212 -0.203125 0.046875 0.203125 -1.321 -1.321 -1.321 -0.203125 0.046875 0.234375 -1.51764 -1.51764 -1.51764 -0.234375 0.015625 0.203125 -3.32428 -3.32428 -3.32428 -0.234375 0.015625 0.234375 -2.43991 -2.43991 -2.43991 -0.234375 0.046875 0.203125 -1.95758 -1.95758 -1.95758 -0.234375 0.046875 0.234375 -1.60027 -1.60027 -1.60027 -0.203125 0.078125 0.140625 -1.32025 -1.32025 -1.32025 -0.203125 0.078125 0.171875 -1.10642 -1.10642 -1.10642 -0.234375 0.078125 0.140625 -2.34356 -2.34356 -2.34356 -0.234375 0.078125 0.171875 -2.15142 -2.15142 -2.15142 -0.203125 0.078125 0.203125 -1.05043 -1.05043 -1.05043 -0.203125 0.078125 0.234375 -1.06977 -1.06977 -1.06977 -0.203125 0.109375 0.203125 -1.07715 -1.07715 -1.07715 -0.234375 0.078125 0.203125 -2.11005 -2.11005 -2.11005 -0.234375 0.078125 0.234375 -1.68717 -1.68717 -1.68717 -0.234375 0.109375 0.203125 -1.94519 -1.94519 -1.94519 -0.234375 0.109375 0.234375 -1.93522 -1.93522 -1.93522 -0.140625 0.140625 0.015625 -2.3174 -2.3174 -2.3174 -0.140625 0.140625 0.046875 -1.7105 -1.7105 -1.7105 -0.140625 0.171875 0.015625 -0.370687 -0.370687 -0.370687 -0.140625 0.171875 0.046875 -2.19241 -2.19241 -2.19241 -0.171875 0.171875 0.015625 -2.19655 -2.19655 -2.19655 -0.171875 0.171875 0.046875 -1.88728 -1.88728 -1.88728 -0.140625 0.171875 0.078125 -2.39219 -2.39219 -2.39219 -0.140625 0.171875 0.109375 2.03053 2.03053 2.03053 -0.171875 0.140625 0.078125 -1.55226 -1.55226 -1.55226 -0.171875 0.171875 0.078125 -0.614932 -0.614932 -0.614932 -0.171875 0.171875 0.109375 -3.3905 -3.3905 -3.3905 -0.140625 0.203125 0.015625 0.0730931 0.0730931 0.0730931 -0.140625 0.203125 0.046875 -2.29814 -2.29814 -2.29814 -0.171875 0.203125 0.015625 -0.167376 -0.167376 -0.167376 -0.171875 0.203125 0.046875 -3.07407 -3.07407 -3.07407 -0.140625 0.203125 0.078125 -1.61039 -1.61039 -1.61039 -0.140625 0.203125 0.109375 -3.85751 -3.85751 -3.85751 -0.140625 0.234375 0.078125 0.00555776 0.00555776 0.00555776 -0.140625 0.234375 0.109375 -2.49398 -2.49398 -2.49398 -0.171875 0.203125 0.078125 -3.92635 -3.92635 -3.92635 -0.171875 0.203125 0.109375 9.39419 9.39419 9.39419 -0.171875 0.234375 0.078125 -3.17074 -3.17074 -3.17074 -0.171875 0.234375 0.109375 2.07459 2.07459 2.07459 -0.203125 0.140625 0.015625 -1.97492 -1.97492 -1.97492 -0.203125 0.171875 0.015625 1.3413 1.3413 1.3413 -0.203125 0.171875 0.046875 -1.27134 -1.27134 -1.27134 -0.234375 0.140625 0.015625 -1.78164 -1.78164 -1.78164 -0.234375 0.171875 0.015625 -1.48166 -1.48166 -1.48166 -0.234375 0.171875 0.046875 -2.2139 -2.2139 -2.2139 -0.203125 0.140625 0.078125 -1.41838 -1.41838 -1.41838 -0.203125 0.171875 0.078125 -1.62324 -1.62324 -1.62324 -0.234375 0.140625 0.078125 -1.49271 -1.49271 -1.49271 -0.234375 0.140625 0.109375 -1.20132 -1.20132 -1.20132 -0.234375 0.171875 0.078125 -3.55583 -3.55583 -3.55583 -0.234375 0.171875 0.109375 2.61767 2.61767 2.61767 -0.203125 0.203125 0.046875 12.019 12.019 12.019 -0.203125 0.234375 0.046875 -1.14145 -1.14145 -1.14145 -0.234375 0.203125 0.046875 -2.99598 -2.99598 -2.99598 -0.234375 0.234375 0.015625 0.881993 0.881993 0.881993 -0.234375 0.234375 0.046875 0.630222 0.630222 0.630222 -0.203125 0.203125 0.078125 -6.41342 -6.41342 -6.41342 -0.234375 0.203125 0.078125 -3.60947 -3.60947 -3.60947 -0.234375 0.203125 0.109375 -3.67582 -3.67582 -3.67582 -0.234375 0.234375 0.078125 -2.02001 -2.02001 -2.02001 -0.234375 0.234375 0.109375 -1.48599 -1.48599 -1.48599 -0.171875 0.140625 0.171875 -2.47043 -2.47043 -2.47043 -0.171875 0.171875 0.171875 3.05485 3.05485 3.05485 -0.140625 0.140625 0.203125 -1.90788 -1.90788 -1.90788 -0.140625 0.140625 0.234375 -1.82749 -1.82749 -1.82749 -0.140625 0.171875 0.234375 -2.74009 -2.74009 -2.74009 -0.171875 0.140625 0.203125 -1.80542 -1.80542 -1.80542 -0.171875 0.140625 0.234375 -1.22296 -1.22296 -1.22296 -0.171875 0.171875 0.203125 -1.82781 -1.82781 -1.82781 -0.171875 0.171875 0.234375 -1.79222 -1.79222 -1.79222 -0.140625 0.203125 0.140625 -1.81742 -1.81742 -1.81742 -0.140625 0.234375 0.140625 -2.66479 -2.66479 -2.66479 -0.140625 0.234375 0.171875 -66.454 -66.454 -66.454 -0.171875 0.203125 0.140625 -0.645548 -0.645548 -0.645548 -0.171875 0.203125 0.171875 0.456213 0.456213 0.456213 -0.171875 0.234375 0.140625 5.19047 5.19047 5.19047 -0.171875 0.234375 0.171875 1.63578 1.63578 1.63578 -0.171875 0.203125 0.203125 -1.84151 -1.84151 -1.84151 -0.171875 0.234375 0.203125 -2.99539 -2.99539 -2.99539 -0.203125 0.171875 0.171875 -2.0383 -2.0383 -2.0383 -0.234375 0.140625 0.171875 -2.28653 -2.28653 -2.28653 -0.234375 0.171875 0.140625 0.507214 0.507214 0.507214 -0.234375 0.171875 0.171875 -0.801642 -0.801642 -0.801642 -0.203125 0.140625 0.203125 -1.44587 -1.44587 -1.44587 -0.203125 0.171875 0.203125 -1.77955 -1.77955 -1.77955 -0.203125 0.171875 0.234375 -1.34111 -1.34111 -1.34111 -0.234375 0.140625 0.203125 -1.42696 -1.42696 -1.42696 -0.234375 0.140625 0.234375 -1.87 -1.87 -1.87 -0.234375 0.171875 0.234375 -1.95358 -1.95358 -1.95358 -0.203125 0.203125 0.140625 0.631484 0.631484 0.631484 -0.203125 0.203125 0.171875 -1.45422 -1.45422 -1.45422 -0.203125 0.234375 0.140625 -3.81273 -3.81273 -3.81273 -0.203125 0.234375 0.171875 -2.04042 -2.04042 -2.04042 -0.234375 0.203125 0.140625 0.458007 0.458007 0.458007 -0.234375 0.234375 0.140625 -3.96419 -3.96419 -3.96419 -0.234375 0.234375 0.171875 -2.16566 -2.16566 -2.16566 -0.203125 0.203125 0.203125 -1.84153 -1.84153 -1.84153 -0.203125 0.203125 0.234375 -2.29887 -2.29887 -2.29887 -0.203125 0.234375 0.203125 -2.98667 -2.98667 -2.98667 -0.203125 0.234375 0.234375 -1.34477 -1.34477 -1.34477 -0.234375 0.203125 0.234375 -6.06029 -6.06029 -6.06029 -0.234375 0.234375 0.203125 -2.2096 -2.2096 -2.2096 -0.234375 0.234375 0.234375 -3.09469 -3.09469 -3.09469 -0.015625 0.015625 0.265625 -50.1032 -50.1032 -50.1032 -0.015625 0.015625 0.296875 -25.3338 -25.3338 -25.3338 -0.046875 0.015625 0.296875 78.5329 78.5329 78.5329 -0.015625 0.015625 0.328125 54.4082 54.4082 54.4082 -0.015625 0.046875 0.328125 69.087 69.087 69.087 -0.046875 0.015625 0.328125 -37.5645 -37.5645 -37.5645 -0.046875 0.046875 0.328125 95.5702 95.5702 95.5702 -0.015625 0.109375 0.265625 6.96699 6.96699 6.96699 -0.015625 0.109375 0.296875 -14.6073 -14.6073 -14.6073 -0.046875 0.078125 0.265625 -118.167 -118.167 -118.167 -0.046875 0.078125 0.296875 -152.622 -152.622 -152.622 -0.046875 0.109375 0.265625 -19.7097 -19.7097 -19.7097 -0.046875 0.109375 0.296875 -94.2627 -94.2627 -94.2627 -0.015625 0.078125 0.328125 134.859 134.859 134.859 -0.015625 0.109375 0.328125 -117.912 -117.912 -117.912 -0.046875 0.078125 0.328125 35.9845 35.9845 35.9845 -0.046875 0.109375 0.328125 34.9059 34.9059 34.9059 -0.078125 0.015625 0.265625 -21.3814 -21.3814 -21.3814 -0.078125 0.015625 0.296875 -62.9348 -62.9348 -62.9348 -0.078125 0.046875 0.296875 60.1783 60.1783 60.1783 -0.078125 0.015625 0.328125 -35.2824 -35.2824 -35.2824 -0.078125 0.046875 0.328125 20.0491 20.0491 20.0491 -0.109375 0.015625 0.328125 -0.815152 -0.815152 -0.815152 -0.109375 0.046875 0.328125 -2.44139 -2.44139 -2.44139 -0.078125 0.078125 0.265625 -59.4815 -59.4815 -59.4815 -0.078125 0.078125 0.296875 -25.5873 -25.5873 -25.5873 -0.078125 0.109375 0.265625 -9.96025 -9.96025 -9.96025 -0.078125 0.109375 0.296875 32.9678 32.9678 32.9678 -0.109375 0.078125 0.265625 -2.98362 -2.98362 -2.98362 -0.109375 0.078125 0.296875 -1.9683 -1.9683 -1.9683 -0.109375 0.109375 0.265625 -0.73702 -0.73702 -0.73702 -0.109375 0.078125 0.328125 -3.48307 -3.48307 -3.48307 -0.046875 0.171875 0.265625 -8.17571 -8.17571 -8.17571 -0.046875 0.171875 0.296875 -9.41558 -9.41558 -9.41558 -0.046875 0.203125 0.265625 -2.2044 -2.2044 -2.2044 -0.046875 0.203125 0.296875 1.33905 1.33905 1.33905 -0.046875 0.234375 0.265625 -11.8245 -11.8245 -11.8245 -0.046875 0.234375 0.296875 -14.7709 -14.7709 -14.7709 -0.078125 0.140625 0.265625 -12.858 -12.858 -12.858 -0.078125 0.140625 0.296875 -2.12826 -2.12826 -2.12826 -0.078125 0.171875 0.265625 -1.08902 -1.08902 -1.08902 -0.078125 0.171875 0.296875 0.881687 0.881687 0.881687 -0.109375 0.140625 0.265625 -1.84367 -1.84367 -1.84367 -0.109375 0.140625 0.296875 -1.03044 -1.03044 -1.03044 -0.109375 0.171875 0.265625 -2.95109 -2.95109 -2.95109 -0.109375 0.171875 0.296875 -1.69538 -1.69538 -1.69538 -0.078125 0.171875 0.328125 -2.2291 -2.2291 -2.2291 -0.109375 0.171875 0.328125 -1.1446 -1.1446 -1.1446 -0.078125 0.203125 0.296875 -0.391854 -0.391854 -0.391854 -0.078125 0.234375 0.296875 3.23792 3.23792 3.23792 -0.109375 0.203125 0.296875 -1.66052 -1.66052 -1.66052 -0.109375 0.234375 0.296875 -2.16405 -2.16405 -2.16405 -0.078125 0.203125 0.328125 6.8985 6.8985 6.8985 -0.078125 0.234375 0.328125 -2.61834 -2.61834 -2.61834 -0.109375 0.203125 0.328125 -1.12013 -1.12013 -1.12013 -0.109375 0.234375 0.328125 -1.77799 -1.77799 -1.77799 -0.140625 0.015625 0.265625 -0.913623 -0.913623 -0.913623 -0.140625 0.046875 0.296875 -1.91224 -1.91224 -1.91224 -0.171875 0.015625 0.265625 -0.386246 -0.386246 -0.386246 -0.171875 0.015625 0.296875 -0.542239 -0.542239 -0.542239 -0.171875 0.046875 0.265625 -1.74005 -1.74005 -1.74005 -0.171875 0.046875 0.296875 -1.37576 -1.37576 -1.37576 -0.140625 0.015625 0.328125 -1.28616 -1.28616 -1.28616 -0.140625 0.046875 0.328125 -0.96789 -0.96789 -0.96789 -0.171875 0.015625 0.328125 -1.32033 -1.32033 -1.32033 -0.171875 0.046875 0.328125 -1.49752 -1.49752 -1.49752 -0.140625 0.078125 0.265625 -0.990738 -0.990738 -0.990738 -0.140625 0.078125 0.296875 -1.71204 -1.71204 -1.71204 -0.140625 0.109375 0.265625 -0.576046 -0.576046 -0.576046 -0.171875 0.078125 0.265625 -1.24585 -1.24585 -1.24585 -0.171875 0.078125 0.296875 -1.26824 -1.26824 -1.26824 -0.140625 0.078125 0.328125 -1.15295 -1.15295 -1.15295 -0.140625 0.140625 0.265625 -1.75705 -1.75705 -1.75705 -0.140625 0.171875 0.265625 -0.218769 -0.218769 -0.218769 -0.140625 0.171875 0.296875 -1.17971 -1.17971 -1.17971 -0.171875 0.171875 0.265625 -0.71424 -0.71424 -0.71424 -0.171875 0.171875 0.296875 -0.774977 -0.774977 -0.774977 -0.140625 0.203125 0.265625 -0.710305 -0.710305 -0.710305 -0.140625 0.203125 0.296875 0.461531 0.461531 0.461531 -0.140625 0.234375 0.296875 -1.60426 -1.60426 -1.60426 -0.171875 0.203125 0.296875 2.8925 2.8925 2.8925 -0.171875 0.234375 0.296875 2.38793 2.38793 2.38793 -0.171875 0.203125 0.328125 0.0244314 0.0244314 0.0244314 -0.203125 0.171875 0.265625 -2.08886 -2.08886 -2.08886 -0.203125 0.171875 0.296875 -1.47813 -1.47813 -1.47813 -0.234375 0.171875 0.265625 -2.15754 -2.15754 -2.15754 -0.234375 0.171875 0.296875 -1.43 -1.43 -1.43 -0.203125 0.203125 0.296875 0.415735 0.415735 0.415735 -0.203125 0.234375 0.296875 1.47234 1.47234 1.47234 -0.234375 0.203125 0.265625 -0.585827 -0.585827 -0.585827 -0.234375 0.203125 0.296875 -5.04627 -5.04627 -5.04627 -0.234375 0.234375 0.265625 -1.16546 -1.16546 -1.16546 -0.234375 0.234375 0.296875 0.261804 0.261804 0.261804 -0.015625 0.265625 0.015625 -1.19917 -1.19917 -1.19917 -0.015625 0.265625 0.046875 1.39475 1.39475 1.39475 -0.015625 0.296875 0.015625 -1.41045 -1.41045 -1.41045 -0.015625 0.296875 0.046875 -4.89526 -4.89526 -4.89526 -0.046875 0.265625 0.015625 -1.07753 -1.07753 -1.07753 -0.046875 0.265625 0.046875 -1.33883 -1.33883 -1.33883 -0.046875 0.296875 0.015625 -1.42259 -1.42259 -1.42259 -0.046875 0.296875 0.046875 0.88699 0.88699 0.88699 -0.015625 0.265625 0.078125 -4.04051 -4.04051 -4.04051 -0.015625 0.265625 0.109375 -27.0999 -27.0999 -27.0999 -0.015625 0.296875 0.078125 -1.23194 -1.23194 -1.23194 -0.015625 0.296875 0.109375 12.4817 12.4817 12.4817 -0.015625 0.328125 0.015625 -2.21302 -2.21302 -2.21302 -0.046875 0.328125 0.015625 -2.27833 -2.27833 -2.27833 -0.015625 0.328125 0.078125 -4.93398 -4.93398 -4.93398 -0.015625 0.328125 0.109375 -13.3068 -13.3068 -13.3068 -0.015625 0.359375 0.109375 46.0582 46.0582 46.0582 -0.078125 0.265625 0.015625 -1.40345 -1.40345 -1.40345 -0.078125 0.265625 0.046875 -0.662615 -0.662615 -0.662615 -0.078125 0.296875 0.015625 -1.86867 -1.86867 -1.86867 -0.078125 0.296875 0.046875 -0.820118 -0.820118 -0.820118 -0.109375 0.265625 0.015625 -1.99713 -1.99713 -1.99713 -0.109375 0.265625 0.046875 -2.55514 -2.55514 -2.55514 -0.109375 0.296875 0.015625 -2.03808 -2.03808 -2.03808 -0.109375 0.296875 0.046875 1.55392 1.55392 1.55392 -0.078125 0.296875 0.078125 -3.35883 -3.35883 -3.35883 -0.109375 0.265625 0.078125 -2.11942 -2.11942 -2.11942 -0.078125 0.328125 0.015625 -2.21952 -2.21952 -2.21952 -0.078125 0.328125 0.046875 -1.77824 -1.77824 -1.77824 -0.078125 0.359375 0.015625 -1.31069 -1.31069 -1.31069 -0.078125 0.359375 0.046875 -4.06737 -4.06737 -4.06737 -0.109375 0.328125 0.015625 -0.70394 -0.70394 -0.70394 -0.109375 0.328125 0.046875 -1.77098 -1.77098 -1.77098 -0.109375 0.359375 0.015625 0.298656 0.298656 0.298656 -0.109375 0.359375 0.046875 -1.51348 -1.51348 -1.51348 -0.078125 0.359375 0.078125 0.494325 0.494325 0.494325 -0.078125 0.359375 0.109375 16.039 16.039 16.039 -0.109375 0.359375 0.078125 -3.13596 -3.13596 -3.13596 -0.109375 0.359375 0.109375 -2.59003 -2.59003 -2.59003 -0.015625 0.265625 0.171875 -33.5731 -33.5731 -33.5731 -0.015625 0.296875 0.140625 22.7684 22.7684 22.7684 -0.015625 0.296875 0.171875 -22.7604 -22.7604 -22.7604 -0.046875 0.265625 0.171875 -35.6668 -35.6668 -35.6668 -0.046875 0.296875 0.171875 -18.5749 -18.5749 -18.5749 -0.015625 0.265625 0.203125 -90.518 -90.518 -90.518 -0.015625 0.265625 0.234375 -4.67487 -4.67487 -4.67487 -0.015625 0.296875 0.203125 -3.59165 -3.59165 -3.59165 -0.015625 0.296875 0.234375 6.90118 6.90118 6.90118 -0.046875 0.265625 0.203125 -33.5552 -33.5552 -33.5552 -0.046875 0.265625 0.234375 -8.27388 -8.27388 -8.27388 -0.046875 0.296875 0.234375 -0.444672 -0.444672 -0.444672 -0.015625 0.328125 0.140625 -9.61359 -9.61359 -9.61359 -0.015625 0.328125 0.171875 -22.8706 -22.8706 -22.8706 -0.015625 0.359375 0.140625 6.12486 6.12486 6.12486 -0.015625 0.359375 0.171875 -60.6465 -60.6465 -60.6465 -0.046875 0.328125 0.140625 -93.826 -93.826 -93.826 -0.046875 0.328125 0.171875 44.7737 44.7737 44.7737 -0.046875 0.359375 0.140625 -31.4387 -31.4387 -31.4387 -0.046875 0.359375 0.171875 -42.3425 -42.3425 -42.3425 -0.015625 0.328125 0.234375 -1.97627 -1.97627 -1.97627 -0.015625 0.359375 0.203125 -6.46906 -6.46906 -6.46906 -0.015625 0.359375 0.234375 -1.82031 -1.82031 -1.82031 -0.046875 0.328125 0.234375 -1.25035 -1.25035 -1.25035 -0.046875 0.359375 0.203125 -1.82712 -1.82712 -1.82712 -0.046875 0.359375 0.234375 0.156033 0.156033 0.156033 -0.078125 0.265625 0.140625 12.7903 12.7903 12.7903 -0.078125 0.265625 0.171875 3.15326 3.15326 3.15326 -0.078125 0.296875 0.171875 22.622 22.622 22.622 -0.109375 0.265625 0.140625 -1.6642 -1.6642 -1.6642 -0.109375 0.265625 0.171875 -1.96453 -1.96453 -1.96453 -0.109375 0.296875 0.140625 -1.98897 -1.98897 -1.98897 -0.109375 0.296875 0.171875 -1.88256 -1.88256 -1.88256 -0.078125 0.265625 0.203125 -3.17327 -3.17327 -3.17327 -0.078125 0.265625 0.234375 -8.07195 -8.07195 -8.07195 -0.078125 0.296875 0.203125 -1.08383 -1.08383 -1.08383 -0.078125 0.296875 0.234375 -1.5854 -1.5854 -1.5854 -0.109375 0.265625 0.203125 -3.06564 -3.06564 -3.06564 -0.109375 0.265625 0.234375 -2.05068 -2.05068 -2.05068 -0.109375 0.296875 0.203125 -3.96574 -3.96574 -3.96574 -0.109375 0.296875 0.234375 -0.717671 -0.717671 -0.717671 -0.078125 0.328125 0.171875 -48.3625 -48.3625 -48.3625 -0.078125 0.359375 0.140625 29.8118 29.8118 29.8118 -0.078125 0.359375 0.171875 -33.0599 -33.0599 -33.0599 -0.109375 0.328125 0.140625 2.02021 2.02021 2.02021 -0.109375 0.328125 0.171875 1.77556 1.77556 1.77556 -0.109375 0.359375 0.140625 -2.45535 -2.45535 -2.45535 -0.078125 0.328125 0.203125 -1.72278 -1.72278 -1.72278 -0.078125 0.328125 0.234375 -2.89487 -2.89487 -2.89487 -0.078125 0.359375 0.203125 -1.36456 -1.36456 -1.36456 -0.078125 0.359375 0.234375 -0.399375 -0.399375 -0.399375 -0.109375 0.328125 0.234375 -6.99863 -6.99863 -6.99863 -0.015625 0.421875 0.015625 -1.00422 -1.00422 -1.00422 -0.015625 0.421875 0.046875 2.0639 2.0639 2.0639 -0.046875 0.390625 0.015625 -1.48177 -1.48177 -1.48177 -0.046875 0.390625 0.046875 -5.38135 -5.38135 -5.38135 -0.046875 0.421875 0.015625 -1.51077 -1.51077 -1.51077 -0.046875 0.421875 0.046875 -0.877097 -0.877097 -0.877097 -0.015625 0.390625 0.109375 12.7184 12.7184 12.7184 -0.015625 0.421875 0.078125 0.283366 0.283366 0.283366 -0.015625 0.421875 0.109375 3.36233 3.36233 3.36233 -0.046875 0.390625 0.078125 -1.51119 -1.51119 -1.51119 -0.046875 0.390625 0.109375 86.2406 86.2406 86.2406 -0.046875 0.421875 0.078125 -2.15135 -2.15135 -2.15135 -0.015625 0.453125 0.046875 -0.848435 -0.848435 -0.848435 -0.046875 0.453125 0.015625 -2.13467 -2.13467 -2.13467 -0.046875 0.484375 0.015625 -1.37976 -1.37976 -1.37976 -0.015625 0.453125 0.078125 -1.62117 -1.62117 -1.62117 -0.078125 0.390625 0.015625 -1.07004 -1.07004 -1.07004 -0.078125 0.390625 0.046875 -5.36461 -5.36461 -5.36461 -0.078125 0.421875 0.015625 -2.07947 -2.07947 -2.07947 -0.078125 0.421875 0.046875 -3.49881 -3.49881 -3.49881 -0.109375 0.390625 0.015625 -4.03434 -4.03434 -4.03434 -0.109375 0.390625 0.046875 -1.25817 -1.25817 -1.25817 -0.109375 0.421875 0.046875 -1.46333 -1.46333 -1.46333 -0.078125 0.390625 0.078125 -4.23989 -4.23989 -4.23989 -0.078125 0.390625 0.109375 -16.5457 -16.5457 -16.5457 -0.109375 0.390625 0.078125 -1.40475 -1.40475 -1.40475 -0.109375 0.390625 0.109375 -2.47318 -2.47318 -2.47318 -0.109375 0.421875 0.078125 -2.04605 -2.04605 -2.04605 -0.078125 0.453125 0.015625 -2.01041 -2.01041 -2.01041 -0.078125 0.453125 0.046875 -2.14327 -2.14327 -2.14327 -0.078125 0.484375 0.015625 -1.4485 -1.4485 -1.4485 -0.078125 0.484375 0.046875 -1.90657 -1.90657 -1.90657 -0.109375 0.453125 0.046875 -1.98033 -1.98033 -1.98033 -0.109375 0.484375 0.015625 -2.20997 -2.20997 -2.20997 -0.109375 0.484375 0.046875 -2.06404 -2.06404 -2.06404 -0.109375 0.453125 0.078125 -2.59688 -2.59688 -2.59688 -0.109375 0.484375 0.078125 -2.29813 -2.29813 -2.29813 -0.015625 0.390625 0.140625 16.2939 16.2939 16.2939 -0.046875 0.390625 0.140625 122.196 122.196 122.196 -0.078125 0.390625 0.140625 58.9077 58.9077 58.9077 -0.140625 0.296875 0.015625 -1.24 -1.24 -1.24 -0.140625 0.296875 0.046875 -0.0240171 -0.0240171 -0.0240171 -0.171875 0.296875 0.015625 -4.90964 -4.90964 -4.90964 -0.140625 0.328125 0.015625 -0.830067 -0.830067 -0.830067 -0.140625 0.328125 0.046875 -0.256949 -0.256949 -0.256949 -0.171875 0.328125 0.015625 -1.35984 -1.35984 -1.35984 -0.171875 0.328125 0.046875 -3.161 -3.161 -3.161 -0.171875 0.359375 0.046875 1.04322 1.04322 1.04322 -0.140625 0.328125 0.109375 -0.709996 -0.709996 -0.709996 -0.140625 0.359375 0.078125 -1.39073 -1.39073 -1.39073 -0.140625 0.359375 0.109375 -1.83723 -1.83723 -1.83723 -0.171875 0.328125 0.078125 0.853249 0.853249 0.853249 -0.171875 0.328125 0.109375 -17.001 -17.001 -17.001 -0.171875 0.359375 0.078125 -0.905525 -0.905525 -0.905525 -0.171875 0.359375 0.109375 -17.9704 -17.9704 -17.9704 -0.203125 0.265625 0.046875 1.99873 1.99873 1.99873 -0.203125 0.296875 0.015625 -4.30366 -4.30366 -4.30366 -0.203125 0.296875 0.046875 -1.92334 -1.92334 -1.92334 -0.234375 0.265625 0.015625 -3.78232 -3.78232 -3.78232 -0.234375 0.265625 0.046875 0.883068 0.883068 0.883068 -0.234375 0.296875 0.015625 -2.0642 -2.0642 -2.0642 -0.234375 0.296875 0.046875 4.48592 4.48592 4.48592 -0.203125 0.296875 0.109375 -1.11747 -1.11747 -1.11747 -0.203125 0.328125 0.015625 0.544954 0.544954 0.544954 -0.203125 0.328125 0.046875 -0.859294 -0.859294 -0.859294 -0.203125 0.359375 0.015625 -4.22804 -4.22804 -4.22804 -0.203125 0.359375 0.046875 -2.65941 -2.65941 -2.65941 -0.234375 0.328125 0.046875 -1.27881 -1.27881 -1.27881 -0.234375 0.359375 0.046875 -11.4083 -11.4083 -11.4083 -0.203125 0.328125 0.078125 -3.48021 -3.48021 -3.48021 -0.203125 0.328125 0.109375 4.4771 4.4771 4.4771 -0.234375 0.328125 0.078125 -0.785908 -0.785908 -0.785908 -0.234375 0.328125 0.109375 -4.65054 -4.65054 -4.65054 -0.234375 0.359375 0.078125 -1.58409 -1.58409 -1.58409 -0.234375 0.359375 0.109375 -6.37073 -6.37073 -6.37073 -0.140625 0.265625 0.171875 -2.15069 -2.15069 -2.15069 -0.140625 0.296875 0.140625 -1.2658 -1.2658 -1.2658 -0.140625 0.296875 0.171875 -0.463253 -0.463253 -0.463253 -0.171875 0.265625 0.140625 -0.238963 -0.238963 -0.238963 -0.171875 0.265625 0.171875 -1.2197 -1.2197 -1.2197 -0.171875 0.296875 0.140625 -2.86462 -2.86462 -2.86462 -0.171875 0.296875 0.171875 -1.54644 -1.54644 -1.54644 -0.140625 0.265625 0.203125 -2.41277 -2.41277 -2.41277 -0.140625 0.296875 0.203125 -2.59391 -2.59391 -2.59391 -0.171875 0.265625 0.203125 -2.35663 -2.35663 -2.35663 -0.171875 0.296875 0.203125 -2.29373 -2.29373 -2.29373 -0.140625 0.328125 0.140625 -0.507086 -0.507086 -0.507086 -0.171875 0.328125 0.140625 -8.23503 -8.23503 -8.23503 -0.140625 0.328125 0.203125 -4.41765 -4.41765 -4.41765 -0.140625 0.328125 0.234375 -2.84088 -2.84088 -2.84088 -0.171875 0.328125 0.203125 1.9768 1.9768 1.9768 -0.171875 0.328125 0.234375 1.18408 1.18408 1.18408 -0.203125 0.265625 0.140625 -1.146 -1.146 -1.146 -0.203125 0.265625 0.171875 -1.42305 -1.42305 -1.42305 -0.203125 0.296875 0.140625 -0.96448 -0.96448 -0.96448 -0.203125 0.296875 0.171875 0.909606 0.909606 0.909606 -0.234375 0.265625 0.140625 -2.77875 -2.77875 -2.77875 -0.234375 0.265625 0.171875 -1.63191 -1.63191 -1.63191 -0.234375 0.296875 0.140625 -3.34131 -3.34131 -3.34131 -0.234375 0.296875 0.171875 -4.3339 -4.3339 -4.3339 -0.203125 0.265625 0.203125 -1.29347 -1.29347 -1.29347 -0.203125 0.265625 0.234375 -5.08802 -5.08802 -5.08802 -0.203125 0.296875 0.203125 -2.51599 -2.51599 -2.51599 -0.203125 0.296875 0.234375 -1.8364 -1.8364 -1.8364 -0.234375 0.265625 0.234375 -4.30961 -4.30961 -4.30961 -0.234375 0.296875 0.203125 0.206009 0.206009 0.206009 -0.234375 0.296875 0.234375 -2.612 -2.612 -2.612 -0.234375 0.328125 0.140625 -2.1887 -2.1887 -2.1887 -0.234375 0.328125 0.171875 9.77193 9.77193 9.77193 -0.203125 0.328125 0.234375 -3.12119 -3.12119 -3.12119 -0.234375 0.328125 0.203125 0.697666 0.697666 0.697666 -0.140625 0.390625 0.046875 -2.04017 -2.04017 -2.04017 -0.140625 0.421875 0.046875 -1.87199 -1.87199 -1.87199 -0.171875 0.390625 0.046875 -6.06267 -6.06267 -6.06267 -0.171875 0.421875 0.015625 -2.32849 -2.32849 -2.32849 -0.171875 0.421875 0.046875 0.804012 0.804012 0.804012 -0.140625 0.390625 0.078125 -0.954395 -0.954395 -0.954395 -0.140625 0.421875 0.078125 -1.99962 -1.99962 -1.99962 -0.171875 0.453125 0.015625 -6.59222 -6.59222 -6.59222 -0.171875 0.453125 0.046875 -2.37209 -2.37209 -2.37209 -0.171875 0.484375 0.046875 -1.8655 -1.8655 -1.8655 -0.140625 0.453125 0.078125 -2.3323 -2.3323 -2.3323 -0.140625 0.484375 0.078125 -2.87551 -2.87551 -2.87551 -0.171875 0.453125 0.078125 -1.78651 -1.78651 -1.78651 -0.171875 0.484375 0.078125 -2.41235 -2.41235 -2.41235 -0.203125 0.390625 0.015625 -3.52903 -3.52903 -3.52903 -0.203125 0.390625 0.046875 -8.24819 -8.24819 -8.24819 -0.203125 0.421875 0.015625 2.41273 2.41273 2.41273 -0.203125 0.453125 0.015625 -0.70123 -0.70123 -0.70123 -0.203125 0.453125 0.046875 -2.31338 -2.31338 -2.31338 -0.203125 0.484375 0.015625 -18.5769 -18.5769 -18.5769 -0.203125 0.484375 0.046875 -2.29201 -2.29201 -2.29201 -0.203125 0.484375 0.078125 -2.45796 -2.45796 -2.45796 -0.015625 0.296875 0.265625 -15.4985 -15.4985 -15.4985 -0.046875 0.296875 0.265625 -10.7761 -10.7761 -10.7761 -0.015625 0.328125 0.265625 -6.52609 -6.52609 -6.52609 -0.046875 0.328125 0.265625 -3.71203 -3.71203 -3.71203 -0.078125 0.265625 0.265625 -8.89342 -8.89342 -8.89342 -0.078125 0.265625 0.296875 0.370733 0.370733 0.370733 -0.109375 0.265625 0.265625 -1.23805 -1.23805 -1.23805 -0.109375 0.265625 0.296875 -2.09623 -2.09623 -2.09623 -0.109375 0.296875 0.265625 -0.572296 -0.572296 -0.572296 -0.109375 0.296875 0.296875 -2.37448 -2.37448 -2.37448 -0.109375 0.328125 0.265625 -1.19122 -1.19122 -1.19122 -0.140625 0.265625 0.296875 -1.98449 -1.98449 -1.98449 -0.140625 0.296875 0.296875 -2.16303 -2.16303 -2.16303 -0.171875 0.265625 0.296875 -1.06901 -1.06901 -1.06901 -0.171875 0.296875 0.296875 -0.278574 -0.278574 -0.278574 -0.140625 0.328125 0.265625 -1.64548 -1.64548 -1.64548 -0.140625 0.328125 0.296875 -0.529773 -0.529773 -0.529773 -0.171875 0.328125 0.265625 -2.5421 -2.5421 -2.5421 -0.171875 0.328125 0.296875 -1.47049 -1.47049 -1.47049 -0.203125 0.265625 0.265625 -3.12296 -3.12296 -3.12296 -0.203125 0.265625 0.296875 -0.860583 -0.860583 -0.860583 -0.203125 0.296875 0.265625 -1.92187 -1.92187 -1.92187 -0.203125 0.296875 0.296875 -0.875338 -0.875338 -0.875338 -0.203125 0.328125 0.265625 3.00857 3.00857 3.00857 -0.265625 0.015625 0.015625 -2.07609 -2.07609 -2.07609 -0.265625 0.015625 0.046875 -4.08021 -4.08021 -4.08021 -0.265625 0.046875 0.015625 -2.20658 -2.20658 -2.20658 -0.265625 0.046875 0.046875 -2.51768 -2.51768 -2.51768 -0.296875 0.015625 0.015625 -2.25521 -2.25521 -2.25521 -0.296875 0.015625 0.046875 -1.90075 -1.90075 -1.90075 -0.296875 0.046875 0.015625 -2.33365 -2.33365 -2.33365 -0.265625 0.015625 0.078125 -1.25301 -1.25301 -1.25301 -0.265625 0.015625 0.109375 -1.37529 -1.37529 -1.37529 -0.265625 0.046875 0.078125 -1.86335 -1.86335 -1.86335 -0.296875 0.015625 0.078125 -1.55877 -1.55877 -1.55877 -0.296875 0.015625 0.109375 -1.26346 -1.26346 -1.26346 -0.296875 0.046875 0.109375 -2.17011 -2.17011 -2.17011 -0.265625 0.078125 0.015625 -2.40645 -2.40645 -2.40645 -0.265625 0.078125 0.046875 -1.98353 -1.98353 -1.98353 -0.265625 0.109375 0.015625 -1.982 -1.982 -1.982 -0.265625 0.109375 0.046875 871.039 871.039 871.039 -0.296875 0.109375 0.046875 -1.66855 -1.66855 -1.66855 -0.265625 0.078125 0.078125 -1.46354 -1.46354 -1.46354 -0.265625 0.109375 0.078125 -1.55818 -1.55818 -1.55818 -0.328125 0.015625 0.015625 -1.82813 -1.82813 -1.82813 -0.328125 0.015625 0.046875 -1.4041 -1.4041 -1.4041 -0.328125 0.046875 0.015625 -2.24881 -2.24881 -2.24881 -0.359375 0.015625 0.015625 -1.86552 -1.86552 -1.86552 -0.359375 0.046875 0.015625 -2.82793 -2.82793 -2.82793 -0.328125 0.015625 0.078125 -1.14849 -1.14849 -1.14849 -0.328125 0.015625 0.109375 -0.650549 -0.650549 -0.650549 -0.328125 0.046875 0.109375 -2.41089 -2.41089 -2.41089 -0.359375 0.015625 0.109375 -2.82614 -2.82614 -2.82614 -0.359375 0.046875 0.109375 -1.47697 -1.47697 -1.47697 -0.328125 0.109375 0.015625 -2.10088 -2.10088 -2.10088 -0.328125 0.109375 0.046875 -1.0955 -1.0955 -1.0955 -0.359375 0.078125 0.015625 -5.81324 -5.81324 -5.81324 -0.359375 0.109375 0.015625 1.65539 1.65539 1.65539 -0.328125 0.078125 0.109375 -1.98238 -1.98238 -1.98238 -0.328125 0.109375 0.078125 -1.65395 -1.65395 -1.65395 -0.328125 0.109375 0.109375 -1.67509 -1.67509 -1.67509 -0.359375 0.078125 0.109375 -2.25162 -2.25162 -2.25162 -0.359375 0.109375 0.109375 -1.43733 -1.43733 -1.43733 -0.265625 0.015625 0.140625 -1.61779 -1.61779 -1.61779 -0.265625 0.015625 0.171875 -1.79174 -1.79174 -1.79174 -0.265625 0.046875 0.171875 -1.41566 -1.41566 -1.41566 -0.296875 0.015625 0.140625 -1.41169 -1.41169 -1.41169 -0.296875 0.015625 0.171875 -1.568 -1.568 -1.568 -0.296875 0.046875 0.140625 -3.51379 -3.51379 -3.51379 -0.296875 0.046875 0.171875 -1.18495 -1.18495 -1.18495 -0.265625 0.046875 0.203125 -2.03539 -2.03539 -2.03539 -0.265625 0.046875 0.234375 -1.84904 -1.84904 -1.84904 -0.296875 0.015625 0.203125 -1.98067 -1.98067 -1.98067 -0.296875 0.015625 0.234375 -2.02738 -2.02738 -2.02738 -0.296875 0.046875 0.203125 -1.53673 -1.53673 -1.53673 -0.296875 0.046875 0.234375 -2.06673 -2.06673 -2.06673 -0.296875 0.078125 0.140625 -2.84172 -2.84172 -2.84172 -0.296875 0.078125 0.171875 -1.77511 -1.77511 -1.77511 -0.296875 0.109375 0.140625 -1.91828 -1.91828 -1.91828 -0.296875 0.109375 0.171875 -2.61081 -2.61081 -2.61081 -0.265625 0.078125 0.234375 -1.83058 -1.83058 -1.83058 -0.265625 0.109375 0.234375 -1.81932 -1.81932 -1.81932 -0.296875 0.078125 0.234375 -2.39292 -2.39292 -2.39292 -0.328125 0.015625 0.140625 -1.72707 -1.72707 -1.72707 -0.328125 0.015625 0.171875 -2.51005 -2.51005 -2.51005 -0.328125 0.046875 0.171875 -1.79903 -1.79903 -1.79903 -0.359375 0.015625 0.140625 -0.446981 -0.446981 -0.446981 -0.359375 0.015625 0.171875 -4.22127 -4.22127 -4.22127 -0.359375 0.046875 0.171875 -2.98082 -2.98082 -2.98082 -0.328125 0.015625 0.203125 -1.72138 -1.72138 -1.72138 -0.328125 0.015625 0.234375 -1.44222 -1.44222 -1.44222 -0.359375 0.015625 0.203125 -3.16513 -3.16513 -3.16513 -0.359375 0.015625 0.234375 -1.4029 -1.4029 -1.4029 -0.359375 0.046875 0.203125 -2.30122 -2.30122 -2.30122 -0.359375 0.046875 0.234375 -1.93754 -1.93754 -1.93754 -0.328125 0.078125 0.140625 -1.57716 -1.57716 -1.57716 -0.328125 0.078125 0.171875 -1.95152 -1.95152 -1.95152 -0.328125 0.109375 0.140625 -2.96985 -2.96985 -2.96985 -0.328125 0.109375 0.171875 -2.18212 -2.18212 -2.18212 -0.359375 0.078125 0.171875 -2.17873 -2.17873 -2.17873 -0.359375 0.109375 0.140625 -2.68033 -2.68033 -2.68033 -0.359375 0.109375 0.171875 -2.45418 -2.45418 -2.45418 -0.359375 0.109375 0.203125 -2.78401 -2.78401 -2.78401 -0.359375 0.109375 0.234375 -1.6686 -1.6686 -1.6686 -0.265625 0.140625 0.015625 -2.24564 -2.24564 -2.24564 -0.265625 0.140625 0.046875 -1.37777 -1.37777 -1.37777 -0.265625 0.171875 0.015625 -5.23724 -5.23724 -5.23724 -0.265625 0.171875 0.046875 4.31395 4.31395 4.31395 -0.296875 0.140625 0.015625 -2.04734 -2.04734 -2.04734 -0.296875 0.140625 0.046875 -0.888998 -0.888998 -0.888998 -0.296875 0.171875 0.015625 -1.95553 -1.95553 -1.95553 -0.296875 0.171875 0.046875 -0.913801 -0.913801 -0.913801 -0.265625 0.140625 0.078125 -0.995486 -0.995486 -0.995486 -0.265625 0.140625 0.109375 -1.1747 -1.1747 -1.1747 -0.265625 0.171875 0.078125 -1.54775 -1.54775 -1.54775 -0.265625 0.171875 0.109375 -0.482445 -0.482445 -0.482445 -0.296875 0.140625 0.109375 -0.869605 -0.869605 -0.869605 -0.296875 0.171875 0.109375 -0.150372 -0.150372 -0.150372 -0.265625 0.203125 0.015625 -3.82294 -3.82294 -3.82294 -0.265625 0.203125 0.046875 -5.78918 -5.78918 -5.78918 -0.265625 0.234375 0.015625 2.6481 2.6481 2.6481 -0.296875 0.203125 0.015625 -1.3012 -1.3012 -1.3012 -0.296875 0.203125 0.046875 -3.25341 -3.25341 -3.25341 -0.296875 0.234375 0.015625 -3.82522 -3.82522 -3.82522 -0.296875 0.234375 0.046875 -4.84775 -4.84775 -4.84775 -0.265625 0.203125 0.078125 -2.79743 -2.79743 -2.79743 -0.265625 0.203125 0.109375 -2.68637 -2.68637 -2.68637 -0.265625 0.234375 0.078125 -0.646568 -0.646568 -0.646568 -0.328125 0.140625 0.015625 -2.21771 -2.21771 -2.21771 -0.328125 0.140625 0.046875 -1.14527 -1.14527 -1.14527 -0.328125 0.171875 0.015625 -2.00458 -2.00458 -2.00458 -0.328125 0.171875 0.046875 -1.20377 -1.20377 -1.20377 -0.359375 0.140625 0.015625 -1.40131 -1.40131 -1.40131 -0.359375 0.140625 0.046875 -1.00763 -1.00763 -1.00763 -0.359375 0.171875 0.046875 -1.21203 -1.21203 -1.21203 -0.328125 0.140625 0.078125 -0.715643 -0.715643 -0.715643 -0.328125 0.140625 0.109375 -0.857923 -0.857923 -0.857923 -0.328125 0.171875 0.109375 -1.32591 -1.32591 -1.32591 -0.359375 0.140625 0.078125 -1.09284 -1.09284 -1.09284 -0.359375 0.140625 0.109375 -1.50073 -1.50073 -1.50073 -0.359375 0.171875 0.109375 -1.26358 -1.26358 -1.26358 -0.328125 0.234375 0.015625 -3.12125 -3.12125 -3.12125 -0.359375 0.203125 0.109375 -1.46638 -1.46638 -1.46638 -0.359375 0.234375 0.078125 -1.97908 -1.97908 -1.97908 -0.359375 0.234375 0.109375 -0.881729 -0.881729 -0.881729 -0.265625 0.140625 0.140625 -2.76904 -2.76904 -2.76904 -0.265625 0.140625 0.171875 -2.86573 -2.86573 -2.86573 -0.265625 0.171875 0.140625 -3.11806 -3.11806 -3.11806 -0.265625 0.171875 0.171875 -3.42858 -3.42858 -3.42858 -0.296875 0.140625 0.140625 -1.23103 -1.23103 -1.23103 -0.296875 0.140625 0.171875 -1.47317 -1.47317 -1.47317 -0.296875 0.171875 0.140625 -2.16946 -2.16946 -2.16946 -0.296875 0.171875 0.171875 -1.41088 -1.41088 -1.41088 -0.265625 0.140625 0.203125 -2.04538 -2.04538 -2.04538 -0.265625 0.140625 0.234375 -2.33336 -2.33336 -2.33336 -0.265625 0.171875 0.203125 -2.26645 -2.26645 -2.26645 -0.296875 0.140625 0.234375 -2.2065 -2.2065 -2.2065 -0.296875 0.171875 0.203125 -1.51024 -1.51024 -1.51024 -0.296875 0.171875 0.234375 -1.09526 -1.09526 -1.09526 -0.265625 0.203125 0.140625 -2.81561 -2.81561 -2.81561 -0.265625 0.203125 0.171875 -2.4728 -2.4728 -2.4728 -0.265625 0.234375 0.171875 -1.25083 -1.25083 -1.25083 -0.296875 0.203125 0.140625 -2.33235 -2.33235 -2.33235 -0.296875 0.203125 0.171875 -1.29705 -1.29705 -1.29705 -0.296875 0.234375 0.171875 -2.63885 -2.63885 -2.63885 -0.265625 0.203125 0.203125 -1.95482 -1.95482 -1.95482 -0.265625 0.234375 0.203125 -3.20857 -3.20857 -3.20857 -0.265625 0.234375 0.234375 -4.0391 -4.0391 -4.0391 -0.296875 0.203125 0.203125 -2.41757 -2.41757 -2.41757 -0.296875 0.234375 0.203125 -3.70624 -3.70624 -3.70624 -0.296875 0.234375 0.234375 -2.40732 -2.40732 -2.40732 -0.328125 0.140625 0.140625 -1.983 -1.983 -1.983 -0.328125 0.171875 0.140625 -1.03063 -1.03063 -1.03063 -0.328125 0.171875 0.171875 -1.65915 -1.65915 -1.65915 -0.359375 0.140625 0.140625 -1.00533 -1.00533 -1.00533 -0.359375 0.140625 0.171875 -2.64992 -2.64992 -2.64992 -0.359375 0.171875 0.140625 -1.30102 -1.30102 -1.30102 -0.359375 0.171875 0.171875 -1.92071 -1.92071 -1.92071 -0.328125 0.140625 0.234375 -2.00465 -2.00465 -2.00465 -0.328125 0.171875 0.234375 -1.50073 -1.50073 -1.50073 -0.359375 0.140625 0.234375 -1.74524 -1.74524 -1.74524 -0.359375 0.171875 0.203125 -2.03806 -2.03806 -2.03806 -0.359375 0.171875 0.234375 -1.59031 -1.59031 -1.59031 -0.328125 0.203125 0.140625 -0.969215 -0.969215 -0.969215 -0.328125 0.203125 0.171875 -0.374607 -0.374607 -0.374607 -0.328125 0.234375 0.140625 2.54399 2.54399 2.54399 -0.359375 0.203125 0.140625 -0.959235 -0.959235 -0.959235 -0.359375 0.203125 0.171875 -1.74002 -1.74002 -1.74002 -0.359375 0.234375 0.140625 -1.22498 -1.22498 -1.22498 -0.359375 0.234375 0.171875 -2.472 -2.472 -2.472 -0.328125 0.203125 0.203125 -1.71806 -1.71806 -1.71806 -0.328125 0.203125 0.234375 -1.4809 -1.4809 -1.4809 -0.328125 0.234375 0.234375 -1.58103 -1.58103 -1.58103 -0.359375 0.203125 0.203125 -1.82847 -1.82847 -1.82847 -0.359375 0.234375 0.203125 -2.05461 -2.05461 -2.05461 -0.359375 0.234375 0.234375 -2.06385 -2.06385 -2.06385 -0.390625 0.015625 0.015625 -2.36763 -2.36763 -2.36763 -0.390625 0.046875 0.015625 -0.222617 -0.222617 -0.222617 -0.390625 0.046875 0.046875 3.62119 3.62119 3.62119 -0.421875 0.046875 0.015625 2.34318 2.34318 2.34318 -0.421875 0.046875 0.046875 4.95886 4.95886 4.95886 -0.390625 0.015625 0.109375 -1.58127 -1.58127 -1.58127 -0.390625 0.046875 0.109375 -0.925503 -0.925503 -0.925503 -0.421875 0.046875 0.078125 -2.46443 -2.46443 -2.46443 -0.421875 0.046875 0.109375 -2.14806 -2.14806 -2.14806 -0.390625 0.078125 0.015625 -6.22228 -6.22228 -6.22228 -0.390625 0.109375 0.015625 -4.4042 -4.4042 -4.4042 -0.421875 0.078125 0.015625 -6.93825 -6.93825 -6.93825 -0.421875 0.078125 0.046875 0.595678 0.595678 0.595678 -0.421875 0.109375 0.015625 -10.1587 -10.1587 -10.1587 -0.421875 0.109375 0.046875 -6.08305 -6.08305 -6.08305 -0.390625 0.078125 0.109375 -1.1709 -1.1709 -1.1709 -0.390625 0.109375 0.109375 -1.22403 -1.22403 -1.22403 -0.421875 0.078125 0.078125 -1.43194 -1.43194 -1.43194 -0.421875 0.078125 0.109375 -1.38153 -1.38153 -1.38153 -0.421875 0.109375 0.078125 -1.22063 -1.22063 -1.22063 -0.421875 0.109375 0.109375 -1.11826 -1.11826 -1.11826 -0.453125 0.015625 0.046875 -1.24273 -1.24273 -1.24273 -0.453125 0.046875 0.046875 -0.946028 -0.946028 -0.946028 -0.484375 0.015625 0.046875 -0.906557 -0.906557 -0.906557 -0.484375 0.046875 0.015625 -0.952482 -0.952482 -0.952482 -0.484375 0.046875 0.046875 -1.04317 -1.04317 -1.04317 -0.453125 0.015625 0.078125 -2.53459 -2.53459 -2.53459 -0.453125 0.015625 0.109375 -2.14498 -2.14498 -2.14498 -0.453125 0.046875 0.078125 -2.00283 -2.00283 -2.00283 -0.453125 0.046875 0.109375 -1.76873 -1.76873 -1.76873 -0.453125 0.078125 0.015625 -1.02061 -1.02061 -1.02061 -0.453125 0.078125 0.046875 -0.955887 -0.955887 -0.955887 -0.484375 0.078125 0.015625 -1.211 -1.211 -1.211 -0.484375 0.078125 0.046875 -1.13021 -1.13021 -1.13021 -0.390625 0.015625 0.140625 -1.0095 -1.0095 -1.0095 -0.390625 0.015625 0.171875 -3.50784 -3.50784 -3.50784 -0.421875 0.015625 0.140625 -1.13225 -1.13225 -1.13225 -0.390625 0.046875 0.203125 -3.54083 -3.54083 -3.54083 -0.390625 0.046875 0.234375 -2.40768 -2.40768 -2.40768 -0.390625 0.078125 0.203125 -2.37592 -2.37592 -2.37592 -0.390625 0.078125 0.234375 -2.49111 -2.49111 -2.49111 -0.390625 0.109375 0.203125 -0.351793 -0.351793 -0.351793 -0.390625 0.109375 0.234375 -2.48052 -2.48052 -2.48052 -0.453125 0.015625 0.140625 -11.7229 -11.7229 -11.7229 -0.390625 0.140625 0.015625 -1.19359 -1.19359 -1.19359 -0.390625 0.140625 0.046875 -0.882736 -0.882736 -0.882736 -0.390625 0.171875 0.015625 -1.71045 -1.71045 -1.71045 -0.421875 0.140625 0.015625 -1.96369 -1.96369 -1.96369 -0.421875 0.140625 0.046875 -1.38325 -1.38325 -1.38325 -0.421875 0.171875 0.015625 -1.97753 -1.97753 -1.97753 -0.421875 0.171875 0.046875 -1.85733 -1.85733 -1.85733 -0.390625 0.140625 0.078125 -0.430622 -0.430622 -0.430622 -0.390625 0.140625 0.109375 -1.54241 -1.54241 -1.54241 -0.390625 0.171875 0.109375 -1.67071 -1.67071 -1.67071 -0.421875 0.140625 0.078125 -1.82753 -1.82753 -1.82753 -0.421875 0.140625 0.109375 -1.37589 -1.37589 -1.37589 -0.421875 0.171875 0.078125 -2.22414 -2.22414 -2.22414 -0.421875 0.171875 0.109375 -2.09668 -2.09668 -2.09668 -0.390625 0.234375 0.046875 -2.70817 -2.70817 -2.70817 -0.421875 0.203125 0.015625 -2.27936 -2.27936 -2.27936 -0.421875 0.203125 0.046875 -1.92296 -1.92296 -1.92296 -0.421875 0.234375 0.015625 -1.671 -1.671 -1.671 -0.421875 0.234375 0.046875 -2.88768 -2.88768 -2.88768 -0.390625 0.203125 0.109375 -1.74418 -1.74418 -1.74418 -0.390625 0.234375 0.078125 -1.48039 -1.48039 -1.48039 -0.421875 0.203125 0.078125 -2.0314 -2.0314 -2.0314 -0.421875 0.203125 0.109375 -2.02688 -2.02688 -2.02688 -0.421875 0.234375 0.078125 -1.61091 -1.61091 -1.61091 -0.453125 0.171875 0.046875 -1.65604 -1.65604 -1.65604 -0.453125 0.171875 0.078125 -1.74418 -1.74418 -1.74418 -0.453125 0.234375 0.015625 -1.43654 -1.43654 -1.43654 -0.453125 0.203125 0.078125 -1.02373 -1.02373 -1.02373 -0.390625 0.140625 0.171875 -3.92039 -3.92039 -3.92039 -0.390625 0.140625 0.203125 -3.36768 -3.36768 -3.36768 -0.390625 0.171875 0.203125 -2.4842 -2.4842 -2.4842 -0.390625 0.234375 0.140625 -1.78194 -1.78194 -1.78194 -0.390625 0.234375 0.171875 -1.52239 -1.52239 -1.52239 -0.390625 0.234375 0.203125 -2.94883 -2.94883 -2.94883 -0.296875 0.046875 0.265625 -3.2739 -3.2739 -3.2739 -0.265625 0.078125 0.265625 -2.37258 -2.37258 -2.37258 -0.265625 0.109375 0.265625 -2.37133 -2.37133 -2.37133 -0.296875 0.078125 0.265625 -1.91536 -1.91536 -1.91536 -0.296875 0.109375 0.265625 -2.22213 -2.22213 -2.22213 -0.328125 0.046875 0.265625 -2.59754 -2.59754 -2.59754 -0.359375 0.046875 0.265625 -0.353464 -0.353464 -0.353464 -0.328125 0.078125 0.265625 -2.04427 -2.04427 -2.04427 -0.328125 0.109375 0.265625 -2.16384 -2.16384 -2.16384 -0.359375 0.078125 0.265625 -0.757326 -0.757326 -0.757326 -0.359375 0.109375 0.265625 -1.16998 -1.16998 -1.16998 -0.265625 0.140625 0.265625 -2.65348 -2.65348 -2.65348 -0.296875 0.140625 0.265625 -2.32324 -2.32324 -2.32324 -0.328125 0.140625 0.265625 -2.648 -2.648 -2.648 -0.265625 0.265625 0.046875 -5.92571 -5.92571 -5.92571 -0.265625 0.296875 0.046875 -6.76231 -6.76231 -6.76231 -0.296875 0.265625 0.046875 -22.4851 -22.4851 -22.4851 -0.296875 0.296875 0.046875 -15.8091 -15.8091 -15.8091 -0.296875 0.296875 0.078125 -8.0102 -8.0102 -8.0102 -0.296875 0.296875 0.109375 -1.0001 -1.0001 -1.0001 -0.265625 0.328125 0.046875 -6.38585 -6.38585 -6.38585 -0.265625 0.359375 0.046875 -1.34859 -1.34859 -1.34859 -0.296875 0.328125 0.046875 27.7671 27.7671 27.7671 -0.265625 0.359375 0.078125 -1.01346 -1.01346 -1.01346 -0.265625 0.359375 0.109375 0.232384 0.232384 0.232384 -0.296875 0.328125 0.078125 6.02823 6.02823 6.02823 -0.296875 0.328125 0.109375 -0.745305 -0.745305 -0.745305 -0.296875 0.359375 0.078125 -1.48952 -1.48952 -1.48952 -0.296875 0.359375 0.109375 -1.66447 -1.66447 -1.66447 -0.328125 0.265625 0.015625 9.06193 9.06193 9.06193 -0.328125 0.265625 0.046875 15.5016 15.5016 15.5016 -0.328125 0.296875 0.046875 -10.2242 -10.2242 -10.2242 -0.359375 0.265625 0.015625 -2.05124 -2.05124 -2.05124 -0.359375 0.265625 0.046875 -1.69274 -1.69274 -1.69274 -0.359375 0.296875 0.046875 -0.794665 -0.794665 -0.794665 -0.328125 0.296875 0.078125 2.0931 2.0931 2.0931 -0.328125 0.296875 0.109375 -1.36815 -1.36815 -1.36815 -0.359375 0.265625 0.078125 -1.29379 -1.29379 -1.29379 -0.359375 0.265625 0.109375 -2.06228 -2.06228 -2.06228 -0.359375 0.296875 0.078125 -0.911445 -0.911445 -0.911445 -0.359375 0.296875 0.109375 -0.948877 -0.948877 -0.948877 -0.328125 0.328125 0.078125 -0.125374 -0.125374 -0.125374 -0.265625 0.296875 0.140625 0.474263 0.474263 0.474263 -0.265625 0.296875 0.171875 -2.61289 -2.61289 -2.61289 -0.296875 0.296875 0.140625 -2.06875 -2.06875 -2.06875 -0.265625 0.265625 0.234375 -3.9196 -3.9196 -3.9196 -0.265625 0.296875 0.234375 -3.65726 -3.65726 -3.65726 -0.296875 0.265625 0.234375 -2.71734 -2.71734 -2.71734 -0.296875 0.296875 0.203125 -3.17268 -3.17268 -3.17268 -0.296875 0.296875 0.234375 -2.35175 -2.35175 -2.35175 -0.265625 0.328125 0.140625 -0.682012 -0.682012 -0.682012 -0.265625 0.328125 0.171875 -0.916943 -0.916943 -0.916943 -0.296875 0.328125 0.140625 -1.80272 -1.80272 -1.80272 -0.296875 0.328125 0.171875 -1.2344 -1.2344 -1.2344 -0.265625 0.328125 0.203125 -0.751778 -0.751778 -0.751778 -0.265625 0.328125 0.234375 -2.85244 -2.85244 -2.85244 -0.296875 0.328125 0.203125 -0.72843 -0.72843 -0.72843 -0.328125 0.296875 0.140625 -2.93811 -2.93811 -2.93811 -0.328125 0.296875 0.171875 0.0869459 0.0869459 0.0869459 -0.359375 0.265625 0.140625 -1.54076 -1.54076 -1.54076 -0.359375 0.296875 0.140625 -1.60784 -1.60784 -1.60784 -0.359375 0.296875 0.171875 -1.36786 -1.36786 -1.36786 -0.328125 0.265625 0.234375 -2.10403 -2.10403 -2.10403 -0.328125 0.296875 0.203125 -0.53086 -0.53086 -0.53086 -0.328125 0.296875 0.234375 -0.343726 -0.343726 -0.343726 -0.359375 0.265625 0.203125 -0.561558 -0.561558 -0.561558 -0.359375 0.265625 0.234375 -2.35085 -2.35085 -2.35085 -0.359375 0.296875 0.203125 -0.583783 -0.583783 -0.583783 -0.328125 0.328125 0.140625 -0.524509 -0.524509 -0.524509 -0.328125 0.328125 0.171875 -1.23726 -1.23726 -1.23726 -0.390625 0.265625 0.015625 -1.65882 -1.65882 -1.65882 -0.390625 0.265625 0.046875 -2.51458 -2.51458 -2.51458 -0.421875 0.265625 0.015625 -1.99975 -1.99975 -1.99975 -0.421875 0.296875 0.015625 -1.56188 -1.56188 -1.56188 -0.390625 0.265625 0.078125 -1.65076 -1.65076 -1.65076 -0.453125 0.265625 0.015625 -1.74998 -1.74998 -1.74998 -0.390625 0.265625 0.140625 -1.23242 -1.23242 -1.23242 -0.390625 0.265625 0.171875 -1.98263 -1.98263 -1.98263 -0.390625 0.296875 0.171875 -1.29478 -1.29478 -1.29478 -0.390625 0.265625 0.203125 -2.96344 -2.96344 -2.96344 -0.109375 0.515625 0.015625 -6.87974 -6.87974 -6.87974 -0.109375 0.515625 0.046875 -1.89375 -1.89375 -1.89375 -0.109375 0.546875 0.015625 -5.41156 -5.41156 -5.41156 -0.109375 0.546875 0.046875 -1.21027 -1.21027 -1.21027 -0.109375 0.515625 0.078125 -4.50982 -4.50982 -4.50982 -0.109375 0.546875 0.078125 -2.58112 -2.58112 -2.58112 -0.140625 0.546875 0.015625 -6.36868 -6.36868 -6.36868 -0.140625 0.546875 0.046875 -1.90943 -1.90943 -1.90943 -0.140625 0.515625 0.078125 -2.40368 -2.40368 -2.40368 -0.140625 0.515625 0.109375 -3.0316 -3.0316 -3.0316 -0.140625 0.546875 0.078125 -1.06358 -1.06358 -1.06358 -0.140625 0.546875 0.109375 -2.28906 -2.28906 -2.28906 -0.171875 0.515625 0.109375 -1.61146 -1.61146 -1.61146 -0.171875 0.546875 0.109375 -1.22014 -1.22014 -1.22014 -0.140625 0.578125 0.015625 0.455371 0.455371 0.455371 -0.140625 0.578125 0.046875 -0.674509 -0.674509 -0.674509 -0.140625 0.609375 0.015625 -0.905806 -0.905806 -0.905806 -0.171875 0.578125 0.015625 -0.0760673 -0.0760673 -0.0760673 -0.171875 0.578125 0.046875 -2.89359 -2.89359 -2.89359 -0.171875 0.609375 0.015625 0.263004 0.263004 0.263004 -0.171875 0.609375 0.046875 -2.04016 -2.04016 -2.04016 -0.140625 0.578125 0.078125 0.434319 0.434319 0.434319 -0.171875 0.578125 0.078125 0.29044 0.29044 0.29044 -0.171875 0.609375 0.078125 -1.55761 -1.55761 -1.55761 -0.203125 0.515625 0.015625 -3.80733 -3.80733 -3.80733 -0.203125 0.515625 0.046875 -1.88745 -1.88745 -1.88745 -0.234375 0.515625 0.015625 -6.60257 -6.60257 -6.60257 -0.234375 0.515625 0.046875 -1.21877 -1.21877 -1.21877 -0.234375 0.546875 0.046875 -1.25639 -1.25639 -1.25639 -0.203125 0.515625 0.078125 -2.40031 -2.40031 -2.40031 -0.203125 0.515625 0.109375 -1.70781 -1.70781 -1.70781 -0.203125 0.546875 0.078125 -1.55927 -1.55927 -1.55927 -0.203125 0.546875 0.109375 -1.83411 -1.83411 -1.83411 -0.234375 0.515625 0.078125 -1.44772 -1.44772 -1.44772 -0.234375 0.546875 0.078125 -0.931402 -0.931402 -0.931402 -0.203125 0.609375 0.015625 -0.658196 -0.658196 -0.658196 -0.203125 0.609375 0.046875 -0.764328 -0.764328 -0.764328 -0.234375 0.578125 0.015625 -1.18743 -1.18743 -1.18743 -0.234375 0.578125 0.046875 -0.940275 -0.940275 -0.940275 -0.234375 0.609375 0.015625 -1.26653 -1.26653 -1.26653 -0.234375 0.609375 0.046875 -0.842745 -0.842745 -0.842745 -0.203125 0.578125 0.078125 -0.456884 -0.456884 -0.456884 -0.203125 0.609375 0.078125 -0.900029 -0.900029 -0.900029 -0.234375 0.578125 0.078125 -0.979661 -0.979661 -0.979661 -0.234375 0.609375 0.078125 -0.517274 -0.517274 -0.517274 -0.265625 0.515625 0.015625 -42.9668 -42.9668 -42.9668 -0.265625 0.515625 0.046875 -0.665517 -0.665517 -0.665517 -0.265625 0.546875 0.015625 22.9673 22.9673 22.9673 -0.265625 0.546875 0.046875 -1.08196 -1.08196 -1.08196 -0.265625 0.578125 0.015625 -11.5542 -11.5542 -11.5542 -0.265625 0.578125 0.046875 -0.804912 -0.804912 -0.804912 -0.515625 0.015625 0.015625 -0.773258 -0.773258 -0.773258 -0.515625 0.015625 0.046875 -0.287589 -0.287589 -0.287589 -0.515625 0.046875 0.015625 -1.42889 -1.42889 -1.42889 -0.515625 0.046875 0.046875 -0.783495 -0.783495 -0.783495 -0.546875 0.015625 0.015625 -0.767691 -0.767691 -0.767691 -0.546875 0.015625 0.046875 -1.37451 -1.37451 -1.37451 -0.515625 0.078125 0.015625 -1.51117 -1.51117 -1.51117 -0.578125 0.015625 0.015625 -2.63157 -2.63157 -2.63157 - diff --git a/tensorflow/script/ocnn_lrp_results/heatmap_1_filt.ply b/tensorflow/script/ocnn_lrp_results/heatmap_1_filt.ply deleted file mode 100644 index d3dd1b5..0000000 --- a/tensorflow/script/ocnn_lrp_results/heatmap_1_filt.ply +++ /dev/null @@ -1,8303 +0,0 @@ -ply -format ascii 1.0 -element vertex 8291 -property float x -property float y -property float z -property float nx -property float ny -property float nz -element face 0 -property list uchar int vertex_indices -end_header -14.088999999999999 18.2851 19.9071 0.013843750857055304 0.013843750857055304 0.013843750857055304 -14.088999999999999 18.2851 20.9071 0.0 0.0 0.0 -14.088999999999999 18.2851 21.9071 0.0 0.0 0.0 -14.088999999999999 18.2851 22.9071 0.014649348043266367 0.014649348043266367 0.014649348043266367 -15.088999999999999 18.2851 19.9071 0.050850823559870396 0.050850823559870396 0.050850823559870396 -15.088999999999999 18.2851 20.9071 0.0 0.0 0.0 -16.089 18.2851 20.9071 0.0 0.0 0.0 -15.088999999999999 18.2851 21.9071 0.0 0.0 0.0 -15.088999999999999 18.2851 22.9071 0.021320000591180648 0.021320000591180648 0.021320000591180648 -16.089 18.2851 21.9071 0.0 0.0 0.0 -16.089 18.2851 22.9071 0.0 0.0 0.0 -14.088999999999999 19.2851 18.9071 0.0 0.0 0.0 -14.088999999999999 20.2851 18.9071 0.0 0.0 0.0 -14.088999999999999 21.2851 18.9071 0.023781728357070354 0.023781728357070354 0.023781728357070354 -15.088999999999999 19.2851 18.9071 0.0 0.0 0.0 -15.088999999999999 20.2851 18.9071 0.0 0.0 0.0 -16.089 19.2851 18.9071 0.0 0.0 0.0 -16.089 20.2851 18.9071 0.5331155177704843 0.5331155177704843 0.5331155177704843 -15.088999999999999 21.2851 18.9071 0.11004268380140558 0.11004268380140558 0.11004268380140558 -16.089 21.2851 18.9071 0.49785134683427634 0.49785134683427634 0.49785134683427634 -9.088999999999999 19.2851 20.9071 0.0 0.0 0.0 -9.088999999999999 20.2851 20.9071 0.0 0.0 0.0 -10.088999999999999 19.2851 20.9071 0.003663049975912323 0.003663049975912323 0.003663049975912323 -10.088999999999999 20.2851 20.9071 0.0 0.0 0.0 -9.088999999999999 19.2851 21.9071 0.0 0.0 0.0 -9.088999999999999 19.2851 22.9071 0.19927589964635842 0.19927589964635842 0.19927589964635842 -9.088999999999999 20.2851 21.9071 0.004538583875754732 0.004538583875754732 0.004538583875754732 -9.088999999999999 20.2851 22.9071 0.0 0.0 0.0 -10.088999999999999 19.2851 21.9071 0.01877873773405374 0.01877873773405374 0.01877873773405374 -10.088999999999999 19.2851 22.9071 0.0 0.0 0.0 -10.088999999999999 20.2851 22.9071 0.04418588595864809 0.04418588595864809 0.04418588595864809 -9.088999999999999 21.2851 20.9071 0.0 0.0 0.0 -9.088999999999999 22.2851 20.9071 0.0 0.0 0.0 -10.088999999999999 21.2851 20.9071 0.0 0.0 0.0 -10.088999999999999 22.2851 20.9071 0.04943727960855405 0.04943727960855405 0.04943727960855405 -9.088999999999999 21.2851 21.9071 0.0 0.0 0.0 -9.088999999999999 21.2851 22.9071 0.0 0.0 0.0 -9.088999999999999 22.2851 21.9071 0.019813340819775673 0.019813340819775673 0.019813340819775673 -9.088999999999999 22.2851 22.9071 0.13546351202601842 0.13546351202601842 0.13546351202601842 -10.088999999999999 21.2851 22.9071 0.0 0.0 0.0 -10.088999999999999 22.2851 21.9071 0.0 0.0 0.0 -10.088999999999999 22.2851 22.9071 0.22663029320910133 0.22663029320910133 0.22663029320910133 -11.088999999999999 19.2851 20.9071 0.0 0.0 0.0 -11.088999999999999 20.2851 20.9071 0.0 0.0 0.0 -12.088999999999999 19.2851 20.9071 0.0 0.0 0.0 -12.088999999999999 20.2851 19.9071 0.04708457392574482 0.04708457392574482 0.04708457392574482 -12.088999999999999 20.2851 20.9071 0.0 0.0 0.0 -11.088999999999999 19.2851 21.9071 0.015042473266275624 0.015042473266275624 0.015042473266275624 -11.088999999999999 19.2851 22.9071 0.0 0.0 0.0 -11.088999999999999 20.2851 21.9071 0.0 0.0 0.0 -11.088999999999999 20.2851 22.9071 0.0 0.0 0.0 -12.088999999999999 19.2851 21.9071 0.0 0.0 0.0 -12.088999999999999 19.2851 22.9071 0.18226151121415146 0.18226151121415146 0.18226151121415146 -12.088999999999999 20.2851 21.9071 0.0 0.0 0.0 -12.088999999999999 20.2851 22.9071 0.0 0.0 0.0 -11.088999999999999 21.2851 20.9071 0.0 0.0 0.0 -11.088999999999999 22.2851 20.9071 0.0 0.0 0.0 -12.088999999999999 21.2851 19.9071 0.0010900786004875167 0.0010900786004875167 0.0010900786004875167 -12.088999999999999 21.2851 20.9071 0.0 0.0 0.0 -12.088999999999999 22.2851 19.9071 0.0 0.0 0.0 -12.088999999999999 22.2851 20.9071 0.0 0.0 0.0 -11.088999999999999 22.2851 21.9071 0.0 0.0 0.0 -11.088999999999999 22.2851 22.9071 0.401647788453455 0.401647788453455 0.401647788453455 -12.088999999999999 22.2851 21.9071 0.0 0.0 0.0 -12.088999999999999 22.2851 22.9071 0.0 0.0 0.0 -9.088999999999999 20.2851 23.9071 0.34123721532387746 0.34123721532387746 0.34123721532387746 -10.088999999999999 19.2851 23.9071 0.0 0.0 0.0 -10.088999999999999 20.2851 23.9071 0.0 0.0 0.0 -9.088999999999999 21.2851 23.9071 0.44350690094081097 0.44350690094081097 0.44350690094081097 -10.088999999999999 21.2851 23.9071 0.0 0.0 0.0 -10.088999999999999 22.2851 23.9071 0.0 0.0 0.0 -11.088999999999999 20.2851 23.9071 0.0 0.0 0.0 -12.088999999999999 20.2851 23.9071 0.1898219134837912 0.1898219134837912 0.1898219134837912 -11.088999999999999 21.2851 23.9071 0.0 0.0 0.0 -11.088999999999999 22.2851 23.9071 0.0 0.0 0.0 -12.088999999999999 21.2851 23.9071 0.0 0.0 0.0 -12.088999999999999 22.2851 23.9071 0.0 0.0 0.0 -12.088999999999999 22.2851 24.9071 0.03868209275430499 0.03868209275430499 0.03868209275430499 -10.088999999999999 24.2851 20.9071 0.0 0.0 0.0 -10.088999999999999 23.2851 21.9071 0.0 0.0 0.0 -10.088999999999999 23.2851 22.9071 0.5300434745840699 0.5300434745840699 0.5300434745840699 -10.088999999999999 24.2851 21.9071 0.0900409204616294 0.0900409204616294 0.0900409204616294 -10.088999999999999 24.2851 22.9071 0.0 0.0 0.0 -10.088999999999999 25.2851 20.9071 0.12774553443176176 0.12774553443176176 0.12774553443176176 -10.088999999999999 26.2851 20.9071 0.0 0.0 0.0 -10.088999999999999 25.2851 21.9071 0.143328350878518 0.143328350878518 0.143328350878518 -10.088999999999999 25.2851 22.9071 0.0 0.0 0.0 -10.088999999999999 26.2851 21.9071 0.0 0.0 0.0 -10.088999999999999 26.2851 22.9071 0.0 0.0 0.0 -11.088999999999999 23.2851 20.9071 0.04849513338678205 0.04849513338678205 0.04849513338678205 -11.088999999999999 24.2851 20.9071 0.153082429188164 0.153082429188164 0.153082429188164 -12.088999999999999 23.2851 19.9071 0.197912629764183 0.197912629764183 0.197912629764183 -12.088999999999999 23.2851 20.9071 0.15497563287268268 0.15497563287268268 0.15497563287268268 -12.088999999999999 24.2851 20.9071 0.09486790001201133 0.09486790001201133 0.09486790001201133 -11.088999999999999 23.2851 21.9071 0.2599740102297165 0.2599740102297165 0.2599740102297165 -11.088999999999999 23.2851 22.9071 0.0 0.0 0.0 -11.088999999999999 24.2851 21.9071 0.1788977642203614 0.1788977642203614 0.1788977642203614 -11.088999999999999 24.2851 22.9071 0.0 0.0 0.0 -12.088999999999999 23.2851 21.9071 0.0 0.0 0.0 -12.088999999999999 23.2851 22.9071 0.0 0.0 0.0 -12.088999999999999 24.2851 21.9071 0.0 0.0 0.0 -12.088999999999999 24.2851 22.9071 0.0 0.0 0.0 -11.088999999999999 25.2851 20.9071 0.0 0.0 0.0 -11.088999999999999 26.2851 20.9071 0.014007041900494925 0.014007041900494925 0.014007041900494925 -12.088999999999999 25.2851 20.9071 0.0 0.0 0.0 -12.088999999999999 26.2851 20.9071 0.0 0.0 0.0 -11.088999999999999 26.2851 21.9071 0.0 0.0 0.0 -11.088999999999999 26.2851 22.9071 0.0 0.0 0.0 -10.088999999999999 24.2851 23.9071 0.0 0.0 0.0 -10.088999999999999 25.2851 23.9071 0.0 0.0 0.0 -10.088999999999999 26.2851 23.9071 0.0 0.0 0.0 -11.088999999999999 23.2851 23.9071 0.46676562436735125 0.46676562436735125 0.46676562436735125 -11.088999999999999 24.2851 23.9071 0.09651735947156422 0.09651735947156422 0.09651735947156422 -12.088999999999999 23.2851 23.9071 0.0 0.0 0.0 -12.088999999999999 23.2851 24.9071 0.16370597348068675 0.16370597348068675 0.16370597348068675 -12.088999999999999 24.2851 23.9071 0.036728687098843076 0.036728687098843076 0.036728687098843076 -12.088999999999999 24.2851 24.9071 0.014539725508694399 0.014539725508694399 0.014539725508694399 -12.088999999999999 23.2851 25.9071 0.0238576486040873 0.0238576486040873 0.0238576486040873 -12.088999999999999 24.2851 25.9071 0.0 0.0 0.0 -11.088999999999999 25.2851 23.9071 0.0647605230256478 0.0647605230256478 0.0647605230256478 -11.088999999999999 26.2851 23.9071 0.0 0.0 0.0 -12.088999999999999 25.2851 23.9071 0.0395788752391741 0.0395788752391741 0.0395788752391741 -12.088999999999999 25.2851 24.9071 0.15154429954729012 0.15154429954729012 0.15154429954729012 -12.088999999999999 26.2851 23.9071 0.0 0.0 0.0 -12.088999999999999 26.2851 24.9071 0.0 0.0 0.0 -13.088999999999999 19.2851 19.9071 0.0 0.0 0.0 -13.088999999999999 19.2851 20.9071 0.0 0.0 0.0 -13.088999999999999 20.2851 19.9071 0.0 0.0 0.0 -13.088999999999999 20.2851 20.9071 0.0 0.0 0.0 -14.088999999999999 19.2851 19.9071 0.0 0.0 0.0 -14.088999999999999 19.2851 20.9071 0.0 0.0 0.0 -14.088999999999999 20.2851 19.9071 0.002849370349421444 0.002849370349421444 0.002849370349421444 -13.088999999999999 19.2851 21.9071 0.0 0.0 0.0 -13.088999999999999 19.2851 22.9071 0.0 0.0 0.0 -14.088999999999999 19.2851 21.9071 0.0 0.0 0.0 -14.088999999999999 19.2851 22.9071 0.0 0.0 0.0 -13.088999999999999 21.2851 19.9071 0.047302971306480354 0.047302971306480354 0.047302971306480354 -13.088999999999999 22.2851 19.9071 0.0 0.0 0.0 -14.088999999999999 21.2851 19.9071 0.0 0.0 0.0 -14.088999999999999 21.2851 20.9071 0.0 0.0 0.0 -14.088999999999999 22.2851 19.9071 0.0 0.0 0.0 -14.088999999999999 22.2851 20.9071 0.0 0.0 0.0 -13.088999999999999 22.2851 22.9071 0.0 0.0 0.0 -14.088999999999999 22.2851 21.9071 0.0 0.0 0.0 -14.088999999999999 22.2851 22.9071 0.0 0.0 0.0 -15.088999999999999 19.2851 19.9071 0.0 0.0 0.0 -15.088999999999999 19.2851 20.9071 0.0 0.0 0.0 -16.089 19.2851 19.9071 0.0 0.0 0.0 -16.089 19.2851 20.9071 0.0 0.0 0.0 -16.089 20.2851 19.9071 0.047245909070937 0.047245909070937 0.047245909070937 -16.089 20.2851 20.9071 0.0 0.0 0.0 -15.088999999999999 19.2851 22.9071 0.015657476069460996 0.015657476069460996 0.015657476069460996 -15.088999999999999 20.2851 22.9071 0.0 0.0 0.0 -16.089 19.2851 22.9071 0.0 0.0 0.0 -15.088999999999999 21.2851 19.9071 0.0 0.0 0.0 -15.088999999999999 21.2851 20.9071 0.0 0.0 0.0 -15.088999999999999 22.2851 19.9071 0.0 0.0 0.0 -15.088999999999999 22.2851 20.9071 0.0 0.0 0.0 -16.089 21.2851 19.9071 0.0 0.0 0.0 -16.089 21.2851 20.9071 0.0 0.0 0.0 -16.089 22.2851 19.9071 0.026082530847795066 0.026082530847795066 0.026082530847795066 -16.089 22.2851 20.9071 0.5078897598464722 0.5078897598464722 0.5078897598464722 -15.088999999999999 21.2851 21.9071 0.0 0.0 0.0 -15.088999999999999 21.2851 22.9071 0.0 0.0 0.0 -15.088999999999999 22.2851 21.9071 0.0 0.0 0.0 -15.088999999999999 22.2851 22.9071 0.0 0.0 0.0 -16.089 21.2851 21.9071 0.0 0.0 0.0 -16.089 21.2851 22.9071 0.0 0.0 0.0 -16.089 22.2851 21.9071 0.0 0.0 0.0 -16.089 22.2851 22.9071 0.41696984936557346 0.41696984936557346 0.41696984936557346 -13.088999999999999 19.2851 23.9071 0.07202125057225262 0.07202125057225262 0.07202125057225262 -13.088999999999999 20.2851 23.9071 0.11999812637227142 0.11999812637227142 0.11999812637227142 -14.088999999999999 19.2851 23.9071 0.0685273052876964 0.0685273052876964 0.0685273052876964 -14.088999999999999 20.2851 23.9071 0.17637602233046715 0.17637602233046715 0.17637602233046715 -13.088999999999999 21.2851 23.9071 0.0 0.0 0.0 -13.088999999999999 22.2851 23.9071 0.08101628858395685 0.08101628858395685 0.08101628858395685 -13.088999999999999 22.2851 24.9071 0.03158008277032538 0.03158008277032538 0.03158008277032538 -14.088999999999999 21.2851 23.9071 0.0 0.0 0.0 -14.088999999999999 22.2851 23.9071 0.06715356773226548 0.06715356773226548 0.06715356773226548 -14.088999999999999 22.2851 24.9071 0.0 0.0 0.0 -13.088999999999999 22.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 22.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 22.2851 26.9071 0.0 0.0 0.0 -15.088999999999999 19.2851 23.9071 0.0 0.0 0.0 -15.088999999999999 20.2851 23.9071 0.0 0.0 0.0 -16.089 19.2851 23.9071 0.0 0.0 0.0 -16.089 20.2851 23.9071 0.031705073198065606 0.031705073198065606 0.031705073198065606 -15.088999999999999 21.2851 23.9071 0.0 0.0 0.0 -15.088999999999999 22.2851 23.9071 0.0 0.0 0.0 -15.088999999999999 22.2851 24.9071 0.0 0.0 0.0 -16.089 21.2851 23.9071 0.009220197365847631 0.009220197365847631 0.009220197365847631 -16.089 21.2851 24.9071 0.0 0.0 0.0 -16.089 22.2851 23.9071 0.0 0.0 0.0 -16.089 22.2851 24.9071 0.0 0.0 0.0 -15.088999999999999 21.2851 25.9071 0.15404741613274037 0.15404741613274037 0.15404741613274037 -15.088999999999999 21.2851 26.9071 0.17256687105326135 0.17256687105326135 0.17256687105326135 -15.088999999999999 22.2851 25.9071 0.0677784585963925 0.0677784585963925 0.0677784585963925 -15.088999999999999 22.2851 26.9071 0.02724396346655351 0.02724396346655351 0.02724396346655351 -16.089 21.2851 25.9071 0.0 0.0 0.0 -16.089 21.2851 26.9071 0.0 0.0 0.0 -16.089 22.2851 25.9071 0.0 0.0 0.0 -16.089 22.2851 26.9071 0.07071597656144814 0.07071597656144814 0.07071597656144814 -13.088999999999999 23.2851 19.9071 0.11484665557508889 0.11484665557508889 0.11484665557508889 -13.088999999999999 24.2851 19.9071 0.0 0.0 0.0 -13.088999999999999 24.2851 20.9071 0.0 0.0 0.0 -14.088999999999999 23.2851 19.9071 0.0 0.0 0.0 -14.088999999999999 23.2851 20.9071 0.0 0.0 0.0 -14.088999999999999 24.2851 20.9071 0.0 0.0 0.0 -13.088999999999999 23.2851 21.9071 0.0 0.0 0.0 -13.088999999999999 23.2851 22.9071 0.0 0.0 0.0 -13.088999999999999 24.2851 21.9071 0.0 0.0 0.0 -13.088999999999999 24.2851 22.9071 0.0 0.0 0.0 -14.088999999999999 23.2851 21.9071 0.0 0.0 0.0 -14.088999999999999 23.2851 22.9071 0.0 0.0 0.0 -14.088999999999999 24.2851 21.9071 0.0 0.0 0.0 -14.088999999999999 24.2851 22.9071 0.0 0.0 0.0 -13.088999999999999 25.2851 20.9071 0.0 0.0 0.0 -13.088999999999999 26.2851 20.9071 0.0 0.0 0.0 -14.088999999999999 25.2851 20.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 19.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 20.9071 0.0 0.0 0.0 -13.088999999999999 26.2851 21.9071 0.20280002727775184 0.20280002727775184 0.20280002727775184 -14.088999999999999 25.2851 21.9071 0.20458005711043098 0.20458005711043098 0.20458005711043098 -14.088999999999999 25.2851 22.9071 0.20036218643056947 0.20036218643056947 0.20036218643056947 -14.088999999999999 26.2851 21.9071 0.33268492036137226 0.33268492036137226 0.33268492036137226 -14.088999999999999 26.2851 22.9071 0.0 0.0 0.0 -15.088999999999999 23.2851 19.9071 0.0 0.0 0.0 -15.088999999999999 23.2851 20.9071 0.0 0.0 0.0 -15.088999999999999 24.2851 19.9071 0.0 0.0 0.0 -15.088999999999999 24.2851 20.9071 0.0 0.0 0.0 -16.089 23.2851 19.9071 0.0 0.0 0.0 -16.089 24.2851 19.9071 0.0 0.0 0.0 -16.089 24.2851 20.9071 0.7490919869799569 0.7490919869799569 0.7490919869799569 -15.088999999999999 23.2851 21.9071 0.0 0.0 0.0 -15.088999999999999 23.2851 22.9071 0.0 0.0 0.0 -15.088999999999999 24.2851 21.9071 0.0 0.0 0.0 -15.088999999999999 24.2851 22.9071 0.0 0.0 0.0 -15.088999999999999 25.2851 19.9071 0.0 0.0 0.0 -15.088999999999999 25.2851 20.9071 0.0 0.0 0.0 -15.088999999999999 26.2851 19.9071 0.0 0.0 0.0 -16.089 25.2851 19.9071 0.0 0.0 0.0 -16.089 25.2851 20.9071 0.0 0.0 0.0 -16.089 26.2851 19.9071 0.0 0.0 0.0 -15.088999999999999 25.2851 21.9071 0.029729019872909924 0.029729019872909924 0.029729019872909924 -15.088999999999999 25.2851 22.9071 0.24315228669788794 0.24315228669788794 0.24315228669788794 -15.088999999999999 26.2851 21.9071 0.0 0.0 0.0 -15.088999999999999 26.2851 22.9071 0.109450470924878 0.109450470924878 0.109450470924878 -16.089 25.2851 21.9071 0.0 0.0 0.0 -16.089 25.2851 22.9071 0.0 0.0 0.0 -16.089 26.2851 21.9071 0.0872522077458347 0.0872522077458347 0.0872522077458347 -16.089 26.2851 22.9071 0.04726117173350139 0.04726117173350139 0.04726117173350139 -13.088999999999999 23.2851 24.9071 0.0 0.0 0.0 -13.088999999999999 24.2851 24.9071 0.0 0.0 0.0 -14.088999999999999 23.2851 23.9071 0.0 0.0 0.0 -14.088999999999999 23.2851 24.9071 0.0 0.0 0.0 -13.088999999999999 23.2851 25.9071 0.0 0.0 0.0 -13.088999999999999 24.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 23.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 23.2851 26.9071 0.0 0.0 0.0 -14.088999999999999 24.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 24.2851 26.9071 0.0 0.0 0.0 -13.088999999999999 25.2851 23.9071 0.22523017527577122 0.22523017527577122 0.22523017527577122 -13.088999999999999 25.2851 24.9071 0.0 0.0 0.0 -13.088999999999999 26.2851 24.9071 0.0 0.0 0.0 -14.088999999999999 25.2851 24.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 24.9071 0.0 0.0 0.0 -13.088999999999999 25.2851 25.9071 0.0 0.0 0.0 -13.088999999999999 26.2851 25.9071 0.0 0.0 0.0 -13.088999999999999 26.2851 26.9071 0.0 0.0 0.0 -14.088999999999999 25.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 25.2851 26.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 26.9071 0.0 0.0 0.0 -15.088999999999999 23.2851 23.9071 0.0 0.0 0.0 -15.088999999999999 23.2851 24.9071 0.0 0.0 0.0 -15.088999999999999 23.2851 25.9071 0.0 0.0 0.0 -15.088999999999999 24.2851 25.9071 0.0 0.0 0.0 -15.088999999999999 24.2851 26.9071 0.0 0.0 0.0 -15.088999999999999 25.2851 24.9071 0.0 0.0 0.0 -15.088999999999999 26.2851 24.9071 0.0 0.0 0.0 -16.089 25.2851 23.9071 0.01831076897516243 0.01831076897516243 0.01831076897516243 -16.089 25.2851 24.9071 0.040998354934728795 0.040998354934728795 0.040998354934728795 -16.089 26.2851 23.9071 0.013828217374462501 0.013828217374462501 0.013828217374462501 -16.089 26.2851 24.9071 0.0 0.0 0.0 -15.088999999999999 25.2851 25.9071 0.0 0.0 0.0 -15.088999999999999 25.2851 26.9071 0.0 0.0 0.0 -15.088999999999999 26.2851 25.9071 0.0 0.0 0.0 -15.088999999999999 26.2851 26.9071 0.0 0.0 0.0 -16.089 25.2851 25.9071 0.0 0.0 0.0 -16.089 25.2851 26.9071 0.0 0.0 0.0 -16.089 26.2851 25.9071 0.0 0.0 0.0 -16.089 26.2851 26.9071 0.0 0.0 0.0 -17.089 18.2851 18.9071 0.0 0.0 0.0 -18.089 18.2851 18.9071 0.0 0.0 0.0 -19.089 18.2851 18.9071 0.02920410205218198 0.02920410205218198 0.02920410205218198 -20.089 18.2851 18.9071 0.0 0.0 0.0 -17.089 17.2851 19.9071 0.0 0.0 0.0 -17.089 17.2851 20.9071 0.0 0.0 0.0 -17.089 18.2851 19.9071 0.0 0.0 0.0 -17.089 18.2851 20.9071 0.0 0.0 0.0 -18.089 17.2851 19.9071 0.0 0.0 0.0 -18.089 17.2851 20.9071 0.0 0.0 0.0 -18.089 18.2851 19.9071 0.0 0.0 0.0 -17.089 17.2851 21.9071 0.0 0.0 0.0 -17.089 18.2851 21.9071 0.0 0.0 0.0 -17.089 18.2851 22.9071 0.0 0.0 0.0 -18.089 17.2851 21.9071 0.0 0.0 0.0 -18.089 18.2851 21.9071 0.0 0.0 0.0 -19.089 17.2851 19.9071 0.0 0.0 0.0 -19.089 17.2851 20.9071 0.0 0.0 0.0 -19.089 18.2851 19.9071 0.0 0.0 0.0 -19.089 18.2851 20.9071 0.0 0.0 0.0 -20.089 18.2851 19.9071 0.0 0.0 0.0 -20.089 18.2851 20.9071 0.0 0.0 0.0 -19.089 17.2851 21.9071 0.0 0.0 0.0 -19.089 18.2851 21.9071 0.0 0.0 0.0 -20.089 18.2851 21.9071 0.0 0.0 0.0 -19.089 17.2851 26.9071 0.034187508426347005 0.034187508426347005 0.034187508426347005 -19.089 18.2851 26.9071 0.0 0.0 0.0 -20.089 17.2851 26.9071 0.0 0.0 0.0 -20.089 18.2851 26.9071 0.0 0.0 0.0 -21.089 18.2851 19.9071 0.02542045367695341 0.02542045367695341 0.02542045367695341 -21.089 18.2851 20.9071 0.0 0.0 0.0 -21.089 17.2851 26.9071 0.012132258377875328 0.012132258377875328 0.012132258377875328 -21.089 18.2851 26.9071 0.00788696103571377 0.00788696103571377 0.00788696103571377 -22.089 18.2851 26.9071 0.019520990365647306 0.019520990365647306 0.019520990365647306 -23.089 17.2851 25.9071 0.0 0.0 0.0 -23.089 17.2851 26.9071 0.0 0.0 0.0 -23.089 18.2851 25.9071 0.0 0.0 0.0 -23.089 18.2851 26.9071 0.0 0.0 0.0 -24.089 17.2851 25.9071 0.0 0.0 0.0 -24.089 17.2851 26.9071 0.10873750042155346 0.10873750042155346 0.10873750042155346 -24.089 18.2851 25.9071 0.05809151761418307 0.05809151761418307 0.05809151761418307 -17.089 19.2851 17.9071 0.0 0.0 0.0 -17.089 19.2851 18.9071 0.016425611070342325 0.016425611070342325 0.016425611070342325 -17.089 20.2851 17.9071 0.3811941672417703 0.3811941672417703 0.3811941672417703 -17.089 20.2851 18.9071 0.44317811324071693 0.44317811324071693 0.44317811324071693 -18.089 19.2851 17.9071 0.022226297623575867 0.022226297623575867 0.022226297623575867 -18.089 19.2851 18.9071 0.04545650954652681 0.04545650954652681 0.04545650954652681 -18.089 20.2851 17.9071 0.0 0.0 0.0 -17.089 21.2851 17.9071 0.0 0.0 0.0 -17.089 21.2851 18.9071 0.0 0.0 0.0 -17.089 22.2851 18.9071 0.39088399044473704 0.39088399044473704 0.39088399044473704 -18.089 21.2851 17.9071 0.0 0.0 0.0 -18.089 21.2851 18.9071 0.0 0.0 0.0 -18.089 22.2851 17.9071 0.3961590879731805 0.3961590879731805 0.3961590879731805 -18.089 22.2851 18.9071 0.36278773510640705 0.36278773510640705 0.36278773510640705 -19.089 19.2851 17.9071 0.0 0.0 0.0 -19.089 19.2851 18.9071 0.0 0.0 0.0 -19.089 20.2851 17.9071 0.0 0.0 0.0 -19.089 20.2851 18.9071 0.0 0.0 0.0 -20.089 19.2851 18.9071 0.017574974616613896 0.017574974616613896 0.017574974616613896 -20.089 20.2851 18.9071 0.0 0.0 0.0 -19.089 21.2851 17.9071 0.0 0.0 0.0 -19.089 21.2851 18.9071 0.0 0.0 0.0 -19.089 22.2851 17.9071 0.0032312743694372487 0.0032312743694372487 0.0032312743694372487 -19.089 22.2851 18.9071 0.0 0.0 0.0 -20.089 21.2851 17.9071 0.0 0.0 0.0 -20.089 21.2851 18.9071 0.0 0.0 0.0 -20.089 22.2851 17.9071 0.07089566228753517 0.07089566228753517 0.07089566228753517 -20.089 22.2851 18.9071 0.0314948171515166 0.0314948171515166 0.0314948171515166 -18.089 24.2851 14.9071 0.3076262636381725 0.3076262636381725 0.3076262636381725 -18.089 25.2851 14.9071 0.0 0.0 0.0 -18.089 26.2851 14.9071 0.05553944290003849 0.05553944290003849 0.05553944290003849 -19.089 24.2851 14.9071 0.0 0.0 0.0 -20.089 24.2851 13.9071 0.1026337012736735 0.1026337012736735 0.1026337012736735 -20.089 24.2851 14.9071 0.12249467811049414 0.12249467811049414 0.12249467811049414 -19.089 25.2851 14.9071 0.0 0.0 0.0 -19.089 26.2851 14.9071 0.013523796732891303 0.013523796732891303 0.013523796732891303 -20.089 25.2851 13.9071 0.0 0.0 0.0 -20.089 25.2851 14.9071 0.0 0.0 0.0 -20.089 26.2851 13.9071 0.0 0.0 0.0 -20.089 26.2851 14.9071 0.0 0.0 0.0 -18.089 24.2851 15.9071 0.2589576654358 0.2589576654358 0.2589576654358 -18.089 24.2851 16.9071 0.0 0.0 0.0 -17.089 24.2851 18.9071 0.0 0.0 0.0 -18.089 23.2851 18.9071 0.0 0.0 0.0 -18.089 24.2851 17.9071 0.14119278486824213 0.14119278486824213 0.14119278486824213 -18.089 24.2851 18.9071 0.0 0.0 0.0 -18.089 25.2851 15.9071 0.0 0.0 0.0 -18.089 25.2851 16.9071 0.22239958360307738 0.22239958360307738 0.22239958360307738 -18.089 26.2851 15.9071 0.0 0.0 0.0 -18.089 26.2851 16.9071 0.0 0.0 0.0 -17.089 25.2851 18.9071 0.06681442313436797 0.06681442313436797 0.06681442313436797 -18.089 25.2851 17.9071 0.32399587521720924 0.32399587521720924 0.32399587521720924 -18.089 25.2851 18.9071 0.0 0.0 0.0 -18.089 26.2851 17.9071 0.0 0.0 0.0 -18.089 26.2851 18.9071 0.013240207363425788 0.013240207363425788 0.013240207363425788 -19.089 23.2851 15.9071 0.0 0.0 0.0 -19.089 23.2851 16.9071 0.0 0.0 0.0 -19.089 24.2851 15.9071 0.042018633791001216 0.042018633791001216 0.042018633791001216 -19.089 24.2851 16.9071 0.0687415258984491 0.0687415258984491 0.0687415258984491 -20.089 23.2851 15.9071 0.0 0.0 0.0 -20.089 23.2851 16.9071 0.0 0.0 0.0 -20.089 24.2851 15.9071 0.12759500984035707 0.12759500984035707 0.12759500984035707 -20.089 24.2851 16.9071 0.023432981250195196 0.023432981250195196 0.023432981250195196 -19.089 23.2851 18.9071 0.05525599251383922 0.05525599251383922 0.05525599251383922 -19.089 24.2851 17.9071 0.0 0.0 0.0 -19.089 24.2851 18.9071 0.0 0.0 0.0 -20.089 23.2851 18.9071 0.0 0.0 0.0 -20.089 24.2851 17.9071 0.0 0.0 0.0 -20.089 24.2851 18.9071 0.005968938000462979 0.005968938000462979 0.005968938000462979 -19.089 26.2851 15.9071 0.005545413682248793 0.005545413682248793 0.005545413682248793 -19.089 26.2851 16.9071 0.0 0.0 0.0 -20.089 26.2851 15.9071 0.0 0.0 0.0 -19.089 25.2851 18.9071 0.014088341002221795 0.014088341002221795 0.014088341002221795 -19.089 26.2851 18.9071 0.0 0.0 0.0 -20.089 25.2851 18.9071 0.0 0.0 0.0 -21.089 20.2851 16.9071 0.0 0.0 0.0 -22.089 20.2851 16.9071 0.0 0.0 0.0 -21.089 20.2851 17.9071 0.0 0.0 0.0 -21.089 20.2851 18.9071 0.0 0.0 0.0 -22.089 20.2851 17.9071 0.0 0.0 0.0 -22.089 20.2851 18.9071 0.004413917493425097 0.004413917493425097 0.004413917493425097 -21.089 21.2851 15.9071 0.011480026934310127 0.011480026934310127 0.011480026934310127 -21.089 21.2851 16.9071 0.0 0.0 0.0 -21.089 22.2851 16.9071 0.0 0.0 0.0 -22.089 21.2851 15.9071 0.0 0.0 0.0 -22.089 21.2851 16.9071 0.0 0.0 0.0 -22.089 22.2851 15.9071 0.0 0.0 0.0 -22.089 22.2851 16.9071 0.0 0.0 0.0 -21.089 21.2851 17.9071 0.0 0.0 0.0 -21.089 21.2851 18.9071 0.0 0.0 0.0 -21.089 22.2851 17.9071 0.06629530395131468 0.06629530395131468 0.06629530395131468 -21.089 22.2851 18.9071 0.0 0.0 0.0 -22.089 22.2851 17.9071 0.0 0.0 0.0 -23.089 20.2851 16.9071 0.0 0.0 0.0 -23.089 20.2851 17.9071 0.00036977872674012844 0.00036977872674012844 0.00036977872674012844 -23.089 20.2851 18.9071 0.0 0.0 0.0 -23.089 21.2851 16.9071 0.022714131561841423 0.022714131561841423 0.022714131561841423 -23.089 22.2851 16.9071 0.012002514430982296 0.012002514430982296 0.012002514430982296 -24.089 22.2851 16.9071 0.0 0.0 0.0 -23.089 21.2851 17.9071 0.009836448103449745 0.009836448103449745 0.009836448103449745 -23.089 21.2851 18.9071 0.0 0.0 0.0 -23.089 22.2851 17.9071 0.0 0.0 0.0 -24.089 21.2851 17.9071 0.0 0.0 0.0 -24.089 21.2851 18.9071 0.0 0.0 0.0 -24.089 22.2851 17.9071 0.0 0.0 0.0 -24.089 22.2851 18.9071 0.0 0.0 0.0 -21.089 24.2851 13.9071 0.0 0.0 0.0 -21.089 24.2851 14.9071 0.023015970695127196 0.023015970695127196 0.023015970695127196 -22.089 24.2851 14.9071 0.0 0.0 0.0 -21.089 25.2851 13.9071 0.0 0.0 0.0 -21.089 25.2851 14.9071 0.0 0.0 0.0 -21.089 26.2851 13.9071 0.0 0.0 0.0 -21.089 26.2851 14.9071 0.0 0.0 0.0 -22.089 25.2851 13.9071 0.0 0.0 0.0 -22.089 25.2851 14.9071 0.0 0.0 0.0 -22.089 26.2851 13.9071 0.0 0.0 0.0 -22.089 26.2851 14.9071 0.0 0.0 0.0 -23.089 24.2851 13.9071 0.02476823285594042 0.02476823285594042 0.02476823285594042 -23.089 24.2851 14.9071 0.06309665071805075 0.06309665071805075 0.06309665071805075 -24.089 24.2851 13.9071 0.0 0.0 0.0 -24.089 24.2851 14.9071 0.0 0.0 0.0 -23.089 25.2851 13.9071 0.0 0.0 0.0 -23.089 25.2851 14.9071 0.0 0.0 0.0 -23.089 26.2851 13.9071 0.0 0.0 0.0 -24.089 25.2851 13.9071 0.0017502358537631584 0.0017502358537631584 0.0017502358537631584 -24.089 26.2851 13.9071 0.0 0.0 0.0 -21.089 23.2851 16.9071 0.26659107629850876 0.26659107629850876 0.26659107629850876 -21.089 24.2851 15.9071 0.11672468061075764 0.11672468061075764 0.11672468061075764 -21.089 24.2851 16.9071 0.0 0.0 0.0 -22.089 23.2851 15.9071 0.012306376185411038 0.012306376185411038 0.012306376185411038 -22.089 23.2851 16.9071 0.0 0.0 0.0 -22.089 24.2851 15.9071 0.0 0.0 0.0 -22.089 24.2851 16.9071 0.0 0.0 0.0 -21.089 23.2851 17.9071 0.0 0.0 0.0 -21.089 23.2851 18.9071 0.0 0.0 0.0 -21.089 24.2851 17.9071 0.0 0.0 0.0 -21.089 24.2851 18.9071 0.0 0.0 0.0 -22.089 23.2851 17.9071 0.05606471968099063 0.05606471968099063 0.05606471968099063 -22.089 24.2851 17.9071 0.0 0.0 0.0 -22.089 24.2851 18.9071 0.0 0.0 0.0 -21.089 25.2851 16.9071 0.0 0.0 0.0 -22.089 25.2851 15.9071 0.0 0.0 0.0 -22.089 25.2851 16.9071 0.0 0.0 0.0 -21.089 25.2851 17.9071 0.0 0.0 0.0 -21.089 25.2851 18.9071 0.0 0.0 0.0 -22.089 25.2851 17.9071 0.0 0.0 0.0 -23.089 23.2851 15.9071 0.013077551818900579 0.013077551818900579 0.013077551818900579 -23.089 23.2851 16.9071 0.0 0.0 0.0 -23.089 24.2851 15.9071 0.01602526299936007 0.01602526299936007 0.01602526299936007 -23.089 24.2851 16.9071 0.0 0.0 0.0 -24.089 23.2851 15.9071 0.0 0.0 0.0 -24.089 23.2851 16.9071 0.0 0.0 0.0 -24.089 24.2851 15.9071 0.0 0.0 0.0 -24.089 24.2851 16.9071 0.0 0.0 0.0 -23.089 24.2851 18.9071 0.0 0.0 0.0 -24.089 23.2851 17.9071 0.0 0.0 0.0 -24.089 23.2851 18.9071 0.0 0.0 0.0 -24.089 24.2851 17.9071 0.0 0.0 0.0 -24.089 24.2851 18.9071 0.0 0.0 0.0 -23.089 25.2851 15.9071 0.0 0.0 0.0 -23.089 25.2851 16.9071 0.0 0.0 0.0 -23.089 26.2851 16.9071 0.0 0.0 0.0 -24.089 25.2851 16.9071 0.0 0.0 0.0 -24.089 26.2851 16.9071 0.0 0.0 0.0 -23.089 25.2851 17.9071 0.0 0.0 0.0 -23.089 25.2851 18.9071 0.0 0.0 0.0 -23.089 26.2851 17.9071 0.04919437873168933 0.04919437873168933 0.04919437873168933 -23.089 26.2851 18.9071 0.0 0.0 0.0 -24.089 25.2851 17.9071 0.0 0.0 0.0 -24.089 25.2851 18.9071 0.0 0.0 0.0 -24.089 26.2851 17.9071 0.017871079688433374 0.017871079688433374 0.017871079688433374 -24.089 26.2851 18.9071 0.0 0.0 0.0 -17.089 19.2851 19.9071 0.0 0.0 0.0 -17.089 19.2851 20.9071 0.0 0.0 0.0 -17.089 20.2851 20.9071 0.0 0.0 0.0 -18.089 20.2851 20.9071 0.0 0.0 0.0 -17.089 19.2851 21.9071 0.0 0.0 0.0 -17.089 19.2851 22.9071 0.0 0.0 0.0 -17.089 20.2851 21.9071 0.0 0.0 0.0 -17.089 20.2851 22.9071 0.0 0.0 0.0 -18.089 19.2851 21.9071 0.0 0.0 0.0 -18.089 19.2851 22.9071 0.0 0.0 0.0 -18.089 20.2851 21.9071 0.0 0.0 0.0 -18.089 20.2851 22.9071 0.0 0.0 0.0 -17.089 21.2851 19.9071 0.0 0.0 0.0 -17.089 21.2851 20.9071 0.0 0.0 0.0 -17.089 22.2851 19.9071 0.0 0.0 0.0 -17.089 22.2851 20.9071 0.5277096404850297 0.5277096404850297 0.5277096404850297 -18.089 21.2851 20.9071 0.0 0.0 0.0 -17.089 21.2851 21.9071 0.0 0.0 0.0 -17.089 21.2851 22.9071 0.0 0.0 0.0 -17.089 22.2851 21.9071 0.0 0.0 0.0 -17.089 22.2851 22.9071 0.3285487165244796 0.3285487165244796 0.3285487165244796 -18.089 21.2851 21.9071 0.0 0.0 0.0 -18.089 21.2851 22.9071 0.0 0.0 0.0 -18.089 22.2851 21.9071 0.18180682236901508 0.18180682236901508 0.18180682236901508 -18.089 22.2851 22.9071 0.0 0.0 0.0 -19.089 20.2851 20.9071 0.0 0.0 0.0 -20.089 19.2851 19.9071 0.025324891188047947 0.025324891188047947 0.025324891188047947 -20.089 19.2851 20.9071 0.0 0.0 0.0 -20.089 20.2851 19.9071 0.04756945632794325 0.04756945632794325 0.04756945632794325 -20.089 20.2851 20.9071 0.01615466273140076 0.01615466273140076 0.01615466273140076 -19.089 19.2851 21.9071 0.060237817315374365 0.060237817315374365 0.060237817315374365 -19.089 19.2851 22.9071 0.0 0.0 0.0 -19.089 20.2851 21.9071 0.0 0.0 0.0 -19.089 20.2851 22.9071 0.0 0.0 0.0 -20.089 19.2851 21.9071 0.0 0.0 0.0 -20.089 19.2851 22.9071 0.0 0.0 0.0 -20.089 20.2851 21.9071 0.0 0.0 0.0 -20.089 21.2851 19.9071 0.0 0.0 0.0 -20.089 21.2851 20.9071 0.0 0.0 0.0 -20.089 22.2851 19.9071 0.0 0.0 0.0 -20.089 22.2851 20.9071 0.0 0.0 0.0 -19.089 21.2851 21.9071 0.0 0.0 0.0 -19.089 21.2851 22.9071 0.0 0.0 0.0 -19.089 22.2851 22.9071 0.0 0.0 0.0 -20.089 21.2851 21.9071 0.0 0.0 0.0 -20.089 21.2851 22.9071 0.0 0.0 0.0 -20.089 22.2851 21.9071 0.0 0.0 0.0 -20.089 22.2851 22.9071 0.0 0.0 0.0 -17.089 19.2851 23.9071 0.0 0.0 0.0 -17.089 19.2851 24.9071 0.007176986688400926 0.007176986688400926 0.007176986688400926 -17.089 20.2851 23.9071 0.0 0.0 0.0 -17.089 20.2851 24.9071 0.0 0.0 0.0 -18.089 19.2851 23.9071 0.0 0.0 0.0 -18.089 19.2851 24.9071 0.0 0.0 0.0 -18.089 20.2851 23.9071 0.0 0.0 0.0 -17.089 19.2851 25.9071 0.020017539244861778 0.020017539244861778 0.020017539244861778 -17.089 20.2851 25.9071 0.0700756008114952 0.0700756008114952 0.0700756008114952 -17.089 20.2851 26.9071 0.062167187074233354 0.062167187074233354 0.062167187074233354 -18.089 19.2851 25.9071 0.0 0.0 0.0 -18.089 20.2851 25.9071 0.08314486397198977 0.08314486397198977 0.08314486397198977 -18.089 20.2851 26.9071 0.0 0.0 0.0 -17.089 21.2851 23.9071 0.0 0.0 0.0 -17.089 21.2851 24.9071 0.0 0.0 0.0 -17.089 22.2851 23.9071 0.0 0.0 0.0 -17.089 22.2851 24.9071 0.0 0.0 0.0 -18.089 21.2851 23.9071 0.0 0.0 0.0 -18.089 22.2851 23.9071 0.0 0.0 0.0 -18.089 22.2851 24.9071 0.0 0.0 0.0 -17.089 21.2851 25.9071 0.0 0.0 0.0 -17.089 21.2851 26.9071 0.14211343594997355 0.14211343594997355 0.14211343594997355 -17.089 22.2851 25.9071 0.17027346407695468 0.17027346407695468 0.17027346407695468 -17.089 22.2851 26.9071 0.10134112147631069 0.10134112147631069 0.10134112147631069 -18.089 21.2851 25.9071 0.09142910394463445 0.09142910394463445 0.09142910394463445 -18.089 21.2851 26.9071 0.0 0.0 0.0 -18.089 22.2851 25.9071 0.15549099997167026 0.15549099997167026 0.15549099997167026 -19.089 19.2851 23.9071 0.0 0.0 0.0 -19.089 19.2851 24.9071 0.0 0.0 0.0 -19.089 20.2851 23.9071 0.0 0.0 0.0 -19.089 20.2851 24.9071 0.0 0.0 0.0 -20.089 20.2851 24.9071 0.0 0.0 0.0 -19.089 19.2851 25.9071 0.0 0.0 0.0 -19.089 19.2851 26.9071 0.06093767786317096 0.06093767786317096 0.06093767786317096 -19.089 20.2851 25.9071 0.0 0.0 0.0 -19.089 20.2851 26.9071 0.0 0.0 0.0 -20.089 19.2851 26.9071 0.09453460721292695 0.09453460721292695 0.09453460721292695 -20.089 20.2851 25.9071 0.093483669305907 0.093483669305907 0.093483669305907 -20.089 20.2851 26.9071 0.0 0.0 0.0 -19.089 21.2851 23.9071 0.0 0.0 0.0 -19.089 21.2851 24.9071 0.0 0.0 0.0 -19.089 22.2851 23.9071 0.0 0.0 0.0 -19.089 22.2851 24.9071 0.01347586565425371 0.01347586565425371 0.01347586565425371 -20.089 21.2851 23.9071 0.0 0.0 0.0 -20.089 21.2851 24.9071 0.19719051331823506 0.19719051331823506 0.19719051331823506 -20.089 22.2851 23.9071 0.0 0.0 0.0 -20.089 22.2851 24.9071 0.2211512237939877 0.2211512237939877 0.2211512237939877 -19.089 21.2851 25.9071 0.0 0.0 0.0 -19.089 21.2851 26.9071 0.0 0.0 0.0 -19.089 22.2851 25.9071 0.0 0.0 0.0 -19.089 22.2851 26.9071 0.11630965424764901 0.11630965424764901 0.11630965424764901 -20.089 21.2851 25.9071 0.0 0.0 0.0 -20.089 21.2851 26.9071 0.08852989448539872 0.08852989448539872 0.08852989448539872 -20.089 22.2851 25.9071 0.05605285937631979 0.05605285937631979 0.05605285937631979 -20.089 22.2851 26.9071 0.12083098928667911 0.12083098928667911 0.12083098928667911 -17.089 23.2851 19.9071 0.0 0.0 0.0 -17.089 23.2851 20.9071 0.840948909913063 0.840948909913063 0.840948909913063 -17.089 24.2851 19.9071 0.10680418758192844 0.10680418758192844 0.10680418758192844 -18.089 23.2851 19.9071 0.0 0.0 0.0 -18.089 24.2851 19.9071 0.0 0.0 0.0 -17.089 23.2851 22.9071 0.7097238051974094 0.7097238051974094 0.7097238051974094 -18.089 23.2851 22.9071 0.0 0.0 0.0 -18.089 24.2851 22.9071 0.0 0.0 0.0 -17.089 25.2851 19.9071 0.03743487870542247 0.03743487870542247 0.03743487870542247 -17.089 26.2851 19.9071 0.0 0.0 0.0 -18.089 25.2851 19.9071 0.0 0.0 0.0 -18.089 26.2851 19.9071 0.0 0.0 0.0 -17.089 25.2851 22.9071 0.0 0.0 0.0 -17.089 26.2851 22.9071 0.0 0.0 0.0 -18.089 25.2851 22.9071 0.2768036204103232 0.2768036204103232 0.2768036204103232 -18.089 26.2851 22.9071 0.0 0.0 0.0 -19.089 23.2851 19.9071 0.033287901194552924 0.033287901194552924 0.033287901194552924 -19.089 24.2851 19.9071 0.011621219281055065 0.011621219281055065 0.011621219281055065 -20.089 23.2851 19.9071 0.0 0.0 0.0 -20.089 23.2851 20.9071 0.0 0.0 0.0 -20.089 24.2851 19.9071 0.0 0.0 0.0 -20.089 24.2851 20.9071 0.0 0.0 0.0 -19.089 23.2851 22.9071 0.0 0.0 0.0 -19.089 24.2851 21.9071 0.0 0.0 0.0 -19.089 24.2851 22.9071 0.0 0.0 0.0 -20.089 23.2851 21.9071 0.0 0.0 0.0 -20.089 23.2851 22.9071 0.005351718890445992 0.005351718890445992 0.005351718890445992 -20.089 24.2851 21.9071 0.0 0.0 0.0 -20.089 24.2851 22.9071 0.0 0.0 0.0 -19.089 25.2851 19.9071 0.0 0.0 0.0 -19.089 25.2851 20.9071 0.0 0.0 0.0 -19.089 26.2851 19.9071 0.0 0.0 0.0 -20.089 25.2851 19.9071 0.0 0.0 0.0 -20.089 25.2851 20.9071 0.0 0.0 0.0 -20.089 26.2851 19.9071 0.0 0.0 0.0 -20.089 26.2851 20.9071 0.0 0.0 0.0 -19.089 25.2851 21.9071 0.0 0.0 0.0 -19.089 25.2851 22.9071 0.12454919921170686 0.12454919921170686 0.12454919921170686 -19.089 26.2851 21.9071 0.0 0.0 0.0 -19.089 26.2851 22.9071 0.0 0.0 0.0 -20.089 25.2851 21.9071 0.09799125680947365 0.09799125680947365 0.09799125680947365 -20.089 25.2851 22.9071 0.0 0.0 0.0 -20.089 26.2851 21.9071 0.0 0.0 0.0 -20.089 26.2851 22.9071 0.04632729180918871 0.04632729180918871 0.04632729180918871 -17.089 23.2851 23.9071 0.0 0.0 0.0 -17.089 23.2851 24.9071 0.0 0.0 0.0 -18.089 23.2851 23.9071 0.008524154957005658 0.008524154957005658 0.008524154957005658 -18.089 23.2851 24.9071 0.0 0.0 0.0 -18.089 24.2851 23.9071 0.0 0.0 0.0 -18.089 24.2851 24.9071 0.06464922684061762 0.06464922684061762 0.06464922684061762 -17.089 23.2851 25.9071 0.01890826318318038 0.01890826318318038 0.01890826318318038 -17.089 23.2851 26.9071 0.023257279059805742 0.023257279059805742 0.023257279059805742 -17.089 24.2851 26.9071 0.0 0.0 0.0 -18.089 23.2851 25.9071 0.056374189753006836 0.056374189753006836 0.056374189753006836 -18.089 23.2851 26.9071 0.10631167213098798 0.10631167213098798 0.10631167213098798 -18.089 24.2851 25.9071 0.0 0.0 0.0 -18.089 24.2851 26.9071 0.0 0.0 0.0 -17.089 25.2851 23.9071 0.2048572546573978 0.2048572546573978 0.2048572546573978 -17.089 25.2851 24.9071 0.06676471650044011 0.06676471650044011 0.06676471650044011 -17.089 26.2851 23.9071 0.1359681529252528 0.1359681529252528 0.1359681529252528 -17.089 26.2851 24.9071 0.4080245401587887 0.4080245401587887 0.4080245401587887 -18.089 25.2851 24.9071 0.0 0.0 0.0 -18.089 26.2851 23.9071 0.13673667148664329 0.13673667148664329 0.13673667148664329 -18.089 26.2851 24.9071 0.0 0.0 0.0 -17.089 25.2851 25.9071 0.0 0.0 0.0 -17.089 25.2851 26.9071 0.012012085679867768 0.012012085679867768 0.012012085679867768 -17.089 26.2851 25.9071 0.0 0.0 0.0 -17.089 26.2851 26.9071 0.0 0.0 0.0 -18.089 25.2851 25.9071 0.05551324499829454 0.05551324499829454 0.05551324499829454 -18.089 25.2851 26.9071 0.0 0.0 0.0 -18.089 26.2851 25.9071 0.0 0.0 0.0 -18.089 26.2851 26.9071 0.027415690019297532 0.027415690019297532 0.027415690019297532 -19.089 23.2851 23.9071 0.061401796176006586 0.061401796176006586 0.061401796176006586 -19.089 23.2851 24.9071 0.08358104771516583 0.08358104771516583 0.08358104771516583 -19.089 24.2851 23.9071 0.0 0.0 0.0 -19.089 24.2851 24.9071 0.013410545366949607 0.013410545366949607 0.013410545366949607 -20.089 23.2851 23.9071 0.05752804498499386 0.05752804498499386 0.05752804498499386 -20.089 23.2851 24.9071 0.08206122756909644 0.08206122756909644 0.08206122756909644 -20.089 24.2851 23.9071 0.0 0.0 0.0 -20.089 24.2851 24.9071 0.0 0.0 0.0 -19.089 23.2851 25.9071 0.008858071136079454 0.008858071136079454 0.008858071136079454 -19.089 23.2851 26.9071 0.004996555833962227 0.004996555833962227 0.004996555833962227 -19.089 24.2851 25.9071 0.049020126106509354 0.049020126106509354 0.049020126106509354 -19.089 24.2851 26.9071 0.0 0.0 0.0 -20.089 23.2851 25.9071 0.0 0.0 0.0 -20.089 23.2851 26.9071 0.0 0.0 0.0 -20.089 24.2851 25.9071 0.0 0.0 0.0 -20.089 24.2851 26.9071 0.0 0.0 0.0 -19.089 26.2851 24.9071 0.1323638628009803 0.1323638628009803 0.1323638628009803 -19.089 25.2851 25.9071 0.0 0.0 0.0 -19.089 26.2851 25.9071 0.18804264316391722 0.18804264316391722 0.18804264316391722 -19.089 26.2851 26.9071 0.0 0.0 0.0 -20.089 25.2851 25.9071 0.009368480056596075 0.009368480056596075 0.009368480056596075 -20.089 25.2851 26.9071 0.0 0.0 0.0 -20.089 26.2851 25.9071 0.0 0.0 0.0 -20.089 26.2851 26.9071 0.0 0.0 0.0 -21.089 19.2851 19.9071 0.0 0.0 0.0 -21.089 19.2851 20.9071 0.0 0.0 0.0 -21.089 20.2851 19.9071 0.0 0.0 0.0 -22.089 20.2851 19.9071 0.09532506277730703 0.09532506277730703 0.09532506277730703 -21.089 20.2851 22.9071 0.23717973530529038 0.23717973530529038 0.23717973530529038 -21.089 21.2851 19.9071 0.0 0.0 0.0 -21.089 22.2851 19.9071 0.0 0.0 0.0 -21.089 22.2851 20.9071 0.034946086747400115 0.034946086747400115 0.034946086747400115 -22.089 21.2851 19.9071 0.012786261706685611 0.012786261706685611 0.012786261706685611 -22.089 21.2851 20.9071 0.10582686080004457 0.10582686080004457 0.10582686080004457 -22.089 22.2851 19.9071 0.008674455913535642 0.008674455913535642 0.008674455913535642 -22.089 22.2851 20.9071 0.05705058465871234 0.05705058465871234 0.05705058465871234 -21.089 21.2851 21.9071 0.08548294661705119 0.08548294661705119 0.08548294661705119 -21.089 21.2851 22.9071 0.0 0.0 0.0 -21.089 22.2851 21.9071 0.0 0.0 0.0 -21.089 22.2851 22.9071 0.0 0.0 0.0 -22.089 21.2851 21.9071 0.0 0.0 0.0 -22.089 21.2851 22.9071 0.0 0.0 0.0 -22.089 22.2851 21.9071 0.0 0.0 0.0 -22.089 22.2851 22.9071 0.07793580063643882 0.07793580063643882 0.07793580063643882 -23.089 20.2851 19.9071 0.0894689741931765 0.0894689741931765 0.0894689741931765 -23.089 21.2851 19.9071 0.0031447085291791983 0.0031447085291791983 0.0031447085291791983 -23.089 21.2851 20.9071 0.0 0.0 0.0 -23.089 22.2851 20.9071 0.03755461465105296 0.03755461465105296 0.03755461465105296 -24.089 21.2851 19.9071 0.01756065194126748 0.01756065194126748 0.01756065194126748 -24.089 21.2851 20.9071 0.007650791081596316 0.007650791081596316 0.007650791081596316 -24.089 22.2851 19.9071 0.0 0.0 0.0 -24.089 22.2851 20.9071 0.005784101276647871 0.005784101276647871 0.005784101276647871 -23.089 21.2851 22.9071 0.0 0.0 0.0 -23.089 22.2851 21.9071 0.18100532426216764 0.18100532426216764 0.18100532426216764 -23.089 22.2851 22.9071 0.030957570407600415 0.030957570407600415 0.030957570407600415 -24.089 22.2851 21.9071 0.1081053639910886 0.1081053639910886 0.1081053639910886 -21.089 20.2851 23.9071 0.013065664710059441 0.013065664710059441 0.013065664710059441 -22.089 20.2851 23.9071 0.0 0.0 0.0 -21.089 19.2851 26.9071 0.008830651247006667 0.008830651247006667 0.008830651247006667 -21.089 20.2851 25.9071 0.0 0.0 0.0 -21.089 20.2851 26.9071 0.0 0.0 0.0 -22.089 19.2851 26.9071 0.0 0.0 0.0 -22.089 20.2851 25.9071 0.0561729391764376 0.0561729391764376 0.0561729391764376 -22.089 20.2851 26.9071 0.03824992378639745 0.03824992378639745 0.03824992378639745 -21.089 21.2851 23.9071 0.02302863130908543 0.02302863130908543 0.02302863130908543 -21.089 21.2851 24.9071 0.17679149962890905 0.17679149962890905 0.17679149962890905 -21.089 22.2851 24.9071 0.0 0.0 0.0 -22.089 21.2851 23.9071 0.0 0.0 0.0 -22.089 21.2851 24.9071 0.0 0.0 0.0 -22.089 22.2851 24.9071 0.0 0.0 0.0 -21.089 21.2851 25.9071 0.16260240567115097 0.16260240567115097 0.16260240567115097 -21.089 21.2851 26.9071 0.0 0.0 0.0 -21.089 22.2851 25.9071 0.24273477947439645 0.24273477947439645 0.24273477947439645 -22.089 21.2851 25.9071 0.03185186950480055 0.03185186950480055 0.03185186950480055 -22.089 21.2851 26.9071 0.20185836616467598 0.20185836616467598 0.20185836616467598 -22.089 22.2851 25.9071 0.03128939818463707 0.03128939818463707 0.03128939818463707 -23.089 19.2851 25.9071 0.0 0.0 0.0 -23.089 19.2851 26.9071 0.0 0.0 0.0 -23.089 20.2851 25.9071 0.0 0.0 0.0 -23.089 20.2851 26.9071 0.0 0.0 0.0 -24.089 19.2851 25.9071 0.0 0.0 0.0 -24.089 20.2851 25.9071 0.14757021417424868 0.14757021417424868 0.14757021417424868 -24.089 20.2851 26.9071 0.00778902868049707 0.00778902868049707 0.00778902868049707 -23.089 21.2851 23.9071 0.02489398333347748 0.02489398333347748 0.02489398333347748 -23.089 21.2851 24.9071 0.011048882695385436 0.011048882695385436 0.011048882695385436 -23.089 22.2851 23.9071 0.0 0.0 0.0 -23.089 22.2851 24.9071 0.0 0.0 0.0 -23.089 21.2851 25.9071 0.0011314711968893746 0.0011314711968893746 0.0011314711968893746 -23.089 21.2851 26.9071 0.0050085500733870435 0.0050085500733870435 0.0050085500733870435 -23.089 22.2851 25.9071 0.0 0.0 0.0 -23.089 22.2851 26.9071 0.0 0.0 0.0 -24.089 22.2851 25.9071 0.0 0.0 0.0 -24.089 22.2851 26.9071 0.0 0.0 0.0 -21.089 23.2851 19.9071 0.0 0.0 0.0 -21.089 23.2851 20.9071 0.0 0.0 0.0 -21.089 24.2851 19.9071 0.0 0.0 0.0 -21.089 24.2851 20.9071 0.0 0.0 0.0 -22.089 23.2851 20.9071 0.0 0.0 0.0 -22.089 24.2851 19.9071 0.0 0.0 0.0 -22.089 24.2851 20.9071 0.0 0.0 0.0 -21.089 23.2851 21.9071 0.0 0.0 0.0 -21.089 23.2851 22.9071 0.0 0.0 0.0 -21.089 24.2851 21.9071 0.0 0.0 0.0 -21.089 24.2851 22.9071 0.0 0.0 0.0 -22.089 23.2851 21.9071 0.0 0.0 0.0 -22.089 23.2851 22.9071 0.01958167790348321 0.01958167790348321 0.01958167790348321 -22.089 24.2851 21.9071 0.0 0.0 0.0 -22.089 24.2851 22.9071 0.0 0.0 0.0 -21.089 25.2851 19.9071 0.0 0.0 0.0 -21.089 25.2851 20.9071 0.0 0.0 0.0 -21.089 26.2851 20.9071 0.0 0.0 0.0 -22.089 25.2851 19.9071 0.0 0.0 0.0 -22.089 25.2851 20.9071 0.0 0.0 0.0 -22.089 26.2851 20.9071 0.0 0.0 0.0 -21.089 25.2851 21.9071 0.02577951017228471 0.02577951017228471 0.02577951017228471 -21.089 25.2851 22.9071 0.0 0.0 0.0 -21.089 26.2851 21.9071 0.0009520298531929756 0.0009520298531929756 0.0009520298531929756 -21.089 26.2851 22.9071 0.0 0.0 0.0 -22.089 25.2851 21.9071 0.0 0.0 0.0 -22.089 25.2851 22.9071 0.0 0.0 0.0 -22.089 26.2851 21.9071 0.0 0.0 0.0 -22.089 26.2851 22.9071 0.0 0.0 0.0 -24.089 23.2851 19.9071 0.0 0.0 0.0 -24.089 23.2851 20.9071 0.004993832062209778 0.004993832062209778 0.004993832062209778 -23.089 23.2851 21.9071 0.0 0.0 0.0 -23.089 23.2851 22.9071 0.0 0.0 0.0 -23.089 24.2851 21.9071 0.016501497386219414 0.016501497386219414 0.016501497386219414 -23.089 24.2851 22.9071 0.029330515074815083 0.029330515074815083 0.029330515074815083 -24.089 23.2851 21.9071 0.0 0.0 0.0 -24.089 24.2851 21.9071 0.0 0.0 0.0 -24.089 24.2851 22.9071 0.0 0.0 0.0 -24.089 25.2851 19.9071 0.0 0.0 0.0 -24.089 26.2851 19.9071 0.0 0.0 0.0 -23.089 25.2851 21.9071 0.0 0.0 0.0 -23.089 25.2851 22.9071 0.0 0.0 0.0 -23.089 26.2851 21.9071 0.0 0.0 0.0 -23.089 26.2851 22.9071 0.0 0.0 0.0 -24.089 25.2851 21.9071 0.0 0.0 0.0 -24.089 25.2851 22.9071 0.0 0.0 0.0 -24.089 26.2851 21.9071 0.0 0.0 0.0 -24.089 26.2851 22.9071 0.0 0.0 0.0 -21.089 23.2851 23.9071 0.009451495553270723 0.009451495553270723 0.009451495553270723 -21.089 23.2851 24.9071 0.0 0.0 0.0 -21.089 24.2851 24.9071 0.0 0.0 0.0 -22.089 23.2851 23.9071 0.11018790334044977 0.11018790334044977 0.11018790334044977 -22.089 23.2851 24.9071 0.04705441489241743 0.04705441489241743 0.04705441489241743 -22.089 24.2851 23.9071 0.0 0.0 0.0 -22.089 24.2851 24.9071 0.015424706454876851 0.015424706454876851 0.015424706454876851 -21.089 23.2851 25.9071 0.0 0.0 0.0 -21.089 24.2851 25.9071 0.0 0.0 0.0 -21.089 24.2851 26.9071 0.0 0.0 0.0 -22.089 23.2851 25.9071 0.0 0.0 0.0 -21.089 25.2851 24.9071 0.01101245769534749 0.01101245769534749 0.01101245769534749 -21.089 26.2851 24.9071 0.0 0.0 0.0 -22.089 25.2851 23.9071 0.0 0.0 0.0 -22.089 25.2851 24.9071 0.03286474895317992 0.03286474895317992 0.03286474895317992 -22.089 26.2851 23.9071 0.0 0.0 0.0 -22.089 26.2851 24.9071 0.003638908645622364 0.003638908645622364 0.003638908645622364 -21.089 25.2851 25.9071 0.07516256395463777 0.07516256395463777 0.07516256395463777 -21.089 25.2851 26.9071 0.0 0.0 0.0 -21.089 26.2851 25.9071 0.04381280628779597 0.04381280628779597 0.04381280628779597 -21.089 26.2851 26.9071 0.0 0.0 0.0 -22.089 25.2851 25.9071 0.06243401940716928 0.06243401940716928 0.06243401940716928 -22.089 25.2851 26.9071 0.0 0.0 0.0 -22.089 26.2851 25.9071 0.0 0.0 0.0 -22.089 26.2851 26.9071 0.0 0.0 0.0 -23.089 23.2851 23.9071 0.15007997654807828 0.15007997654807828 0.15007997654807828 -23.089 23.2851 24.9071 0.04433818731762006 0.04433818731762006 0.04433818731762006 -23.089 24.2851 23.9071 0.21058495496290308 0.21058495496290308 0.21058495496290308 -23.089 24.2851 24.9071 0.0 0.0 0.0 -24.089 24.2851 23.9071 0.0 0.0 0.0 -24.089 24.2851 24.9071 0.21637656495872298 0.21637656495872298 0.21637656495872298 -23.089 23.2851 25.9071 0.0 0.0 0.0 -23.089 24.2851 25.9071 0.00785181558284702 0.00785181558284702 0.00785181558284702 -24.089 23.2851 25.9071 0.0 0.0 0.0 -24.089 23.2851 26.9071 0.1175041768345553 0.1175041768345553 0.1175041768345553 -24.089 24.2851 25.9071 0.0 0.0 0.0 -24.089 24.2851 26.9071 0.0 0.0 0.0 -23.089 25.2851 23.9071 0.003145768639815271 0.003145768639815271 0.003145768639815271 -23.089 25.2851 24.9071 0.0 0.0 0.0 -23.089 26.2851 23.9071 0.0 0.0 0.0 -23.089 26.2851 24.9071 0.0 0.0 0.0 -24.089 26.2851 24.9071 0.41387922767490615 0.41387922767490615 0.41387922767490615 -23.089 25.2851 25.9071 0.0 0.0 0.0 -23.089 26.2851 25.9071 0.0 0.0 0.0 -24.089 25.2851 25.9071 0.0 0.0 0.0 -24.089 25.2851 26.9071 0.0 0.0 0.0 -24.089 26.2851 25.9071 0.0 0.0 0.0 -11.088999999999999 26.2851 31.9071 0.0 0.0 0.0 -11.088999999999999 26.2851 32.9071 0.0 0.0 0.0 -12.088999999999999 26.2851 31.9071 0.0 0.0 0.0 -12.088999999999999 26.2851 32.9071 0.0 0.0 0.0 -11.088999999999999 26.2851 34.9071 0.0 0.0 0.0 -12.088999999999999 25.2851 34.9071 0.0 0.0 0.0 -12.088999999999999 26.2851 33.9071 0.0 0.0 0.0 -12.088999999999999 26.2851 34.9071 0.0 0.0 0.0 -14.088999999999999 22.2851 27.9071 0.2253471237273279 0.2253471237273279 0.2253471237273279 -15.088999999999999 21.2851 27.9071 0.0 0.0 0.0 -15.088999999999999 22.2851 27.9071 0.0 0.0 0.0 -15.088999999999999 22.2851 28.9071 0.0 0.0 0.0 -16.089 21.2851 27.9071 0.036331631519874875 0.036331631519874875 0.036331631519874875 -16.089 22.2851 27.9071 0.08179902933481023 0.08179902933481023 0.08179902933481023 -16.089 22.2851 28.9071 0.17463517892864008 0.17463517892864008 0.17463517892864008 -15.088999999999999 22.2851 29.9071 0.0 0.0 0.0 -16.089 22.2851 29.9071 0.0 0.0 0.0 -13.088999999999999 24.2851 28.9071 0.0 0.0 0.0 -14.088999999999999 23.2851 27.9071 0.039601897930616685 0.039601897930616685 0.039601897930616685 -14.088999999999999 23.2851 28.9071 0.0 0.0 0.0 -14.088999999999999 24.2851 27.9071 0.020921669556517666 0.020921669556517666 0.020921669556517666 -14.088999999999999 24.2851 28.9071 0.0 0.0 0.0 -13.088999999999999 23.2851 29.9071 0.0 0.0 0.0 -13.088999999999999 23.2851 30.9071 0.0 0.0 0.0 -13.088999999999999 24.2851 29.9071 0.0 0.0 0.0 -13.088999999999999 24.2851 30.9071 0.0 0.0 0.0 -14.088999999999999 23.2851 29.9071 0.00020699455948826055 0.00020699455948826055 0.00020699455948826055 -14.088999999999999 23.2851 30.9071 0.0 0.0 0.0 -14.088999999999999 24.2851 29.9071 0.0 0.0 0.0 -14.088999999999999 24.2851 30.9071 0.0 0.0 0.0 -13.088999999999999 26.2851 27.9071 0.0 0.0 0.0 -14.088999999999999 25.2851 27.9071 0.0 0.0 0.0 -14.088999999999999 25.2851 28.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 27.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 28.9071 0.0 0.0 0.0 -13.088999999999999 25.2851 29.9071 0.0 0.0 0.0 -14.088999999999999 25.2851 29.9071 0.019589923551777928 0.019589923551777928 0.019589923551777928 -14.088999999999999 25.2851 30.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 29.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 30.9071 0.0 0.0 0.0 -15.088999999999999 23.2851 27.9071 0.0 0.0 0.0 -15.088999999999999 23.2851 28.9071 0.0 0.0 0.0 -15.088999999999999 24.2851 27.9071 0.0 0.0 0.0 -15.088999999999999 23.2851 29.9071 0.0 0.0 0.0 -15.088999999999999 23.2851 30.9071 0.0 0.0 0.0 -15.088999999999999 24.2851 30.9071 0.0 0.0 0.0 -16.089 23.2851 29.9071 0.0 0.0 0.0 -16.089 23.2851 30.9071 0.030223968962499143 0.030223968962499143 0.030223968962499143 -15.088999999999999 25.2851 27.9071 0.0038437138197622987 0.0038437138197622987 0.0038437138197622987 -15.088999999999999 26.2851 27.9071 0.0 0.0 0.0 -15.088999999999999 26.2851 28.9071 0.0 0.0 0.0 -16.089 25.2851 27.9071 0.0 0.0 0.0 -16.089 26.2851 27.9071 0.0 0.0 0.0 -16.089 26.2851 28.9071 0.0 0.0 0.0 -15.088999999999999 26.2851 29.9071 0.0 0.0 0.0 -15.088999999999999 26.2851 30.9071 0.0 0.0 0.0 -16.089 25.2851 29.9071 0.003345603846409903 0.003345603846409903 0.003345603846409903 -16.089 25.2851 30.9071 0.0 0.0 0.0 -16.089 26.2851 29.9071 0.0 0.0 0.0 -16.089 26.2851 30.9071 0.0 0.0 0.0 -14.088999999999999 24.2851 31.9071 0.07570633036323486 0.07570633036323486 0.07570633036323486 -13.088999999999999 26.2851 31.9071 0.0 0.0 0.0 -13.088999999999999 26.2851 32.9071 0.0 0.0 0.0 -14.088999999999999 25.2851 31.9071 0.0029465254685078247 0.0029465254685078247 0.0029465254685078247 -14.088999999999999 26.2851 31.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 32.9071 0.0 0.0 0.0 -13.088999999999999 25.2851 34.9071 0.0 0.0 0.0 -13.088999999999999 26.2851 33.9071 0.0 0.0 0.0 -13.088999999999999 26.2851 34.9071 0.0 0.0 0.0 -14.088999999999999 25.2851 34.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 33.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 34.9071 0.0 0.0 0.0 -15.088999999999999 23.2851 31.9071 0.0 0.0 0.0 -15.088999999999999 24.2851 31.9071 0.0 0.0 0.0 -16.089 23.2851 31.9071 0.0 0.0 0.0 -16.089 24.2851 31.9071 0.0 0.0 0.0 -16.089 24.2851 32.9071 0.0 0.0 0.0 -16.089 23.2851 33.9071 0.0 0.0 0.0 -16.089 23.2851 34.9071 0.0 0.0 0.0 -16.089 24.2851 33.9071 0.0 0.0 0.0 -16.089 24.2851 34.9071 0.0 0.0 0.0 -15.088999999999999 25.2851 31.9071 0.017785272054658116 0.017785272054658116 0.017785272054658116 -15.088999999999999 26.2851 31.9071 0.0 0.0 0.0 -16.089 25.2851 31.9071 0.0 0.0 0.0 -16.089 25.2851 32.9071 0.0 0.0 0.0 -16.089 26.2851 32.9071 0.0 0.0 0.0 -15.088999999999999 25.2851 34.9071 0.0 0.0 0.0 -15.088999999999999 26.2851 34.9071 0.0 0.0 0.0 -16.089 25.2851 33.9071 0.0 0.0 0.0 -16.089 25.2851 34.9071 0.0 0.0 0.0 -16.089 26.2851 33.9071 0.0 0.0 0.0 -16.089 26.2851 34.9071 0.0 0.0 0.0 -11.088999999999999 26.2851 35.9071 0.0 0.0 0.0 -12.088999999999999 25.2851 35.9071 0.0 0.0 0.0 -12.088999999999999 25.2851 36.9071 0.0 0.0 0.0 -12.088999999999999 26.2851 35.9071 0.0 0.0 0.0 -12.088999999999999 26.2851 36.9071 0.0 0.0 0.0 -13.088999999999999 25.2851 35.9071 0.0 0.0 0.0 -13.088999999999999 25.2851 36.9071 0.0 0.0 0.0 -13.088999999999999 26.2851 36.9071 0.0 0.0 0.0 -14.088999999999999 25.2851 35.9071 0.0 0.0 0.0 -14.088999999999999 25.2851 36.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 35.9071 0.0 0.0 0.0 -14.088999999999999 26.2851 36.9071 0.0 0.0 0.0 -16.089 24.2851 35.9071 0.0 0.0 0.0 -15.088999999999999 26.2851 35.9071 0.0 0.0 0.0 -16.089 25.2851 35.9071 0.0 0.0 0.0 -16.089 26.2851 35.9071 0.0 0.0 0.0 -19.089 17.2851 27.9071 0.16733992158376687 0.16733992158376687 0.16733992158376687 -19.089 17.2851 28.9071 0.17784092149923167 0.17784092149923167 0.17784092149923167 -19.089 18.2851 27.9071 0.47471900406539325 0.47471900406539325 0.47471900406539325 -19.089 18.2851 28.9071 0.04575515275765081 0.04575515275765081 0.04575515275765081 -20.089 17.2851 27.9071 0.19227927155845412 0.19227927155845412 0.19227927155845412 -20.089 17.2851 28.9071 0.4111755913832886 0.4111755913832886 0.4111755913832886 -20.089 18.2851 28.9071 0.1595731498707235 0.1595731498707235 0.1595731498707235 -19.089 18.2851 29.9071 0.0 0.0 0.0 -20.089 18.2851 29.9071 0.0 0.0 0.0 -21.089 17.2851 27.9071 0.08125172072133623 0.08125172072133623 0.08125172072133623 -21.089 17.2851 28.9071 0.01662603383229011 0.01662603383229011 0.01662603383229011 -21.089 18.2851 27.9071 0.06638403210083393 0.06638403210083393 0.06638403210083393 -21.089 18.2851 28.9071 0.05068993339997207 0.05068993339997207 0.05068993339997207 -22.089 18.2851 27.9071 0.0 0.0 0.0 -22.089 18.2851 28.9071 0.0 0.0 0.0 -21.089 18.2851 29.9071 0.0 0.0 0.0 -23.089 17.2851 27.9071 0.09464968454011305 0.09464968454011305 0.09464968454011305 -23.089 18.2851 27.9071 0.09543046129125085 0.09543046129125085 0.09543046129125085 -23.089 18.2851 28.9071 0.12164837381765946 0.12164837381765946 0.12164837381765946 -24.089 17.2851 27.9071 0.0 0.0 0.0 -24.089 18.2851 27.9071 0.13263959194699043 0.13263959194699043 0.13263959194699043 -24.089 18.2851 28.9071 0.04780682785053195 0.04780682785053195 0.04780682785053195 -17.089 22.2851 27.9071 0.0 0.0 0.0 -17.089 22.2851 28.9071 0.00640319882573289 0.00640319882573289 0.00640319882573289 -18.089 22.2851 27.9071 0.0 0.0 0.0 -18.089 22.2851 28.9071 0.0 0.0 0.0 -17.089 22.2851 29.9071 0.04820366524432092 0.04820366524432092 0.04820366524432092 -19.089 19.2851 27.9071 0.5746262334263198 0.5746262334263198 0.5746262334263198 -19.089 19.2851 28.9071 0.0 0.0 0.0 -19.089 20.2851 27.9071 0.1509702887167549 0.1509702887167549 0.1509702887167549 -19.089 20.2851 28.9071 0.0 0.0 0.0 -20.089 19.2851 28.9071 0.10845552686340397 0.10845552686340397 0.10845552686340397 -20.089 20.2851 27.9071 0.10488129069037061 0.10488129069037061 0.10488129069037061 -20.089 20.2851 28.9071 0.0 0.0 0.0 -19.089 19.2851 29.9071 0.3944841198737316 0.3944841198737316 0.3944841198737316 -19.089 20.2851 30.9071 0.0 0.0 0.0 -20.089 19.2851 29.9071 0.0 0.0 0.0 -20.089 19.2851 30.9071 0.05851899329215268 0.05851899329215268 0.05851899329215268 -20.089 20.2851 29.9071 0.11849718013436397 0.11849718013436397 0.11849718013436397 -20.089 20.2851 30.9071 0.0 0.0 0.0 -19.089 21.2851 27.9071 0.3606945375490994 0.3606945375490994 0.3606945375490994 -19.089 21.2851 28.9071 0.0 0.0 0.0 -19.089 22.2851 27.9071 0.14050355432982495 0.14050355432982495 0.14050355432982495 -19.089 22.2851 28.9071 0.07288904461686158 0.07288904461686158 0.07288904461686158 -20.089 21.2851 27.9071 0.0 0.0 0.0 -20.089 21.2851 28.9071 0.16238537177269993 0.16238537177269993 0.16238537177269993 -20.089 22.2851 27.9071 0.0 0.0 0.0 -19.089 21.2851 29.9071 0.0 0.0 0.0 -19.089 21.2851 30.9071 0.0 0.0 0.0 -19.089 22.2851 29.9071 0.0 0.0 0.0 -20.089 21.2851 29.9071 0.40027908390650885 0.40027908390650885 0.40027908390650885 -20.089 21.2851 30.9071 0.0 0.0 0.0 -20.089 22.2851 29.9071 0.0 0.0 0.0 -20.089 22.2851 30.9071 0.0 0.0 0.0 -19.089 20.2851 31.9071 0.0 0.0 0.0 -19.089 20.2851 32.9071 0.0 0.0 0.0 -20.089 19.2851 31.9071 0.1335353355543087 0.1335353355543087 0.1335353355543087 -20.089 19.2851 32.9071 0.012337033269418008 0.012337033269418008 0.012337033269418008 -20.089 20.2851 31.9071 0.0 0.0 0.0 -20.089 20.2851 32.9071 0.0 0.0 0.0 -19.089 21.2851 31.9071 0.0 0.0 0.0 -19.089 21.2851 32.9071 0.0 0.0 0.0 -20.089 21.2851 31.9071 0.0 0.0 0.0 -20.089 21.2851 32.9071 0.0 0.0 0.0 -20.089 22.2851 31.9071 0.0 0.0 0.0 -20.089 22.2851 32.9071 0.0 0.0 0.0 -17.089 23.2851 28.9071 0.04721511423522975 0.04721511423522975 0.04721511423522975 -17.089 24.2851 27.9071 0.0 0.0 0.0 -17.089 24.2851 28.9071 0.0 0.0 0.0 -18.089 23.2851 27.9071 0.0 0.0 0.0 -18.089 23.2851 28.9071 0.04150402917766995 0.04150402917766995 0.04150402917766995 -18.089 24.2851 27.9071 0.0 0.0 0.0 -18.089 24.2851 28.9071 0.0 0.0 0.0 -17.089 23.2851 29.9071 0.0 0.0 0.0 -17.089 23.2851 30.9071 0.04815033049174852 0.04815033049174852 0.04815033049174852 -17.089 24.2851 29.9071 0.0 0.0 0.0 -17.089 24.2851 30.9071 0.0 0.0 0.0 -18.089 24.2851 29.9071 0.0 0.0 0.0 -18.089 24.2851 30.9071 0.0 0.0 0.0 -17.089 25.2851 27.9071 0.0 0.0 0.0 -17.089 25.2851 28.9071 0.0 0.0 0.0 -17.089 26.2851 27.9071 0.0 0.0 0.0 -17.089 26.2851 28.9071 0.054763608092416205 0.054763608092416205 0.054763608092416205 -18.089 25.2851 27.9071 0.0 0.0 0.0 -18.089 25.2851 28.9071 0.0 0.0 0.0 -18.089 26.2851 27.9071 0.0 0.0 0.0 -18.089 26.2851 28.9071 0.0 0.0 0.0 -17.089 25.2851 29.9071 0.0 0.0 0.0 -17.089 25.2851 30.9071 0.0 0.0 0.0 -17.089 26.2851 29.9071 0.0 0.0 0.0 -17.089 26.2851 30.9071 0.0 0.0 0.0 -18.089 25.2851 29.9071 0.0 0.0 0.0 -18.089 26.2851 29.9071 0.0 0.0 0.0 -19.089 23.2851 27.9071 0.06720209833390275 0.06720209833390275 0.06720209833390275 -19.089 23.2851 28.9071 0.0 0.0 0.0 -19.089 24.2851 27.9071 0.0 0.0 0.0 -19.089 24.2851 28.9071 0.03019762278211294 0.03019762278211294 0.03019762278211294 -20.089 23.2851 27.9071 0.0 0.0 0.0 -20.089 23.2851 28.9071 0.0 0.0 0.0 -20.089 24.2851 27.9071 0.0 0.0 0.0 -20.089 24.2851 28.9071 0.019655408135533937 0.019655408135533937 0.019655408135533937 -19.089 23.2851 29.9071 0.0 0.0 0.0 -19.089 24.2851 29.9071 0.007571746478297293 0.007571746478297293 0.007571746478297293 -19.089 24.2851 30.9071 0.0 0.0 0.0 -20.089 23.2851 29.9071 0.0 0.0 0.0 -20.089 23.2851 30.9071 0.0 0.0 0.0 -20.089 24.2851 29.9071 0.0 0.0 0.0 -20.089 24.2851 30.9071 0.0 0.0 0.0 -19.089 25.2851 27.9071 0.0019724914799318 0.0019724914799318 0.0019724914799318 -19.089 25.2851 28.9071 0.01023256866132598 0.01023256866132598 0.01023256866132598 -19.089 26.2851 27.9071 0.006362280548713464 0.006362280548713464 0.006362280548713464 -19.089 26.2851 28.9071 0.0 0.0 0.0 -20.089 25.2851 27.9071 0.0 0.0 0.0 -20.089 25.2851 28.9071 0.010315320940261614 0.010315320940261614 0.010315320940261614 -20.089 26.2851 27.9071 0.0 0.0 0.0 -20.089 26.2851 28.9071 0.0 0.0 0.0 -19.089 25.2851 29.9071 0.0 0.0 0.0 -19.089 25.2851 30.9071 0.12313272591500446 0.12313272591500446 0.12313272591500446 -19.089 26.2851 29.9071 0.0 0.0 0.0 -19.089 26.2851 30.9071 0.15313951141126825 0.15313951141126825 0.15313951141126825 -20.089 25.2851 29.9071 0.0 0.0 0.0 -20.089 25.2851 30.9071 0.04873058905646491 0.04873058905646491 0.04873058905646491 -20.089 26.2851 29.9071 0.0 0.0 0.0 -20.089 26.2851 30.9071 0.10589889629501398 0.10589889629501398 0.10589889629501398 -17.089 23.2851 31.9071 0.0 0.0 0.0 -17.089 24.2851 31.9071 0.0 0.0 0.0 -17.089 24.2851 32.9071 0.0 0.0 0.0 -18.089 24.2851 31.9071 0.0 0.0 0.0 -18.089 24.2851 32.9071 0.0 0.0 0.0 -17.089 23.2851 33.9071 0.0 0.0 0.0 -17.089 23.2851 34.9071 0.0 0.0 0.0 -17.089 24.2851 33.9071 0.0 0.0 0.0 -17.089 24.2851 34.9071 0.0 0.0 0.0 -18.089 23.2851 33.9071 0.0 0.0 0.0 -18.089 23.2851 34.9071 0.0 0.0 0.0 -18.089 24.2851 33.9071 0.0 0.0 0.0 -18.089 24.2851 34.9071 0.0 0.0 0.0 -17.089 25.2851 31.9071 0.0 0.0 0.0 -17.089 25.2851 32.9071 0.0 0.0 0.0 -17.089 26.2851 31.9071 0.0 0.0 0.0 -17.089 26.2851 32.9071 0.0 0.0 0.0 -18.089 25.2851 31.9071 0.0 0.0 0.0 -18.089 25.2851 32.9071 0.0 0.0 0.0 -18.089 26.2851 31.9071 0.0 0.0 0.0 -18.089 26.2851 32.9071 0.0 0.0 0.0 -17.089 26.2851 33.9071 0.0 0.0 0.0 -17.089 26.2851 34.9071 0.0 0.0 0.0 -18.089 25.2851 33.9071 0.0 0.0 0.0 -18.089 25.2851 34.9071 0.0 0.0 0.0 -18.089 26.2851 33.9071 0.0 0.0 0.0 -18.089 26.2851 34.9071 0.0 0.0 0.0 -19.089 24.2851 31.9071 0.022720396567073125 0.022720396567073125 0.022720396567073125 -19.089 24.2851 33.9071 0.0 0.0 0.0 -19.089 24.2851 34.9071 0.0 0.0 0.0 -19.089 25.2851 31.9071 0.0 0.0 0.0 -19.089 26.2851 31.9071 0.0 0.0 0.0 -20.089 25.2851 32.9071 0.015796721483853332 0.015796721483853332 0.015796721483853332 -20.089 26.2851 31.9071 0.0 0.0 0.0 -20.089 26.2851 32.9071 0.2659815367077161 0.2659815367077161 0.2659815367077161 -19.089 25.2851 33.9071 0.0 0.0 0.0 -19.089 25.2851 34.9071 0.0 0.0 0.0 -19.089 26.2851 33.9071 0.0 0.0 0.0 -19.089 26.2851 34.9071 0.0 0.0 0.0 -20.089 25.2851 33.9071 0.0 0.0 0.0 -20.089 26.2851 33.9071 0.0 0.0 0.0 -20.089 26.2851 34.9071 0.0 0.0 0.0 -21.089 19.2851 27.9071 0.18938774441484107 0.18938774441484107 0.18938774441484107 -21.089 19.2851 28.9071 0.0 0.0 0.0 -21.089 20.2851 27.9071 0.2409665688014582 0.2409665688014582 0.2409665688014582 -21.089 20.2851 28.9071 0.2033639965513664 0.2033639965513664 0.2033639965513664 -22.089 19.2851 27.9071 0.0 0.0 0.0 -22.089 19.2851 28.9071 0.0 0.0 0.0 -22.089 20.2851 27.9071 0.034238431174288465 0.034238431174288465 0.034238431174288465 -22.089 20.2851 28.9071 0.0 0.0 0.0 -21.089 19.2851 29.9071 0.0 0.0 0.0 -21.089 19.2851 30.9071 0.007614664667872998 0.007614664667872998 0.007614664667872998 -21.089 20.2851 29.9071 0.0 0.0 0.0 -21.089 20.2851 30.9071 0.007054095642566986 0.007054095642566986 0.007054095642566986 -22.089 19.2851 30.9071 0.0 0.0 0.0 -22.089 20.2851 29.9071 0.08864848545908201 0.08864848545908201 0.08864848545908201 -22.089 20.2851 30.9071 0.0 0.0 0.0 -21.089 21.2851 28.9071 0.0 0.0 0.0 -22.089 21.2851 28.9071 0.0 0.0 0.0 -22.089 22.2851 28.9071 0.02959893017690149 0.02959893017690149 0.02959893017690149 -21.089 21.2851 29.9071 0.0 0.0 0.0 -21.089 21.2851 30.9071 0.05632241862528658 0.05632241862528658 0.05632241862528658 -21.089 22.2851 30.9071 0.0026871131363788493 0.0026871131363788493 0.0026871131363788493 -22.089 21.2851 29.9071 0.0 0.0 0.0 -22.089 21.2851 30.9071 0.0 0.0 0.0 -22.089 22.2851 29.9071 0.0 0.0 0.0 -22.089 22.2851 30.9071 0.0 0.0 0.0 -23.089 19.2851 27.9071 0.0 0.0 0.0 -23.089 19.2851 28.9071 0.05816134058795983 0.05816134058795983 0.05816134058795983 -23.089 20.2851 27.9071 0.0 0.0 0.0 -23.089 20.2851 28.9071 0.0 0.0 0.0 -24.089 19.2851 27.9071 0.12875070610803283 0.12875070610803283 0.12875070610803283 -24.089 19.2851 28.9071 0.15918072927670207 0.15918072927670207 0.15918072927670207 -24.089 20.2851 27.9071 0.0 0.0 0.0 -23.089 20.2851 30.9071 0.0 0.0 0.0 -24.089 20.2851 30.9071 0.0 0.0 0.0 -23.089 21.2851 27.9071 0.0 0.0 0.0 -23.089 21.2851 28.9071 0.0 0.0 0.0 -23.089 22.2851 27.9071 0.0 0.0 0.0 -23.089 22.2851 28.9071 0.004153930049311903 0.004153930049311903 0.004153930049311903 -24.089 21.2851 27.9071 0.50423095836692 0.50423095836692 0.50423095836692 -24.089 21.2851 28.9071 0.5465828687833699 0.5465828687833699 0.5465828687833699 -24.089 22.2851 27.9071 0.01865490320444871 0.01865490320444871 0.01865490320444871 -24.089 22.2851 28.9071 0.5223273712980181 0.5223273712980181 0.5223273712980181 -23.089 21.2851 29.9071 0.0 0.0 0.0 -23.089 21.2851 30.9071 0.0 0.0 0.0 -23.089 22.2851 29.9071 0.0 0.0 0.0 -23.089 22.2851 30.9071 0.0 0.0 0.0 -24.089 21.2851 29.9071 0.5411073561687181 0.5411073561687181 0.5411073561687181 -24.089 21.2851 30.9071 0.33497345183272087 0.33497345183272087 0.33497345183272087 -24.089 22.2851 30.9071 0.0 0.0 0.0 -21.089 19.2851 31.9071 0.0 0.0 0.0 -21.089 19.2851 32.9071 0.0 0.0 0.0 -21.089 20.2851 32.9071 0.0 0.0 0.0 -22.089 19.2851 31.9071 0.0 0.0 0.0 -22.089 19.2851 32.9071 0.0 0.0 0.0 -22.089 20.2851 31.9071 0.0 0.0 0.0 -22.089 20.2851 32.9071 0.0 0.0 0.0 -21.089 21.2851 32.9071 0.0 0.0 0.0 -21.089 22.2851 31.9071 0.0 0.0 0.0 -21.089 22.2851 32.9071 0.0 0.0 0.0 -22.089 21.2851 32.9071 0.0 0.0 0.0 -22.089 22.2851 31.9071 0.0 0.0 0.0 -22.089 22.2851 32.9071 0.0 0.0 0.0 -21.089 22.2851 34.9071 0.015095115637108466 0.015095115637108466 0.015095115637108466 -22.089 22.2851 33.9071 0.0 0.0 0.0 -22.089 22.2851 34.9071 0.09297949214772304 0.09297949214772304 0.09297949214772304 -23.089 20.2851 31.9071 0.0 0.0 0.0 -23.089 20.2851 32.9071 0.0 0.0 0.0 -24.089 20.2851 31.9071 0.20179118252164005 0.20179118252164005 0.20179118252164005 -24.089 20.2851 32.9071 0.0 0.0 0.0 -23.089 21.2851 32.9071 0.0 0.0 0.0 -23.089 22.2851 31.9071 0.0 0.0 0.0 -23.089 22.2851 32.9071 0.09567242495817697 0.09567242495817697 0.09567242495817697 -24.089 21.2851 32.9071 0.0 0.0 0.0 -24.089 22.2851 31.9071 0.4442291415640532 0.4442291415640532 0.4442291415640532 -24.089 22.2851 32.9071 0.0 0.0 0.0 -23.089 21.2851 33.9071 0.0 0.0 0.0 -23.089 22.2851 33.9071 0.0 0.0 0.0 -23.089 22.2851 34.9071 0.10249015699503718 0.10249015699503718 0.10249015699503718 -24.089 22.2851 34.9071 0.0 0.0 0.0 -21.089 24.2851 27.9071 0.0 0.0 0.0 -22.089 23.2851 28.9071 0.03409864403345533 0.03409864403345533 0.03409864403345533 -21.089 23.2851 30.9071 0.0 0.0 0.0 -21.089 24.2851 30.9071 0.00014804680265276287 0.00014804680265276287 0.00014804680265276287 -22.089 23.2851 29.9071 0.0 0.0 0.0 -22.089 23.2851 30.9071 0.0 0.0 0.0 -22.089 24.2851 29.9071 0.035979835135159545 0.035979835135159545 0.035979835135159545 -22.089 24.2851 30.9071 0.0 0.0 0.0 -21.089 25.2851 27.9071 0.0 0.0 0.0 -21.089 25.2851 28.9071 0.0 0.0 0.0 -21.089 26.2851 27.9071 0.0 0.0 0.0 -21.089 26.2851 28.9071 0.0 0.0 0.0 -21.089 25.2851 29.9071 0.0025763987936701376 0.0025763987936701376 0.0025763987936701376 -21.089 25.2851 30.9071 0.0 0.0 0.0 -21.089 26.2851 30.9071 0.07338181692394251 0.07338181692394251 0.07338181692394251 -22.089 25.2851 29.9071 0.04706331700076193 0.04706331700076193 0.04706331700076193 -22.089 25.2851 30.9071 0.0 0.0 0.0 -22.089 26.2851 30.9071 0.003126360753140163 0.003126360753140163 0.003126360753140163 -23.089 23.2851 27.9071 0.0 0.0 0.0 -23.089 23.2851 28.9071 0.0 0.0 0.0 -23.089 24.2851 27.9071 0.0 0.0 0.0 -23.089 24.2851 28.9071 0.0 0.0 0.0 -24.089 23.2851 27.9071 0.27938044301993337 0.27938044301993337 0.27938044301993337 -24.089 23.2851 28.9071 0.0 0.0 0.0 -24.089 24.2851 27.9071 0.0 0.0 0.0 -24.089 24.2851 28.9071 0.2790659823916128 0.2790659823916128 0.2790659823916128 -23.089 23.2851 29.9071 0.0 0.0 0.0 -23.089 23.2851 30.9071 0.042103137131878805 0.042103137131878805 0.042103137131878805 -23.089 24.2851 29.9071 0.0 0.0 0.0 -24.089 23.2851 29.9071 0.5108466959670935 0.5108466959670935 0.5108466959670935 -24.089 23.2851 30.9071 0.0 0.0 0.0 -24.089 24.2851 29.9071 0.14407273542398405 0.14407273542398405 0.14407273542398405 -24.089 24.2851 30.9071 0.0 0.0 0.0 -23.089 25.2851 28.9071 0.0 0.0 0.0 -24.089 25.2851 27.9071 0.3820950416561325 0.3820950416561325 0.3820950416561325 -24.089 25.2851 28.9071 0.0 0.0 0.0 -24.089 26.2851 28.9071 0.0 0.0 0.0 -23.089 25.2851 29.9071 0.0 0.0 0.0 -23.089 25.2851 30.9071 0.0 0.0 0.0 -23.089 26.2851 29.9071 0.005280169952332267 0.005280169952332267 0.005280169952332267 -23.089 26.2851 30.9071 0.0 0.0 0.0 -24.089 25.2851 29.9071 0.13539232944822358 0.13539232944822358 0.13539232944822358 -24.089 25.2851 30.9071 0.0 0.0 0.0 -24.089 26.2851 29.9071 0.17130097142477638 0.17130097142477638 0.17130097142477638 -24.089 26.2851 30.9071 0.0 0.0 0.0 -21.089 24.2851 31.9071 0.0 0.0 0.0 -21.089 24.2851 32.9071 0.08857103889899155 0.08857103889899155 0.08857103889899155 -22.089 23.2851 31.9071 0.0 0.0 0.0 -22.089 24.2851 31.9071 0.03248131140236985 0.03248131140236985 0.03248131140236985 -22.089 24.2851 32.9071 0.05342067769315874 0.05342067769315874 0.05342067769315874 -21.089 23.2851 33.9071 0.18341765521169767 0.18341765521169767 0.18341765521169767 -21.089 23.2851 34.9071 0.0 0.0 0.0 -21.089 24.2851 33.9071 0.0 0.0 0.0 -21.089 24.2851 34.9071 0.06503611590215655 0.06503611590215655 0.06503611590215655 -22.089 23.2851 33.9071 0.0 0.0 0.0 -22.089 23.2851 34.9071 0.0 0.0 0.0 -22.089 24.2851 33.9071 0.0 0.0 0.0 -22.089 24.2851 34.9071 0.0 0.0 0.0 -21.089 25.2851 31.9071 0.2670780021795454 0.2670780021795454 0.2670780021795454 -21.089 25.2851 32.9071 0.0 0.0 0.0 -21.089 26.2851 31.9071 0.0 0.0 0.0 -21.089 26.2851 32.9071 0.3794403546549367 0.3794403546549367 0.3794403546549367 -22.089 25.2851 31.9071 0.0 0.0 0.0 -22.089 25.2851 32.9071 0.2735861692884421 0.2735861692884421 0.2735861692884421 -22.089 26.2851 31.9071 0.0 0.0 0.0 -21.089 25.2851 33.9071 0.07663045221338757 0.07663045221338757 0.07663045221338757 -21.089 25.2851 34.9071 0.0 0.0 0.0 -21.089 26.2851 33.9071 0.01577070692627117 0.01577070692627117 0.01577070692627117 -21.089 26.2851 34.9071 0.0 0.0 0.0 -22.089 25.2851 34.9071 0.0 0.0 0.0 -22.089 26.2851 34.9071 0.0 0.0 0.0 -23.089 23.2851 31.9071 0.02385688956546973 0.02385688956546973 0.02385688956546973 -23.089 23.2851 32.9071 0.0 0.0 0.0 -23.089 24.2851 31.9071 0.0 0.0 0.0 -23.089 24.2851 32.9071 0.10086019888612781 0.10086019888612781 0.10086019888612781 -24.089 23.2851 31.9071 0.09870340626846826 0.09870340626846826 0.09870340626846826 -24.089 23.2851 32.9071 0.0 0.0 0.0 -24.089 24.2851 31.9071 0.1953510349272687 0.1953510349272687 0.1953510349272687 -24.089 24.2851 32.9071 0.0 0.0 0.0 -23.089 23.2851 33.9071 0.0 0.0 0.0 -23.089 23.2851 34.9071 0.38199144415161396 0.38199144415161396 0.38199144415161396 -23.089 24.2851 33.9071 0.0 0.0 0.0 -23.089 24.2851 34.9071 0.0 0.0 0.0 -24.089 23.2851 33.9071 0.0 0.0 0.0 -24.089 23.2851 34.9071 0.0 0.0 0.0 -24.089 24.2851 33.9071 0.21622376490176018 0.21622376490176018 0.21622376490176018 -24.089 24.2851 34.9071 0.07033838053590219 0.07033838053590219 0.07033838053590219 -23.089 25.2851 31.9071 0.0 0.0 0.0 -23.089 25.2851 32.9071 0.22461166918231334 0.22461166918231334 0.22461166918231334 -23.089 26.2851 31.9071 0.1369960555332342 0.1369960555332342 0.1369960555332342 -23.089 26.2851 32.9071 0.28554615484237134 0.28554615484237134 0.28554615484237134 -24.089 25.2851 31.9071 0.7172719845456413 0.7172719845456413 0.7172719845456413 -24.089 25.2851 32.9071 0.9328671368385179 0.9328671368385179 0.9328671368385179 -24.089 26.2851 31.9071 0.0 0.0 0.0 -24.089 26.2851 32.9071 0.641892279217469 0.641892279217469 0.641892279217469 -23.089 25.2851 33.9071 0.0 0.0 0.0 -23.089 25.2851 34.9071 0.0 0.0 0.0 -23.089 26.2851 33.9071 0.1761533531747509 0.1761533531747509 0.1761533531747509 -23.089 26.2851 34.9071 0.4495070829843728 0.4495070829843728 0.4495070829843728 -24.089 25.2851 33.9071 0.0 0.0 0.0 -24.089 25.2851 34.9071 0.5873143059141909 0.5873143059141909 0.5873143059141909 -24.089 26.2851 33.9071 0.18356572950280517 0.18356572950280517 0.18356572950280517 -17.089 23.2851 35.9071 0.03093935180419556 0.03093935180419556 0.03093935180419556 -17.089 24.2851 35.9071 0.0 0.0 0.0 -18.089 24.2851 35.9071 0.0 0.0 0.0 -17.089 25.2851 35.9071 0.0 0.0 0.0 -17.089 26.2851 35.9071 0.0 0.0 0.0 -18.089 25.2851 35.9071 0.0 0.0 0.0 -18.089 26.2851 35.9071 0.0 0.0 0.0 -19.089 26.2851 35.9071 0.0 0.0 0.0 -19.089 26.2851 36.9071 0.0 0.0 0.0 -20.089 26.2851 35.9071 0.0 0.0 0.0 -20.089 26.2851 36.9071 0.0 0.0 0.0 -21.089 22.2851 35.9071 0.0 0.0 0.0 -22.089 22.2851 35.9071 0.18783974188750388 0.18783974188750388 0.18783974188750388 -22.089 22.2851 36.9071 0.33164268383721457 0.33164268383721457 0.33164268383721457 -22.089 22.2851 37.9071 0.04338465346556407 0.04338465346556407 0.04338465346556407 -23.089 22.2851 35.9071 0.21731904494703747 0.21731904494703747 0.21731904494703747 -23.089 22.2851 36.9071 0.31227319622885213 0.31227319622885213 0.31227319622885213 -24.089 21.2851 35.9071 0.0 0.0 0.0 -24.089 21.2851 36.9071 0.0 0.0 0.0 -24.089 22.2851 35.9071 0.13983420058831897 0.13983420058831897 0.13983420058831897 -24.089 22.2851 36.9071 0.0 0.0 0.0 -23.089 22.2851 37.9071 0.015891889552278167 0.015891889552278167 0.015891889552278167 -24.089 22.2851 37.9071 0.0 0.0 0.0 -21.089 23.2851 35.9071 0.15020565877630201 0.15020565877630201 0.15020565877630201 -21.089 23.2851 36.9071 0.22503046537042354 0.22503046537042354 0.22503046537042354 -21.089 24.2851 35.9071 0.008880341446452054 0.008880341446452054 0.008880341446452054 -21.089 24.2851 36.9071 0.0 0.0 0.0 -22.089 23.2851 35.9071 0.05213391071572206 0.05213391071572206 0.05213391071572206 -22.089 23.2851 36.9071 0.0 0.0 0.0 -22.089 24.2851 35.9071 0.11655085549858962 0.11655085549858962 0.11655085549858962 -22.089 24.2851 36.9071 0.2714605419225405 0.2714605419225405 0.2714605419225405 -21.089 23.2851 37.9071 0.0 0.0 0.0 -21.089 24.2851 37.9071 0.0 0.0 0.0 -22.089 23.2851 37.9071 0.0 0.0 0.0 -22.089 23.2851 38.9071 0.0 0.0 0.0 -22.089 24.2851 37.9071 0.0 0.0 0.0 -22.089 24.2851 38.9071 0.033154256480790636 0.033154256480790636 0.033154256480790636 -21.089 25.2851 35.9071 0.0 0.0 0.0 -21.089 25.2851 36.9071 0.178302946560136 0.178302946560136 0.178302946560136 -21.089 26.2851 35.9071 0.0 0.0 0.0 -21.089 26.2851 36.9071 0.0 0.0 0.0 -22.089 25.2851 35.9071 0.0 0.0 0.0 -22.089 25.2851 36.9071 0.3196625510314497 0.3196625510314497 0.3196625510314497 -22.089 26.2851 35.9071 0.0 0.0 0.0 -21.089 25.2851 37.9071 0.0 0.0 0.0 -22.089 25.2851 37.9071 0.0 0.0 0.0 -22.089 25.2851 38.9071 0.20743394706347 0.20743394706347 0.20743394706347 -24.089 23.2851 36.9071 0.0 0.0 0.0 -23.089 23.2851 37.9071 0.0 0.0 0.0 -23.089 23.2851 38.9071 0.0 0.0 0.0 -23.089 24.2851 38.9071 0.0 0.0 0.0 -24.089 23.2851 37.9071 0.0 0.0 0.0 -24.089 23.2851 38.9071 0.0 0.0 0.0 -24.089 24.2851 37.9071 0.18460356227824706 0.18460356227824706 0.18460356227824706 -24.089 24.2851 38.9071 0.12791847697956124 0.12791847697956124 0.12791847697956124 -23.089 25.2851 35.9071 0.0 0.0 0.0 -23.089 25.2851 36.9071 0.0 0.0 0.0 -23.089 26.2851 35.9071 0.0 0.0 0.0 -23.089 26.2851 36.9071 0.0 0.0 0.0 -24.089 25.2851 35.9071 0.0 0.0 0.0 -24.089 25.2851 36.9071 0.0 0.0 0.0 -24.089 26.2851 35.9071 0.3090999094457085 0.3090999094457085 0.3090999094457085 -24.089 26.2851 36.9071 0.0 0.0 0.0 -23.089 25.2851 37.9071 0.32198162948396036 0.32198162948396036 0.32198162948396036 -23.089 25.2851 38.9071 0.2496105022376782 0.2496105022376782 0.2496105022376782 -23.089 26.2851 37.9071 0.0 0.0 0.0 -24.089 25.2851 37.9071 0.1927742031502657 0.1927742031502657 0.1927742031502657 -24.089 25.2851 38.9071 0.0 0.0 0.0 -24.089 26.2851 37.9071 0.0 0.0 0.0 -8.088999999999999 28.2851 22.9071 0.03795575412804935 0.03795575412804935 0.03795575412804935 -8.088999999999999 29.2851 21.9071 0.13414955430246867 0.13414955430246867 0.13414955430246867 -8.088999999999999 29.2851 22.9071 0.15903133532359187 0.15903133532359187 0.15903133532359187 -8.088999999999999 30.2851 21.9071 0.0 0.0 0.0 -8.088999999999999 30.2851 22.9071 0.27446721367151633 0.27446721367151633 0.27446721367151633 -8.088999999999999 28.2851 23.9071 0.0 0.0 0.0 -8.088999999999999 28.2851 24.9071 0.0 0.0 0.0 -8.088999999999999 29.2851 23.9071 0.03574972941016081 0.03574972941016081 0.03574972941016081 -8.088999999999999 29.2851 24.9071 0.0 0.0 0.0 -8.088999999999999 30.2851 23.9071 0.0 0.0 0.0 -8.088999999999999 30.2851 24.9071 0.0 0.0 0.0 -8.088999999999999 31.2851 21.9071 0.0 0.0 0.0 -8.088999999999999 31.2851 22.9071 0.023368141294362918 0.023368141294362918 0.023368141294362918 -8.088999999999999 31.2851 23.9071 0.053148380739890734 0.053148380739890734 0.053148380739890734 -14.088999999999999 28.2851 18.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 17.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 18.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 17.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 18.9071 0.0 0.0 0.0 -16.089 28.2851 15.9071 0.0022251319056004206 0.0022251319056004206 0.0022251319056004206 -16.089 28.2851 16.9071 0.0 0.0 0.0 -15.088999999999999 27.2851 18.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 17.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 18.9071 0.0 0.0 0.0 -16.089 27.2851 17.9071 0.0 0.0 0.0 -16.089 27.2851 18.9071 0.0 0.0 0.0 -16.089 28.2851 17.9071 0.03948175809959223 0.03948175809959223 0.03948175809959223 -16.089 28.2851 18.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 16.9071 0.0 0.0 0.0 -15.088999999999999 30.2851 16.9071 0.03428404874019046 0.03428404874019046 0.03428404874019046 -16.089 29.2851 15.9071 0.0 0.0 0.0 -16.089 29.2851 16.9071 0.0 0.0 0.0 -16.089 30.2851 15.9071 0.0 0.0 0.0 -16.089 30.2851 16.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 17.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 18.9071 0.0 0.0 0.0 -15.088999999999999 30.2851 17.9071 0.0 0.0 0.0 -16.089 30.2851 17.9071 0.0 0.0 0.0 -14.088999999999999 31.2851 18.9071 0.0 0.0 0.0 -16.089 31.2851 16.9071 0.0 0.0 0.0 -15.088999999999999 31.2851 17.9071 0.08513448587764974 0.08513448587764974 0.08513448587764974 -15.088999999999999 31.2851 18.9071 0.0 0.0 0.0 -16.089 31.2851 17.9071 0.0 0.0 0.0 -16.089 31.2851 18.9071 0.014775119969558683 0.014775119969558683 0.014775119969558683 -10.088999999999999 28.2851 20.9071 0.2269658062514978 0.2269658062514978 0.2269658062514978 -9.088999999999999 28.2851 21.9071 0.04547192987829872 0.04547192987829872 0.04547192987829872 -9.088999999999999 28.2851 22.9071 0.0 0.0 0.0 -10.088999999999999 27.2851 22.9071 0.0 0.0 0.0 -10.088999999999999 28.2851 21.9071 0.008224691065997693 0.008224691065997693 0.008224691065997693 -10.088999999999999 28.2851 22.9071 0.075073675057433 0.075073675057433 0.075073675057433 -9.088999999999999 29.2851 20.9071 0.0 0.0 0.0 -9.088999999999999 30.2851 20.9071 0.0 0.0 0.0 -10.088999999999999 29.2851 19.9071 0.0 0.0 0.0 -10.088999999999999 29.2851 20.9071 0.0 0.0 0.0 -10.088999999999999 30.2851 19.9071 0.5157881146236383 0.5157881146236383 0.5157881146236383 -10.088999999999999 30.2851 20.9071 0.3578762836072504 0.3578762836072504 0.3578762836072504 -9.088999999999999 29.2851 21.9071 0.0 0.0 0.0 -9.088999999999999 29.2851 22.9071 0.0 0.0 0.0 -9.088999999999999 30.2851 21.9071 0.04686390700841195 0.04686390700841195 0.04686390700841195 -10.088999999999999 29.2851 21.9071 0.0 0.0 0.0 -11.088999999999999 28.2851 20.9071 0.0 0.0 0.0 -12.088999999999999 27.2851 20.9071 0.004123939851371671 0.004123939851371671 0.004123939851371671 -12.088999999999999 28.2851 20.9071 0.058902602626083024 0.058902602626083024 0.058902602626083024 -11.088999999999999 27.2851 21.9071 0.0 0.0 0.0 -11.088999999999999 27.2851 22.9071 0.0 0.0 0.0 -11.088999999999999 28.2851 21.9071 0.05362551693957263 0.05362551693957263 0.05362551693957263 -11.088999999999999 28.2851 22.9071 0.05952783487742967 0.05952783487742967 0.05952783487742967 -12.088999999999999 27.2851 21.9071 0.0 0.0 0.0 -12.088999999999999 27.2851 22.9071 0.0 0.0 0.0 -12.088999999999999 28.2851 21.9071 0.0 0.0 0.0 -11.088999999999999 29.2851 19.9071 0.0 0.0 0.0 -11.088999999999999 29.2851 20.9071 0.15964275916393664 0.15964275916393664 0.15964275916393664 -11.088999999999999 30.2851 19.9071 0.0 0.0 0.0 -11.088999999999999 30.2851 20.9071 0.0 0.0 0.0 -12.088999999999999 29.2851 19.9071 0.012153107157055386 0.012153107157055386 0.012153107157055386 -12.088999999999999 29.2851 20.9071 0.18850199363867098 0.18850199363867098 0.18850199363867098 -12.088999999999999 30.2851 19.9071 0.06201727976209947 0.06201727976209947 0.06201727976209947 -12.088999999999999 30.2851 20.9071 0.0 0.0 0.0 -11.088999999999999 30.2851 22.9071 0.07969547767878205 0.07969547767878205 0.07969547767878205 -12.088999999999999 30.2851 22.9071 0.09246351202327538 0.09246351202327538 0.09246351202327538 -9.088999999999999 27.2851 23.9071 0.0 0.0 0.0 -9.088999999999999 27.2851 24.9071 0.0 0.0 0.0 -9.088999999999999 28.2851 23.9071 0.10904163520056291 0.10904163520056291 0.10904163520056291 -9.088999999999999 28.2851 24.9071 0.0502932514614633 0.0502932514614633 0.0502932514614633 -10.088999999999999 27.2851 23.9071 0.0 0.0 0.0 -10.088999999999999 27.2851 24.9071 0.0 0.0 0.0 -10.088999999999999 28.2851 24.9071 0.017193053416236927 0.017193053416236927 0.017193053416236927 -9.088999999999999 28.2851 25.9071 0.0 0.0 0.0 -10.088999999999999 27.2851 25.9071 0.0 0.0 0.0 -10.088999999999999 28.2851 25.9071 0.0 0.0 0.0 -9.088999999999999 29.2851 24.9071 0.037786973307437265 0.037786973307437265 0.037786973307437265 -9.088999999999999 30.2851 23.9071 0.0072691022556166125 0.0072691022556166125 0.0072691022556166125 -9.088999999999999 30.2851 24.9071 0.0 0.0 0.0 -10.088999999999999 30.2851 24.9071 0.02261187314910651 0.02261187314910651 0.02261187314910651 -9.088999999999999 29.2851 25.9071 0.03059122909822513 0.03059122909822513 0.03059122909822513 -9.088999999999999 30.2851 25.9071 0.0 0.0 0.0 -10.088999999999999 29.2851 25.9071 0.0 0.0 0.0 -10.088999999999999 30.2851 25.9071 0.0 0.0 0.0 -11.088999999999999 27.2851 23.9071 0.0 0.0 0.0 -11.088999999999999 27.2851 24.9071 0.0 0.0 0.0 -12.088999999999999 27.2851 23.9071 0.18485182062548486 0.18485182062548486 0.18485182062548486 -12.088999999999999 27.2851 24.9071 0.0 0.0 0.0 -12.088999999999999 28.2851 24.9071 0.0 0.0 0.0 -11.088999999999999 27.2851 25.9071 0.0 0.0 0.0 -11.088999999999999 28.2851 25.9071 0.0 0.0 0.0 -12.088999999999999 27.2851 25.9071 0.0 0.0 0.0 -12.088999999999999 28.2851 25.9071 0.0 0.0 0.0 -11.088999999999999 30.2851 23.9071 0.10860674088407768 0.10860674088407768 0.10860674088407768 -11.088999999999999 30.2851 24.9071 0.008540798848874792 0.008540798848874792 0.008540798848874792 -12.088999999999999 29.2851 23.9071 0.0 0.0 0.0 -12.088999999999999 29.2851 24.9071 0.0 0.0 0.0 -12.088999999999999 30.2851 23.9071 0.024953279470638575 0.024953279470638575 0.024953279470638575 -12.088999999999999 30.2851 24.9071 0.0 0.0 0.0 -11.088999999999999 29.2851 25.9071 0.0 0.0 0.0 -11.088999999999999 30.2851 25.9071 0.0 0.0 0.0 -12.088999999999999 29.2851 25.9071 0.0 0.0 0.0 -9.088999999999999 31.2851 20.9071 0.5568311588537375 0.5568311588537375 0.5568311588537375 -10.088999999999999 31.2851 19.9071 0.3501197304809968 0.3501197304809968 0.3501197304809968 -10.088999999999999 31.2851 20.9071 0.03463600297042906 0.03463600297042906 0.03463600297042906 -9.088999999999999 31.2851 21.9071 0.0 0.0 0.0 -9.088999999999999 31.2851 22.9071 0.0 0.0 0.0 -9.088999999999999 32.2851 22.9071 0.0 0.0 0.0 -10.088999999999999 31.2851 21.9071 0.0 0.0 0.0 -10.088999999999999 31.2851 22.9071 0.1008134678070207 0.1008134678070207 0.1008134678070207 -10.088999999999999 32.2851 21.9071 0.0 0.0 0.0 -10.088999999999999 32.2851 22.9071 0.0 0.0 0.0 -11.088999999999999 31.2851 19.9071 0.2877424215934664 0.2877424215934664 0.2877424215934664 -11.088999999999999 31.2851 20.9071 0.0 0.0 0.0 -12.088999999999999 31.2851 20.9071 0.06120076479323568 0.06120076479323568 0.06120076479323568 -11.088999999999999 31.2851 21.9071 0.0 0.0 0.0 -11.088999999999999 31.2851 22.9071 0.31843402305414475 0.31843402305414475 0.31843402305414475 -11.088999999999999 32.2851 21.9071 0.0 0.0 0.0 -12.088999999999999 31.2851 21.9071 0.17726323303377706 0.17726323303377706 0.17726323303377706 -12.088999999999999 31.2851 22.9071 0.0 0.0 0.0 -9.088999999999999 31.2851 23.9071 0.0030178932548994494 0.0030178932548994494 0.0030178932548994494 -9.088999999999999 31.2851 24.9071 0.0 0.0 0.0 -10.088999999999999 31.2851 23.9071 0.32945666420457764 0.32945666420457764 0.32945666420457764 -10.088999999999999 31.2851 24.9071 0.0 0.0 0.0 -11.088999999999999 31.2851 23.9071 0.12641727244125525 0.12641727244125525 0.12641727244125525 -11.088999999999999 31.2851 24.9071 0.023550879372992804 0.023550879372992804 0.023550879372992804 -13.088999999999999 27.2851 20.9071 0.0 0.0 0.0 -13.088999999999999 28.2851 20.9071 0.17255911693436796 0.17255911693436796 0.17255911693436796 -14.088999999999999 27.2851 19.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 20.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 19.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 20.9071 0.0 0.0 0.0 -13.088999999999999 27.2851 21.9071 0.0 0.0 0.0 -13.088999999999999 28.2851 21.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 21.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 22.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 21.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 22.9071 0.07400311186139935 0.07400311186139935 0.07400311186139935 -13.088999999999999 29.2851 20.9071 0.22336657799524945 0.22336657799524945 0.22336657799524945 -13.088999999999999 30.2851 20.9071 0.16436152083565977 0.16436152083565977 0.16436152083565977 -14.088999999999999 29.2851 19.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 20.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 19.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 20.9071 0.14942363395556113 0.14942363395556113 0.14942363395556113 -13.088999999999999 29.2851 21.9071 0.0 0.0 0.0 -13.088999999999999 29.2851 22.9071 0.0 0.0 0.0 -13.088999999999999 30.2851 21.9071 0.0 0.0 0.0 -13.088999999999999 30.2851 22.9071 0.04484099593615938 0.04484099593615938 0.04484099593615938 -14.088999999999999 29.2851 21.9071 0.021286571509471656 0.021286571509471656 0.021286571509471656 -14.088999999999999 29.2851 22.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 22.9071 0.0 0.0 0.0 -15.088999999999999 27.2851 19.9071 0.0 0.0 0.0 -15.088999999999999 27.2851 20.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 19.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 20.9071 0.0 0.0 0.0 -16.089 27.2851 19.9071 0.007256561369981765 0.007256561369981765 0.007256561369981765 -16.089 28.2851 19.9071 0.0 0.0 0.0 -16.089 28.2851 20.9071 0.0 0.0 0.0 -15.088999999999999 27.2851 21.9071 0.25697147674626486 0.25697147674626486 0.25697147674626486 -15.088999999999999 27.2851 22.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 21.9071 0.05977441034874346 0.05977441034874346 0.05977441034874346 -15.088999999999999 28.2851 22.9071 0.0 0.0 0.0 -16.089 27.2851 21.9071 0.0661472437621607 0.0661472437621607 0.0661472437621607 -16.089 27.2851 22.9071 0.04797529359103615 0.04797529359103615 0.04797529359103615 -16.089 28.2851 21.9071 0.0 0.0 0.0 -16.089 28.2851 22.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 20.9071 0.0 0.0 0.0 -15.088999999999999 30.2851 20.9071 0.0 0.0 0.0 -16.089 29.2851 20.9071 0.0 0.0 0.0 -16.089 30.2851 20.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 22.9071 0.0 0.0 0.0 -15.088999999999999 30.2851 22.9071 0.0 0.0 0.0 -16.089 29.2851 21.9071 0.05997684777452892 0.05997684777452892 0.05997684777452892 -16.089 29.2851 22.9071 0.0 0.0 0.0 -16.089 30.2851 22.9071 0.0 0.0 0.0 -13.088999999999999 27.2851 24.9071 0.0 0.0 0.0 -13.088999999999999 28.2851 24.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 23.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 24.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 23.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 24.9071 0.0 0.0 0.0 -13.088999999999999 27.2851 25.9071 0.0 0.0 0.0 -13.088999999999999 27.2851 26.9071 0.0 0.0 0.0 -13.088999999999999 28.2851 25.9071 0.0 0.0 0.0 -13.088999999999999 28.2851 26.9071 0.018102517896694932 0.018102517896694932 0.018102517896694932 -14.088999999999999 27.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 26.9071 0.02846719860117305 0.02846719860117305 0.02846719860117305 -13.088999999999999 29.2851 23.9071 0.0 0.0 0.0 -13.088999999999999 29.2851 24.9071 0.0 0.0 0.0 -13.088999999999999 30.2851 23.9071 0.08779036143706712 0.08779036143706712 0.08779036143706712 -13.088999999999999 30.2851 24.9071 0.01854584965032891 0.01854584965032891 0.01854584965032891 -14.088999999999999 29.2851 23.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 24.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 23.9071 0.1757433278048512 0.1757433278048512 0.1757433278048512 -14.088999999999999 30.2851 24.9071 0.0 0.0 0.0 -13.088999999999999 29.2851 26.9071 0.0 0.0 0.0 -13.088999999999999 30.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 26.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 26.9071 0.0 0.0 0.0 -15.088999999999999 27.2851 23.9071 0.07825175640211918 0.07825175640211918 0.07825175640211918 -15.088999999999999 27.2851 24.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 23.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 24.9071 0.0 0.0 0.0 -16.089 27.2851 23.9071 0.01700556784805427 0.01700556784805427 0.01700556784805427 -16.089 27.2851 24.9071 0.0 0.0 0.0 -16.089 28.2851 23.9071 0.0 0.0 0.0 -16.089 28.2851 24.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 25.9071 0.0 0.0 0.0 -16.089 27.2851 25.9071 0.0 0.0 0.0 -16.089 27.2851 26.9071 0.0 0.0 0.0 -16.089 28.2851 25.9071 0.011059241756617967 0.011059241756617967 0.011059241756617967 -16.089 28.2851 26.9071 0.04332656371368061 0.04332656371368061 0.04332656371368061 -15.088999999999999 29.2851 23.9071 0.016092086032872908 0.016092086032872908 0.016092086032872908 -15.088999999999999 29.2851 24.9071 0.0 0.0 0.0 -15.088999999999999 30.2851 23.9071 0.04400046022354619 0.04400046022354619 0.04400046022354619 -16.089 29.2851 23.9071 0.5976502539755721 0.5976502539755721 0.5976502539755721 -16.089 29.2851 24.9071 0.04688611928946411 0.04688611928946411 0.04688611928946411 -16.089 30.2851 23.9071 0.0 0.0 0.0 -16.089 30.2851 24.9071 0.14296951438401753 0.14296951438401753 0.14296951438401753 -15.088999999999999 29.2851 25.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 26.9071 0.0 0.0 0.0 -15.088999999999999 30.2851 25.9071 0.0 0.0 0.0 -15.088999999999999 30.2851 26.9071 0.0 0.0 0.0 -16.089 29.2851 25.9071 0.032542267595284405 0.032542267595284405 0.032542267595284405 -16.089 30.2851 25.9071 0.0 0.0 0.0 -16.089 30.2851 26.9071 0.02288366560040065 0.02288366560040065 0.02288366560040065 -14.088999999999999 31.2851 19.9071 0.23108828494171085 0.23108828494171085 0.23108828494171085 -14.088999999999999 31.2851 20.9071 0.0 0.0 0.0 -13.088999999999999 31.2851 21.9071 0.0 0.0 0.0 -13.088999999999999 31.2851 22.9071 0.10490969356781879 0.10490969356781879 0.10490969356781879 -14.088999999999999 31.2851 22.9071 0.0 0.0 0.0 -14.088999999999999 32.2851 22.9071 0.0 0.0 0.0 -15.088999999999999 31.2851 19.9071 0.2071947238771051 0.2071947238771051 0.2071947238771051 -15.088999999999999 31.2851 20.9071 0.009195229087115578 0.009195229087115578 0.009195229087115578 -15.088999999999999 32.2851 20.9071 0.016161501478828246 0.016161501478828246 0.016161501478828246 -16.089 31.2851 19.9071 0.00019802826560894426 0.00019802826560894426 0.00019802826560894426 -16.089 31.2851 20.9071 0.0 0.0 0.0 -16.089 32.2851 20.9071 0.0 0.0 0.0 -15.088999999999999 31.2851 21.9071 0.07584028953841707 0.07584028953841707 0.07584028953841707 -15.088999999999999 31.2851 22.9071 0.3012115495872711 0.3012115495872711 0.3012115495872711 -15.088999999999999 32.2851 21.9071 0.09749530957685708 0.09749530957685708 0.09749530957685708 -15.088999999999999 32.2851 22.9071 0.16540488541041004 0.16540488541041004 0.16540488541041004 -16.089 31.2851 21.9071 0.006560153212535838 0.006560153212535838 0.006560153212535838 -16.089 31.2851 22.9071 0.11880437240844835 0.11880437240844835 0.11880437240844835 -16.089 32.2851 21.9071 0.0 0.0 0.0 -15.088999999999999 33.2851 20.9071 0.0 0.0 0.0 -16.089 33.2851 20.9071 0.0 0.0 0.0 -15.088999999999999 33.2851 21.9071 0.06809018271036632 0.06809018271036632 0.06809018271036632 -15.088999999999999 33.2851 22.9071 0.0 0.0 0.0 -15.088999999999999 34.2851 21.9071 0.048239696558856265 0.048239696558856265 0.048239696558856265 -15.088999999999999 34.2851 22.9071 0.0 0.0 0.0 -16.089 33.2851 21.9071 0.0026846958705534375 0.0026846958705534375 0.0026846958705534375 -16.089 34.2851 21.9071 0.0 0.0 0.0 -16.089 34.2851 22.9071 0.28172476319733125 0.28172476319733125 0.28172476319733125 -13.088999999999999 31.2851 23.9071 0.05917001983606709 0.05917001983606709 0.05917001983606709 -13.088999999999999 31.2851 24.9071 0.0 0.0 0.0 -13.088999999999999 32.2851 23.9071 0.0 0.0 0.0 -13.088999999999999 32.2851 24.9071 0.0 0.0 0.0 -14.088999999999999 31.2851 23.9071 0.008331208435556597 0.008331208435556597 0.008331208435556597 -14.088999999999999 32.2851 23.9071 0.02354829407686975 0.02354829407686975 0.02354829407686975 -14.088999999999999 32.2851 24.9071 0.6525298234547352 0.6525298234547352 0.6525298234547352 -13.088999999999999 31.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 31.2851 25.9071 0.0 0.0 0.0 -14.088999999999999 32.2851 25.9071 0.7165343939504332 0.7165343939504332 0.7165343939504332 -15.088999999999999 32.2851 23.9071 0.0 0.0 0.0 -15.088999999999999 32.2851 24.9071 0.5905434140702971 0.5905434140702971 0.5905434140702971 -16.089 31.2851 23.9071 0.0 0.0 0.0 -15.088999999999999 31.2851 25.9071 0.03025762772551239 0.03025762772551239 0.03025762772551239 -15.088999999999999 31.2851 26.9071 0.0 0.0 0.0 -15.088999999999999 32.2851 25.9071 0.6077642716952351 0.6077642716952351 0.6077642716952351 -15.088999999999999 32.2851 26.9071 0.5561637749424813 0.5561637749424813 0.5561637749424813 -16.089 31.2851 26.9071 0.0 0.0 0.0 -16.089 32.2851 25.9071 0.0 0.0 0.0 -16.089 32.2851 26.9071 0.5711260872150417 0.5711260872150417 0.5711260872150417 -15.088999999999999 33.2851 23.9071 0.1349894799505249 0.1349894799505249 0.1349894799505249 -15.088999999999999 33.2851 24.9071 0.0 0.0 0.0 -15.088999999999999 34.2851 23.9071 0.0 0.0 0.0 -15.088999999999999 34.2851 24.9071 0.7427716740911879 0.7427716740911879 0.7427716740911879 -16.089 34.2851 23.9071 0.0 0.0 0.0 -16.089 34.2851 24.9071 0.0 0.0 0.0 -15.088999999999999 33.2851 25.9071 0.0 0.0 0.0 -15.088999999999999 33.2851 26.9071 0.0 0.0 0.0 -15.088999999999999 34.2851 25.9071 0.0 0.0 0.0 -15.088999999999999 34.2851 26.9071 0.6525720777296284 0.6525720777296284 0.6525720777296284 -16.089 33.2851 25.9071 0.0 0.0 0.0 -16.089 33.2851 26.9071 0.0 0.0 0.0 -16.089 34.2851 25.9071 0.2520916713416026 0.2520916713416026 0.2520916713416026 -16.089 34.2851 26.9071 0.0 0.0 0.0 -16.089 35.2851 24.9071 0.0 0.0 0.0 -16.089 35.2851 25.9071 0.0 0.0 0.0 -16.089 35.2851 26.9071 0.19685811814858645 0.19685811814858645 0.19685811814858645 -20.089 27.2851 14.9071 0.0 0.0 0.0 -19.089 30.2851 14.9071 0.0 0.0 0.0 -20.089 30.2851 14.9071 0.0 0.0 0.0 -17.089 28.2851 15.9071 0.0 0.0 0.0 -17.089 28.2851 16.9071 0.0 0.0 0.0 -18.089 27.2851 16.9071 0.0 0.0 0.0 -18.089 28.2851 15.9071 0.0 0.0 0.0 -18.089 28.2851 16.9071 0.0 0.0 0.0 -17.089 27.2851 17.9071 0.0 0.0 0.0 -17.089 27.2851 18.9071 0.0 0.0 0.0 -17.089 28.2851 17.9071 0.0 0.0 0.0 -17.089 28.2851 18.9071 0.0 0.0 0.0 -18.089 27.2851 17.9071 0.0 0.0 0.0 -18.089 27.2851 18.9071 0.015393966781544248 0.015393966781544248 0.015393966781544248 -18.089 28.2851 17.9071 0.0 0.0 0.0 -18.089 28.2851 18.9071 0.0 0.0 0.0 -17.089 29.2851 15.9071 0.0 0.0 0.0 -17.089 30.2851 15.9071 0.0 0.0 0.0 -17.089 30.2851 16.9071 0.0 0.0 0.0 -18.089 29.2851 15.9071 0.0 0.0 0.0 -18.089 29.2851 16.9071 0.0 0.0 0.0 -18.089 30.2851 15.9071 0.0 0.0 0.0 -18.089 30.2851 16.9071 0.0 0.0 0.0 -17.089 30.2851 18.9071 0.01086306654837835 0.01086306654837835 0.01086306654837835 -18.089 29.2851 17.9071 0.0 0.0 0.0 -18.089 29.2851 18.9071 0.0 0.0 0.0 -18.089 30.2851 17.9071 0.0 0.0 0.0 -18.089 30.2851 18.9071 0.0 0.0 0.0 -19.089 27.2851 15.9071 0.0 0.0 0.0 -19.089 27.2851 16.9071 0.0 0.0 0.0 -19.089 28.2851 16.9071 0.0 0.0 0.0 -20.089 27.2851 15.9071 0.0 0.0 0.0 -20.089 27.2851 16.9071 0.0 0.0 0.0 -20.089 28.2851 16.9071 0.0 0.0 0.0 -19.089 27.2851 17.9071 0.0 0.0 0.0 -19.089 27.2851 18.9071 0.0 0.0 0.0 -19.089 28.2851 17.9071 0.0 0.0 0.0 -19.089 28.2851 18.9071 0.0 0.0 0.0 -20.089 27.2851 18.9071 0.00862553534776534 0.00862553534776534 0.00862553534776534 -20.089 28.2851 17.9071 0.0 0.0 0.0 -20.089 28.2851 18.9071 0.018879522789946913 0.018879522789946913 0.018879522789946913 -19.089 29.2851 15.9071 0.0 0.0 0.0 -19.089 29.2851 16.9071 0.0 0.0 0.0 -19.089 30.2851 15.9071 0.0 0.0 0.0 -19.089 30.2851 16.9071 0.0 0.0 0.0 -20.089 29.2851 15.9071 0.0 0.0 0.0 -20.089 29.2851 16.9071 0.0 0.0 0.0 -20.089 30.2851 15.9071 0.014540654396109116 0.014540654396109116 0.014540654396109116 -19.089 29.2851 17.9071 0.0 0.0 0.0 -19.089 29.2851 18.9071 0.0 0.0 0.0 -19.089 30.2851 17.9071 0.0 0.0 0.0 -19.089 30.2851 18.9071 0.0 0.0 0.0 -20.089 29.2851 17.9071 0.0 0.0 0.0 -20.089 29.2851 18.9071 0.0 0.0 0.0 -20.089 30.2851 17.9071 0.0 0.0 0.0 -20.089 30.2851 18.9071 0.0 0.0 0.0 -19.089 31.2851 14.9071 0.0 0.0 0.0 -19.089 32.2851 14.9071 0.0 0.0 0.0 -20.089 31.2851 14.9071 0.03820547352548382 0.03820547352548382 0.03820547352548382 -20.089 32.2851 14.9071 0.0 0.0 0.0 -17.089 31.2851 16.9071 0.0 0.0 0.0 -18.089 31.2851 16.9071 0.0 0.0 0.0 -17.089 31.2851 17.9071 0.0 0.0 0.0 -17.089 31.2851 18.9071 0.0 0.0 0.0 -18.089 31.2851 17.9071 0.0 0.0 0.0 -18.089 31.2851 18.9071 0.0 0.0 0.0 -19.089 31.2851 15.9071 0.0 0.0 0.0 -19.089 31.2851 16.9071 0.0 0.0 0.0 -19.089 32.2851 15.9071 0.008256673044720792 0.008256673044720792 0.008256673044720792 -19.089 32.2851 16.9071 0.007561211153991078 0.007561211153991078 0.007561211153991078 -20.089 32.2851 15.9071 0.0 0.0 0.0 -20.089 32.2851 16.9071 0.0 0.0 0.0 -19.089 31.2851 17.9071 0.0 0.0 0.0 -19.089 31.2851 18.9071 0.0 0.0 0.0 -19.089 32.2851 17.9071 0.012231202934374824 0.012231202934374824 0.012231202934374824 -19.089 32.2851 18.9071 0.0 0.0 0.0 -20.089 31.2851 17.9071 0.0 0.0 0.0 -20.089 32.2851 17.9071 0.0 0.0 0.0 -20.089 32.2851 18.9071 0.028345926859811202 0.028345926859811202 0.028345926859811202 -20.089 33.2851 16.9071 0.0 0.0 0.0 -20.089 33.2851 17.9071 0.004864632357486892 0.004864632357486892 0.004864632357486892 -20.089 33.2851 18.9071 0.0 0.0 0.0 -21.089 27.2851 14.9071 0.0 0.0 0.0 -22.089 27.2851 13.9071 0.0 0.0 0.0 -22.089 27.2851 14.9071 0.0 0.0 0.0 -22.089 28.2851 13.9071 0.0 0.0 0.0 -22.089 28.2851 14.9071 0.4502429360887023 0.4502429360887023 0.4502429360887023 -21.089 30.2851 14.9071 0.4247155795526391 0.4247155795526391 0.4247155795526391 -23.089 27.2851 13.9071 0.0 0.0 0.0 -23.089 28.2851 13.9071 0.0 0.0 0.0 -23.089 28.2851 14.9071 0.43989737903847 0.43989737903847 0.43989737903847 -24.089 27.2851 13.9071 0.0 0.0 0.0 -24.089 28.2851 13.9071 0.0 0.0 0.0 -23.089 29.2851 13.9071 0.0 0.0 0.0 -23.089 29.2851 14.9071 0.3101690948031214 0.3101690948031214 0.3101690948031214 -24.089 29.2851 13.9071 0.0 0.0 0.0 -24.089 29.2851 14.9071 0.0 0.0 0.0 -21.089 27.2851 15.9071 0.0 0.0 0.0 -21.089 28.2851 15.9071 0.0 0.0 0.0 -21.089 28.2851 16.9071 0.08547314336355642 0.08547314336355642 0.08547314336355642 -22.089 28.2851 15.9071 0.0 0.0 0.0 -22.089 28.2851 16.9071 0.060656129573342765 0.060656129573342765 0.060656129573342765 -21.089 28.2851 17.9071 0.1913449275397056 0.1913449275397056 0.1913449275397056 -21.089 28.2851 18.9071 0.04514848741612364 0.04514848741612364 0.04514848741612364 -22.089 27.2851 18.9071 0.0 0.0 0.0 -22.089 28.2851 17.9071 0.03123003887978455 0.03123003887978455 0.03123003887978455 -22.089 28.2851 18.9071 0.006658226076206625 0.006658226076206625 0.006658226076206625 -21.089 29.2851 15.9071 0.0 0.0 0.0 -21.089 29.2851 16.9071 0.0 0.0 0.0 -21.089 30.2851 15.9071 0.0 0.0 0.0 -21.089 30.2851 16.9071 0.0 0.0 0.0 -22.089 29.2851 15.9071 0.0 0.0 0.0 -22.089 29.2851 16.9071 0.0 0.0 0.0 -22.089 30.2851 15.9071 0.0 0.0 0.0 -22.089 30.2851 16.9071 0.0 0.0 0.0 -21.089 29.2851 17.9071 0.0 0.0 0.0 -21.089 29.2851 18.9071 0.0 0.0 0.0 -21.089 30.2851 17.9071 0.0 0.0 0.0 -21.089 30.2851 18.9071 0.0 0.0 0.0 -22.089 29.2851 17.9071 0.0 0.0 0.0 -22.089 29.2851 18.9071 0.04790456841166369 0.04790456841166369 0.04790456841166369 -22.089 30.2851 17.9071 0.0 0.0 0.0 -22.089 30.2851 18.9071 0.0 0.0 0.0 -23.089 28.2851 15.9071 0.0 0.0 0.0 -24.089 27.2851 16.9071 0.0 0.0 0.0 -24.089 28.2851 16.9071 0.0 0.0 0.0 -23.089 27.2851 17.9071 0.0 0.0 0.0 -23.089 27.2851 18.9071 0.0 0.0 0.0 -23.089 28.2851 18.9071 0.0 0.0 0.0 -24.089 27.2851 17.9071 0.0 0.0 0.0 -24.089 28.2851 17.9071 0.0 0.0 0.0 -24.089 28.2851 18.9071 0.0 0.0 0.0 -23.089 29.2851 15.9071 0.0 0.0 0.0 -23.089 29.2851 16.9071 0.0 0.0 0.0 -23.089 30.2851 15.9071 0.0 0.0 0.0 -23.089 30.2851 16.9071 0.015403847413590667 0.015403847413590667 0.015403847413590667 -24.089 29.2851 15.9071 5.276858959810827e-05 5.276858959810827e-05 5.276858959810827e-05 -24.089 29.2851 16.9071 0.0 0.0 0.0 -24.089 30.2851 15.9071 0.0 0.0 0.0 -24.089 30.2851 16.9071 0.043174597229064145 0.043174597229064145 0.043174597229064145 -23.089 29.2851 17.9071 0.0 0.0 0.0 -23.089 29.2851 18.9071 0.013402420923418108 0.013402420923418108 0.013402420923418108 -23.089 30.2851 17.9071 0.0 0.0 0.0 -23.089 30.2851 18.9071 0.14841701395827045 0.14841701395827045 0.14841701395827045 -24.089 29.2851 17.9071 0.2693227275644395 0.2693227275644395 0.2693227275644395 -24.089 29.2851 18.9071 0.0 0.0 0.0 -24.089 30.2851 17.9071 0.12433707790758992 0.12433707790758992 0.12433707790758992 -24.089 30.2851 18.9071 0.0 0.0 0.0 -21.089 31.2851 14.9071 0.0 0.0 0.0 -21.089 32.2851 14.9071 0.0 0.0 0.0 -23.089 34.2851 14.9071 0.13560259395159038 0.13560259395159038 0.13560259395159038 -24.089 34.2851 14.9071 0.14592892673257796 0.14592892673257796 0.14592892673257796 -21.089 31.2851 15.9071 0.0 0.0 0.0 -21.089 32.2851 15.9071 0.0 0.0 0.0 -21.089 32.2851 16.9071 0.0 0.0 0.0 -22.089 31.2851 15.9071 0.0 0.0 0.0 -22.089 32.2851 15.9071 0.0 0.0 0.0 -22.089 32.2851 16.9071 0.09447855784613338 0.09447855784613338 0.09447855784613338 -21.089 32.2851 18.9071 0.0 0.0 0.0 -22.089 32.2851 18.9071 0.0 0.0 0.0 -21.089 33.2851 16.9071 0.010953923150022677 0.010953923150022677 0.010953923150022677 -22.089 33.2851 15.9071 0.0 0.0 0.0 -22.089 33.2851 16.9071 0.12005160221800218 0.12005160221800218 0.12005160221800218 -21.089 33.2851 17.9071 0.0 0.0 0.0 -21.089 33.2851 18.9071 0.0 0.0 0.0 -22.089 33.2851 17.9071 0.1396594340315174 0.1396594340315174 0.1396594340315174 -22.089 33.2851 18.9071 0.0 0.0 0.0 -23.089 31.2851 15.9071 0.08791544646567147 0.08791544646567147 0.08791544646567147 -23.089 32.2851 15.9071 0.03864444626881671 0.03864444626881671 0.03864444626881671 -24.089 31.2851 15.9071 0.07674913846746917 0.07674913846746917 0.07674913846746917 -24.089 31.2851 16.9071 0.0 0.0 0.0 -24.089 32.2851 15.9071 0.058685365073974365 0.058685365073974365 0.058685365073974365 -24.089 32.2851 16.9071 0.0 0.0 0.0 -23.089 31.2851 18.9071 0.03248131140236985 0.03248131140236985 0.03248131140236985 -23.089 32.2851 18.9071 0.0 0.0 0.0 -24.089 31.2851 17.9071 0.0 0.0 0.0 -24.089 31.2851 18.9071 0.12416224570301261 0.12416224570301261 0.12416224570301261 -24.089 32.2851 17.9071 0.0 0.0 0.0 -24.089 32.2851 18.9071 0.07638520250052008 0.07638520250052008 0.07638520250052008 -23.089 33.2851 15.9071 0.0 0.0 0.0 -23.089 33.2851 16.9071 0.19004180720526984 0.19004180720526984 0.19004180720526984 -23.089 34.2851 15.9071 0.28550326299048207 0.28550326299048207 0.28550326299048207 -23.089 34.2851 16.9071 0.27933950425709003 0.27933950425709003 0.27933950425709003 -24.089 33.2851 15.9071 0.0 0.0 0.0 -24.089 33.2851 16.9071 0.0 0.0 0.0 -24.089 34.2851 15.9071 0.49482359197156806 0.49482359197156806 0.49482359197156806 -24.089 34.2851 16.9071 0.0 0.0 0.0 -23.089 33.2851 17.9071 0.2400112158076669 0.2400112158076669 0.2400112158076669 -23.089 33.2851 18.9071 0.0 0.0 0.0 -23.089 34.2851 17.9071 0.0 0.0 0.0 -23.089 34.2851 18.9071 0.0 0.0 0.0 -24.089 33.2851 17.9071 0.0 0.0 0.0 -24.089 33.2851 18.9071 0.0 0.0 0.0 -24.089 34.2851 17.9071 0.0 0.0 0.0 -24.089 34.2851 18.9071 0.0 0.0 0.0 -17.089 27.2851 19.9071 0.009414520362058773 0.009414520362058773 0.009414520362058773 -18.089 27.2851 19.9071 0.0 0.0 0.0 -18.089 27.2851 20.9071 0.02626334180490328 0.02626334180490328 0.02626334180490328 -17.089 27.2851 22.9071 0.17798629732933155 0.17798629732933155 0.17798629732933155 -17.089 28.2851 22.9071 0.0 0.0 0.0 -17.089 29.2851 20.9071 0.0 0.0 0.0 -17.089 30.2851 19.9071 0.006591134852965716 0.006591134852965716 0.006591134852965716 -17.089 30.2851 20.9071 0.0 0.0 0.0 -18.089 30.2851 19.9071 0.0 0.0 0.0 -18.089 30.2851 20.9071 0.0 0.0 0.0 -17.089 29.2851 21.9071 0.0 0.0 0.0 -17.089 29.2851 22.9071 0.0 0.0 0.0 -17.089 30.2851 21.9071 0.0 0.0 0.0 -18.089 29.2851 21.9071 0.0 0.0 0.0 -18.089 29.2851 22.9071 0.0 0.0 0.0 -18.089 30.2851 21.9071 0.0 0.0 0.0 -18.089 30.2851 22.9071 0.24201560019031448 0.24201560019031448 0.24201560019031448 -19.089 27.2851 19.9071 0.0 0.0 0.0 -19.089 27.2851 20.9071 0.027157887672967083 0.027157887672967083 0.027157887672967083 -19.089 28.2851 19.9071 0.0 0.0 0.0 -19.089 28.2851 20.9071 0.04381009891127157 0.04381009891127157 0.04381009891127157 -20.089 27.2851 20.9071 0.04395204403471383 0.04395204403471383 0.04395204403471383 -20.089 28.2851 19.9071 0.0 0.0 0.0 -20.089 28.2851 20.9071 0.02699201968252814 0.02699201968252814 0.02699201968252814 -19.089 27.2851 21.9071 0.09933975386159999 0.09933975386159999 0.09933975386159999 -19.089 27.2851 22.9071 0.0 0.0 0.0 -20.089 27.2851 21.9071 0.0426584974593047 0.0426584974593047 0.0426584974593047 -20.089 27.2851 22.9071 0.17483492460176867 0.17483492460176867 0.17483492460176867 -20.089 28.2851 21.9071 0.06901370446828467 0.06901370446828467 0.06901370446828467 -20.089 28.2851 22.9071 0.030473474445277225 0.030473474445277225 0.030473474445277225 -19.089 29.2851 19.9071 0.0 0.0 0.0 -19.089 29.2851 20.9071 0.0 0.0 0.0 -19.089 30.2851 19.9071 0.0 0.0 0.0 -19.089 30.2851 20.9071 0.011636657793961747 0.011636657793961747 0.011636657793961747 -20.089 29.2851 19.9071 0.0 0.0 0.0 -20.089 29.2851 20.9071 0.0 0.0 0.0 -20.089 30.2851 19.9071 0.0 0.0 0.0 -20.089 30.2851 20.9071 0.0 0.0 0.0 -19.089 29.2851 21.9071 0.06261273381200462 0.06261273381200462 0.06261273381200462 -19.089 29.2851 22.9071 0.0 0.0 0.0 -19.089 30.2851 21.9071 0.010994904301459623 0.010994904301459623 0.010994904301459623 -19.089 30.2851 22.9071 0.0 0.0 0.0 -20.089 29.2851 22.9071 0.0 0.0 0.0 -20.089 30.2851 22.9071 0.0 0.0 0.0 -17.089 27.2851 24.9071 0.016852178291595948 0.016852178291595948 0.016852178291595948 -17.089 28.2851 24.9071 0.0 0.0 0.0 -18.089 27.2851 24.9071 0.0 0.0 0.0 -18.089 28.2851 24.9071 0.035837188409583866 0.035837188409583866 0.035837188409583866 -17.089 27.2851 25.9071 0.0 0.0 0.0 -17.089 27.2851 26.9071 0.0 0.0 0.0 -17.089 28.2851 25.9071 0.0 0.0 0.0 -17.089 28.2851 26.9071 0.0 0.0 0.0 -18.089 27.2851 25.9071 0.0 0.0 0.0 -18.089 27.2851 26.9071 0.0 0.0 0.0 -18.089 28.2851 25.9071 0.0 0.0 0.0 -18.089 28.2851 26.9071 0.0 0.0 0.0 -17.089 29.2851 23.9071 0.504741802276815 0.504741802276815 0.504741802276815 -17.089 29.2851 24.9071 0.0 0.0 0.0 -17.089 30.2851 23.9071 0.2343984136278707 0.2343984136278707 0.2343984136278707 -17.089 30.2851 24.9071 0.08672666845097002 0.08672666845097002 0.08672666845097002 -18.089 29.2851 23.9071 0.0004858546072286811 0.0004858546072286811 0.0004858546072286811 -18.089 29.2851 24.9071 0.0 0.0 0.0 -18.089 30.2851 24.9071 0.32481358251972947 0.32481358251972947 0.32481358251972947 -17.089 29.2851 25.9071 0.0 0.0 0.0 -17.089 29.2851 26.9071 0.047296867867564533 0.047296867867564533 0.047296867867564533 -17.089 30.2851 25.9071 0.0 0.0 0.0 -17.089 30.2851 26.9071 0.02438074928608629 0.02438074928608629 0.02438074928608629 -18.089 29.2851 25.9071 0.0 0.0 0.0 -18.089 29.2851 26.9071 0.0 0.0 0.0 -18.089 30.2851 25.9071 0.0 0.0 0.0 -18.089 30.2851 26.9071 0.0 0.0 0.0 -19.089 27.2851 24.9071 0.0 0.0 0.0 -19.089 27.2851 26.9071 0.020819588438268605 0.020819588438268605 0.020819588438268605 -20.089 27.2851 25.9071 0.0 0.0 0.0 -20.089 27.2851 26.9071 0.0007407050195037278 0.0007407050195037278 0.0007407050195037278 -20.089 28.2851 26.9071 0.06876803570768313 0.06876803570768313 0.06876803570768313 -19.089 29.2851 23.9071 0.0 0.0 0.0 -19.089 29.2851 24.9071 0.0 0.0 0.0 -19.089 30.2851 24.9071 0.0 0.0 0.0 -20.089 29.2851 23.9071 0.0 0.0 0.0 -20.089 29.2851 24.9071 0.0 0.0 0.0 -20.089 30.2851 23.9071 0.0 0.0 0.0 -20.089 30.2851 24.9071 0.0020203745836347236 0.0020203745836347236 0.0020203745836347236 -20.089 29.2851 25.9071 0.0 0.0 0.0 -20.089 29.2851 26.9071 0.0 0.0 0.0 -20.089 30.2851 25.9071 0.03920884657728537 0.03920884657728537 0.03920884657728537 -20.089 30.2851 26.9071 0.1928898108394668 0.1928898108394668 0.1928898108394668 -17.089 31.2851 19.9071 0.011591282904858 0.011591282904858 0.011591282904858 -17.089 32.2851 20.9071 0.03854220196534557 0.03854220196534557 0.03854220196534557 -17.089 31.2851 21.9071 0.0 0.0 0.0 -17.089 31.2851 22.9071 0.0 0.0 0.0 -17.089 32.2851 21.9071 0.0 0.0 0.0 -18.089 31.2851 21.9071 0.0 0.0 0.0 -18.089 31.2851 22.9071 0.08562822578327804 0.08562822578327804 0.08562822578327804 -18.089 32.2851 21.9071 0.0 0.0 0.0 -18.089 32.2851 22.9071 0.36550218509126203 0.36550218509126203 0.36550218509126203 -17.089 33.2851 20.9071 0.21125732367460281 0.21125732367460281 0.21125732367460281 -17.089 33.2851 21.9071 0.0 0.0 0.0 -17.089 34.2851 21.9071 0.14557390671524092 0.14557390671524092 0.14557390671524092 -17.089 34.2851 22.9071 0.13472066251711842 0.13472066251711842 0.13472066251711842 -18.089 33.2851 21.9071 0.0 0.0 0.0 -18.089 33.2851 22.9071 0.0 0.0 0.0 -18.089 34.2851 21.9071 0.3725670854362465 0.3725670854362465 0.3725670854362465 -18.089 34.2851 22.9071 0.0 0.0 0.0 -19.089 31.2851 19.9071 0.0 0.0 0.0 -19.089 31.2851 20.9071 0.0 0.0 0.0 -19.089 32.2851 19.9071 0.0 0.0 0.0 -20.089 31.2851 19.9071 0.0 0.0 0.0 -20.089 31.2851 20.9071 0.03053616022281194 0.03053616022281194 0.03053616022281194 -20.089 32.2851 19.9071 0.0 0.0 0.0 -20.089 32.2851 20.9071 0.03279655103231007 0.03279655103231007 0.03279655103231007 -19.089 31.2851 21.9071 0.0 0.0 0.0 -19.089 31.2851 22.9071 0.0 0.0 0.0 -19.089 32.2851 22.9071 0.0 0.0 0.0 -20.089 31.2851 21.9071 0.0 0.0 0.0 -20.089 31.2851 22.9071 0.0 0.0 0.0 -20.089 32.2851 21.9071 0.0 0.0 0.0 -20.089 32.2851 22.9071 0.0 0.0 0.0 -19.089 34.2851 20.9071 0.08432941485602109 0.08432941485602109 0.08432941485602109 -20.089 33.2851 19.9071 0.0 0.0 0.0 -20.089 33.2851 20.9071 0.0 0.0 0.0 -20.089 34.2851 20.9071 0.0 0.0 0.0 -19.089 33.2851 21.9071 0.08039795334155943 0.08039795334155943 0.08039795334155943 -19.089 33.2851 22.9071 0.0 0.0 0.0 -19.089 34.2851 21.9071 0.2933586288640695 0.2933586288640695 0.2933586288640695 -19.089 34.2851 22.9071 0.14545918081514042 0.14545918081514042 0.14545918081514042 -20.089 33.2851 21.9071 0.0 0.0 0.0 -20.089 33.2851 22.9071 0.0 0.0 0.0 -20.089 34.2851 21.9071 0.0 0.0 0.0 -17.089 31.2851 23.9071 0.021756607641393724 0.021756607641393724 0.021756607641393724 -17.089 31.2851 24.9071 0.0 0.0 0.0 -17.089 32.2851 23.9071 0.0 0.0 0.0 -18.089 31.2851 23.9071 0.1779330487218616 0.1779330487218616 0.1779330487218616 -18.089 31.2851 24.9071 0.0 0.0 0.0 -18.089 32.2851 23.9071 0.3560303589547342 0.3560303589547342 0.3560303589547342 -17.089 31.2851 25.9071 0.0 0.0 0.0 -17.089 31.2851 26.9071 0.0 0.0 0.0 -17.089 32.2851 25.9071 0.08027448344766817 0.08027448344766817 0.08027448344766817 -17.089 32.2851 26.9071 0.07803825446274093 0.07803825446274093 0.07803825446274093 -18.089 31.2851 25.9071 0.0 0.0 0.0 -18.089 31.2851 26.9071 0.0 0.0 0.0 -18.089 32.2851 25.9071 0.0 0.0 0.0 -18.089 32.2851 26.9071 0.08900440100002238 0.08900440100002238 0.08900440100002238 -17.089 34.2851 23.9071 0.0 0.0 0.0 -18.089 33.2851 23.9071 0.06419369644073902 0.06419369644073902 0.06419369644073902 -18.089 34.2851 23.9071 0.0 0.0 0.0 -18.089 34.2851 24.9071 0.10889359305094432 0.10889359305094432 0.10889359305094432 -18.089 34.2851 25.9071 0.08905649906167366 0.08905649906167366 0.08905649906167366 -18.089 34.2851 26.9071 0.0 0.0 0.0 -19.089 31.2851 23.9071 0.08834719220071491 0.08834719220071491 0.08834719220071491 -19.089 31.2851 24.9071 0.13949386822475732 0.13949386822475732 0.13949386822475732 -19.089 32.2851 23.9071 0.0 0.0 0.0 -20.089 31.2851 23.9071 0.0 0.0 0.0 -20.089 31.2851 24.9071 0.0 0.0 0.0 -20.089 32.2851 24.9071 0.0 0.0 0.0 -19.089 31.2851 25.9071 0.0 0.0 0.0 -19.089 31.2851 26.9071 0.100462046594098 0.100462046594098 0.100462046594098 -19.089 32.2851 25.9071 0.0 0.0 0.0 -19.089 32.2851 26.9071 0.028386902494237618 0.028386902494237618 0.028386902494237618 -20.089 31.2851 25.9071 0.0 0.0 0.0 -20.089 31.2851 26.9071 0.0 0.0 0.0 -20.089 32.2851 25.9071 0.0 0.0 0.0 -19.089 34.2851 24.9071 0.0 0.0 0.0 -20.089 33.2851 24.9071 0.0 0.0 0.0 -20.089 34.2851 24.9071 0.0 0.0 0.0 -19.089 33.2851 25.9071 0.04160262996399042 0.04160262996399042 0.04160262996399042 -19.089 33.2851 26.9071 0.004992461701302696 0.004992461701302696 0.004992461701302696 -19.089 34.2851 25.9071 0.0 0.0 0.0 -19.089 34.2851 26.9071 0.0 0.0 0.0 -20.089 33.2851 25.9071 0.0 0.0 0.0 -20.089 33.2851 26.9071 0.0 0.0 0.0 -20.089 34.2851 25.9071 0.0 0.0 0.0 -20.089 34.2851 26.9071 0.0 0.0 0.0 -21.089 28.2851 19.9071 0.0 0.0 0.0 -21.089 28.2851 20.9071 0.0 0.0 0.0 -22.089 27.2851 19.9071 0.0 0.0 0.0 -22.089 27.2851 20.9071 0.0 0.0 0.0 -22.089 28.2851 19.9071 0.0 0.0 0.0 -22.089 28.2851 20.9071 0.0 0.0 0.0 -21.089 27.2851 21.9071 0.0 0.0 0.0 -21.089 27.2851 22.9071 0.0 0.0 0.0 -21.089 28.2851 21.9071 0.0 0.0 0.0 -21.089 28.2851 22.9071 0.0 0.0 0.0 -22.089 27.2851 21.9071 0.0 0.0 0.0 -22.089 27.2851 22.9071 0.0 0.0 0.0 -22.089 28.2851 21.9071 0.0 0.0 0.0 -22.089 28.2851 22.9071 0.0 0.0 0.0 -21.089 29.2851 19.9071 0.0 0.0 0.0 -21.089 29.2851 20.9071 0.0 0.0 0.0 -21.089 30.2851 19.9071 0.0 0.0 0.0 -21.089 30.2851 20.9071 0.0 0.0 0.0 -22.089 29.2851 19.9071 0.0 0.0 0.0 -22.089 29.2851 20.9071 0.0 0.0 0.0 -21.089 29.2851 21.9071 0.0 0.0 0.0 -21.089 29.2851 22.9071 0.0 0.0 0.0 -21.089 30.2851 22.9071 0.0 0.0 0.0 -22.089 29.2851 21.9071 0.0 0.0 0.0 -22.089 29.2851 22.9071 0.0 0.0 0.0 -22.089 30.2851 21.9071 0.0 0.0 0.0 -22.089 30.2851 22.9071 0.0 0.0 0.0 -23.089 27.2851 19.9071 0.0 0.0 0.0 -23.089 28.2851 19.9071 0.0 0.0 0.0 -23.089 28.2851 20.9071 0.0 0.0 0.0 -24.089 28.2851 20.9071 0.0 0.0 0.0 -23.089 27.2851 21.9071 0.0 0.0 0.0 -23.089 27.2851 22.9071 0.0 0.0 0.0 -23.089 28.2851 21.9071 0.0 0.0 0.0 -23.089 28.2851 22.9071 0.0 0.0 0.0 -24.089 28.2851 21.9071 0.0 0.0 0.0 -24.089 28.2851 22.9071 0.0 0.0 0.0 -23.089 29.2851 20.9071 0.0 0.0 0.0 -24.089 29.2851 20.9071 0.0 0.0 0.0 -23.089 29.2851 21.9071 0.0 0.0 0.0 -23.089 29.2851 22.9071 0.0 0.0 0.0 -23.089 30.2851 21.9071 0.0 0.0 0.0 -23.089 30.2851 22.9071 0.03402405452098742 0.03402405452098742 0.03402405452098742 -24.089 29.2851 21.9071 0.02280029381156941 0.02280029381156941 0.02280029381156941 -24.089 29.2851 22.9071 0.0 0.0 0.0 -24.089 30.2851 21.9071 0.0 0.0 0.0 -24.089 30.2851 22.9071 0.009318301890232186 0.009318301890232186 0.009318301890232186 -21.089 28.2851 23.9071 0.0 0.0 0.0 -21.089 28.2851 24.9071 0.0 0.0 0.0 -22.089 27.2851 23.9071 0.0 0.0 0.0 -22.089 27.2851 24.9071 0.0 0.0 0.0 -22.089 28.2851 23.9071 0.0 0.0 0.0 -22.089 28.2851 24.9071 0.0 0.0 0.0 -21.089 27.2851 25.9071 0.0 0.0 0.0 -21.089 27.2851 26.9071 0.024979827937899757 0.024979827937899757 0.024979827937899757 -21.089 28.2851 25.9071 0.14419218100953332 0.14419218100953332 0.14419218100953332 -21.089 28.2851 26.9071 0.0 0.0 0.0 -22.089 27.2851 25.9071 0.01437004036352758 0.01437004036352758 0.01437004036352758 -22.089 27.2851 26.9071 0.0 0.0 0.0 -22.089 28.2851 25.9071 0.0 0.0 0.0 -22.089 28.2851 26.9071 0.0 0.0 0.0 -21.089 29.2851 23.9071 0.0 0.0 0.0 -21.089 29.2851 24.9071 0.0 0.0 0.0 -21.089 30.2851 23.9071 0.0 0.0 0.0 -21.089 30.2851 24.9071 0.005381262033268021 0.005381262033268021 0.005381262033268021 -22.089 29.2851 23.9071 0.0 0.0 0.0 -22.089 29.2851 24.9071 0.0 0.0 0.0 -22.089 30.2851 23.9071 0.0 0.0 0.0 -21.089 29.2851 25.9071 0.0 0.0 0.0 -21.089 29.2851 26.9071 0.0 0.0 0.0 -21.089 30.2851 25.9071 0.0 0.0 0.0 -21.089 30.2851 26.9071 0.006885135586530167 0.006885135586530167 0.006885135586530167 -22.089 29.2851 25.9071 0.0 0.0 0.0 -22.089 29.2851 26.9071 0.0 0.0 0.0 -22.089 30.2851 26.9071 0.0 0.0 0.0 -23.089 27.2851 23.9071 0.0 0.0 0.0 -23.089 27.2851 24.9071 0.0 0.0 0.0 -23.089 28.2851 23.9071 0.0 0.0 0.0 -23.089 28.2851 24.9071 0.0 0.0 0.0 -24.089 27.2851 23.9071 0.0 0.0 0.0 -24.089 27.2851 24.9071 0.2759457688222747 0.2759457688222747 0.2759457688222747 -24.089 28.2851 23.9071 0.0 0.0 0.0 -24.089 28.2851 24.9071 0.0 0.0 0.0 -23.089 27.2851 25.9071 0.0 0.0 0.0 -23.089 27.2851 26.9071 0.0 0.0 0.0 -23.089 28.2851 25.9071 0.0 0.0 0.0 -23.089 28.2851 26.9071 0.0 0.0 0.0 -24.089 27.2851 25.9071 0.4916078868749732 0.4916078868749732 0.4916078868749732 -24.089 28.2851 25.9071 0.0 0.0 0.0 -23.089 29.2851 23.9071 0.0 0.0 0.0 -23.089 29.2851 24.9071 0.0 0.0 0.0 -23.089 30.2851 23.9071 0.0 0.0 0.0 -24.089 29.2851 23.9071 0.0 0.0 0.0 -24.089 29.2851 24.9071 0.0 0.0 0.0 -24.089 30.2851 23.9071 0.0 0.0 0.0 -24.089 30.2851 24.9071 0.0 0.0 0.0 -23.089 29.2851 25.9071 0.0 0.0 0.0 -23.089 29.2851 26.9071 0.0 0.0 0.0 -23.089 30.2851 26.9071 0.0 0.0 0.0 -24.089 29.2851 25.9071 0.0 0.0 0.0 -24.089 29.2851 26.9071 0.0 0.0 0.0 -24.089 30.2851 25.9071 0.0020643734307389987 0.0020643734307389987 0.0020643734307389987 -24.089 30.2851 26.9071 0.0 0.0 0.0 -21.089 32.2851 19.9071 0.01440894315573324 0.01440894315573324 0.01440894315573324 -21.089 32.2851 20.9071 0.0 0.0 0.0 -22.089 32.2851 19.9071 0.0 0.0 0.0 -22.089 32.2851 20.9071 0.0 0.0 0.0 -22.089 31.2851 22.9071 0.0 0.0 0.0 -22.089 32.2851 21.9071 0.0 0.0 0.0 -21.089 33.2851 19.9071 0.0 0.0 0.0 -21.089 33.2851 20.9071 0.0 0.0 0.0 -21.089 34.2851 19.9071 0.0 0.0 0.0 -21.089 34.2851 20.9071 0.0 0.0 0.0 -22.089 33.2851 19.9071 0.0 0.0 0.0 -22.089 33.2851 20.9071 0.0 0.0 0.0 -22.089 34.2851 19.9071 0.0 0.0 0.0 -21.089 33.2851 21.9071 0.0 0.0 0.0 -21.089 33.2851 22.9071 0.0 0.0 0.0 -21.089 34.2851 21.9071 0.0 0.0 0.0 -21.089 34.2851 22.9071 0.0 0.0 0.0 -22.089 33.2851 22.9071 0.0 0.0 0.0 -22.089 34.2851 21.9071 0.0 0.0 0.0 -22.089 34.2851 22.9071 0.0 0.0 0.0 -23.089 31.2851 20.9071 0.0 0.0 0.0 -23.089 32.2851 19.9071 0.030559533756379497 0.030559533756379497 0.030559533756379497 -23.089 32.2851 20.9071 0.0 0.0 0.0 -24.089 31.2851 20.9071 0.04445219109678607 0.04445219109678607 0.04445219109678607 -24.089 32.2851 19.9071 0.00826132206447568 0.00826132206447568 0.00826132206447568 -24.089 32.2851 20.9071 0.0 0.0 0.0 -23.089 31.2851 21.9071 0.0 0.0 0.0 -23.089 31.2851 22.9071 0.03406672191575017 0.03406672191575017 0.03406672191575017 -23.089 32.2851 21.9071 0.0 0.0 0.0 -23.089 32.2851 22.9071 0.0 0.0 0.0 -24.089 31.2851 21.9071 0.0 0.0 0.0 -24.089 32.2851 21.9071 0.0 0.0 0.0 -24.089 32.2851 22.9071 0.0 0.0 0.0 -23.089 33.2851 19.9071 0.0 0.0 0.0 -23.089 33.2851 20.9071 0.0 0.0 0.0 -23.089 34.2851 19.9071 0.021267312211994682 0.021267312211994682 0.021267312211994682 -24.089 33.2851 19.9071 0.05093465641973468 0.05093465641973468 0.05093465641973468 -24.089 33.2851 20.9071 0.0 0.0 0.0 -24.089 34.2851 19.9071 0.0 0.0 0.0 -24.089 34.2851 20.9071 0.0 0.0 0.0 -23.089 33.2851 21.9071 0.0 0.0 0.0 -23.089 33.2851 22.9071 0.0 0.0 0.0 -23.089 34.2851 21.9071 0.0 0.0 0.0 -23.089 34.2851 22.9071 0.0 0.0 0.0 -24.089 33.2851 21.9071 0.0 0.0 0.0 -24.089 33.2851 22.9071 0.0 0.0 0.0 -24.089 34.2851 21.9071 0.0 0.0 0.0 -24.089 34.2851 22.9071 0.0 0.0 0.0 -21.089 31.2851 24.9071 0.0 0.0 0.0 -22.089 31.2851 23.9071 0.0 0.0 0.0 -21.089 31.2851 25.9071 0.0 0.0 0.0 -21.089 32.2851 25.9071 0.0 0.0 0.0 -21.089 32.2851 26.9071 0.0 0.0 0.0 -22.089 31.2851 25.9071 0.0 0.0 0.0 -22.089 31.2851 26.9071 0.0 0.0 0.0 -22.089 32.2851 25.9071 0.0 0.0 0.0 -22.089 32.2851 26.9071 0.0 0.0 0.0 -21.089 33.2851 23.9071 0.003793893652639462 0.003793893652639462 0.003793893652639462 -21.089 33.2851 24.9071 0.0 0.0 0.0 -21.089 34.2851 23.9071 0.0 0.0 0.0 -21.089 34.2851 24.9071 0.0 0.0 0.0 -22.089 33.2851 23.9071 0.0 0.0 0.0 -22.089 34.2851 23.9071 0.0 0.0 0.0 -22.089 34.2851 24.9071 0.0 0.0 0.0 -21.089 33.2851 25.9071 0.0 0.0 0.0 -21.089 33.2851 26.9071 0.0 0.0 0.0 -21.089 34.2851 25.9071 0.0 0.0 0.0 -21.089 34.2851 26.9071 0.0 0.0 0.0 -22.089 33.2851 25.9071 0.0 0.0 0.0 -22.089 33.2851 26.9071 0.0 0.0 0.0 -22.089 34.2851 25.9071 0.0 0.0 0.0 -22.089 34.2851 26.9071 0.0 0.0 0.0 -23.089 32.2851 23.9071 0.0 0.0 0.0 -24.089 32.2851 23.9071 0.0 0.0 0.0 -24.089 32.2851 24.9071 0.0 0.0 0.0 -23.089 31.2851 26.9071 0.0 0.0 0.0 -23.089 32.2851 25.9071 0.0 0.0 0.0 -23.089 32.2851 26.9071 0.0 0.0 0.0 -24.089 31.2851 25.9071 0.0 0.0 0.0 -24.089 31.2851 26.9071 0.0 0.0 0.0 -24.089 32.2851 25.9071 0.0 0.0 0.0 -24.089 32.2851 26.9071 0.0 0.0 0.0 -23.089 33.2851 23.9071 0.0 0.0 0.0 -23.089 33.2851 24.9071 0.0 0.0 0.0 -23.089 34.2851 23.9071 0.0 0.0 0.0 -23.089 34.2851 24.9071 0.0 0.0 0.0 -24.089 33.2851 23.9071 0.0 0.0 0.0 -24.089 33.2851 24.9071 0.0 0.0 0.0 -24.089 34.2851 23.9071 0.0 0.0 0.0 -24.089 34.2851 24.9071 0.0 0.0 0.0 -23.089 33.2851 25.9071 0.0 0.0 0.0 -23.089 33.2851 26.9071 0.0 0.0 0.0 -23.089 34.2851 25.9071 0.0 0.0 0.0 -23.089 34.2851 26.9071 0.0 0.0 0.0 -24.089 33.2851 25.9071 0.0 0.0 0.0 -24.089 33.2851 26.9071 0.0 0.0 0.0 -24.089 34.2851 25.9071 0.0 0.0 0.0 -24.089 34.2851 26.9071 0.0 0.0 0.0 -23.089 35.2851 14.9071 0.0 0.0 0.0 -23.089 36.2851 14.9071 0.0 0.0 0.0 -24.089 35.2851 14.9071 0.0 0.0 0.0 -24.089 36.2851 14.9071 0.0 0.0 0.0 -24.089 37.2851 14.9071 0.0 0.0 0.0 -24.089 38.2851 14.9071 0.13733418118468393 0.13733418118468393 0.13733418118468393 -22.089 35.2851 18.9071 0.11721679231685725 0.11721679231685725 0.11721679231685725 -22.089 36.2851 18.9071 0.0 0.0 0.0 -22.089 37.2851 18.9071 0.015376562756253806 0.015376562756253806 0.015376562756253806 -23.089 35.2851 15.9071 0.4990522167639394 0.4990522167639394 0.4990522167639394 -23.089 35.2851 16.9071 0.0 0.0 0.0 -23.089 36.2851 15.9071 0.2651140996772901 0.2651140996772901 0.2651140996772901 -23.089 36.2851 16.9071 0.05838857004240263 0.05838857004240263 0.05838857004240263 -24.089 36.2851 15.9071 0.373142798690684 0.373142798690684 0.373142798690684 -23.089 35.2851 17.9071 0.0 0.0 0.0 -23.089 35.2851 18.9071 0.07035279344419121 0.07035279344419121 0.07035279344419121 -23.089 36.2851 17.9071 0.2213983912610965 0.2213983912610965 0.2213983912610965 -23.089 36.2851 18.9071 0.0 0.0 0.0 -24.089 35.2851 17.9071 0.0 0.0 0.0 -24.089 36.2851 17.9071 0.026330405325333532 0.026330405325333532 0.026330405325333532 -24.089 36.2851 18.9071 0.0 0.0 0.0 -23.089 37.2851 15.9071 0.0 0.0 0.0 -23.089 37.2851 16.9071 0.0 0.0 0.0 -24.089 37.2851 15.9071 0.011558685816976748 0.011558685816976748 0.011558685816976748 -24.089 37.2851 16.9071 0.0 0.0 0.0 -24.089 38.2851 15.9071 0.0 0.0 0.0 -24.089 38.2851 16.9071 0.0 0.0 0.0 -23.089 37.2851 17.9071 0.0 0.0 0.0 -23.089 37.2851 18.9071 0.033800094056626026 0.033800094056626026 0.033800094056626026 -23.089 38.2851 18.9071 0.0 0.0 0.0 -24.089 37.2851 17.9071 0.025821244327657703 0.025821244327657703 0.025821244327657703 -24.089 37.2851 18.9071 0.0213877633652897 0.0213877633652897 0.0213877633652897 -24.089 38.2851 17.9071 0.050190840283419115 0.050190840283419115 0.050190840283419115 -24.089 38.2851 18.9071 0.0 0.0 0.0 -24.089 39.2851 14.9071 0.16532474457927365 0.16532474457927365 0.16532474457927365 -24.089 39.2851 15.9071 0.45267010929497914 0.45267010929497914 0.45267010929497914 -24.089 39.2851 16.9071 0.0 0.0 0.0 -18.089 35.2851 22.9071 0.0 0.0 0.0 -19.089 35.2851 20.9071 0.0 0.0 0.0 -19.089 36.2851 19.9071 0.0 0.0 0.0 -19.089 36.2851 20.9071 0.2536041495441717 0.2536041495441717 0.2536041495441717 -20.089 35.2851 19.9071 0.0 0.0 0.0 -20.089 35.2851 20.9071 0.0 0.0 0.0 -20.089 36.2851 19.9071 0.05494871705448712 0.05494871705448712 0.05494871705448712 -19.089 35.2851 21.9071 0.0 0.0 0.0 -19.089 35.2851 22.9071 0.0 0.0 0.0 -19.089 36.2851 21.9071 0.0 0.0 0.0 -19.089 36.2851 22.9071 0.0 0.0 0.0 -20.089 35.2851 22.9071 0.0 0.0 0.0 -20.089 36.2851 22.9071 0.0 0.0 0.0 -19.089 37.2851 20.9071 0.0 0.0 0.0 -20.089 37.2851 19.9071 0.07696523321014183 0.07696523321014183 0.07696523321014183 -20.089 37.2851 20.9071 0.0 0.0 0.0 -20.089 38.2851 20.9071 0.0 0.0 0.0 -19.089 37.2851 21.9071 0.15500994288545852 0.15500994288545852 0.15500994288545852 -19.089 37.2851 22.9071 0.16313050826761286 0.16313050826761286 0.16313050826761286 -20.089 37.2851 21.9071 0.03420167102271871 0.03420167102271871 0.03420167102271871 -20.089 37.2851 22.9071 0.0 0.0 0.0 -20.089 38.2851 21.9071 0.034733150671887376 0.034733150671887376 0.034733150671887376 -20.089 38.2851 22.9071 0.0 0.0 0.0 -17.089 35.2851 23.9071 0.30410578145156236 0.30410578145156236 0.30410578145156236 -17.089 35.2851 24.9071 0.14398519140894175 0.14398519140894175 0.14398519140894175 -18.089 35.2851 23.9071 0.0 0.0 0.0 -18.089 35.2851 24.9071 0.0 0.0 0.0 -17.089 35.2851 25.9071 0.28574932534090564 0.28574932534090564 0.28574932534090564 -17.089 35.2851 26.9071 0.0 0.0 0.0 -18.089 35.2851 25.9071 0.2580437472870703 0.2580437472870703 0.2580437472870703 -18.089 35.2851 26.9071 0.0 0.0 0.0 -19.089 35.2851 23.9071 0.0 0.0 0.0 -19.089 35.2851 24.9071 0.0 0.0 0.0 -20.089 35.2851 23.9071 0.0021038545212320385 0.0021038545212320385 0.0021038545212320385 -20.089 35.2851 24.9071 0.007323329934172175 0.007323329934172175 0.007323329934172175 -20.089 36.2851 23.9071 0.021251749143318805 0.021251749143318805 0.021251749143318805 -20.089 36.2851 24.9071 0.44994108697968554 0.44994108697968554 0.44994108697968554 -19.089 35.2851 25.9071 0.0 0.0 0.0 -19.089 35.2851 26.9071 0.01296286227851455 0.01296286227851455 0.01296286227851455 -19.089 36.2851 25.9071 0.0 0.0 0.0 -19.089 36.2851 26.9071 0.0 0.0 0.0 -20.089 35.2851 25.9071 0.0 0.0 0.0 -20.089 36.2851 25.9071 0.049964800748650694 0.049964800748650694 0.049964800748650694 -20.089 37.2851 23.9071 0.0 0.0 0.0 -20.089 37.2851 24.9071 0.38354762628486705 0.38354762628486705 0.38354762628486705 -20.089 38.2851 23.9071 0.0 0.0 0.0 -20.089 38.2851 24.9071 0.12413152533145168 0.12413152533145168 0.12413152533145168 -19.089 37.2851 25.9071 0.0 0.0 0.0 -19.089 37.2851 26.9071 0.0 0.0 0.0 -20.089 37.2851 25.9071 0.13285158186261817 0.13285158186261817 0.13285158186261817 -20.089 37.2851 26.9071 0.21607536021277532 0.21607536021277532 0.21607536021277532 -20.089 38.2851 25.9071 0.13849872494499885 0.13849872494499885 0.13849872494499885 -20.089 39.2851 22.9071 0.0 0.0 0.0 -20.089 39.2851 23.9071 0.062473668503187585 0.062473668503187585 0.062473668503187585 -20.089 39.2851 24.9071 0.01653593705450006 0.01653593705450006 0.01653593705450006 -20.089 40.2851 23.9071 0.0 0.0 0.0 -20.089 40.2851 24.9071 0.0 0.0 0.0 -20.089 39.2851 25.9071 0.11060835631661675 0.11060835631661675 0.11060835631661675 -20.089 39.2851 26.9071 0.1763608493858324 0.1763608493858324 0.1763608493858324 -20.089 40.2851 25.9071 0.12113426839462361 0.12113426839462361 0.12113426839462361 -20.089 40.2851 26.9071 0.03493825235077916 0.03493825235077916 0.03493825235077916 -20.089 41.2851 24.9071 0.14038465966118852 0.14038465966118852 0.14038465966118852 -20.089 41.2851 25.9071 0.0 0.0 0.0 -20.089 41.2851 26.9071 0.0 0.0 0.0 -21.089 35.2851 19.9071 0.0 0.0 0.0 -21.089 35.2851 20.9071 0.0 0.0 0.0 -21.089 36.2851 19.9071 0.06514644658179562 0.06514644658179562 0.06514644658179562 -22.089 35.2851 19.9071 0.030971561000819478 0.030971561000819478 0.030971561000819478 -22.089 36.2851 19.9071 0.0 0.0 0.0 -21.089 35.2851 21.9071 0.0 0.0 0.0 -21.089 35.2851 22.9071 0.0 0.0 0.0 -21.089 36.2851 22.9071 0.0 0.0 0.0 -22.089 35.2851 21.9071 0.0 0.0 0.0 -22.089 35.2851 22.9071 0.0 0.0 0.0 -21.089 37.2851 19.9071 0.0 0.0 0.0 -21.089 37.2851 20.9071 0.010562621085685734 0.010562621085685734 0.010562621085685734 -21.089 38.2851 19.9071 0.0 0.0 0.0 -21.089 38.2851 20.9071 0.0 0.0 0.0 -22.089 37.2851 19.9071 0.0 0.0 0.0 -22.089 38.2851 19.9071 0.0 0.0 0.0 -22.089 38.2851 20.9071 0.03233981657278939 0.03233981657278939 0.03233981657278939 -21.089 37.2851 21.9071 0.0 0.0 0.0 -21.089 38.2851 21.9071 0.0 0.0 0.0 -21.089 38.2851 22.9071 0.0 0.0 0.0 -22.089 38.2851 21.9071 0.026813158310259714 0.026813158310259714 0.026813158310259714 -22.089 38.2851 22.9071 0.05131004410294176 0.05131004410294176 0.05131004410294176 -24.089 35.2851 20.9071 0.0 0.0 0.0 -24.089 36.2851 20.9071 0.12296269378207121 0.12296269378207121 0.12296269378207121 -23.089 35.2851 21.9071 0.0 0.0 0.0 -23.089 35.2851 22.9071 0.0 0.0 0.0 -23.089 36.2851 21.9071 0.0 0.0 0.0 -23.089 36.2851 22.9071 0.0 0.0 0.0 -24.089 35.2851 21.9071 0.0 0.0 0.0 -24.089 35.2851 22.9071 0.0 0.0 0.0 -24.089 36.2851 21.9071 0.0010971219358001342 0.0010971219358001342 0.0010971219358001342 -24.089 36.2851 22.9071 0.0 0.0 0.0 -23.089 37.2851 19.9071 0.0 0.0 0.0 -23.089 37.2851 20.9071 0.0 0.0 0.0 -23.089 38.2851 19.9071 0.0 0.0 0.0 -23.089 38.2851 20.9071 0.0 0.0 0.0 -24.089 37.2851 19.9071 0.0734793366279407 0.0734793366279407 0.0734793366279407 -24.089 37.2851 20.9071 0.0 0.0 0.0 -24.089 38.2851 19.9071 0.0870494688833753 0.0870494688833753 0.0870494688833753 -24.089 38.2851 20.9071 0.0969420851611266 0.0969420851611266 0.0969420851611266 -23.089 37.2851 21.9071 0.06076976141435797 0.06076976141435797 0.06076976141435797 -23.089 38.2851 21.9071 0.0 0.0 0.0 -23.089 38.2851 22.9071 0.0 0.0 0.0 -24.089 37.2851 21.9071 0.0 0.0 0.0 -24.089 37.2851 22.9071 0.0 0.0 0.0 -24.089 38.2851 21.9071 0.0 0.0 0.0 -24.089 38.2851 22.9071 0.0 0.0 0.0 -21.089 35.2851 23.9071 0.0 0.0 0.0 -21.089 35.2851 24.9071 0.0 0.0 0.0 -21.089 36.2851 23.9071 0.0 0.0 0.0 -21.089 36.2851 24.9071 0.0 0.0 0.0 -22.089 35.2851 23.9071 0.0 0.0 0.0 -22.089 36.2851 23.9071 0.0 0.0 0.0 -22.089 36.2851 24.9071 0.0 0.0 0.0 -21.089 35.2851 25.9071 0.0611265130429352 0.0611265130429352 0.0611265130429352 -21.089 36.2851 25.9071 0.019518033252827045 0.019518033252827045 0.019518033252827045 -22.089 35.2851 25.9071 0.041006058899394564 0.041006058899394564 0.041006058899394564 -22.089 35.2851 26.9071 0.0 0.0 0.0 -22.089 36.2851 25.9071 0.0 0.0 0.0 -22.089 36.2851 26.9071 0.0 0.0 0.0 -21.089 37.2851 24.9071 0.0 0.0 0.0 -21.089 38.2851 24.9071 0.027323895421010755 0.027323895421010755 0.027323895421010755 -22.089 37.2851 24.9071 0.0 0.0 0.0 -21.089 37.2851 25.9071 0.0 0.0 0.0 -21.089 37.2851 26.9071 0.05643438109907604 0.05643438109907604 0.05643438109907604 -21.089 38.2851 25.9071 0.05564950694216517 0.05564950694216517 0.05564950694216517 -21.089 38.2851 26.9071 0.0 0.0 0.0 -22.089 37.2851 25.9071 0.0 0.0 0.0 -22.089 37.2851 26.9071 0.14041963711052322 0.14041963711052322 0.14041963711052322 -22.089 38.2851 25.9071 0.0 0.0 0.0 -22.089 38.2851 26.9071 0.0 0.0 0.0 -23.089 35.2851 23.9071 0.0 0.0 0.0 -23.089 35.2851 24.9071 0.0 0.0 0.0 -23.089 36.2851 23.9071 0.0 0.0 0.0 -23.089 36.2851 24.9071 0.0 0.0 0.0 -24.089 35.2851 23.9071 0.0 0.0 0.0 -24.089 35.2851 24.9071 0.0 0.0 0.0 -24.089 36.2851 23.9071 0.0 0.0 0.0 -24.089 36.2851 24.9071 0.0 0.0 0.0 -23.089 35.2851 25.9071 0.0 0.0 0.0 -23.089 36.2851 25.9071 0.0 0.0 0.0 -24.089 35.2851 25.9071 0.0 0.0 0.0 -24.089 35.2851 26.9071 0.00913637763590929 0.00913637763590929 0.00913637763590929 -24.089 36.2851 25.9071 0.0 0.0 0.0 -24.089 36.2851 26.9071 0.0 0.0 0.0 -23.089 37.2851 23.9071 0.0 0.0 0.0 -23.089 37.2851 24.9071 0.0 0.0 0.0 -23.089 38.2851 23.9071 0.0 0.0 0.0 -23.089 38.2851 24.9071 0.0 0.0 0.0 -24.089 37.2851 23.9071 0.0 0.0 0.0 -24.089 37.2851 24.9071 0.0 0.0 0.0 -24.089 38.2851 23.9071 0.0 0.0 0.0 -24.089 38.2851 24.9071 0.0 0.0 0.0 -23.089 37.2851 25.9071 0.0 0.0 0.0 -23.089 37.2851 26.9071 0.0 0.0 0.0 -23.089 38.2851 25.9071 0.0 0.0 0.0 -23.089 38.2851 26.9071 0.0 0.0 0.0 -24.089 37.2851 25.9071 0.0 0.0 0.0 -24.089 37.2851 26.9071 0.0 0.0 0.0 -24.089 38.2851 25.9071 0.0 0.0 0.0 -24.089 38.2851 26.9071 0.0 0.0 0.0 -21.089 39.2851 21.9071 0.0 0.0 0.0 -21.089 39.2851 22.9071 0.023346827115604603 0.023346827115604603 0.023346827115604603 -22.089 39.2851 21.9071 0.0 0.0 0.0 -22.089 39.2851 22.9071 0.0 0.0 0.0 -22.089 40.2851 22.9071 0.0 0.0 0.0 -23.089 39.2851 22.9071 0.0 0.0 0.0 -23.089 40.2851 22.9071 0.03367645570505373 0.03367645570505373 0.03367645570505373 -24.089 39.2851 22.9071 0.0 0.0 0.0 -21.089 39.2851 23.9071 0.0 0.0 0.0 -21.089 40.2851 23.9071 0.0 0.0 0.0 -21.089 40.2851 24.9071 0.0 0.0 0.0 -22.089 40.2851 23.9071 0.0 0.0 0.0 -22.089 40.2851 24.9071 0.0777952039650478 0.0777952039650478 0.0777952039650478 -21.089 39.2851 26.9071 0.0 0.0 0.0 -21.089 40.2851 26.9071 0.21235643343330904 0.21235643343330904 0.21235643343330904 -22.089 39.2851 26.9071 0.0 0.0 0.0 -21.089 41.2851 23.9071 0.033831635029449504 0.033831635029449504 0.033831635029449504 -21.089 41.2851 24.9071 0.0 0.0 0.0 -22.089 41.2851 23.9071 0.0 0.0 0.0 -22.089 41.2851 24.9071 0.0 0.0 0.0 -22.089 42.2851 24.9071 0.029658994948587796 0.029658994948587796 0.029658994948587796 -21.089 41.2851 25.9071 0.0 0.0 0.0 -21.089 41.2851 26.9071 0.0863907608634869 0.0863907608634869 0.0863907608634869 -21.089 42.2851 25.9071 0.023599384576742852 0.023599384576742852 0.023599384576742852 -21.089 42.2851 26.9071 0.0 0.0 0.0 -22.089 41.2851 25.9071 0.0 0.0 0.0 -22.089 42.2851 25.9071 0.0005213713697898121 0.0005213713697898121 0.0005213713697898121 -22.089 42.2851 26.9071 0.03422856247941182 0.03422856247941182 0.03422856247941182 -23.089 39.2851 23.9071 0.0 0.0 0.0 -23.089 40.2851 23.9071 0.0 0.0 0.0 -23.089 40.2851 24.9071 0.02174815666002585 0.02174815666002585 0.02174815666002585 -24.089 39.2851 23.9071 0.0 0.0 0.0 -24.089 39.2851 24.9071 0.02678091686953141 0.02678091686953141 0.02678091686953141 -24.089 40.2851 23.9071 0.0 0.0 0.0 -24.089 40.2851 24.9071 0.03613580528251239 0.03613580528251239 0.03613580528251239 -23.089 39.2851 25.9071 0.06616831788855565 0.06616831788855565 0.06616831788855565 -23.089 39.2851 26.9071 0.0 0.0 0.0 -23.089 40.2851 25.9071 0.0 0.0 0.0 -24.089 39.2851 25.9071 0.0 0.0 0.0 -24.089 40.2851 25.9071 0.03573455781912912 0.03573455781912912 0.03573455781912912 -24.089 40.2851 26.9071 0.0 0.0 0.0 -23.089 41.2851 24.9071 0.057397252623601125 0.057397252623601125 0.057397252623601125 -23.089 42.2851 24.9071 0.01604952483754114 0.01604952483754114 0.01604952483754114 -24.089 41.2851 24.9071 0.0 0.0 0.0 -24.089 42.2851 24.9071 0.009074366360629589 0.009074366360629589 0.009074366360629589 -23.089 41.2851 26.9071 0.0 0.0 0.0 -23.089 42.2851 25.9071 0.10815158170240785 0.10815158170240785 0.10815158170240785 -23.089 42.2851 26.9071 0.0 0.0 0.0 -24.089 41.2851 25.9071 0.0 0.0 0.0 -24.089 41.2851 26.9071 0.0 0.0 0.0 -24.089 42.2851 25.9071 0.0032341454844428395 0.0032341454844428395 0.0032341454844428395 -24.089 42.2851 26.9071 0.0 0.0 0.0 -11.088999999999999 27.2851 30.9071 0.004441345987323152 0.004441345987323152 0.004441345987323152 -11.088999999999999 28.2851 30.9071 0.0 0.0 0.0 -12.088999999999999 27.2851 30.9071 0.024144783093234853 0.024144783093234853 0.024144783093234853 -12.088999999999999 28.2851 30.9071 0.08434936452511031 0.08434936452511031 0.08434936452511031 -11.088999999999999 29.2851 30.9071 0.020990359155698246 0.020990359155698246 0.020990359155698246 -12.088999999999999 29.2851 30.9071 0.070502315068545 0.070502315068545 0.070502315068545 -11.088999999999999 27.2851 31.9071 0.0 0.0 0.0 -11.088999999999999 27.2851 32.9071 0.0 0.0 0.0 -11.088999999999999 28.2851 31.9071 0.0 0.0 0.0 -11.088999999999999 28.2851 32.9071 0.0 0.0 0.0 -12.088999999999999 27.2851 31.9071 0.0 0.0 0.0 -12.088999999999999 27.2851 32.9071 0.0 0.0 0.0 -11.088999999999999 27.2851 33.9071 0.0 0.0 0.0 -11.088999999999999 27.2851 34.9071 0.0 0.0 0.0 -11.088999999999999 28.2851 33.9071 0.0 0.0 0.0 -11.088999999999999 28.2851 34.9071 0.0 0.0 0.0 -12.088999999999999 27.2851 33.9071 0.0 0.0 0.0 -12.088999999999999 27.2851 34.9071 0.0 0.0 0.0 -12.088999999999999 28.2851 33.9071 0.0 0.0 0.0 -11.088999999999999 29.2851 31.9071 0.0 0.0 0.0 -11.088999999999999 29.2851 32.9071 0.0 0.0 0.0 -11.088999999999999 30.2851 31.9071 0.0 0.0 0.0 -11.088999999999999 30.2851 32.9071 0.0 0.0 0.0 -12.088999999999999 29.2851 31.9071 0.0 0.0 0.0 -12.088999999999999 29.2851 32.9071 0.0 0.0 0.0 -12.088999999999999 30.2851 31.9071 0.0 0.0 0.0 -12.088999999999999 30.2851 32.9071 0.0 0.0 0.0 -11.088999999999999 29.2851 33.9071 0.0017271137981405365 0.0017271137981405365 0.0017271137981405365 -11.088999999999999 29.2851 34.9071 0.0 0.0 0.0 -11.088999999999999 30.2851 34.9071 0.0 0.0 0.0 -12.088999999999999 29.2851 33.9071 0.0 0.0 0.0 -12.088999999999999 29.2851 34.9071 0.021389303121862366 0.021389303121862366 0.021389303121862366 -12.088999999999999 30.2851 33.9071 0.0 0.0 0.0 -12.088999999999999 30.2851 34.9071 0.12447085517591029 0.12447085517591029 0.12447085517591029 -13.088999999999999 27.2851 27.9071 0.0 0.0 0.0 -13.088999999999999 27.2851 28.9071 0.0 0.0 0.0 -13.088999999999999 28.2851 27.9071 0.0 0.0 0.0 -13.088999999999999 28.2851 28.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 27.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 28.9071 0.0 0.0 0.0 -13.088999999999999 27.2851 29.9071 0.0 0.0 0.0 -13.088999999999999 27.2851 30.9071 0.0 0.0 0.0 -13.088999999999999 28.2851 29.9071 0.0 0.0 0.0 -13.088999999999999 28.2851 30.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 29.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 29.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 30.9071 0.0 0.0 0.0 -13.088999999999999 29.2851 27.9071 0.018879522789946913 0.018879522789946913 0.018879522789946913 -13.088999999999999 29.2851 28.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 27.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 28.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 27.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 28.9071 0.0 0.0 0.0 -13.088999999999999 29.2851 29.9071 0.0 0.0 0.0 -13.088999999999999 29.2851 30.9071 0.0 0.0 0.0 -13.088999999999999 30.2851 30.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 29.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 30.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 29.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 30.9071 0.0 0.0 0.0 -15.088999999999999 27.2851 28.9071 0.0 0.0 0.0 -16.089 27.2851 27.9071 0.0 0.0 0.0 -16.089 27.2851 28.9071 0.0 0.0 0.0 -16.089 28.2851 28.9071 0.0 0.0 0.0 -15.088999999999999 27.2851 29.9071 0.0 0.0 0.0 -15.088999999999999 27.2851 30.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 29.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 30.9071 0.0 0.0 0.0 -16.089 27.2851 29.9071 0.050497111659720526 0.050497111659720526 0.050497111659720526 -16.089 28.2851 29.9071 0.0 0.0 0.0 -16.089 28.2851 30.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 28.9071 0.0 0.0 0.0 -15.088999999999999 30.2851 27.9071 0.0 0.0 0.0 -15.088999999999999 30.2851 28.9071 0.0 0.0 0.0 -16.089 29.2851 28.9071 0.0 0.0 0.0 -16.089 30.2851 27.9071 0.0 0.0 0.0 -16.089 30.2851 28.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 29.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 30.9071 0.0 0.0 0.0 -15.088999999999999 30.2851 29.9071 0.0015251004919342932 0.0015251004919342932 0.0015251004919342932 -15.088999999999999 30.2851 30.9071 0.0 0.0 0.0 -16.089 29.2851 29.9071 0.0 0.0 0.0 -16.089 29.2851 30.9071 0.0 0.0 0.0 -16.089 30.2851 29.9071 0.0 0.0 0.0 -16.089 30.2851 30.9071 0.0 0.0 0.0 -13.088999999999999 27.2851 31.9071 0.0 0.0 0.0 -13.088999999999999 27.2851 32.9071 0.0 0.0 0.0 -13.088999999999999 28.2851 31.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 31.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 32.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 31.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 32.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 33.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 34.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 34.9071 0.06005862004002773 0.06005862004002773 0.06005862004002773 -13.088999999999999 29.2851 31.9071 0.0 0.0 0.0 -13.088999999999999 29.2851 32.9071 0.0 0.0 0.0 -13.088999999999999 30.2851 31.9071 0.0 0.0 0.0 -13.088999999999999 30.2851 32.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 31.9071 0.0 0.0 0.0 -13.088999999999999 29.2851 34.9071 0.0 0.0 0.0 -13.088999999999999 30.2851 33.9071 0.0 0.0 0.0 -13.088999999999999 30.2851 34.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 34.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 34.9071 0.0 0.0 0.0 -15.088999999999999 27.2851 32.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 31.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 32.9071 0.0 0.0 0.0 -16.089 27.2851 31.9071 0.0 0.0 0.0 -16.089 27.2851 32.9071 0.0 0.0 0.0 -16.089 28.2851 31.9071 0.0 0.0 0.0 -16.089 28.2851 32.9071 0.0 0.0 0.0 -15.088999999999999 27.2851 33.9071 0.0 0.0 0.0 -15.088999999999999 27.2851 34.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 33.9071 0.0 0.0 0.0 -15.088999999999999 28.2851 34.9071 0.0014160052198814049 0.0014160052198814049 0.0014160052198814049 -16.089 27.2851 33.9071 0.0 0.0 0.0 -16.089 27.2851 34.9071 0.0 0.0 0.0 -16.089 28.2851 33.9071 0.0 0.0 0.0 -16.089 28.2851 34.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 32.9071 0.0 0.0 0.0 -16.089 29.2851 32.9071 0.0 0.0 0.0 -16.089 30.2851 32.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 33.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 34.9071 0.0 0.0 0.0 -15.088999999999999 30.2851 33.9071 0.0 0.0 0.0 -15.088999999999999 30.2851 34.9071 0.0 0.0 0.0 -16.089 29.2851 33.9071 0.0 0.0 0.0 -16.089 29.2851 34.9071 0.0 0.0 0.0 -16.089 30.2851 33.9071 0.0 0.0 0.0 -13.088999999999999 31.2851 30.9071 0.0 0.0 0.0 -14.088999999999999 31.2851 30.9071 0.0 0.0 0.0 -16.089 32.2851 27.9071 0.0 0.0 0.0 -16.089 32.2851 28.9071 0.0 0.0 0.0 -15.088999999999999 31.2851 30.9071 0.0 0.0 0.0 -16.089 31.2851 30.9071 0.0 0.0 0.0 -16.089 32.2851 30.9071 0.0 0.0 0.0 -16.089 33.2851 27.9071 0.1286667473633924 0.1286667473633924 0.1286667473633924 -16.089 33.2851 28.9071 0.0 0.0 0.0 -16.089 34.2851 27.9071 0.0 0.0 0.0 -16.089 34.2851 28.9071 0.0 0.0 0.0 -13.088999999999999 31.2851 31.9071 0.0 0.0 0.0 -13.088999999999999 31.2851 32.9071 0.0 0.0 0.0 -13.088999999999999 32.2851 31.9071 0.0 0.0 0.0 -13.088999999999999 32.2851 32.9071 0.0 0.0 0.0 -14.088999999999999 31.2851 31.9071 0.0 0.0 0.0 -14.088999999999999 32.2851 31.9071 0.0 0.0 0.0 -14.088999999999999 32.2851 32.9071 0.0 0.0 0.0 -13.088999999999999 31.2851 33.9071 0.0 0.0 0.0 -13.088999999999999 31.2851 34.9071 0.0 0.0 0.0 -13.088999999999999 32.2851 33.9071 0.0 0.0 0.0 -14.088999999999999 31.2851 33.9071 0.0 0.0 0.0 -14.088999999999999 31.2851 34.9071 0.03806939638155626 0.03806939638155626 0.03806939638155626 -14.088999999999999 32.2851 33.9071 0.0 0.0 0.0 -14.088999999999999 32.2851 34.9071 0.03783125033230853 0.03783125033230853 0.03783125033230853 -13.088999999999999 33.2851 32.9071 0.0 0.0 0.0 -14.088999999999999 33.2851 31.9071 0.0 0.0 0.0 -14.088999999999999 33.2851 32.9071 0.0 0.0 0.0 -14.088999999999999 33.2851 33.9071 0.0 0.0 0.0 -14.088999999999999 33.2851 34.9071 0.0 0.0 0.0 -15.088999999999999 31.2851 31.9071 0.0 0.0 0.0 -15.088999999999999 32.2851 31.9071 0.0 0.0 0.0 -16.089 31.2851 31.9071 0.0 0.0 0.0 -16.089 31.2851 32.9071 0.0 0.0 0.0 -16.089 32.2851 31.9071 0.0 0.0 0.0 -16.089 32.2851 32.9071 0.0 0.0 0.0 -15.088999999999999 31.2851 33.9071 0.0 0.0 0.0 -15.088999999999999 31.2851 34.9071 0.0 0.0 0.0 -15.088999999999999 32.2851 34.9071 0.0025721958866230994 0.0025721958866230994 0.0025721958866230994 -16.089 31.2851 33.9071 0.0 0.0 0.0 -16.089 31.2851 34.9071 0.0 0.0 0.0 -16.089 32.2851 33.9071 0.0 0.0 0.0 -16.089 32.2851 34.9071 0.0 0.0 0.0 -15.088999999999999 33.2851 31.9071 0.0 0.0 0.0 -15.088999999999999 33.2851 32.9071 0.0 0.0 0.0 -16.089 33.2851 31.9071 0.0 0.0 0.0 -16.089 33.2851 32.9071 0.011773590231177519 0.011773590231177519 0.011773590231177519 -15.088999999999999 33.2851 33.9071 0.0 0.0 0.0 -15.088999999999999 33.2851 34.9071 0.0 0.0 0.0 -16.089 33.2851 33.9071 0.0025456208724107614 0.0025456208724107614 0.0025456208724107614 -10.088999999999999 28.2851 35.9071 0.0 0.0 0.0 -10.088999999999999 29.2851 35.9071 0.0 0.0 0.0 -11.088999999999999 27.2851 35.9071 0.0 0.0 0.0 -11.088999999999999 27.2851 36.9071 0.0 0.0 0.0 -11.088999999999999 28.2851 35.9071 0.0 0.0 0.0 -11.088999999999999 28.2851 36.9071 0.0 0.0 0.0 -12.088999999999999 27.2851 35.9071 0.0 0.0 0.0 -12.088999999999999 27.2851 36.9071 0.0 0.0 0.0 -12.088999999999999 28.2851 36.9071 0.0 0.0 0.0 -11.088999999999999 29.2851 35.9071 0.010752015177139326 0.010752015177139326 0.010752015177139326 -11.088999999999999 29.2851 36.9071 0.0 0.0 0.0 -11.088999999999999 30.2851 35.9071 0.0 0.0 0.0 -12.088999999999999 29.2851 36.9071 0.0 0.0 0.0 -12.088999999999999 30.2851 35.9071 0.019706876350043836 0.019706876350043836 0.019706876350043836 -12.088999999999999 30.2851 36.9071 0.0 0.0 0.0 -13.088999999999999 27.2851 36.9071 0.0 0.0 0.0 -13.088999999999999 28.2851 35.9071 0.0 0.0 0.0 -13.088999999999999 28.2851 36.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 35.9071 0.0 0.0 0.0 -14.088999999999999 27.2851 36.9071 0.0 0.0 0.0 -14.088999999999999 28.2851 35.9071 0.05259053605746387 0.05259053605746387 0.05259053605746387 -14.088999999999999 28.2851 36.9071 0.0 0.0 0.0 -13.088999999999999 29.2851 35.9071 0.0 0.0 0.0 -13.088999999999999 29.2851 36.9071 0.0 0.0 0.0 -13.088999999999999 30.2851 35.9071 0.0 0.0 0.0 -14.088999999999999 29.2851 35.9071 0.0 0.0 0.0 -14.088999999999999 30.2851 35.9071 0.0 0.0 0.0 -15.088999999999999 27.2851 35.9071 0.0 0.0 0.0 -15.088999999999999 29.2851 35.9071 0.0 0.0 0.0 -16.089 35.2851 27.9071 0.03531973392412579 0.03531973392412579 0.03531973392412579 -17.089 27.2851 28.9071 0.0027972260038905106 0.0027972260038905106 0.0027972260038905106 -18.089 27.2851 27.9071 0.0 0.0 0.0 -18.089 27.2851 28.9071 0.0 0.0 0.0 -17.089 27.2851 29.9071 0.06032069835707938 0.06032069835707938 0.06032069835707938 -17.089 27.2851 30.9071 0.0 0.0 0.0 -17.089 28.2851 29.9071 0.0 0.0 0.0 -17.089 28.2851 30.9071 0.0 0.0 0.0 -18.089 27.2851 29.9071 0.0 0.0 0.0 -18.089 27.2851 30.9071 0.0 0.0 0.0 -18.089 28.2851 29.9071 0.01921053078760763 0.01921053078760763 0.01921053078760763 -17.089 29.2851 28.9071 0.0 0.0 0.0 -17.089 30.2851 27.9071 0.018446906998471672 0.018446906998471672 0.018446906998471672 -17.089 30.2851 28.9071 0.0 0.0 0.0 -18.089 30.2851 27.9071 0.0 0.0 0.0 -18.089 30.2851 28.9071 0.0 0.0 0.0 -17.089 29.2851 29.9071 0.0 0.0 0.0 -17.089 29.2851 30.9071 0.0 0.0 0.0 -17.089 30.2851 29.9071 0.0 0.0 0.0 -17.089 30.2851 30.9071 0.0 0.0 0.0 -18.089 29.2851 30.9071 0.0 0.0 0.0 -18.089 30.2851 29.9071 0.0 0.0 0.0 -19.089 27.2851 27.9071 0.0 0.0 0.0 -19.089 27.2851 28.9071 0.0 0.0 0.0 -19.089 28.2851 28.9071 0.0 0.0 0.0 -20.089 27.2851 27.9071 0.0 0.0 0.0 -20.089 27.2851 28.9071 0.0 0.0 0.0 -20.089 28.2851 27.9071 0.18128396374613887 0.18128396374613887 0.18128396374613887 -20.089 28.2851 28.9071 0.0 0.0 0.0 -19.089 27.2851 29.9071 0.0 0.0 0.0 -19.089 27.2851 30.9071 0.12799695459428095 0.12799695459428095 0.12799695459428095 -19.089 28.2851 29.9071 0.0 0.0 0.0 -20.089 27.2851 29.9071 0.004404954771629118 0.004404954771629118 0.004404954771629118 -20.089 27.2851 30.9071 0.0 0.0 0.0 -20.089 28.2851 29.9071 0.0 0.0 0.0 -20.089 28.2851 30.9071 0.0 0.0 0.0 -20.089 29.2851 27.9071 0.1204878822037418 0.1204878822037418 0.1204878822037418 -20.089 29.2851 28.9071 0.008657244996011821 0.008657244996011821 0.008657244996011821 -20.089 30.2851 27.9071 0.0 0.0 0.0 -20.089 30.2851 28.9071 0.0 0.0 0.0 -20.089 29.2851 29.9071 0.0 0.0 0.0 -20.089 29.2851 30.9071 0.029094685858395804 0.029094685858395804 0.029094685858395804 -20.089 30.2851 29.9071 0.0 0.0 0.0 -20.089 30.2851 30.9071 0.0017170307654359662 0.0017170307654359662 0.0017170307654359662 -17.089 27.2851 31.9071 0.0 0.0 0.0 -17.089 27.2851 32.9071 0.0 0.0 0.0 -17.089 28.2851 31.9071 0.0 0.0 0.0 -18.089 27.2851 31.9071 0.0 0.0 0.0 -18.089 27.2851 32.9071 0.0 0.0 0.0 -18.089 28.2851 31.9071 0.0 0.0 0.0 -18.089 28.2851 32.9071 0.0 0.0 0.0 -17.089 27.2851 33.9071 0.0 0.0 0.0 -17.089 27.2851 34.9071 0.0 0.0 0.0 -17.089 28.2851 34.9071 0.0 0.0 0.0 -18.089 27.2851 33.9071 0.0 0.0 0.0 -18.089 27.2851 34.9071 0.0 0.0 0.0 -18.089 28.2851 33.9071 0.0 0.0 0.0 -18.089 28.2851 34.9071 0.21030060818019292 0.21030060818019292 0.21030060818019292 -17.089 29.2851 31.9071 0.0 0.0 0.0 -17.089 29.2851 32.9071 0.0 0.0 0.0 -17.089 30.2851 31.9071 0.0 0.0 0.0 -17.089 30.2851 32.9071 0.0 0.0 0.0 -18.089 29.2851 31.9071 0.0 0.0 0.0 -18.089 29.2851 32.9071 0.0 0.0 0.0 -18.089 30.2851 31.9071 0.0 0.0 0.0 -18.089 30.2851 32.9071 0.0 0.0 0.0 -17.089 29.2851 33.9071 0.0 0.0 0.0 -17.089 29.2851 34.9071 0.0 0.0 0.0 -17.089 30.2851 33.9071 0.0 0.0 0.0 -17.089 30.2851 34.9071 0.0 0.0 0.0 -18.089 29.2851 33.9071 0.0 0.0 0.0 -18.089 29.2851 34.9071 0.03422813339303191 0.03422813339303191 0.03422813339303191 -19.089 27.2851 31.9071 0.0 0.0 0.0 -19.089 27.2851 32.9071 0.0 0.0 0.0 -19.089 28.2851 31.9071 0.0 0.0 0.0 -19.089 28.2851 32.9071 0.0 0.0 0.0 -20.089 27.2851 31.9071 0.0 0.0 0.0 -20.089 28.2851 31.9071 0.0 0.0 0.0 -19.089 27.2851 33.9071 0.0 0.0 0.0 -19.089 27.2851 34.9071 0.026028865621270554 0.026028865621270554 0.026028865621270554 -19.089 28.2851 33.9071 0.0133147850200538 0.0133147850200538 0.0133147850200538 -19.089 28.2851 34.9071 0.06420537617172072 0.06420537617172072 0.06420537617172072 -20.089 27.2851 33.9071 0.0 0.0 0.0 -20.089 28.2851 33.9071 0.3886833712563575 0.3886833712563575 0.3886833712563575 -20.089 28.2851 34.9071 0.0 0.0 0.0 -19.089 29.2851 31.9071 0.0 0.0 0.0 -19.089 29.2851 32.9071 0.0 0.0 0.0 -19.089 30.2851 31.9071 0.0 0.0 0.0 -19.089 30.2851 32.9071 0.0 0.0 0.0 -20.089 29.2851 31.9071 0.013893959871311075 0.013893959871311075 0.013893959871311075 -20.089 30.2851 31.9071 0.0 0.0 0.0 -20.089 30.2851 32.9071 0.05528032807834133 0.05528032807834133 0.05528032807834133 -19.089 29.2851 33.9071 0.0 0.0 0.0 -19.089 29.2851 34.9071 0.0 0.0 0.0 -19.089 30.2851 33.9071 0.027697169235441573 0.027697169235441573 0.027697169235441573 -19.089 30.2851 34.9071 0.1334585067385421 0.1334585067385421 0.1334585067385421 -20.089 29.2851 33.9071 0.0 0.0 0.0 -20.089 29.2851 34.9071 0.0 0.0 0.0 -20.089 30.2851 33.9071 0.12527899779589252 0.12527899779589252 0.12527899779589252 -20.089 30.2851 34.9071 0.0 0.0 0.0 -17.089 31.2851 27.9071 0.0 0.0 0.0 -17.089 31.2851 28.9071 0.0 0.0 0.0 -17.089 32.2851 27.9071 0.047175019692482376 0.047175019692482376 0.047175019692482376 -17.089 32.2851 28.9071 0.0 0.0 0.0 -18.089 31.2851 27.9071 0.0 0.0 0.0 -18.089 31.2851 28.9071 0.0 0.0 0.0 -18.089 32.2851 27.9071 0.0 0.0 0.0 -18.089 32.2851 28.9071 0.0 0.0 0.0 -17.089 31.2851 29.9071 0.0 0.0 0.0 -17.089 31.2851 30.9071 0.0 0.0 0.0 -17.089 32.2851 29.9071 0.0 0.0 0.0 -17.089 32.2851 30.9071 0.0 0.0 0.0 -18.089 31.2851 29.9071 0.0 0.0 0.0 -18.089 32.2851 29.9071 0.0 0.0 0.0 -18.089 32.2851 30.9071 0.0 0.0 0.0 -17.089 33.2851 28.9071 0.0 0.0 0.0 -17.089 34.2851 27.9071 0.0 0.0 0.0 -17.089 34.2851 28.9071 0.0 0.0 0.0 -18.089 33.2851 28.9071 0.0 0.0 0.0 -18.089 34.2851 27.9071 0.04841051282465199 0.04841051282465199 0.04841051282465199 -18.089 34.2851 28.9071 0.0 0.0 0.0 -17.089 33.2851 30.9071 0.0 0.0 0.0 -17.089 34.2851 29.9071 0.0 0.0 0.0 -17.089 34.2851 30.9071 0.0 0.0 0.0 -18.089 33.2851 29.9071 0.0 0.0 0.0 -18.089 33.2851 30.9071 0.0 0.0 0.0 -18.089 34.2851 29.9071 0.0 0.0 0.0 -19.089 31.2851 27.9071 0.0 0.0 0.0 -19.089 32.2851 27.9071 0.0 0.0 0.0 -19.089 32.2851 28.9071 0.0 0.0 0.0 -20.089 31.2851 27.9071 0.012509682663641395 0.012509682663641395 0.012509682663641395 -20.089 31.2851 28.9071 0.026783156051399432 0.026783156051399432 0.026783156051399432 -20.089 32.2851 27.9071 0.0 0.0 0.0 -20.089 32.2851 28.9071 0.003552971763598633 0.003552971763598633 0.003552971763598633 -20.089 31.2851 29.9071 0.002171166765813059 0.002171166765813059 0.002171166765813059 -19.089 33.2851 27.9071 0.009186377038615738 0.009186377038615738 0.009186377038615738 -19.089 33.2851 28.9071 0.0 0.0 0.0 -19.089 34.2851 27.9071 0.002110511234812878 0.002110511234812878 0.002110511234812878 -19.089 34.2851 28.9071 0.010376842657182533 0.010376842657182533 0.010376842657182533 -20.089 33.2851 27.9071 0.0 0.0 0.0 -20.089 33.2851 28.9071 0.0 0.0 0.0 -20.089 34.2851 27.9071 0.0 0.0 0.0 -20.089 34.2851 28.9071 0.0 0.0 0.0 -19.089 33.2851 30.9071 0.0 0.0 0.0 -19.089 34.2851 29.9071 0.0 0.0 0.0 -19.089 34.2851 30.9071 0.024267804093850962 0.024267804093850962 0.024267804093850962 -20.089 33.2851 29.9071 0.0 0.0 0.0 -20.089 33.2851 30.9071 0.03274130988032708 0.03274130988032708 0.03274130988032708 -20.089 34.2851 29.9071 0.04164032760637987 0.04164032760637987 0.04164032760637987 -20.089 34.2851 30.9071 0.05694140307112639 0.05694140307112639 0.05694140307112639 -17.089 31.2851 32.9071 0.0 0.0 0.0 -17.089 32.2851 31.9071 0.0 0.0 0.0 -17.089 32.2851 32.9071 0.13109346175088987 0.13109346175088987 0.13109346175088987 -17.089 31.2851 33.9071 0.0 0.0 0.0 -17.089 31.2851 34.9071 0.0 0.0 0.0 -17.089 32.2851 33.9071 0.0 0.0 0.0 -17.089 32.2851 34.9071 0.0 0.0 0.0 -17.089 33.2851 31.9071 0.0 0.0 0.0 -17.089 33.2851 32.9071 0.2940880794376572 0.2940880794376572 0.2940880794376572 -17.089 34.2851 31.9071 0.15555228563300122 0.15555228563300122 0.15555228563300122 -17.089 34.2851 32.9071 0.1291756970158447 0.1291756970158447 0.1291756970158447 -18.089 33.2851 31.9071 0.27558070260880557 0.27558070260880557 0.27558070260880557 -18.089 33.2851 32.9071 0.2140622166092065 0.2140622166092065 0.2140622166092065 -18.089 34.2851 31.9071 0.28410059985384795 0.28410059985384795 0.28410059985384795 -18.089 34.2851 32.9071 0.0 0.0 0.0 -17.089 33.2851 33.9071 0.0 0.0 0.0 -17.089 33.2851 34.9071 0.0 0.0 0.0 -17.089 34.2851 33.9071 0.0 0.0 0.0 -17.089 34.2851 34.9071 0.0 0.0 0.0 -18.089 33.2851 34.9071 0.0 0.0 0.0 -18.089 34.2851 33.9071 0.0 0.0 0.0 -18.089 34.2851 34.9071 0.0 0.0 0.0 -19.089 32.2851 31.9071 0.0 0.0 0.0 -19.089 32.2851 32.9071 0.1769339731109252 0.1769339731109252 0.1769339731109252 -20.089 31.2851 31.9071 0.0 0.0 0.0 -20.089 31.2851 32.9071 0.0160628610572025 0.0160628610572025 0.0160628610572025 -20.089 32.2851 31.9071 0.0 0.0 0.0 -20.089 32.2851 32.9071 0.0 0.0 0.0 -20.089 31.2851 33.9071 0.0 0.0 0.0 -20.089 31.2851 34.9071 0.07123366408051408 0.07123366408051408 0.07123366408051408 -20.089 32.2851 33.9071 0.0 0.0 0.0 -20.089 32.2851 34.9071 0.0 0.0 0.0 -19.089 33.2851 31.9071 0.0 0.0 0.0 -19.089 33.2851 32.9071 0.3130003914077002 0.3130003914077002 0.3130003914077002 -19.089 34.2851 31.9071 0.0 0.0 0.0 -19.089 34.2851 32.9071 0.13312005659541012 0.13312005659541012 0.13312005659541012 -20.089 33.2851 31.9071 0.013349780174341245 0.013349780174341245 0.013349780174341245 -20.089 33.2851 32.9071 0.0 0.0 0.0 -20.089 34.2851 31.9071 0.0 0.0 0.0 -20.089 34.2851 32.9071 0.0 0.0 0.0 -19.089 34.2851 33.9071 0.0 0.0 0.0 -19.089 34.2851 34.9071 0.006985149768564104 0.006985149768564104 0.006985149768564104 -20.089 33.2851 33.9071 0.0 0.0 0.0 -20.089 33.2851 34.9071 0.0 0.0 0.0 -20.089 34.2851 33.9071 0.04507982959866473 0.04507982959866473 0.04507982959866473 -20.089 34.2851 34.9071 0.0 0.0 0.0 -21.089 27.2851 27.9071 0.0 0.0 0.0 -21.089 27.2851 28.9071 0.0 0.0 0.0 -21.089 28.2851 27.9071 0.06535744936175392 0.06535744936175392 0.06535744936175392 -21.089 28.2851 28.9071 0.0 0.0 0.0 -22.089 27.2851 27.9071 0.0 0.0 0.0 -22.089 28.2851 27.9071 0.0 0.0 0.0 -21.089 27.2851 29.9071 0.0 0.0 0.0 -21.089 27.2851 30.9071 0.11219200027409765 0.11219200027409765 0.11219200027409765 -21.089 28.2851 29.9071 0.0 0.0 0.0 -21.089 28.2851 30.9071 0.0 0.0 0.0 -22.089 27.2851 30.9071 0.0 0.0 0.0 -22.089 28.2851 30.9071 0.0 0.0 0.0 -21.089 29.2851 27.9071 0.0 0.0 0.0 -21.089 29.2851 28.9071 0.0 0.0 0.0 -21.089 30.2851 28.9071 0.014713981298680553 0.014713981298680553 0.014713981298680553 -22.089 29.2851 27.9071 0.0 0.0 0.0 -22.089 29.2851 28.9071 0.0 0.0 0.0 -22.089 30.2851 27.9071 0.0 0.0 0.0 -22.089 30.2851 28.9071 0.0 0.0 0.0 -21.089 29.2851 29.9071 0.0 0.0 0.0 -21.089 29.2851 30.9071 0.0 0.0 0.0 -21.089 30.2851 29.9071 0.03885112271267844 0.03885112271267844 0.03885112271267844 -21.089 30.2851 30.9071 0.09838579282077946 0.09838579282077946 0.09838579282077946 -22.089 29.2851 29.9071 0.0 0.0 0.0 -22.089 29.2851 30.9071 0.0 0.0 0.0 -22.089 30.2851 29.9071 0.0 0.0 0.0 -22.089 30.2851 30.9071 0.09118766294083565 0.09118766294083565 0.09118766294083565 -24.089 27.2851 28.9071 0.09927085870521545 0.09927085870521545 0.09927085870521545 -23.089 27.2851 29.9071 0.0 0.0 0.0 -23.089 27.2851 30.9071 0.0 0.0 0.0 -23.089 28.2851 30.9071 0.0 0.0 0.0 -24.089 27.2851 29.9071 0.12980876642657072 0.12980876642657072 0.12980876642657072 -24.089 27.2851 30.9071 0.0 0.0 0.0 -24.089 28.2851 29.9071 0.04138148892850591 0.04138148892850591 0.04138148892850591 -24.089 28.2851 30.9071 0.0 0.0 0.0 -23.089 29.2851 27.9071 0.0 0.0 0.0 -23.089 30.2851 27.9071 0.0 0.0 0.0 -23.089 30.2851 28.9071 0.0 0.0 0.0 -24.089 29.2851 27.9071 0.0 0.0 0.0 -23.089 29.2851 29.9071 0.0 0.0 0.0 -23.089 29.2851 30.9071 0.02033539445620473 0.02033539445620473 0.02033539445620473 -23.089 30.2851 29.9071 0.01755120777446729 0.01755120777446729 0.01755120777446729 -23.089 30.2851 30.9071 0.06549996785093205 0.06549996785093205 0.06549996785093205 -24.089 29.2851 29.9071 0.0 0.0 0.0 -24.089 29.2851 30.9071 0.0 0.0 0.0 -24.089 30.2851 29.9071 0.0 0.0 0.0 -24.089 30.2851 30.9071 0.0 0.0 0.0 -21.089 27.2851 31.9071 0.0 0.0 0.0 -21.089 27.2851 32.9071 0.35449426849471566 0.35449426849471566 0.35449426849471566 -21.089 28.2851 31.9071 0.17103846997906416 0.17103846997906416 0.17103846997906416 -21.089 28.2851 32.9071 0.36237531786148136 0.36237531786148136 0.36237531786148136 -22.089 27.2851 31.9071 0.0 0.0 0.0 -22.089 27.2851 32.9071 0.0 0.0 0.0 -22.089 28.2851 31.9071 0.2037593113955505 0.2037593113955505 0.2037593113955505 -22.089 28.2851 32.9071 0.0 0.0 0.0 -21.089 27.2851 33.9071 0.2737990817972041 0.2737990817972041 0.2737990817972041 -21.089 27.2851 34.9071 0.0 0.0 0.0 -21.089 28.2851 33.9071 0.0 0.0 0.0 -21.089 28.2851 34.9071 0.3001195880664453 0.3001195880664453 0.3001195880664453 -22.089 27.2851 33.9071 0.0 0.0 0.0 -22.089 27.2851 34.9071 0.3912542354558212 0.3912542354558212 0.3912542354558212 -22.089 28.2851 33.9071 0.0 0.0 0.0 -22.089 28.2851 34.9071 0.0 0.0 0.0 -21.089 29.2851 31.9071 0.0 0.0 0.0 -21.089 29.2851 32.9071 0.0 0.0 0.0 -21.089 30.2851 31.9071 0.10905968959138047 0.10905968959138047 0.10905968959138047 -21.089 30.2851 32.9071 0.0 0.0 0.0 -22.089 29.2851 31.9071 0.03882465729884023 0.03882465729884023 0.03882465729884023 -22.089 30.2851 31.9071 0.3935759276735847 0.3935759276735847 0.3935759276735847 -21.089 29.2851 33.9071 0.0 0.0 0.0 -21.089 29.2851 34.9071 0.0 0.0 0.0 -21.089 30.2851 33.9071 0.11045979469337987 0.11045979469337987 0.11045979469337987 -21.089 30.2851 34.9071 0.0 0.0 0.0 -22.089 29.2851 34.9071 0.0 0.0 0.0 -22.089 30.2851 34.9071 0.0 0.0 0.0 -23.089 27.2851 32.9071 0.10610516991390104 0.10610516991390104 0.10610516991390104 -23.089 28.2851 31.9071 0.0 0.0 0.0 -23.089 28.2851 32.9071 0.020551359725119313 0.020551359725119313 0.020551359725119313 -24.089 27.2851 31.9071 0.0 0.0 0.0 -24.089 27.2851 32.9071 0.380350326044402 0.380350326044402 0.380350326044402 -24.089 28.2851 31.9071 0.10084751736989303 0.10084751736989303 0.10084751736989303 -24.089 28.2851 32.9071 0.0 0.0 0.0 -23.089 27.2851 33.9071 0.0 0.0 0.0 -23.089 27.2851 34.9071 0.23747061721974957 0.23747061721974957 0.23747061721974957 -23.089 28.2851 33.9071 0.0 0.0 0.0 -23.089 28.2851 34.9071 0.0 0.0 0.0 -24.089 27.2851 33.9071 0.0 0.0 0.0 -24.089 27.2851 34.9071 0.5050129386736453 0.5050129386736453 0.5050129386736453 -24.089 28.2851 33.9071 0.1371568856822919 0.1371568856822919 0.1371568856822919 -24.089 28.2851 34.9071 0.21540672704279287 0.21540672704279287 0.21540672704279287 -23.089 29.2851 31.9071 0.22814137568611578 0.22814137568611578 0.22814137568611578 -23.089 30.2851 31.9071 0.0 0.0 0.0 -24.089 29.2851 31.9071 0.0 0.0 0.0 -23.089 29.2851 33.9071 0.47446475893880563 0.47446475893880563 0.47446475893880563 -23.089 29.2851 34.9071 0.004443908701351509 0.004443908701351509 0.004443908701351509 -23.089 30.2851 33.9071 0.0 0.0 0.0 -23.089 30.2851 34.9071 0.0 0.0 0.0 -24.089 29.2851 33.9071 0.0 0.0 0.0 -24.089 29.2851 34.9071 0.06371934357912658 0.06371934357912658 0.06371934357912658 -24.089 30.2851 33.9071 0.0 0.0 0.0 -24.089 30.2851 34.9071 0.0 0.0 0.0 -21.089 31.2851 28.9071 0.013367146125524391 0.013367146125524391 0.013367146125524391 -21.089 32.2851 27.9071 0.0 0.0 0.0 -21.089 32.2851 28.9071 0.0 0.0 0.0 -22.089 31.2851 28.9071 0.014605696221416466 0.014605696221416466 0.014605696221416466 -22.089 32.2851 27.9071 0.0 0.0 0.0 -22.089 32.2851 28.9071 0.0 0.0 0.0 -22.089 31.2851 29.9071 0.0 0.0 0.0 -22.089 31.2851 30.9071 0.02447244442508134 0.02447244442508134 0.02447244442508134 -22.089 32.2851 29.9071 0.0 0.0 0.0 -22.089 32.2851 30.9071 0.0 0.0 0.0 -22.089 33.2851 27.9071 0.0 0.0 0.0 -21.089 33.2851 30.9071 0.0 0.0 0.0 -21.089 34.2851 30.9071 0.0 0.0 0.0 -22.089 33.2851 30.9071 0.0 0.0 0.0 -22.089 34.2851 30.9071 0.0 0.0 0.0 -23.089 31.2851 27.9071 0.0 0.0 0.0 -23.089 31.2851 28.9071 0.0 0.0 0.0 -23.089 32.2851 27.9071 0.0 0.0 0.0 -23.089 32.2851 28.9071 0.0 0.0 0.0 -24.089 31.2851 27.9071 0.0 0.0 0.0 -24.089 31.2851 28.9071 0.0 0.0 0.0 -24.089 32.2851 27.9071 0.0 0.0 0.0 -24.089 32.2851 28.9071 0.0 0.0 0.0 -23.089 31.2851 29.9071 0.0 0.0 0.0 -23.089 31.2851 30.9071 0.09444880590594797 0.09444880590594797 0.09444880590594797 -23.089 32.2851 29.9071 0.0 0.0 0.0 -23.089 32.2851 30.9071 0.0 0.0 0.0 -24.089 31.2851 29.9071 0.0 0.0 0.0 -24.089 31.2851 30.9071 0.0 0.0 0.0 -24.089 32.2851 29.9071 0.013365872358817683 0.013365872358817683 0.013365872358817683 -24.089 32.2851 30.9071 0.02960436476189962 0.02960436476189962 0.02960436476189962 -23.089 33.2851 27.9071 0.00021778445417116262 0.00021778445417116262 0.00021778445417116262 -23.089 33.2851 28.9071 0.015344682740196059 0.015344682740196059 0.015344682740196059 -23.089 34.2851 27.9071 0.0318702828330274 0.0318702828330274 0.0318702828330274 -23.089 34.2851 28.9071 0.14639290278127468 0.14639290278127468 0.14639290278127468 -24.089 33.2851 27.9071 0.017783385697566868 0.017783385697566868 0.017783385697566868 -24.089 33.2851 28.9071 0.0 0.0 0.0 -24.089 34.2851 27.9071 0.0 0.0 0.0 -24.089 34.2851 28.9071 0.0 0.0 0.0 -23.089 34.2851 29.9071 0.0 0.0 0.0 -24.089 33.2851 29.9071 0.0 0.0 0.0 -24.089 33.2851 30.9071 0.028843637728044873 0.028843637728044873 0.028843637728044873 -24.089 34.2851 29.9071 0.11068618520964647 0.11068618520964647 0.11068618520964647 -21.089 31.2851 31.9071 0.2581761818243969 0.2581761818243969 0.2581761818243969 -21.089 31.2851 32.9071 0.0 0.0 0.0 -21.089 32.2851 31.9071 0.0 0.0 0.0 -21.089 32.2851 32.9071 0.0 0.0 0.0 -22.089 31.2851 31.9071 0.3300003197059253 0.3300003197059253 0.3300003197059253 -22.089 32.2851 31.9071 0.0 0.0 0.0 -22.089 32.2851 32.9071 0.0 0.0 0.0 -21.089 31.2851 33.9071 0.3244771856607583 0.3244771856607583 0.3244771856607583 -21.089 31.2851 34.9071 0.021607041501317134 0.021607041501317134 0.021607041501317134 -21.089 32.2851 33.9071 0.0 0.0 0.0 -21.089 32.2851 34.9071 0.0 0.0 0.0 -22.089 31.2851 34.9071 0.0 0.0 0.0 -22.089 32.2851 34.9071 0.0 0.0 0.0 -21.089 33.2851 31.9071 0.0 0.0 0.0 -21.089 33.2851 32.9071 0.0 0.0 0.0 -21.089 34.2851 31.9071 0.030858583997498024 0.030858583997498024 0.030858583997498024 -22.089 33.2851 31.9071 0.0 0.0 0.0 -22.089 33.2851 32.9071 0.0 0.0 0.0 -22.089 34.2851 31.9071 0.0 0.0 0.0 -22.089 34.2851 32.9071 0.0 0.0 0.0 -21.089 33.2851 33.9071 0.0 0.0 0.0 -21.089 33.2851 34.9071 0.0 0.0 0.0 -22.089 33.2851 33.9071 0.0 0.0 0.0 -22.089 33.2851 34.9071 0.0 0.0 0.0 -23.089 31.2851 31.9071 0.24707956318751922 0.24707956318751922 0.24707956318751922 -23.089 32.2851 31.9071 0.0 0.0 0.0 -24.089 32.2851 31.9071 0.0 0.0 0.0 -23.089 31.2851 33.9071 0.25099475680974714 0.25099475680974714 0.25099475680974714 -23.089 31.2851 34.9071 0.09013161867538952 0.09013161867538952 0.09013161867538952 -23.089 32.2851 34.9071 0.1866155550707442 0.1866155550707442 0.1866155550707442 -24.089 31.2851 33.9071 0.0 0.0 0.0 -24.089 31.2851 34.9071 0.0 0.0 0.0 -24.089 32.2851 34.9071 0.24947512532942415 0.24947512532942415 0.24947512532942415 -23.089 33.2851 31.9071 0.0 0.0 0.0 -23.089 33.2851 32.9071 0.0036709599661919026 0.0036709599661919026 0.0036709599661919026 -23.089 34.2851 32.9071 0.04376799378802047 0.04376799378802047 0.04376799378802047 -24.089 34.2851 32.9071 0.09183466709261776 0.09183466709261776 0.09183466709261776 -23.089 33.2851 33.9071 0.0 0.0 0.0 -23.089 33.2851 34.9071 0.0 0.0 0.0 -23.089 34.2851 33.9071 0.0 0.0 0.0 -24.089 33.2851 33.9071 0.0 0.0 0.0 -24.089 33.2851 34.9071 0.0 0.0 0.0 -24.089 34.2851 33.9071 0.002453271616217258 0.002453271616217258 0.002453271616217258 -24.089 34.2851 34.9071 0.0 0.0 0.0 -17.089 30.2851 35.9071 0.0 0.0 0.0 -18.089 29.2851 35.9071 0.09655315950979448 0.09655315950979448 0.09655315950979448 -18.089 30.2851 35.9071 0.02063596981724437 0.02063596981724437 0.02063596981724437 -18.089 30.2851 36.9071 0.0 0.0 0.0 -19.089 27.2851 35.9071 0.0 0.0 0.0 -19.089 27.2851 36.9071 0.0 0.0 0.0 -19.089 28.2851 35.9071 0.0 0.0 0.0 -19.089 28.2851 36.9071 0.15796300091110846 0.15796300091110846 0.15796300091110846 -20.089 27.2851 36.9071 0.5376457081687321 0.5376457081687321 0.5376457081687321 -20.089 28.2851 35.9071 0.0 0.0 0.0 -20.089 28.2851 36.9071 0.0 0.0 0.0 -20.089 27.2851 37.9071 0.14569458920391035 0.14569458920391035 0.14569458920391035 -20.089 28.2851 37.9071 0.3883747851929197 0.3883747851929197 0.3883747851929197 -19.089 29.2851 35.9071 0.0 0.0 0.0 -19.089 30.2851 35.9071 0.0 0.0 0.0 -19.089 30.2851 36.9071 0.03787719685641754 0.03787719685641754 0.03787719685641754 -20.089 29.2851 35.9071 0.8353432861204907 0.8353432861204907 0.8353432861204907 -20.089 29.2851 36.9071 0.347182728809579 0.347182728809579 0.347182728809579 -20.089 30.2851 35.9071 0.2900811781149117 0.2900811781149117 0.2900811781149117 -20.089 30.2851 36.9071 0.20796625501128788 0.20796625501128788 0.20796625501128788 -20.089 29.2851 37.9071 0.40845181301355815 0.40845181301355815 0.40845181301355815 -20.089 30.2851 37.9071 0.0 0.0 0.0 -17.089 31.2851 35.9071 0.0 0.0 0.0 -17.089 32.2851 35.9071 0.0 0.0 0.0 -18.089 31.2851 35.9071 0.0 0.0 0.0 -18.089 31.2851 36.9071 0.0 0.0 0.0 -18.089 32.2851 35.9071 0.0 0.0 0.0 -18.089 32.2851 36.9071 0.0 0.0 0.0 -17.089 33.2851 35.9071 0.0 0.0 0.0 -18.089 33.2851 35.9071 0.0 0.0 0.0 -18.089 33.2851 36.9071 0.0 0.0 0.0 -18.089 34.2851 35.9071 0.0 0.0 0.0 -19.089 31.2851 36.9071 0.0 0.0 0.0 -19.089 32.2851 36.9071 0.0 0.0 0.0 -20.089 31.2851 35.9071 0.13024766548755382 0.13024766548755382 0.13024766548755382 -20.089 31.2851 36.9071 0.0 0.0 0.0 -20.089 32.2851 35.9071 0.0 0.0 0.0 -20.089 32.2851 36.9071 0.07331909682879001 0.07331909682879001 0.07331909682879001 -20.089 31.2851 37.9071 0.06634657197680988 0.06634657197680988 0.06634657197680988 -19.089 33.2851 36.9071 0.0 0.0 0.0 -19.089 34.2851 35.9071 0.0 0.0 0.0 -19.089 34.2851 36.9071 0.0 0.0 0.0 -20.089 33.2851 35.9071 0.0 0.0 0.0 -20.089 33.2851 36.9071 0.0 0.0 0.0 -20.089 34.2851 35.9071 0.0 0.0 0.0 -21.089 27.2851 35.9071 0.0 0.0 0.0 -21.089 27.2851 36.9071 0.0 0.0 0.0 -21.089 28.2851 35.9071 0.0 0.0 0.0 -22.089 27.2851 35.9071 0.28815375395346016 0.28815375395346016 0.28815375395346016 -22.089 27.2851 36.9071 0.0 0.0 0.0 -22.089 28.2851 35.9071 0.0 0.0 0.0 -21.089 27.2851 37.9071 0.5179363199080619 0.5179363199080619 0.5179363199080619 -21.089 27.2851 38.9071 0.0 0.0 0.0 -21.089 28.2851 37.9071 0.0 0.0 0.0 -21.089 28.2851 38.9071 0.0 0.0 0.0 -22.089 27.2851 37.9071 0.354055325785753 0.354055325785753 0.354055325785753 -22.089 27.2851 38.9071 0.014059339791571503 0.014059339791571503 0.014059339791571503 -22.089 28.2851 38.9071 0.07396873579714025 0.07396873579714025 0.07396873579714025 -21.089 29.2851 35.9071 0.5307765426679303 0.5307765426679303 0.5307765426679303 -21.089 30.2851 35.9071 0.05156658629357879 0.05156658629357879 0.05156658629357879 -21.089 30.2851 36.9071 0.08470303776881354 0.08470303776881354 0.08470303776881354 -22.089 29.2851 35.9071 0.0 0.0 0.0 -22.089 30.2851 35.9071 0.0 0.0 0.0 -22.089 30.2851 36.9071 0.0 0.0 0.0 -21.089 29.2851 37.9071 0.5484584695159226 0.5484584695159226 0.5484584695159226 -21.089 29.2851 38.9071 0.0 0.0 0.0 -21.089 30.2851 37.9071 0.03306788671577221 0.03306788671577221 0.03306788671577221 -21.089 30.2851 38.9071 0.06486503102663642 0.06486503102663642 0.06486503102663642 -22.089 29.2851 38.9071 0.030323463012703666 0.030323463012703666 0.030323463012703666 -22.089 30.2851 37.9071 0.0 0.0 0.0 -22.089 30.2851 38.9071 0.008793428084753018 0.008793428084753018 0.008793428084753018 -23.089 27.2851 35.9071 0.0 0.0 0.0 -23.089 27.2851 36.9071 0.2755113177968498 0.2755113177968498 0.2755113177968498 -23.089 28.2851 35.9071 0.2264312353895118 0.2264312353895118 0.2264312353895118 -24.089 27.2851 35.9071 0.36407638148872645 0.36407638148872645 0.36407638148872645 -23.089 27.2851 37.9071 0.049892918503553124 0.049892918503553124 0.049892918503553124 -23.089 27.2851 38.9071 0.025808635062021378 0.025808635062021378 0.025808635062021378 -23.089 28.2851 37.9071 0.17687661949058384 0.17687661949058384 0.17687661949058384 -23.089 28.2851 38.9071 0.0 0.0 0.0 -24.089 27.2851 37.9071 0.0 0.0 0.0 -24.089 28.2851 37.9071 0.16876763862179264 0.16876763862179264 0.16876763862179264 -24.089 28.2851 38.9071 0.0 0.0 0.0 -23.089 30.2851 35.9071 0.0 0.0 0.0 -23.089 30.2851 36.9071 0.0 0.0 0.0 -24.089 29.2851 35.9071 0.10225981392984079 0.10225981392984079 0.10225981392984079 -24.089 29.2851 36.9071 0.0 0.0 0.0 -24.089 30.2851 35.9071 0.0 0.0 0.0 -24.089 30.2851 36.9071 0.0 0.0 0.0 -23.089 29.2851 37.9071 0.06512273318173792 0.06512273318173792 0.06512273318173792 -23.089 29.2851 38.9071 0.0 0.0 0.0 -23.089 30.2851 37.9071 0.0 0.0 0.0 -24.089 29.2851 37.9071 0.0 0.0 0.0 -24.089 30.2851 37.9071 0.0 0.0 0.0 -21.089 28.2851 39.9071 0.10225797537494002 0.10225797537494002 0.10225797537494002 -22.089 28.2851 39.9071 0.09838608964903561 0.09838608964903561 0.09838608964903561 -21.089 29.2851 39.9071 0.05450868192253559 0.05450868192253559 0.05450868192253559 -22.089 29.2851 39.9071 0.03181460192897235 0.03181460192897235 0.03181460192897235 -21.089 31.2851 36.9071 0.054707413937541666 0.054707413937541666 0.054707413937541666 -21.089 32.2851 35.9071 0.0 0.0 0.0 -22.089 31.2851 35.9071 0.0 0.0 0.0 -22.089 31.2851 36.9071 0.0 0.0 0.0 -21.089 31.2851 37.9071 0.015540684304564867 0.015540684304564867 0.015540684304564867 -21.089 33.2851 35.9071 0.0 0.0 0.0 -23.089 31.2851 35.9071 0.0 0.0 0.0 -23.089 31.2851 36.9071 0.0 0.0 0.0 -23.089 32.2851 35.9071 0.243137639140916 0.243137639140916 0.243137639140916 -23.089 32.2851 36.9071 0.0 0.0 0.0 -24.089 31.2851 35.9071 0.12469132065281384 0.12469132065281384 0.12469132065281384 -24.089 31.2851 36.9071 0.08481452992019593 0.08481452992019593 0.08481452992019593 -24.089 32.2851 35.9071 0.220606805472336 0.220606805472336 0.220606805472336 -23.089 31.2851 37.9071 0.09290425513235813 0.09290425513235813 0.09290425513235813 -23.089 32.2851 37.9071 0.0 0.0 0.0 -23.089 32.2851 38.9071 0.0 0.0 0.0 -24.089 31.2851 37.9071 0.0 0.0 0.0 -24.089 32.2851 37.9071 0.0 0.0 0.0 -24.089 32.2851 38.9071 0.0 0.0 0.0 -23.089 33.2851 35.9071 0.11007312519056156 0.11007312519056156 0.11007312519056156 -23.089 33.2851 36.9071 0.0 0.0 0.0 -23.089 34.2851 35.9071 0.2311242939405187 0.2311242939405187 0.2311242939405187 -23.089 34.2851 36.9071 0.0 0.0 0.0 -24.089 33.2851 35.9071 0.08555155394000093 0.08555155394000093 0.08555155394000093 -24.089 34.2851 35.9071 0.3475411927053672 0.3475411927053672 0.3475411927053672 -24.089 34.2851 36.9071 0.0 0.0 0.0 -23.089 33.2851 37.9071 0.01310445632595306 0.01310445632595306 0.01310445632595306 -23.089 33.2851 38.9071 0.0 0.0 0.0 -23.089 34.2851 37.9071 0.028418700040826125 0.028418700040826125 0.028418700040826125 -23.089 34.2851 38.9071 0.0 0.0 0.0 -24.089 34.2851 37.9071 0.0 0.0 0.0 -24.089 34.2851 38.9071 0.0 0.0 0.0 -23.089 32.2851 39.9071 0.0 0.0 0.0 -23.089 32.2851 40.9071 0.0 0.0 0.0 -24.089 32.2851 39.9071 0.005049534023618496 0.005049534023618496 0.005049534023618496 -24.089 32.2851 40.9071 0.0 0.0 0.0 -23.089 33.2851 39.9071 0.0 0.0 0.0 -23.089 33.2851 40.9071 0.0 0.0 0.0 -23.089 34.2851 39.9071 0.0 0.0 0.0 -23.089 34.2851 40.9071 0.0 0.0 0.0 -24.089 33.2851 40.9071 0.0 0.0 0.0 -24.089 34.2851 40.9071 0.022293555463566928 0.022293555463566928 0.022293555463566928 -17.089 35.2851 27.9071 0.0 0.0 0.0 -18.089 35.2851 27.9071 0.0 0.0 0.0 -17.089 35.2851 29.9071 0.0 0.0 0.0 -17.089 35.2851 30.9071 0.0 0.0 0.0 -17.089 36.2851 30.9071 0.001217006968860025 0.001217006968860025 0.001217006968860025 -18.089 35.2851 29.9071 0.0 0.0 0.0 -18.089 36.2851 29.9071 0.0 0.0 0.0 -18.089 36.2851 30.9071 0.14483819965864908 0.14483819965864908 0.14483819965864908 -19.089 35.2851 27.9071 0.23987694171728388 0.23987694171728388 0.23987694171728388 -19.089 36.2851 27.9071 0.24174264303151266 0.24174264303151266 0.24174264303151266 -20.089 35.2851 27.9071 0.0 0.0 0.0 -20.089 35.2851 28.9071 0.0 0.0 0.0 -20.089 36.2851 27.9071 0.0 0.0 0.0 -20.089 36.2851 28.9071 0.0 0.0 0.0 -19.089 35.2851 29.9071 0.0 0.0 0.0 -19.089 35.2851 30.9071 0.12383086240028883 0.12383086240028883 0.12383086240028883 -19.089 36.2851 29.9071 0.0 0.0 0.0 -19.089 36.2851 30.9071 0.0 0.0 0.0 -20.089 35.2851 29.9071 0.31223640898447064 0.31223640898447064 0.31223640898447064 -20.089 35.2851 30.9071 0.28203652971465804 0.28203652971465804 0.28203652971465804 -19.089 37.2851 27.9071 0.1418399870227956 0.1418399870227956 0.1418399870227956 -20.089 37.2851 27.9071 0.0 0.0 0.0 -20.089 37.2851 28.9071 0.0 0.0 0.0 -17.089 35.2851 31.9071 0.0 0.0 0.0 -17.089 35.2851 32.9071 0.0026912961270281247 0.0026912961270281247 0.0026912961270281247 -17.089 36.2851 31.9071 0.007457724389688521 0.007457724389688521 0.007457724389688521 -18.089 35.2851 31.9071 0.18620736487906603 0.18620736487906603 0.18620736487906603 -18.089 35.2851 32.9071 0.0 0.0 0.0 -18.089 36.2851 31.9071 0.0 0.0 0.0 -19.089 35.2851 31.9071 0.11606329138767871 0.11606329138767871 0.11606329138767871 -19.089 35.2851 32.9071 0.14721553885877192 0.14721553885877192 0.14721553885877192 -19.089 36.2851 31.9071 0.20014337489316178 0.20014337489316178 0.20014337489316178 -20.089 35.2851 31.9071 0.3522179606754566 0.3522179606754566 0.3522179606754566 -21.089 35.2851 28.9071 0.0 0.0 0.0 -21.089 36.2851 28.9071 0.0 0.0 0.0 -22.089 35.2851 28.9071 0.0 0.0 0.0 -22.089 36.2851 28.9071 0.0 0.0 0.0 -21.089 35.2851 29.9071 0.02394385385769882 0.02394385385769882 0.02394385385769882 -21.089 35.2851 30.9071 0.042535540089071545 0.042535540089071545 0.042535540089071545 -21.089 36.2851 29.9071 0.0 0.0 0.0 -21.089 36.2851 30.9071 0.0 0.0 0.0 -22.089 35.2851 29.9071 0.012162377891648512 0.012162377891648512 0.012162377891648512 -22.089 35.2851 30.9071 0.06169680114158428 0.06169680114158428 0.06169680114158428 -22.089 36.2851 29.9071 0.0 0.0 0.0 -22.089 36.2851 30.9071 0.0 0.0 0.0 -21.089 37.2851 27.9071 0.06460370337137067 0.06460370337137067 0.06460370337137067 -21.089 37.2851 28.9071 0.07037104033427027 0.07037104033427027 0.07037104033427027 -22.089 37.2851 27.9071 0.10917234763772406 0.10917234763772406 0.10917234763772406 -22.089 37.2851 28.9071 0.0 0.0 0.0 -22.089 37.2851 30.9071 0.1939885572655358 0.1939885572655358 0.1939885572655358 -23.089 35.2851 28.9071 0.07519342696355252 0.07519342696355252 0.07519342696355252 -23.089 36.2851 28.9071 0.0 0.0 0.0 -24.089 35.2851 27.9071 0.003557065770380281 0.003557065770380281 0.003557065770380281 -24.089 35.2851 28.9071 0.0 0.0 0.0 -24.089 36.2851 27.9071 0.025027182765204197 0.025027182765204197 0.025027182765204197 -24.089 36.2851 28.9071 0.0 0.0 0.0 -23.089 35.2851 29.9071 0.10972434978629345 0.10972434978629345 0.10972434978629345 -23.089 36.2851 29.9071 0.0 0.0 0.0 -23.089 36.2851 30.9071 0.1334277657167736 0.1334277657167736 0.1334277657167736 -24.089 35.2851 29.9071 0.028145939852646244 0.028145939852646244 0.028145939852646244 -24.089 35.2851 30.9071 0.0 0.0 0.0 -24.089 36.2851 29.9071 0.0 0.0 0.0 -24.089 36.2851 30.9071 0.050094114047991904 0.050094114047991904 0.050094114047991904 -23.089 37.2851 27.9071 0.0001674548794648025 0.0001674548794648025 0.0001674548794648025 -23.089 37.2851 28.9071 0.0 0.0 0.0 -23.089 38.2851 27.9071 0.006983845169174163 0.006983845169174163 0.006983845169174163 -23.089 38.2851 28.9071 0.05601904045447146 0.05601904045447146 0.05601904045447146 -24.089 37.2851 27.9071 0.0 0.0 0.0 -24.089 37.2851 28.9071 0.0 0.0 0.0 -24.089 38.2851 27.9071 0.0023806415320368054 0.0023806415320368054 0.0023806415320368054 -24.089 38.2851 28.9071 0.005435945822822917 0.005435945822822917 0.005435945822822917 -23.089 37.2851 30.9071 0.06378561840808765 0.06378561840808765 0.06378561840808765 -23.089 38.2851 29.9071 0.0 0.0 0.0 -24.089 37.2851 29.9071 0.0 0.0 0.0 -24.089 37.2851 30.9071 0.04345588195993718 0.04345588195993718 0.04345588195993718 -24.089 38.2851 29.9071 0.0 0.0 0.0 -24.089 38.2851 30.9071 0.04855876941992899 0.04855876941992899 0.04855876941992899 -21.089 35.2851 31.9071 0.0 0.0 0.0 -21.089 35.2851 32.9071 0.039562091720226435 0.039562091720226435 0.039562091720226435 -21.089 36.2851 31.9071 0.3443305416562311 0.3443305416562311 0.3443305416562311 -22.089 35.2851 31.9071 0.0 0.0 0.0 -22.089 35.2851 32.9071 0.0 0.0 0.0 -22.089 36.2851 31.9071 0.0 0.0 0.0 -22.089 36.2851 32.9071 0.0 0.0 0.0 -22.089 37.2851 31.9071 0.33292071421291053 0.33292071421291053 0.33292071421291053 -23.089 35.2851 32.9071 0.0 0.0 0.0 -23.089 36.2851 31.9071 0.0 0.0 0.0 -23.089 36.2851 32.9071 0.0 0.0 0.0 -24.089 35.2851 31.9071 0.0 0.0 0.0 -24.089 35.2851 32.9071 0.3392450283894757 0.3392450283894757 0.3392450283894757 -24.089 36.2851 31.9071 0.0 0.0 0.0 -24.089 36.2851 32.9071 0.0 0.0 0.0 -24.089 35.2851 33.9071 0.21641474402840088 0.21641474402840088 0.21641474402840088 -24.089 36.2851 33.9071 0.22439349638928066 0.22439349638928066 0.22439349638928066 -24.089 36.2851 34.9071 0.0 0.0 0.0 -23.089 37.2851 31.9071 0.0 0.0 0.0 -24.089 37.2851 32.9071 0.44087842107263203 0.44087842107263203 0.44087842107263203 -24.089 38.2851 32.9071 0.0 0.0 0.0 -24.089 37.2851 33.9071 0.17470795628478855 0.17470795628478855 0.17470795628478855 -24.089 37.2851 34.9071 0.27418376009743267 0.27418376009743267 0.27418376009743267 -24.089 38.2851 33.9071 0.0 0.0 0.0 -24.089 38.2851 34.9071 0.0 0.0 0.0 -21.089 40.2851 27.9071 0.0 0.0 0.0 -22.089 39.2851 27.9071 0.0 0.0 0.0 -22.089 40.2851 27.9071 0.0 0.0 0.0 -21.089 41.2851 27.9071 0.0 0.0 0.0 -21.089 42.2851 27.9071 0.0 0.0 0.0 -22.089 41.2851 27.9071 0.040868849796136544 0.040868849796136544 0.040868849796136544 -22.089 42.2851 27.9071 0.008692493249422327 0.008692493249422327 0.008692493249422327 -23.089 39.2851 27.9071 0.01617578105981956 0.01617578105981956 0.01617578105981956 -23.089 39.2851 28.9071 0.0 0.0 0.0 -23.089 40.2851 27.9071 0.03976020049078037 0.03976020049078037 0.03976020049078037 -23.089 40.2851 28.9071 0.0 0.0 0.0 -24.089 40.2851 27.9071 0.007071900412176351 0.007071900412176351 0.007071900412176351 -24.089 40.2851 28.9071 0.0 0.0 0.0 -23.089 39.2851 29.9071 0.0 0.0 0.0 -23.089 39.2851 30.9071 0.20235515664038445 0.20235515664038445 0.20235515664038445 -23.089 40.2851 29.9071 0.0 0.0 0.0 -23.089 40.2851 30.9071 0.2336602626665821 0.2336602626665821 0.2336602626665821 -24.089 39.2851 30.9071 0.06899180058024669 0.06899180058024669 0.06899180058024669 -24.089 40.2851 29.9071 0.35654186274959615 0.35654186274959615 0.35654186274959615 -24.089 40.2851 30.9071 0.4322917478467703 0.4322917478467703 0.4322917478467703 -23.089 41.2851 27.9071 0.0 0.0 0.0 -23.089 41.2851 28.9071 0.0 0.0 0.0 -23.089 42.2851 27.9071 0.018158368682186756 0.018158368682186756 0.018158368682186756 -24.089 41.2851 27.9071 0.0 0.0 0.0 -24.089 41.2851 28.9071 0.0 0.0 0.0 -23.089 41.2851 29.9071 0.0 0.0 0.0 -24.089 41.2851 29.9071 0.23726219377427926 0.23726219377427926 0.23726219377427926 -24.089 41.2851 30.9071 0.0 0.0 0.0 -23.089 35.2851 38.9071 0.0 0.0 0.0 -24.089 35.2851 37.9071 0.0 0.0 0.0 -24.089 35.2851 38.9071 0.012645687591947145 0.012645687591947145 0.012645687591947145 -24.089 36.2851 37.9071 0.0 0.0 0.0 -24.089 36.2851 38.9071 0.0 0.0 0.0 -24.089 37.2851 38.9071 0.22403423467165984 0.22403423467165984 0.22403423467165984 -23.089 35.2851 39.9071 0.0 0.0 0.0 -24.089 35.2851 39.9071 0.0 0.0 0.0 -24.089 35.2851 40.9071 0.0 0.0 0.0 -24.089 36.2851 39.9071 0.03244750184864921 0.03244750184864921 0.03244750184864921 -28.089 18.2851 22.9071 0.0 0.0 0.0 -25.089 17.2851 25.9071 0.0 0.0 0.0 -25.089 17.2851 26.9071 0.0 0.0 0.0 -25.089 18.2851 25.9071 0.0 0.0 0.0 -25.089 18.2851 26.9071 0.0 0.0 0.0 -28.089 18.2851 23.9071 0.22109597835243522 0.22109597835243522 0.22109597835243522 -29.089 18.2851 22.9071 1.0 1.0 1.0 -30.089 18.2851 22.9071 1.0 1.0 1.0 -29.089 18.2851 23.9071 0.39778885525992974 0.39778885525992974 0.39778885525992974 -29.089 18.2851 24.9071 0.03026026161503961 0.03026026161503961 0.03026026161503961 -30.089 18.2851 23.9071 0.23503643515278713 0.23503643515278713 0.23503643515278713 -28.089 22.2851 14.9071 0.0 0.0 0.0 -25.089 22.2851 15.9071 0.0 0.0 0.0 -25.089 22.2851 16.9071 0.0 0.0 0.0 -26.089 22.2851 15.9071 0.0 0.0 0.0 -26.089 22.2851 16.9071 0.03845385806558914 0.03845385806558914 0.03845385806558914 -26.089 22.2851 17.9071 0.0 0.0 0.0 -26.089 22.2851 18.9071 0.0 0.0 0.0 -27.089 22.2851 15.9071 0.0 0.0 0.0 -27.089 22.2851 16.9071 0.0 0.0 0.0 -28.089 21.2851 15.9071 0.0 0.0 0.0 -28.089 21.2851 16.9071 0.004615880717153815 0.004615880717153815 0.004615880717153815 -28.089 22.2851 15.9071 0.0 0.0 0.0 -28.089 22.2851 16.9071 0.0 0.0 0.0 -27.089 22.2851 17.9071 0.0 0.0 0.0 -27.089 22.2851 18.9071 0.0 0.0 0.0 -28.089 22.2851 17.9071 0.0 0.0 0.0 -28.089 22.2851 18.9071 0.0 0.0 0.0 -25.089 23.2851 14.9071 0.0 0.0 0.0 -25.089 24.2851 13.9071 0.0 0.0 0.0 -25.089 24.2851 14.9071 0.22277385403123345 0.22277385403123345 0.22277385403123345 -26.089 23.2851 14.9071 0.0 0.0 0.0 -26.089 24.2851 14.9071 0.0 0.0 0.0 -25.089 25.2851 13.9071 0.0 0.0 0.0 -25.089 25.2851 14.9071 0.0 0.0 0.0 -25.089 26.2851 13.9071 0.0 0.0 0.0 -25.089 26.2851 14.9071 0.0 0.0 0.0 -26.089 25.2851 14.9071 0.19017501187564748 0.19017501187564748 0.19017501187564748 -26.089 26.2851 14.9071 0.0 0.0 0.0 -27.089 23.2851 14.9071 0.0 0.0 0.0 -27.089 24.2851 14.9071 0.0 0.0 0.0 -28.089 23.2851 14.9071 0.0 0.0 0.0 -27.089 25.2851 14.9071 0.0 0.0 0.0 -25.089 23.2851 15.9071 0.0 0.0 0.0 -25.089 23.2851 16.9071 0.0 0.0 0.0 -25.089 24.2851 15.9071 0.028638314213460667 0.028638314213460667 0.028638314213460667 -25.089 24.2851 16.9071 0.0 0.0 0.0 -26.089 23.2851 15.9071 0.0 0.0 0.0 -26.089 23.2851 16.9071 0.0 0.0 0.0 -25.089 23.2851 17.9071 0.0 0.0 0.0 -25.089 23.2851 18.9071 0.0 0.0 0.0 -25.089 24.2851 17.9071 0.0 0.0 0.0 -25.089 24.2851 18.9071 0.0 0.0 0.0 -26.089 23.2851 17.9071 0.0 0.0 0.0 -26.089 23.2851 18.9071 0.0 0.0 0.0 -26.089 24.2851 17.9071 0.0 0.0 0.0 -26.089 24.2851 18.9071 0.0 0.0 0.0 -26.089 26.2851 15.9071 0.0 0.0 0.0 -26.089 26.2851 16.9071 0.05373487918927868 0.05373487918927868 0.05373487918927868 -25.089 25.2851 17.9071 0.0 0.0 0.0 -25.089 25.2851 18.9071 0.0 0.0 0.0 -25.089 26.2851 17.9071 0.027385047609585305 0.027385047609585305 0.027385047609585305 -25.089 26.2851 18.9071 0.0 0.0 0.0 -26.089 25.2851 17.9071 0.0 0.0 0.0 -26.089 25.2851 18.9071 0.0 0.0 0.0 -26.089 26.2851 17.9071 0.03160563979525786 0.03160563979525786 0.03160563979525786 -26.089 26.2851 18.9071 0.0 0.0 0.0 -27.089 23.2851 15.9071 0.0 0.0 0.0 -27.089 24.2851 15.9071 0.0 0.0 0.0 -28.089 23.2851 15.9071 0.0 0.0 0.0 -28.089 24.2851 15.9071 0.0 0.0 0.0 -27.089 23.2851 18.9071 0.0 0.0 0.0 -27.089 24.2851 18.9071 0.0 0.0 0.0 -28.089 23.2851 18.9071 0.0 0.0 0.0 -28.089 24.2851 17.9071 0.0 0.0 0.0 -28.089 24.2851 18.9071 0.0044654441916895625 0.0044654441916895625 0.0044654441916895625 -27.089 25.2851 15.9071 0.0 0.0 0.0 -27.089 25.2851 16.9071 0.03545527793983099 0.03545527793983099 0.03545527793983099 -27.089 26.2851 15.9071 0.012828220969773062 0.012828220969773062 0.012828220969773062 -27.089 26.2851 16.9071 0.01552824758267428 0.01552824758267428 0.01552824758267428 -28.089 25.2851 15.9071 0.0 0.0 0.0 -28.089 25.2851 16.9071 0.0 0.0 0.0 -28.089 26.2851 16.9071 0.0 0.0 0.0 -27.089 25.2851 17.9071 0.0 0.0 0.0 -27.089 25.2851 18.9071 0.0 0.0 0.0 -27.089 26.2851 17.9071 0.0 0.0 0.0 -27.089 26.2851 18.9071 0.0 0.0 0.0 -28.089 25.2851 17.9071 0.0 0.0 0.0 -28.089 25.2851 18.9071 0.0 0.0 0.0 -28.089 26.2851 17.9071 0.0 0.0 0.0 -28.089 26.2851 18.9071 0.0 0.0 0.0 -29.089 22.2851 14.9071 0.3776680983855098 0.3776680983855098 0.3776680983855098 -29.089 21.2851 15.9071 0.0 0.0 0.0 -29.089 21.2851 16.9071 0.0 0.0 0.0 -29.089 22.2851 15.9071 0.0 0.0 0.0 -29.089 22.2851 16.9071 0.0 0.0 0.0 -30.089 22.2851 15.9071 0.0 0.0 0.0 -30.089 22.2851 16.9071 0.0 0.0 0.0 -29.089 22.2851 17.9071 0.0 0.0 0.0 -29.089 22.2851 18.9071 0.06983399160832982 0.06983399160832982 0.06983399160832982 -30.089 22.2851 17.9071 0.0 0.0 0.0 -30.089 22.2851 18.9071 0.0 0.0 0.0 -32.089 20.2851 16.9071 0.11145008355439329 0.11145008355439329 0.11145008355439329 -32.089 20.2851 17.9071 0.116429493826524 0.116429493826524 0.116429493826524 -32.089 20.2851 18.9071 0.0030102444387000034 0.0030102444387000034 0.0030102444387000034 -32.089 21.2851 16.9071 0.01868868499414522 0.01868868499414522 0.01868868499414522 -32.089 22.2851 16.9071 0.0 0.0 0.0 -31.089 21.2851 17.9071 0.023418828108857256 0.023418828108857256 0.023418828108857256 -31.089 21.2851 18.9071 0.04133673269135113 0.04133673269135113 0.04133673269135113 -31.089 22.2851 17.9071 0.0 0.0 0.0 -31.089 22.2851 18.9071 0.13432188846359075 0.13432188846359075 0.13432188846359075 -32.089 21.2851 17.9071 0.008355421420071627 0.008355421420071627 0.008355421420071627 -32.089 21.2851 18.9071 0.02643095219478818 0.02643095219478818 0.02643095219478818 -32.089 22.2851 17.9071 0.0 0.0 0.0 -32.089 22.2851 18.9071 0.022726814143560595 0.022726814143560595 0.022726814143560595 -29.089 23.2851 14.9071 0.0 0.0 0.0 -29.089 23.2851 15.9071 0.0 0.0 0.0 -29.089 24.2851 15.9071 0.0 0.0 0.0 -30.089 23.2851 15.9071 0.0 0.0 0.0 -30.089 23.2851 16.9071 0.0 0.0 0.0 -30.089 24.2851 15.9071 0.0 0.0 0.0 -30.089 24.2851 16.9071 0.0 0.0 0.0 -29.089 23.2851 18.9071 0.0 0.0 0.0 -29.089 24.2851 17.9071 0.0 0.0 0.0 -29.089 24.2851 18.9071 0.0 0.0 0.0 -30.089 23.2851 17.9071 0.0 0.0 0.0 -30.089 23.2851 18.9071 0.0061087018351145515 0.0061087018351145515 0.0061087018351145515 -30.089 24.2851 17.9071 0.0 0.0 0.0 -30.089 24.2851 18.9071 0.0 0.0 0.0 -29.089 25.2851 15.9071 0.0 0.0 0.0 -29.089 25.2851 16.9071 0.0 0.0 0.0 -29.089 26.2851 16.9071 0.0 0.0 0.0 -30.089 25.2851 15.9071 0.0 0.0 0.0 -30.089 25.2851 16.9071 0.0 0.0 0.0 -29.089 25.2851 17.9071 0.0 0.0 0.0 -29.089 26.2851 17.9071 0.0 0.0 0.0 -29.089 26.2851 18.9071 0.0 0.0 0.0 -30.089 25.2851 17.9071 0.0 0.0 0.0 -30.089 26.2851 17.9071 0.0 0.0 0.0 -30.089 26.2851 18.9071 0.0 0.0 0.0 -32.089 23.2851 16.9071 0.0 0.0 0.0 -31.089 23.2851 17.9071 0.0 0.0 0.0 -31.089 23.2851 18.9071 0.1107490499757976 0.1107490499757976 0.1107490499757976 -31.089 24.2851 17.9071 0.0 0.0 0.0 -31.089 24.2851 18.9071 0.04224210923277738 0.04224210923277738 0.04224210923277738 -32.089 23.2851 17.9071 0.025925235938904924 0.025925235938904924 0.025925235938904924 -32.089 23.2851 18.9071 0.0 0.0 0.0 -32.089 24.2851 17.9071 0.0 0.0 0.0 -31.089 25.2851 17.9071 0.0 0.0 0.0 -31.089 25.2851 18.9071 0.0 0.0 0.0 -31.089 26.2851 18.9071 0.0 0.0 0.0 -32.089 25.2851 17.9071 0.0 0.0 0.0 -32.089 25.2851 18.9071 0.0 0.0 0.0 -32.089 26.2851 18.9071 0.0 0.0 0.0 -25.089 22.2851 19.9071 0.0 0.0 0.0 -25.089 22.2851 20.9071 0.012004415722640646 0.012004415722640646 0.012004415722640646 -26.089 21.2851 22.9071 0.0 0.0 0.0 -26.089 22.2851 22.9071 0.0 0.0 0.0 -28.089 19.2851 20.9071 0.0 0.0 0.0 -28.089 20.2851 19.9071 0.022010099948590718 0.022010099948590718 0.022010099948590718 -28.089 20.2851 20.9071 0.14368034719093445 0.14368034719093445 0.14368034719093445 -27.089 19.2851 22.9071 0.1154157104105317 0.1154157104105317 0.1154157104105317 -27.089 20.2851 22.9071 0.27633819979178237 0.27633819979178237 0.27633819979178237 -28.089 19.2851 21.9071 0.28062673125374815 0.28062673125374815 0.28062673125374815 -28.089 19.2851 22.9071 0.0 0.0 0.0 -28.089 20.2851 21.9071 0.2564761575565821 0.2564761575565821 0.2564761575565821 -28.089 20.2851 22.9071 0.23752223916824416 0.23752223916824416 0.23752223916824416 -28.089 21.2851 19.9071 0.00011615609014565216 0.00011615609014565216 0.00011615609014565216 -28.089 21.2851 20.9071 0.0 0.0 0.0 -28.089 22.2851 20.9071 0.21753627837890183 0.21753627837890183 0.21753627837890183 -27.089 21.2851 22.9071 0.31897386001951195 0.31897386001951195 0.31897386001951195 -27.089 22.2851 21.9071 0.0 0.0 0.0 -27.089 22.2851 22.9071 0.4134872727095811 0.4134872727095811 0.4134872727095811 -28.089 21.2851 21.9071 0.0 0.0 0.0 -28.089 21.2851 22.9071 0.0 0.0 0.0 -28.089 22.2851 21.9071 0.0 0.0 0.0 -28.089 22.2851 22.9071 0.19453106931145847 0.19453106931145847 0.19453106931145847 -25.089 19.2851 25.9071 0.0 0.0 0.0 -25.089 19.2851 26.9071 0.0 0.0 0.0 -25.089 20.2851 25.9071 0.18106810319085231 0.18106810319085231 0.18106810319085231 -25.089 20.2851 26.9071 0.23143329564852713 0.23143329564852713 0.23143329564852713 -26.089 21.2851 23.9071 0.0 0.0 0.0 -26.089 21.2851 24.9071 0.12551283700583457 0.12551283700583457 0.12551283700583457 -26.089 22.2851 23.9071 0.054277093209676226 0.054277093209676226 0.054277093209676226 -26.089 22.2851 24.9071 0.021678689416039617 0.021678689416039617 0.021678689416039617 -25.089 22.2851 26.9071 0.0 0.0 0.0 -26.089 22.2851 25.9071 0.4004025604890162 0.4004025604890162 0.4004025604890162 -26.089 22.2851 26.9071 0.25459526772237745 0.25459526772237745 0.25459526772237745 -27.089 19.2851 23.9071 0.0 0.0 0.0 -27.089 20.2851 23.9071 0.03611005577814791 0.03611005577814791 0.03611005577814791 -28.089 19.2851 23.9071 0.0 0.0 0.0 -28.089 19.2851 24.9071 0.0 0.0 0.0 -28.089 20.2851 23.9071 0.0 0.0 0.0 -28.089 20.2851 24.9071 0.0 0.0 0.0 -27.089 21.2851 23.9071 0.026037261273310443 0.026037261273310443 0.026037261273310443 -27.089 21.2851 24.9071 0.06411300060594519 0.06411300060594519 0.06411300060594519 -27.089 22.2851 24.9071 0.0 0.0 0.0 -28.089 21.2851 23.9071 0.0 0.0 0.0 -28.089 21.2851 24.9071 0.0 0.0 0.0 -28.089 22.2851 24.9071 0.0014638896692700284 0.0014638896692700284 0.0014638896692700284 -27.089 21.2851 25.9071 0.0 0.0 0.0 -27.089 21.2851 26.9071 0.0 0.0 0.0 -27.089 22.2851 25.9071 0.4621262233953111 0.4621262233953111 0.4621262233953111 -27.089 22.2851 26.9071 0.41151513430301256 0.41151513430301256 0.41151513430301256 -28.089 21.2851 25.9071 0.4138978086564724 0.4138978086564724 0.4138978086564724 -28.089 21.2851 26.9071 0.47381091185266166 0.47381091185266166 0.47381091185266166 -28.089 22.2851 25.9071 0.4357104177372352 0.4357104177372352 0.4357104177372352 -25.089 23.2851 19.9071 0.0 0.0 0.0 -25.089 23.2851 20.9071 0.0107299666447841 0.0107299666447841 0.0107299666447841 -25.089 24.2851 19.9071 0.0 0.0 0.0 -25.089 24.2851 20.9071 0.0 0.0 0.0 -26.089 24.2851 19.9071 0.0 0.0 0.0 -26.089 24.2851 20.9071 0.0 0.0 0.0 -25.089 23.2851 21.9071 0.012949561222764784 0.012949561222764784 0.012949561222764784 -25.089 24.2851 21.9071 0.0 0.0 0.0 -25.089 24.2851 22.9071 0.0 0.0 0.0 -26.089 23.2851 22.9071 0.0 0.0 0.0 -26.089 24.2851 21.9071 0.0 0.0 0.0 -25.089 25.2851 19.9071 0.0 0.0 0.0 -25.089 25.2851 20.9071 0.0 0.0 0.0 -25.089 26.2851 19.9071 0.0 0.0 0.0 -25.089 26.2851 20.9071 0.0 0.0 0.0 -26.089 25.2851 19.9071 0.0 0.0 0.0 -26.089 25.2851 20.9071 0.0 0.0 0.0 -26.089 26.2851 19.9071 0.0 0.0 0.0 -26.089 26.2851 20.9071 0.0 0.0 0.0 -25.089 25.2851 21.9071 0.0 0.0 0.0 -25.089 25.2851 22.9071 0.5343687897142881 0.5343687897142881 0.5343687897142881 -25.089 26.2851 21.9071 0.0 0.0 0.0 -25.089 26.2851 22.9071 0.0 0.0 0.0 -26.089 25.2851 21.9071 0.0 0.0 0.0 -26.089 26.2851 21.9071 0.0 0.0 0.0 -26.089 26.2851 22.9071 0.0 0.0 0.0 -27.089 24.2851 19.9071 0.0 0.0 0.0 -27.089 24.2851 20.9071 0.0 0.0 0.0 -28.089 24.2851 19.9071 0.05066755047542194 0.05066755047542194 0.05066755047542194 -28.089 24.2851 20.9071 0.005356277302411416 0.005356277302411416 0.005356277302411416 -27.089 23.2851 21.9071 0.0 0.0 0.0 -27.089 23.2851 22.9071 0.0 0.0 0.0 -27.089 24.2851 21.9071 0.0 0.0 0.0 -27.089 24.2851 22.9071 0.3881132460244555 0.3881132460244555 0.3881132460244555 -28.089 23.2851 21.9071 0.031473167272763856 0.031473167272763856 0.031473167272763856 -28.089 23.2851 22.9071 0.048714665017437264 0.048714665017437264 0.048714665017437264 -28.089 24.2851 21.9071 0.011606577485552832 0.011606577485552832 0.011606577485552832 -28.089 24.2851 22.9071 0.0 0.0 0.0 -27.089 25.2851 19.9071 0.0 0.0 0.0 -27.089 26.2851 19.9071 0.0 0.0 0.0 -27.089 26.2851 20.9071 0.0 0.0 0.0 -28.089 25.2851 19.9071 0.0 0.0 0.0 -28.089 26.2851 19.9071 0.0 0.0 0.0 -28.089 26.2851 20.9071 0.0 0.0 0.0 -27.089 25.2851 21.9071 0.0 0.0 0.0 -27.089 25.2851 22.9071 0.0 0.0 0.0 -27.089 26.2851 21.9071 0.0 0.0 0.0 -27.089 26.2851 22.9071 0.4453669339492385 0.4453669339492385 0.4453669339492385 -28.089 25.2851 21.9071 0.0 0.0 0.0 -28.089 25.2851 22.9071 0.0037271889566769 0.0037271889566769 0.0037271889566769 -28.089 26.2851 21.9071 0.0 0.0 0.0 -28.089 26.2851 22.9071 0.03954752619828766 0.03954752619828766 0.03954752619828766 -25.089 24.2851 23.9071 0.0 0.0 0.0 -25.089 24.2851 24.9071 0.0 0.0 0.0 -26.089 23.2851 23.9071 0.002501245797512396 0.002501245797512396 0.002501245797512396 -26.089 23.2851 24.9071 0.0 0.0 0.0 -25.089 23.2851 26.9071 0.34082791353730524 0.34082791353730524 0.34082791353730524 -25.089 24.2851 26.9071 0.28760398216366373 0.28760398216366373 0.28760398216366373 -26.089 23.2851 25.9071 0.5085298418738753 0.5085298418738753 0.5085298418738753 -26.089 23.2851 26.9071 0.3627110096690817 0.3627110096690817 0.3627110096690817 -26.089 24.2851 26.9071 0.4404211968117631 0.4404211968117631 0.4404211968117631 -25.089 25.2851 23.9071 0.07447401740717732 0.07447401740717732 0.07447401740717732 -25.089 25.2851 24.9071 0.0 0.0 0.0 -25.089 26.2851 23.9071 0.5483980398950391 0.5483980398950391 0.5483980398950391 -25.089 26.2851 24.9071 0.0 0.0 0.0 -26.089 26.2851 23.9071 0.0 0.0 0.0 -26.089 26.2851 24.9071 0.0 0.0 0.0 -25.089 25.2851 25.9071 0.41817163459673906 0.41817163459673906 0.41817163459673906 -25.089 25.2851 26.9071 0.48062951651105124 0.48062951651105124 0.48062951651105124 -25.089 26.2851 25.9071 0.6126620407174109 0.6126620407174109 0.6126620407174109 -25.089 26.2851 26.9071 0.444606072242449 0.444606072242449 0.444606072242449 -26.089 25.2851 26.9071 0.5377734485433424 0.5377734485433424 0.5377734485433424 -26.089 26.2851 25.9071 0.5391220802570491 0.5391220802570491 0.5391220802570491 -26.089 26.2851 26.9071 0.5886943862740891 0.5886943862740891 0.5886943862740891 -27.089 23.2851 23.9071 0.0066346138526198395 0.0066346138526198395 0.0066346138526198395 -27.089 23.2851 24.9071 0.0 0.0 0.0 -27.089 24.2851 23.9071 0.5141943526905223 0.5141943526905223 0.5141943526905223 -27.089 24.2851 24.9071 0.5155584937341482 0.5155584937341482 0.5155584937341482 -28.089 23.2851 23.9071 0.0 0.0 0.0 -28.089 23.2851 24.9071 0.0 0.0 0.0 -28.089 24.2851 23.9071 0.0 0.0 0.0 -28.089 24.2851 24.9071 0.1850540219999329 0.1850540219999329 0.1850540219999329 -27.089 23.2851 25.9071 0.5266230789589852 0.5266230789589852 0.5266230789589852 -27.089 24.2851 25.9071 0.319166611926711 0.319166611926711 0.319166611926711 -27.089 24.2851 26.9071 0.18065161616108447 0.18065161616108447 0.18065161616108447 -28.089 23.2851 25.9071 0.0 0.0 0.0 -28.089 24.2851 25.9071 0.23366754141196128 0.23366754141196128 0.23366754141196128 -28.089 24.2851 26.9071 0.3693209964568605 0.3693209964568605 0.3693209964568605 -27.089 25.2851 23.9071 0.6415609374479659 0.6415609374479659 0.6415609374479659 -27.089 25.2851 24.9071 0.0 0.0 0.0 -27.089 26.2851 23.9071 0.661439090216652 0.661439090216652 0.661439090216652 -27.089 26.2851 24.9071 0.30060495853739116 0.30060495853739116 0.30060495853739116 -28.089 25.2851 23.9071 0.0 0.0 0.0 -28.089 25.2851 24.9071 0.0 0.0 0.0 -28.089 26.2851 24.9071 0.3550519860922554 0.3550519860922554 0.3550519860922554 -27.089 25.2851 25.9071 0.0 0.0 0.0 -27.089 25.2851 26.9071 0.1642036280043869 0.1642036280043869 0.1642036280043869 -27.089 26.2851 25.9071 0.3620944630019115 0.3620944630019115 0.3620944630019115 -27.089 26.2851 26.9071 0.3496630623447358 0.3496630623447358 0.3496630623447358 -28.089 25.2851 25.9071 0.0 0.0 0.0 -28.089 25.2851 26.9071 0.0 0.0 0.0 -28.089 26.2851 25.9071 0.0 0.0 0.0 -28.089 26.2851 26.9071 0.14973848626019542 0.14973848626019542 0.14973848626019542 -29.089 19.2851 20.9071 0.0 0.0 0.0 -29.089 20.2851 19.9071 0.09385340778178362 0.09385340778178362 0.09385340778178362 -29.089 20.2851 20.9071 0.2770505805130648 0.2770505805130648 0.2770505805130648 -30.089 19.2851 20.9071 0.0 0.0 0.0 -30.089 20.2851 19.9071 0.22070631829767934 0.22070631829767934 0.22070631829767934 -30.089 20.2851 20.9071 0.0 0.0 0.0 -29.089 19.2851 21.9071 0.12112819062154166 0.12112819062154166 0.12112819062154166 -29.089 19.2851 22.9071 0.0 0.0 0.0 -30.089 19.2851 21.9071 0.07667327377040614 0.07667327377040614 0.07667327377040614 -30.089 19.2851 22.9071 0.15148304511877553 0.15148304511877553 0.15148304511877553 -30.089 20.2851 21.9071 0.0 0.0 0.0 -29.089 21.2851 19.9071 0.0 0.0 0.0 -29.089 21.2851 20.9071 0.0 0.0 0.0 -29.089 22.2851 19.9071 0.0 0.0 0.0 -29.089 22.2851 20.9071 0.0 0.0 0.0 -30.089 21.2851 19.9071 0.0 0.0 0.0 -30.089 21.2851 20.9071 0.0 0.0 0.0 -30.089 22.2851 19.9071 0.004228220243357313 0.004228220243357313 0.004228220243357313 -30.089 22.2851 20.9071 0.028633735588448877 0.028633735588448877 0.028633735588448877 -29.089 22.2851 21.9071 0.12625885026836603 0.12625885026836603 0.12625885026836603 -29.089 22.2851 22.9071 0.0 0.0 0.0 -30.089 21.2851 21.9071 0.12275207036444417 0.12275207036444417 0.12275207036444417 -30.089 22.2851 21.9071 0.35386315364436655 0.35386315364436655 0.35386315364436655 -30.089 22.2851 22.9071 0.14441639557407984 0.14441639557407984 0.14441639557407984 -31.089 20.2851 20.9071 0.0 0.0 0.0 -32.089 20.2851 19.9071 0.07237511434807008 0.07237511434807008 0.07237511434807008 -31.089 19.2851 21.9071 0.0 0.0 0.0 -31.089 19.2851 22.9071 0.08670254537525872 0.08670254537525872 0.08670254537525872 -31.089 20.2851 21.9071 0.07614219266829517 0.07614219266829517 0.07614219266829517 -32.089 19.2851 21.9071 0.06108925270928815 0.06108925270928815 0.06108925270928815 -32.089 19.2851 22.9071 0.0 0.0 0.0 -32.089 20.2851 21.9071 0.0 0.0 0.0 -32.089 20.2851 22.9071 0.0 0.0 0.0 -31.089 21.2851 19.9071 0.0 0.0 0.0 -31.089 21.2851 20.9071 0.0 0.0 0.0 -31.089 22.2851 19.9071 0.11177389306627847 0.11177389306627847 0.11177389306627847 -31.089 22.2851 20.9071 0.0 0.0 0.0 -32.089 21.2851 19.9071 0.0 0.0 0.0 -32.089 22.2851 19.9071 0.0 0.0 0.0 -32.089 22.2851 20.9071 0.0 0.0 0.0 -31.089 21.2851 21.9071 0.0 0.0 0.0 -31.089 22.2851 21.9071 0.0 0.0 0.0 -31.089 22.2851 22.9071 0.0 0.0 0.0 -32.089 21.2851 21.9071 0.02213571127726335 0.02213571127726335 0.02213571127726335 -32.089 21.2851 22.9071 0.0 0.0 0.0 -32.089 22.2851 21.9071 0.0 0.0 0.0 -32.089 22.2851 22.9071 0.0 0.0 0.0 -29.089 19.2851 23.9071 0.16178352067299798 0.16178352067299798 0.16178352067299798 -29.089 19.2851 24.9071 0.0 0.0 0.0 -29.089 20.2851 24.9071 0.0 0.0 0.0 -30.089 19.2851 23.9071 0.12380777873171506 0.12380777873171506 0.12380777873171506 -30.089 19.2851 24.9071 0.0 0.0 0.0 -30.089 20.2851 23.9071 0.0 0.0 0.0 -30.089 20.2851 24.9071 0.0 0.0 0.0 -30.089 20.2851 25.9071 0.0 0.0 0.0 -29.089 21.2851 23.9071 0.3351289695537181 0.3351289695537181 0.3351289695537181 -29.089 21.2851 24.9071 0.09167874559036734 0.09167874559036734 0.09167874559036734 -29.089 22.2851 23.9071 0.0 0.0 0.0 -30.089 21.2851 23.9071 0.0 0.0 0.0 -30.089 21.2851 24.9071 0.19361448983080345 0.19361448983080345 0.19361448983080345 -30.089 22.2851 23.9071 0.0 0.0 0.0 -29.089 21.2851 25.9071 0.0 0.0 0.0 -29.089 21.2851 26.9071 0.0 0.0 0.0 -30.089 21.2851 25.9071 0.29934453724154175 0.29934453724154175 0.29934453724154175 -30.089 21.2851 26.9071 0.0 0.0 0.0 -31.089 19.2851 23.9071 0.11588048256070897 0.11588048256070897 0.11588048256070897 -31.089 19.2851 24.9071 0.0 0.0 0.0 -31.089 20.2851 24.9071 0.093825783332204 0.093825783332204 0.093825783332204 -32.089 19.2851 23.9071 0.03536506908676518 0.03536506908676518 0.03536506908676518 -32.089 19.2851 24.9071 0.0 0.0 0.0 -32.089 20.2851 23.9071 0.0 0.0 0.0 -32.089 20.2851 24.9071 0.011595436518134026 0.011595436518134026 0.011595436518134026 -31.089 19.2851 25.9071 0.0 0.0 0.0 -31.089 20.2851 25.9071 0.0 0.0 0.0 -32.089 19.2851 25.9071 0.0 0.0 0.0 -32.089 20.2851 25.9071 0.0 0.0 0.0 -32.089 21.2851 23.9071 0.0 0.0 0.0 -32.089 22.2851 23.9071 0.0 0.0 0.0 -32.089 22.2851 24.9071 0.0 0.0 0.0 -31.089 21.2851 25.9071 0.30602239136646475 0.30602239136646475 0.30602239136646475 -31.089 21.2851 26.9071 0.0 0.0 0.0 -31.089 22.2851 26.9071 0.08867328200794428 0.08867328200794428 0.08867328200794428 -32.089 21.2851 25.9071 0.0 0.0 0.0 -32.089 22.2851 25.9071 0.0 0.0 0.0 -32.089 22.2851 26.9071 0.0 0.0 0.0 -29.089 24.2851 19.9071 0.0 0.0 0.0 -29.089 24.2851 20.9071 0.0636544929637519 0.0636544929637519 0.0636544929637519 -29.089 23.2851 21.9071 0.34318819177828197 0.34318819177828197 0.34318819177828197 -29.089 23.2851 22.9071 0.27349101554371763 0.27349101554371763 0.27349101554371763 -29.089 24.2851 21.9071 0.0 0.0 0.0 -29.089 24.2851 22.9071 0.046534247100702725 0.046534247100702725 0.046534247100702725 -30.089 23.2851 21.9071 0.0 0.0 0.0 -30.089 24.2851 21.9071 0.0 0.0 0.0 -29.089 25.2851 19.9071 0.0 0.0 0.0 -29.089 25.2851 20.9071 0.0 0.0 0.0 -29.089 26.2851 19.9071 0.0 0.0 0.0 -29.089 26.2851 20.9071 0.0 0.0 0.0 -30.089 26.2851 19.9071 0.0 0.0 0.0 -30.089 26.2851 20.9071 0.013142851836553815 0.013142851836553815 0.013142851836553815 -29.089 25.2851 21.9071 0.0 0.0 0.0 -29.089 25.2851 22.9071 0.017325497227993616 0.017325497227993616 0.017325497227993616 -29.089 26.2851 21.9071 0.017591656687045838 0.017591656687045838 0.017591656687045838 -29.089 26.2851 22.9071 0.06559041612337989 0.06559041612337989 0.06559041612337989 -30.089 25.2851 21.9071 0.0 0.0 0.0 -30.089 25.2851 22.9071 0.0 0.0 0.0 -30.089 26.2851 21.9071 0.0 0.0 0.0 -30.089 26.2851 22.9071 0.0 0.0 0.0 -31.089 23.2851 19.9071 0.015655630168759527 0.015655630168759527 0.015655630168759527 -31.089 23.2851 20.9071 0.0 0.0 0.0 -31.089 24.2851 19.9071 0.0 0.0 0.0 -31.089 24.2851 20.9071 0.0 0.0 0.0 -32.089 23.2851 19.9071 0.0 0.0 0.0 -32.089 23.2851 20.9071 0.0 0.0 0.0 -32.089 24.2851 19.9071 0.0 0.0 0.0 -32.089 24.2851 20.9071 0.0 0.0 0.0 -31.089 23.2851 21.9071 0.0 0.0 0.0 -31.089 23.2851 22.9071 0.0 0.0 0.0 -31.089 24.2851 21.9071 0.0 0.0 0.0 -31.089 24.2851 22.9071 0.0 0.0 0.0 -32.089 23.2851 22.9071 0.0 0.0 0.0 -32.089 24.2851 21.9071 0.0 0.0 0.0 -32.089 24.2851 22.9071 0.0 0.0 0.0 -31.089 25.2851 19.9071 0.0 0.0 0.0 -31.089 25.2851 20.9071 0.0 0.0 0.0 -31.089 26.2851 19.9071 0.0112577258030241 0.0112577258030241 0.0112577258030241 -31.089 26.2851 20.9071 0.02982835702388638 0.02982835702388638 0.02982835702388638 -32.089 25.2851 19.9071 0.0 0.0 0.0 -32.089 25.2851 20.9071 0.0 0.0 0.0 -32.089 26.2851 19.9071 0.009520411389269111 0.009520411389269111 0.009520411389269111 -32.089 26.2851 20.9071 0.013316059160578401 0.013316059160578401 0.013316059160578401 -31.089 25.2851 21.9071 0.0 0.0 0.0 -31.089 25.2851 22.9071 0.0 0.0 0.0 -31.089 26.2851 21.9071 0.09162043187628141 0.09162043187628141 0.09162043187628141 -31.089 26.2851 22.9071 0.0 0.0 0.0 -32.089 26.2851 21.9071 0.0 0.0 0.0 -29.089 23.2851 23.9071 0.0 0.0 0.0 -29.089 23.2851 24.9071 0.0 0.0 0.0 -29.089 24.2851 23.9071 0.0 0.0 0.0 -29.089 24.2851 24.9071 0.0 0.0 0.0 -30.089 24.2851 23.9071 0.023037325414379674 0.023037325414379674 0.023037325414379674 -30.089 24.2851 24.9071 0.11990327994698488 0.11990327994698488 0.11990327994698488 -29.089 24.2851 25.9071 0.0 0.0 0.0 -29.089 24.2851 26.9071 0.0 0.0 0.0 -30.089 23.2851 25.9071 0.16541767759082715 0.16541767759082715 0.16541767759082715 -30.089 23.2851 26.9071 0.20223368027758834 0.20223368027758834 0.20223368027758834 -30.089 24.2851 25.9071 0.12448874115902149 0.12448874115902149 0.12448874115902149 -30.089 24.2851 26.9071 0.2904673327322086 0.2904673327322086 0.2904673327322086 -29.089 25.2851 23.9071 0.0 0.0 0.0 -29.089 25.2851 24.9071 0.0 0.0 0.0 -30.089 25.2851 23.9071 0.015055870878480697 0.015055870878480697 0.015055870878480697 -30.089 25.2851 24.9071 0.01722727772079077 0.01722727772079077 0.01722727772079077 -30.089 26.2851 23.9071 0.04628912757095266 0.04628912757095266 0.04628912757095266 -30.089 26.2851 24.9071 0.07693412313962149 0.07693412313962149 0.07693412313962149 -29.089 25.2851 25.9071 0.0 0.0 0.0 -29.089 25.2851 26.9071 0.0 0.0 0.0 -29.089 26.2851 25.9071 0.1553098674313578 0.1553098674313578 0.1553098674313578 -29.089 26.2851 26.9071 0.27277442807543456 0.27277442807543456 0.27277442807543456 -30.089 25.2851 25.9071 0.0 0.0 0.0 -30.089 25.2851 26.9071 0.0 0.0 0.0 -30.089 26.2851 25.9071 0.21991600317832602 0.21991600317832602 0.21991600317832602 -30.089 26.2851 26.9071 0.05657005009996157 0.05657005009996157 0.05657005009996157 -31.089 24.2851 24.9071 0.162949644430409 0.162949644430409 0.162949644430409 -32.089 23.2851 23.9071 0.10346510468635543 0.10346510468635543 0.10346510468635543 -32.089 23.2851 24.9071 0.050921531768995214 0.050921531768995214 0.050921531768995214 -31.089 23.2851 25.9071 0.06097092280326069 0.06097092280326069 0.06097092280326069 -31.089 23.2851 26.9071 0.2334057702739835 0.2334057702739835 0.2334057702739835 -31.089 24.2851 25.9071 0.0 0.0 0.0 -31.089 24.2851 26.9071 0.0 0.0 0.0 -32.089 23.2851 25.9071 0.014536746629416576 0.014536746629416576 0.014536746629416576 -32.089 23.2851 26.9071 0.022988358211019487 0.022988358211019487 0.022988358211019487 -32.089 24.2851 25.9071 0.0 0.0 0.0 -32.089 24.2851 26.9071 0.0 0.0 0.0 -31.089 25.2851 23.9071 0.0 0.0 0.0 -31.089 25.2851 24.9071 0.0044348287168024 0.0044348287168024 0.0044348287168024 -31.089 26.2851 23.9071 0.0 0.0 0.0 -31.089 26.2851 24.9071 0.023702584222737567 0.023702584222737567 0.023702584222737567 -32.089 25.2851 24.9071 0.00631995912177874 0.00631995912177874 0.00631995912177874 -32.089 26.2851 23.9071 0.0 0.0 0.0 -32.089 26.2851 24.9071 0.0 0.0 0.0 -31.089 25.2851 25.9071 0.0 0.0 0.0 -31.089 25.2851 26.9071 0.0 0.0 0.0 -31.089 26.2851 25.9071 0.16057769411574518 0.16057769411574518 0.16057769411574518 -32.089 25.2851 25.9071 0.0 0.0 0.0 -32.089 25.2851 26.9071 0.0 0.0 0.0 -32.089 26.2851 25.9071 0.0 0.0 0.0 -32.089 26.2851 26.9071 0.0 0.0 0.0 -33.089 20.2851 16.9071 0.0 0.0 0.0 -33.089 20.2851 17.9071 0.00887281353989825 0.00887281353989825 0.00887281353989825 -33.089 20.2851 18.9071 0.0 0.0 0.0 -34.089 20.2851 17.9071 0.0 0.0 0.0 -34.089 20.2851 18.9071 0.0 0.0 0.0 -33.089 21.2851 16.9071 0.0094268572934254 0.0094268572934254 0.0094268572934254 -33.089 22.2851 16.9071 0.0 0.0 0.0 -34.089 21.2851 16.9071 0.0 0.0 0.0 -34.089 22.2851 16.9071 0.0 0.0 0.0 -34.089 21.2851 17.9071 0.0 0.0 0.0 -34.089 21.2851 18.9071 0.0 0.0 0.0 -34.089 22.2851 17.9071 0.0 0.0 0.0 -35.089 21.2851 17.9071 0.0 0.0 0.0 -35.089 21.2851 18.9071 0.0 0.0 0.0 -35.089 22.2851 17.9071 0.0 0.0 0.0 -35.089 22.2851 18.9071 0.0 0.0 0.0 -36.089 21.2851 18.9071 0.0 0.0 0.0 -36.089 22.2851 18.9071 0.0 0.0 0.0 -33.089 23.2851 16.9071 0.0 0.0 0.0 -34.089 23.2851 16.9071 0.0 0.0 0.0 -33.089 23.2851 17.9071 0.0 0.0 0.0 -33.089 24.2851 17.9071 0.062008012961046355 0.062008012961046355 0.062008012961046355 -34.089 23.2851 17.9071 0.0 0.0 0.0 -34.089 24.2851 17.9071 0.02513511568981048 0.02513511568981048 0.02513511568981048 -34.089 24.2851 18.9071 0.0 0.0 0.0 -33.089 25.2851 17.9071 0.0 0.0 0.0 -33.089 25.2851 18.9071 0.0 0.0 0.0 -33.089 26.2851 18.9071 0.0 0.0 0.0 -34.089 25.2851 17.9071 0.015298366616939391 0.015298366616939391 0.015298366616939391 -34.089 25.2851 18.9071 0.0 0.0 0.0 -34.089 26.2851 17.9071 0.004159913869673632 0.004159913869673632 0.004159913869673632 -34.089 26.2851 18.9071 0.0 0.0 0.0 -35.089 23.2851 17.9071 0.0 0.0 0.0 -35.089 23.2851 18.9071 0.0 0.0 0.0 -35.089 24.2851 17.9071 0.0 0.0 0.0 -35.089 24.2851 18.9071 0.0 0.0 0.0 -36.089 23.2851 18.9071 0.04198293316446391 0.04198293316446391 0.04198293316446391 -35.089 26.2851 16.9071 0.0 0.0 0.0 -36.089 26.2851 16.9071 0.012431679308938027 0.012431679308938027 0.012431679308938027 -35.089 26.2851 17.9071 0.0 0.0 0.0 -35.089 26.2851 18.9071 0.0 0.0 0.0 -36.089 25.2851 17.9071 0.0 0.0 0.0 -36.089 25.2851 18.9071 0.0 0.0 0.0 -36.089 26.2851 17.9071 0.0 0.0 0.0 -36.089 26.2851 18.9071 0.0 0.0 0.0 -37.089 21.2851 18.9071 0.0 0.0 0.0 -37.089 22.2851 18.9071 0.0 0.0 0.0 -37.089 26.2851 16.9071 0.0 0.0 0.0 -38.089 26.2851 16.9071 0.0 0.0 0.0 -37.089 25.2851 17.9071 0.0 0.0 0.0 -37.089 25.2851 18.9071 0.0 0.0 0.0 -37.089 26.2851 17.9071 0.0 0.0 0.0 -38.089 25.2851 17.9071 0.0 0.0 0.0 -38.089 25.2851 18.9071 0.05476767574351262 0.05476767574351262 0.05476767574351262 -38.089 26.2851 17.9071 0.0 0.0 0.0 -39.089 25.2851 18.9071 0.0 0.0 0.0 -39.089 26.2851 17.9071 0.0 0.0 0.0 -39.089 26.2851 18.9071 0.06864847502234536 0.06864847502234536 0.06864847502234536 -33.089 20.2851 19.9071 0.06315637963595054 0.06315637963595054 0.06315637963595054 -34.089 20.2851 19.9071 0.008852627216834875 0.008852627216834875 0.008852627216834875 -33.089 20.2851 21.9071 0.07887719401598839 0.07887719401598839 0.07887719401598839 -33.089 20.2851 22.9071 0.0 0.0 0.0 -33.089 21.2851 19.9071 0.0 0.0 0.0 -33.089 21.2851 20.9071 0.04369689289586878 0.04369689289586878 0.04369689289586878 -33.089 22.2851 19.9071 0.0 0.0 0.0 -33.089 22.2851 20.9071 0.03726601359416373 0.03726601359416373 0.03726601359416373 -34.089 21.2851 19.9071 0.0 0.0 0.0 -34.089 21.2851 20.9071 0.0 0.0 0.0 -33.089 21.2851 21.9071 0.0 0.0 0.0 -33.089 21.2851 22.9071 0.0 0.0 0.0 -33.089 22.2851 21.9071 0.02125097865823325 0.02125097865823325 0.02125097865823325 -33.089 22.2851 22.9071 0.0 0.0 0.0 -34.089 21.2851 21.9071 0.0 0.0 0.0 -34.089 22.2851 21.9071 0.0 0.0 0.0 -34.089 22.2851 22.9071 0.06241601622350026 0.06241601622350026 0.06241601622350026 -35.089 20.2851 19.9071 0.0 0.0 0.0 -35.089 20.2851 20.9071 0.0 0.0 0.0 -36.089 20.2851 19.9071 0.0 0.0 0.0 -36.089 20.2851 20.9071 0.0 0.0 0.0 -35.089 20.2851 21.9071 0.04906938624023386 0.04906938624023386 0.04906938624023386 -36.089 20.2851 21.9071 0.0 0.0 0.0 -35.089 21.2851 19.9071 0.014982386907969507 0.014982386907969507 0.014982386907969507 -35.089 21.2851 20.9071 0.0 0.0 0.0 -35.089 22.2851 19.9071 0.0 0.0 0.0 -36.089 21.2851 19.9071 0.0 0.0 0.0 -36.089 22.2851 19.9071 0.0 0.0 0.0 -35.089 21.2851 21.9071 0.0 0.0 0.0 -35.089 22.2851 21.9071 0.0 0.0 0.0 -35.089 22.2851 22.9071 0.0 0.0 0.0 -36.089 21.2851 21.9071 0.0 0.0 0.0 -36.089 21.2851 22.9071 0.0 0.0 0.0 -36.089 22.2851 21.9071 0.01011861734632745 0.01011861734632745 0.01011861734632745 -36.089 22.2851 22.9071 0.04359540533378735 0.04359540533378735 0.04359540533378735 -33.089 20.2851 23.9071 0.02046129065231125 0.02046129065231125 0.02046129065231125 -33.089 20.2851 24.9071 0.12086316713298642 0.12086316713298642 0.12086316713298642 -33.089 20.2851 25.9071 0.0920458685057986 0.0920458685057986 0.0920458685057986 -33.089 21.2851 23.9071 0.0 0.0 0.0 -33.089 21.2851 24.9071 0.051125956054527986 0.051125956054527986 0.051125956054527986 -33.089 22.2851 23.9071 0.0 0.0 0.0 -33.089 22.2851 24.9071 0.008698902761748778 0.008698902761748778 0.008698902761748778 -34.089 22.2851 23.9071 0.0 0.0 0.0 -34.089 22.2851 24.9071 0.0 0.0 0.0 -33.089 21.2851 25.9071 0.0 0.0 0.0 -33.089 22.2851 25.9071 0.0 0.0 0.0 -33.089 22.2851 26.9071 0.0 0.0 0.0 -34.089 21.2851 26.9071 0.006788463079665156 0.006788463079665156 0.006788463079665156 -34.089 22.2851 25.9071 0.0 0.0 0.0 -34.089 22.2851 26.9071 0.007137436369050668 0.007137436369050668 0.007137436369050668 -35.089 22.2851 23.9071 0.0 0.0 0.0 -35.089 22.2851 24.9071 0.0 0.0 0.0 -36.089 21.2851 23.9071 0.0 0.0 0.0 -36.089 22.2851 23.9071 0.0 0.0 0.0 -36.089 22.2851 24.9071 0.0 0.0 0.0 -35.089 22.2851 25.9071 0.0 0.0 0.0 -35.089 22.2851 26.9071 0.0 0.0 0.0 -36.089 22.2851 25.9071 0.014968120938576 0.014968120938576 0.014968120938576 -36.089 22.2851 26.9071 0.0 0.0 0.0 -34.089 24.2851 19.9071 0.0 0.0 0.0 -33.089 23.2851 22.9071 0.0 0.0 0.0 -33.089 24.2851 22.9071 0.0 0.0 0.0 -34.089 23.2851 21.9071 0.08531035000025626 0.08531035000025626 0.08531035000025626 -34.089 23.2851 22.9071 0.05765386334423757 0.05765386334423757 0.05765386334423757 -34.089 24.2851 21.9071 0.0027035702243852064 0.0027035702243852064 0.0027035702243852064 -34.089 24.2851 22.9071 0.0 0.0 0.0 -33.089 25.2851 19.9071 0.0 0.0 0.0 -33.089 25.2851 20.9071 0.0 0.0 0.0 -33.089 26.2851 19.9071 0.019697547893296512 0.019697547893296512 0.019697547893296512 -33.089 26.2851 20.9071 0.0 0.0 0.0 -34.089 25.2851 19.9071 0.0019144185604029352 0.0019144185604029352 0.0019144185604029352 -34.089 26.2851 19.9071 0.0 0.0 0.0 -33.089 26.2851 21.9071 0.0 0.0 0.0 -33.089 26.2851 22.9071 0.0 0.0 0.0 -34.089 25.2851 22.9071 0.0 0.0 0.0 -34.089 26.2851 21.9071 0.0 0.0 0.0 -34.089 26.2851 22.9071 0.0 0.0 0.0 -35.089 23.2851 19.9071 0.0 0.0 0.0 -35.089 24.2851 19.9071 0.0 0.0 0.0 -36.089 23.2851 19.9071 0.04727656575948969 0.04727656575948969 0.04727656575948969 -36.089 24.2851 19.9071 0.0 0.0 0.0 -35.089 23.2851 21.9071 0.0 0.0 0.0 -35.089 23.2851 22.9071 0.0012025233860445356 0.0012025233860445356 0.0012025233860445356 -35.089 24.2851 21.9071 0.0 0.0 0.0 -35.089 24.2851 22.9071 0.0 0.0 0.0 -36.089 23.2851 22.9071 0.0 0.0 0.0 -35.089 25.2851 19.9071 0.0 0.0 0.0 -35.089 26.2851 19.9071 0.0 0.0 0.0 -36.089 25.2851 19.9071 0.0 0.0 0.0 -36.089 26.2851 19.9071 0.0 0.0 0.0 -35.089 25.2851 21.9071 0.0 0.0 0.0 -35.089 25.2851 22.9071 0.0 0.0 0.0 -35.089 26.2851 21.9071 0.0 0.0 0.0 -35.089 26.2851 22.9071 0.0 0.0 0.0 -36.089 25.2851 21.9071 0.0 0.0 0.0 -36.089 25.2851 22.9071 0.0 0.0 0.0 -36.089 26.2851 21.9071 0.10189268573894947 0.10189268573894947 0.10189268573894947 -36.089 26.2851 22.9071 0.2586300428912807 0.2586300428912807 0.2586300428912807 -33.089 23.2851 23.9071 0.015271145163800716 0.015271145163800716 0.015271145163800716 -33.089 23.2851 24.9071 0.0 0.0 0.0 -33.089 24.2851 23.9071 0.0027010160491667936 0.0027010160491667936 0.0027010160491667936 -34.089 23.2851 23.9071 0.0 0.0 0.0 -34.089 24.2851 23.9071 0.1945168293054546 0.1945168293054546 0.1945168293054546 -34.089 24.2851 24.9071 0.0 0.0 0.0 -33.089 23.2851 25.9071 0.0 0.0 0.0 -33.089 23.2851 26.9071 0.0 0.0 0.0 -33.089 24.2851 25.9071 0.0 0.0 0.0 -33.089 24.2851 26.9071 0.0 0.0 0.0 -34.089 24.2851 25.9071 0.024997926844770202 0.024997926844770202 0.024997926844770202 -34.089 24.2851 26.9071 0.0 0.0 0.0 -33.089 25.2851 23.9071 0.0 0.0 0.0 -33.089 25.2851 24.9071 0.0 0.0 0.0 -33.089 26.2851 23.9071 0.0 0.0 0.0 -33.089 26.2851 24.9071 0.0 0.0 0.0 -34.089 25.2851 23.9071 0.0 0.0 0.0 -34.089 25.2851 24.9071 0.0009200230139288271 0.0009200230139288271 0.0009200230139288271 -34.089 26.2851 23.9071 0.0 0.0 0.0 -34.089 26.2851 24.9071 0.0 0.0 0.0 -33.089 25.2851 25.9071 0.0 0.0 0.0 -33.089 25.2851 26.9071 0.0 0.0 0.0 -33.089 26.2851 26.9071 0.0 0.0 0.0 -34.089 25.2851 25.9071 0.0 0.0 0.0 -34.089 25.2851 26.9071 0.0 0.0 0.0 -35.089 23.2851 23.9071 0.0 0.0 0.0 -35.089 23.2851 24.9071 0.0 0.0 0.0 -35.089 24.2851 23.9071 0.0 0.0 0.0 -35.089 24.2851 24.9071 0.01957109800916211 0.01957109800916211 0.01957109800916211 -36.089 23.2851 23.9071 0.022590160345639026 0.022590160345639026 0.022590160345639026 -36.089 23.2851 24.9071 0.0 0.0 0.0 -36.089 23.2851 25.9071 0.09563604126905449 0.09563604126905449 0.09563604126905449 -36.089 23.2851 26.9071 0.035866095499664595 0.035866095499664595 0.035866095499664595 -36.089 24.2851 26.9071 0.09778456867292955 0.09778456867292955 0.09778456867292955 -35.089 25.2851 23.9071 0.0 0.0 0.0 -35.089 25.2851 24.9071 0.01895480006257495 0.01895480006257495 0.01895480006257495 -35.089 26.2851 23.9071 0.0 0.0 0.0 -35.089 26.2851 24.9071 0.0 0.0 0.0 -36.089 26.2851 23.9071 0.0 0.0 0.0 -36.089 26.2851 24.9071 0.0 0.0 0.0 -35.089 25.2851 25.9071 0.0 0.0 0.0 -35.089 25.2851 26.9071 0.0 0.0 0.0 -35.089 26.2851 25.9071 0.022172043442474487 0.022172043442474487 0.022172043442474487 -35.089 26.2851 26.9071 0.0 0.0 0.0 -36.089 25.2851 26.9071 0.0 0.0 0.0 -36.089 26.2851 25.9071 0.0 0.0 0.0 -36.089 26.2851 26.9071 0.0 0.0 0.0 -37.089 20.2851 19.9071 0.0 0.0 0.0 -37.089 20.2851 20.9071 0.041619629184133776 0.041619629184133776 0.041619629184133776 -37.089 20.2851 21.9071 0.04618633609783136 0.04618633609783136 0.04618633609783136 -37.089 21.2851 19.9071 0.029344784120607308 0.029344784120607308 0.029344784120607308 -37.089 21.2851 20.9071 0.0 0.0 0.0 -37.089 22.2851 19.9071 0.0 0.0 0.0 -37.089 22.2851 20.9071 0.0 0.0 0.0 -38.089 21.2851 19.9071 0.0 0.0 0.0 -38.089 21.2851 20.9071 0.0 0.0 0.0 -38.089 22.2851 19.9071 0.0 0.0 0.0 -38.089 22.2851 20.9071 0.0 0.0 0.0 -37.089 21.2851 21.9071 0.0 0.0 0.0 -37.089 21.2851 22.9071 0.0 0.0 0.0 -37.089 22.2851 21.9071 0.0 0.0 0.0 -37.089 22.2851 22.9071 0.0 0.0 0.0 -38.089 21.2851 21.9071 0.0 0.0 0.0 -38.089 21.2851 22.9071 0.0 0.0 0.0 -38.089 22.2851 21.9071 0.0 0.0 0.0 -38.089 22.2851 22.9071 0.0 0.0 0.0 -39.089 21.2851 22.9071 0.008960315693781244 0.008960315693781244 0.008960315693781244 -39.089 22.2851 22.9071 0.0 0.0 0.0 -37.089 21.2851 23.9071 0.0 0.0 0.0 -37.089 21.2851 24.9071 0.0 0.0 0.0 -37.089 22.2851 24.9071 0.0 0.0 0.0 -38.089 21.2851 23.9071 0.0 0.0 0.0 -38.089 21.2851 24.9071 0.0 0.0 0.0 -38.089 22.2851 24.9071 0.0 0.0 0.0 -39.089 21.2851 23.9071 0.0 0.0 0.0 -39.089 22.2851 23.9071 0.0 0.0 0.0 -39.089 22.2851 24.9071 0.02247222170833307 0.02247222170833307 0.02247222170833307 -37.089 23.2851 19.9071 0.01918838959561183 0.01918838959561183 0.01918838959561183 -37.089 23.2851 20.9071 0.0 0.0 0.0 -37.089 24.2851 19.9071 0.0200063649941897 0.0200063649941897 0.0200063649941897 -38.089 23.2851 19.9071 0.009237468299473925 0.009237468299473925 0.009237468299473925 -38.089 23.2851 20.9071 0.0 0.0 0.0 -38.089 24.2851 19.9071 0.0 0.0 0.0 -38.089 24.2851 20.9071 0.31240521868975163 0.31240521868975163 0.31240521868975163 -38.089 23.2851 21.9071 0.0 0.0 0.0 -38.089 23.2851 22.9071 0.0 0.0 0.0 -38.089 24.2851 22.9071 0.0 0.0 0.0 -37.089 25.2851 19.9071 0.014072572393901046 0.014072572393901046 0.014072572393901046 -38.089 25.2851 19.9071 0.01599416860679898 0.01599416860679898 0.01599416860679898 -37.089 25.2851 22.9071 0.0 0.0 0.0 -37.089 26.2851 22.9071 0.2197214357787843 0.2197214357787843 0.2197214357787843 -38.089 25.2851 22.9071 0.0 0.0 0.0 -38.089 26.2851 22.9071 0.3558766594093536 0.3558766594093536 0.3558766594093536 -39.089 23.2851 20.9071 0.0 0.0 0.0 -39.089 24.2851 20.9071 0.0 0.0 0.0 -39.089 23.2851 21.9071 0.0 0.0 0.0 -39.089 23.2851 22.9071 0.0 0.0 0.0 -39.089 24.2851 21.9071 0.0 0.0 0.0 -39.089 24.2851 22.9071 0.0 0.0 0.0 -39.089 25.2851 19.9071 0.0 0.0 0.0 -39.089 25.2851 20.9071 0.012591230347774983 0.012591230347774983 0.012591230347774983 -39.089 26.2851 19.9071 0.0 0.0 0.0 -39.089 26.2851 20.9071 0.021341718351944126 0.021341718351944126 0.021341718351944126 -39.089 25.2851 21.9071 0.0 0.0 0.0 -39.089 25.2851 22.9071 0.0 0.0 0.0 -39.089 26.2851 21.9071 0.0 0.0 0.0 -39.089 26.2851 22.9071 0.0 0.0 0.0 -40.089 26.2851 22.9071 0.0 0.0 0.0 -37.089 23.2851 24.9071 0.007017326792677631 0.007017326792677631 0.007017326792677631 -38.089 23.2851 24.9071 0.008796854470926064 0.008796854470926064 0.008796854470926064 -38.089 24.2851 23.9071 0.0 0.0 0.0 -38.089 24.2851 24.9071 0.036045806894479164 0.036045806894479164 0.036045806894479164 -37.089 23.2851 25.9071 0.018516892827250987 0.018516892827250987 0.018516892827250987 -37.089 23.2851 26.9071 0.0649755900176043 0.0649755900176043 0.0649755900176043 -37.089 24.2851 25.9071 0.1538352752224295 0.1538352752224295 0.1538352752224295 -37.089 24.2851 26.9071 0.0 0.0 0.0 -38.089 23.2851 25.9071 0.0 0.0 0.0 -38.089 24.2851 25.9071 0.02510437066661981 0.02510437066661981 0.02510437066661981 -38.089 24.2851 26.9071 0.0 0.0 0.0 -37.089 25.2851 23.9071 0.0 0.0 0.0 -37.089 25.2851 24.9071 0.0 0.0 0.0 -37.089 26.2851 23.9071 0.0 0.0 0.0 -37.089 26.2851 24.9071 0.0 0.0 0.0 -38.089 25.2851 23.9071 0.0 0.0 0.0 -38.089 25.2851 24.9071 0.0 0.0 0.0 -38.089 26.2851 24.9071 0.0 0.0 0.0 -37.089 25.2851 25.9071 0.09078141494235305 0.09078141494235305 0.09078141494235305 -37.089 25.2851 26.9071 0.02638203262309114 0.02638203262309114 0.02638203262309114 -37.089 26.2851 25.9071 0.0 0.0 0.0 -37.089 26.2851 26.9071 0.03474427426221709 0.03474427426221709 0.03474427426221709 -38.089 25.2851 25.9071 0.0 0.0 0.0 -38.089 25.2851 26.9071 0.0034924886560831142 0.0034924886560831142 0.0034924886560831142 -38.089 26.2851 25.9071 0.0 0.0 0.0 -38.089 26.2851 26.9071 0.017034461358811277 0.017034461358811277 0.017034461358811277 -39.089 23.2851 23.9071 0.014825700707652543 0.014825700707652543 0.014825700707652543 -39.089 23.2851 24.9071 0.0 0.0 0.0 -39.089 24.2851 23.9071 0.0 0.0 0.0 -40.089 24.2851 24.9071 0.05971350964029145 0.05971350964029145 0.05971350964029145 -39.089 24.2851 25.9071 0.0 0.0 0.0 -39.089 24.2851 26.9071 0.015904443338780775 0.015904443338780775 0.015904443338780775 -40.089 24.2851 25.9071 0.0 0.0 0.0 -40.089 24.2851 26.9071 0.0 0.0 0.0 -39.089 25.2851 24.9071 0.0 0.0 0.0 -39.089 26.2851 23.9071 0.0 0.0 0.0 -39.089 26.2851 24.9071 0.0 0.0 0.0 -40.089 25.2851 24.9071 0.0 0.0 0.0 -40.089 26.2851 23.9071 0.0 0.0 0.0 -40.089 26.2851 24.9071 0.0 0.0 0.0 -39.089 25.2851 25.9071 0.0 0.0 0.0 -39.089 25.2851 26.9071 0.02683076916841932 0.02683076916841932 0.02683076916841932 -39.089 26.2851 25.9071 0.0 0.0 0.0 -40.089 25.2851 25.9071 0.0 0.0 0.0 -40.089 25.2851 26.9071 0.0 0.0 0.0 -41.089 26.2851 22.9071 0.07671653302512164 0.07671653302512164 0.07671653302512164 -42.089 26.2851 22.9071 0.0 0.0 0.0 -41.089 24.2851 24.9071 0.2450400860879584 0.2450400860879584 0.2450400860879584 -41.089 24.2851 25.9071 0.0 0.0 0.0 -41.089 24.2851 26.9071 0.0067968686038998955 0.0067968686038998955 0.0067968686038998955 -42.089 24.2851 25.9071 0.05225543353285135 0.05225543353285135 0.05225543353285135 -42.089 24.2851 26.9071 0.02777926827272586 0.02777926827272586 0.02777926827272586 -41.089 25.2851 24.9071 0.0 0.0 0.0 -41.089 26.2851 23.9071 0.0 0.0 0.0 -41.089 26.2851 24.9071 0.0 0.0 0.0 -42.089 25.2851 24.9071 0.0 0.0 0.0 -42.089 26.2851 23.9071 0.0 0.0 0.0 -42.089 26.2851 24.9071 0.0 0.0 0.0 -41.089 25.2851 25.9071 0.0 0.0 0.0 -42.089 25.2851 25.9071 0.0 0.0 0.0 -42.089 25.2851 26.9071 0.0 0.0 0.0 -42.089 26.2851 25.9071 0.0 0.0 0.0 -43.089 25.2851 25.9071 0.0 0.0 0.0 -43.089 25.2851 26.9071 0.1580199103835129 0.1580199103835129 0.1580199103835129 -43.089 26.2851 25.9071 0.03762756687542511 0.03762756687542511 0.03762756687542511 -43.089 26.2851 26.9071 0.0 0.0 0.0 -25.089 17.2851 27.9071 0.037363671878553335 0.037363671878553335 0.037363671878553335 -25.089 18.2851 27.9071 0.0 0.0 0.0 -25.089 18.2851 28.9071 0.1327102839363116 0.1327102839363116 0.1327102839363116 -28.089 18.2851 30.9071 0.13259732555446171 0.13259732555446171 0.13259732555446171 -28.089 18.2851 31.9071 0.0 0.0 0.0 -29.089 16.2851 28.9071 0.0 0.0 0.0 -30.089 16.2851 27.9071 0.05291099157592363 0.05291099157592363 0.05291099157592363 -30.089 16.2851 28.9071 0.0 0.0 0.0 -29.089 16.2851 29.9071 0.0 0.0 0.0 -30.089 16.2851 29.9071 0.0 0.0 0.0 -30.089 16.2851 30.9071 0.0 0.0 0.0 -29.089 17.2851 27.9071 0.0 0.0 0.0 -29.089 17.2851 28.9071 0.09198531676010105 0.09198531676010105 0.09198531676010105 -29.089 18.2851 28.9071 0.05847320694466778 0.05847320694466778 0.05847320694466778 -30.089 17.2851 27.9071 0.039584145762539866 0.039584145762539866 0.039584145762539866 -30.089 18.2851 27.9071 0.046360778707304796 0.046360778707304796 0.046360778707304796 -30.089 18.2851 28.9071 0.0 0.0 0.0 -29.089 17.2851 29.9071 0.0 0.0 0.0 -29.089 17.2851 30.9071 0.0 0.0 0.0 -29.089 18.2851 29.9071 0.0 0.0 0.0 -29.089 18.2851 30.9071 0.0 0.0 0.0 -30.089 17.2851 29.9071 0.0 0.0 0.0 -30.089 17.2851 30.9071 0.0 0.0 0.0 -30.089 18.2851 29.9071 0.0 0.0 0.0 -31.089 16.2851 27.9071 0.0 0.0 0.0 -31.089 16.2851 28.9071 0.0 0.0 0.0 -32.089 16.2851 27.9071 0.01272857952338486 0.01272857952338486 0.01272857952338486 -32.089 16.2851 28.9071 0.0 0.0 0.0 -31.089 16.2851 29.9071 0.0 0.0 0.0 -31.089 16.2851 30.9071 0.0 0.0 0.0 -32.089 16.2851 29.9071 0.0 0.0 0.0 -32.089 16.2851 30.9071 0.0 0.0 0.0 -31.089 17.2851 27.9071 0.0 0.0 0.0 -31.089 18.2851 27.9071 0.2250773078724431 0.2250773078724431 0.2250773078724431 -31.089 18.2851 28.9071 0.0 0.0 0.0 -32.089 17.2851 27.9071 0.11126613085039715 0.11126613085039715 0.11126613085039715 -32.089 18.2851 27.9071 0.0 0.0 0.0 -32.089 18.2851 28.9071 0.28065486573337173 0.28065486573337173 0.28065486573337173 -31.089 17.2851 30.9071 0.0 0.0 0.0 -31.089 18.2851 30.9071 0.0 0.0 0.0 -32.089 17.2851 30.9071 0.0034352278791824242 0.0034352278791824242 0.0034352278791824242 -32.089 18.2851 30.9071 0.0 0.0 0.0 -29.089 17.2851 31.9071 0.0 0.0 0.0 -29.089 18.2851 31.9071 0.0 0.0 0.0 -29.089 18.2851 32.9071 0.0 0.0 0.0 -30.089 17.2851 31.9071 0.0 0.0 0.0 -30.089 18.2851 31.9071 0.0 0.0 0.0 -30.089 18.2851 32.9071 0.0 0.0 0.0 -31.089 16.2851 31.9071 0.0 0.0 0.0 -32.089 16.2851 31.9071 0.0 0.0 0.0 -31.089 17.2851 31.9071 0.0 0.0 0.0 -31.089 18.2851 31.9071 0.041194837043159835 0.041194837043159835 0.041194837043159835 -31.089 18.2851 32.9071 0.0 0.0 0.0 -32.089 17.2851 31.9071 0.0 0.0 0.0 -32.089 18.2851 31.9071 0.0 0.0 0.0 -25.089 19.2851 27.9071 0.0 0.0 0.0 -25.089 19.2851 28.9071 0.0 0.0 0.0 -25.089 20.2851 27.9071 0.39003554192652434 0.39003554192652434 0.39003554192652434 -25.089 20.2851 30.9071 0.0 0.0 0.0 -26.089 20.2851 30.9071 0.3133363711722681 0.3133363711722681 0.3133363711722681 -25.089 22.2851 27.9071 0.0 0.0 0.0 -25.089 22.2851 28.9071 0.0 0.0 0.0 -26.089 21.2851 27.9071 0.0 0.0 0.0 -26.089 21.2851 28.9071 0.0 0.0 0.0 -26.089 22.2851 27.9071 0.0 0.0 0.0 -26.089 22.2851 28.9071 0.028268238988846475 0.028268238988846475 0.028268238988846475 -25.089 21.2851 30.9071 0.0 0.0 0.0 -25.089 22.2851 29.9071 0.0 0.0 0.0 -25.089 22.2851 30.9071 0.3104055097433368 0.3104055097433368 0.3104055097433368 -26.089 21.2851 30.9071 0.22241074578291742 0.22241074578291742 0.22241074578291742 -26.089 22.2851 29.9071 0.34629166486007107 0.34629166486007107 0.34629166486007107 -26.089 22.2851 30.9071 0.0 0.0 0.0 -27.089 20.2851 30.9071 0.013537360040987234 0.013537360040987234 0.013537360040987234 -28.089 19.2851 29.9071 0.030346280102455558 0.030346280102455558 0.030346280102455558 -28.089 19.2851 30.9071 0.0 0.0 0.0 -28.089 20.2851 29.9071 0.18233544648306388 0.18233544648306388 0.18233544648306388 -28.089 20.2851 30.9071 0.0 0.0 0.0 -27.089 21.2851 27.9071 0.5028852405280262 0.5028852405280262 0.5028852405280262 -27.089 21.2851 28.9071 0.3266289004347934 0.3266289004347934 0.3266289004347934 -27.089 22.2851 27.9071 0.0 0.0 0.0 -27.089 22.2851 28.9071 0.0 0.0 0.0 -28.089 21.2851 27.9071 0.0 0.0 0.0 -28.089 21.2851 28.9071 0.2509815781397708 0.2509815781397708 0.2509815781397708 -28.089 22.2851 27.9071 0.0 0.0 0.0 -28.089 22.2851 28.9071 0.4549095132572047 0.4549095132572047 0.4549095132572047 -27.089 21.2851 29.9071 0.0 0.0 0.0 -27.089 21.2851 30.9071 0.5701074316334235 0.5701074316334235 0.5701074316334235 -27.089 22.2851 29.9071 0.6220768313063914 0.6220768313063914 0.6220768313063914 -27.089 22.2851 30.9071 0.6858547800428653 0.6858547800428653 0.6858547800428653 -28.089 21.2851 29.9071 0.0 0.0 0.0 -28.089 21.2851 30.9071 0.6126537866961971 0.6126537866961971 0.6126537866961971 -28.089 22.2851 29.9071 0.0 0.0 0.0 -28.089 22.2851 30.9071 0.0 0.0 0.0 -25.089 20.2851 31.9071 0.0 0.0 0.0 -25.089 20.2851 32.9071 0.0 0.0 0.0 -26.089 20.2851 31.9071 0.10109327665562749 0.10109327665562749 0.10109327665562749 -26.089 20.2851 32.9071 0.0 0.0 0.0 -26.089 20.2851 33.9071 0.1335846498733385 0.1335846498733385 0.1335846498733385 -25.089 21.2851 31.9071 0.0 0.0 0.0 -25.089 21.2851 32.9071 0.0 0.0 0.0 -25.089 22.2851 31.9071 0.0 0.0 0.0 -25.089 22.2851 32.9071 0.0 0.0 0.0 -26.089 22.2851 32.9071 0.0 0.0 0.0 -25.089 21.2851 33.9071 0.08616345465182476 0.08616345465182476 0.08616345465182476 -25.089 21.2851 34.9071 0.1983645257274991 0.1983645257274991 0.1983645257274991 -25.089 22.2851 33.9071 0.0585310599711673 0.0585310599711673 0.0585310599711673 -25.089 22.2851 34.9071 0.0 0.0 0.0 -26.089 21.2851 33.9071 0.0 0.0 0.0 -26.089 21.2851 34.9071 0.0 0.0 0.0 -26.089 22.2851 33.9071 0.0 0.0 0.0 -26.089 22.2851 34.9071 0.2392916854414916 0.2392916854414916 0.2392916854414916 -27.089 19.2851 31.9071 0.0 0.0 0.0 -27.089 19.2851 32.9071 0.0 0.0 0.0 -27.089 20.2851 31.9071 0.11868677334821785 0.11868677334821785 0.11868677334821785 -27.089 20.2851 32.9071 0.16806950019926511 0.16806950019926511 0.16806950019926511 -28.089 19.2851 31.9071 0.0 0.0 0.0 -28.089 19.2851 32.9071 0.0570937364277977 0.0570937364277977 0.0570937364277977 -28.089 20.2851 31.9071 0.0327453489918723 0.0327453489918723 0.0327453489918723 -27.089 20.2851 33.9071 0.0247620411108144 0.0247620411108144 0.0247620411108144 -27.089 20.2851 34.9071 0.0 0.0 0.0 -28.089 19.2851 33.9071 0.10479986884886074 0.10479986884886074 0.10479986884886074 -28.089 20.2851 33.9071 0.0 0.0 0.0 -28.089 20.2851 34.9071 0.0 0.0 0.0 -27.089 21.2851 31.9071 0.6445862705348231 0.6445862705348231 0.6445862705348231 -27.089 21.2851 32.9071 0.05671215003013029 0.05671215003013029 0.05671215003013029 -28.089 21.2851 31.9071 0.6446699909377888 0.6446699909377888 0.6446699909377888 -27.089 21.2851 33.9071 0.0 0.0 0.0 -27.089 21.2851 34.9071 0.12826468095566515 0.12826468095566515 0.12826468095566515 -27.089 22.2851 34.9071 0.0 0.0 0.0 -25.089 23.2851 28.9071 0.0 0.0 0.0 -25.089 24.2851 28.9071 0.0 0.0 0.0 -26.089 24.2851 27.9071 0.0 0.0 0.0 -25.089 23.2851 29.9071 0.0 0.0 0.0 -25.089 23.2851 30.9071 0.0 0.0 0.0 -25.089 24.2851 29.9071 0.21842088490541592 0.21842088490541592 0.21842088490541592 -25.089 25.2851 27.9071 0.0 0.0 0.0 -25.089 25.2851 28.9071 0.0 0.0 0.0 -25.089 26.2851 27.9071 0.0 0.0 0.0 -25.089 26.2851 28.9071 0.23182268614334148 0.23182268614334148 0.23182268614334148 -26.089 25.2851 27.9071 0.0 0.0 0.0 -26.089 25.2851 28.9071 0.07469374632206745 0.07469374632206745 0.07469374632206745 -26.089 26.2851 27.9071 0.39684593759952325 0.39684593759952325 0.39684593759952325 -26.089 26.2851 28.9071 0.3254420094453131 0.3254420094453131 0.3254420094453131 -25.089 25.2851 29.9071 0.0 0.0 0.0 -25.089 26.2851 29.9071 0.0 0.0 0.0 -25.089 26.2851 30.9071 0.0 0.0 0.0 -27.089 24.2851 27.9071 0.2612556648657027 0.2612556648657027 0.2612556648657027 -27.089 24.2851 28.9071 0.2260110456048874 0.2260110456048874 0.2260110456048874 -28.089 24.2851 27.9071 0.0 0.0 0.0 -28.089 24.2851 28.9071 0.4972447883802005 0.4972447883802005 0.4972447883802005 -27.089 24.2851 29.9071 0.0 0.0 0.0 -27.089 24.2851 30.9071 0.0 0.0 0.0 -28.089 23.2851 29.9071 0.0819902522634779 0.0819902522634779 0.0819902522634779 -28.089 23.2851 30.9071 0.0 0.0 0.0 -28.089 24.2851 29.9071 0.522336038163076 0.522336038163076 0.522336038163076 -28.089 24.2851 30.9071 0.16109264059144285 0.16109264059144285 0.16109264059144285 -27.089 25.2851 27.9071 0.0 0.0 0.0 -27.089 25.2851 28.9071 0.07717379564190978 0.07717379564190978 0.07717379564190978 -27.089 26.2851 27.9071 0.32617517107848004 0.32617517107848004 0.32617517107848004 -27.089 26.2851 28.9071 0.2691803323735686 0.2691803323735686 0.2691803323735686 -28.089 25.2851 27.9071 0.0 0.0 0.0 -28.089 25.2851 28.9071 0.21359369223074795 0.21359369223074795 0.21359369223074795 -28.089 26.2851 27.9071 0.0 0.0 0.0 -28.089 26.2851 28.9071 0.2826717825261629 0.2826717825261629 0.2826717825261629 -27.089 25.2851 29.9071 0.0 0.0 0.0 -27.089 25.2851 30.9071 0.0 0.0 0.0 -28.089 25.2851 29.9071 0.03745748464412945 0.03745748464412945 0.03745748464412945 -28.089 25.2851 30.9071 0.10832212550867976 0.10832212550867976 0.10832212550867976 -28.089 26.2851 29.9071 0.0 0.0 0.0 -28.089 26.2851 30.9071 0.0 0.0 0.0 -25.089 23.2851 31.9071 0.0 0.0 0.0 -25.089 23.2851 32.9071 0.0 0.0 0.0 -25.089 24.2851 31.9071 0.30431540382602035 0.30431540382602035 0.30431540382602035 -25.089 24.2851 32.9071 0.0807381671068511 0.0807381671068511 0.0807381671068511 -26.089 23.2851 31.9071 0.0 0.0 0.0 -26.089 23.2851 32.9071 0.0 0.0 0.0 -26.089 24.2851 31.9071 0.022850840814925475 0.022850840814925475 0.022850840814925475 -26.089 24.2851 32.9071 0.02483044012245587 0.02483044012245587 0.02483044012245587 -25.089 23.2851 33.9071 0.0 0.0 0.0 -25.089 23.2851 34.9071 0.020588797415322387 0.020588797415322387 0.020588797415322387 -25.089 24.2851 33.9071 0.0 0.0 0.0 -25.089 24.2851 34.9071 0.0 0.0 0.0 -26.089 23.2851 33.9071 0.0 0.0 0.0 -26.089 23.2851 34.9071 0.0 0.0 0.0 -26.089 24.2851 33.9071 0.043851246491598314 0.043851246491598314 0.043851246491598314 -26.089 24.2851 34.9071 0.0 0.0 0.0 -25.089 26.2851 32.9071 0.72157266046119 0.72157266046119 0.72157266046119 -26.089 25.2851 32.9071 0.9981698172855674 0.9981698172855674 0.9981698172855674 -26.089 26.2851 31.9071 0.0 0.0 0.0 -26.089 26.2851 32.9071 0.6139059773611891 0.6139059773611891 0.6139059773611891 -25.089 25.2851 33.9071 0.0 0.0 0.0 -25.089 25.2851 34.9071 0.2629698560753479 0.2629698560753479 0.2629698560753479 -25.089 26.2851 33.9071 0.4388813869758853 0.4388813869758853 0.4388813869758853 -25.089 26.2851 34.9071 0.42650855982132085 0.42650855982132085 0.42650855982132085 -26.089 25.2851 33.9071 0.30138491430723136 0.30138491430723136 0.30138491430723136 -26.089 25.2851 34.9071 0.31883612900709546 0.31883612900709546 0.31883612900709546 -26.089 26.2851 33.9071 0.38692794357914684 0.38692794357914684 0.38692794357914684 -26.089 26.2851 34.9071 0.5864127309781548 0.5864127309781548 0.5864127309781548 -27.089 23.2851 32.9071 0.0 0.0 0.0 -27.089 24.2851 31.9071 0.0 0.0 0.0 -27.089 24.2851 32.9071 0.0 0.0 0.0 -28.089 23.2851 31.9071 0.6409235495032327 0.6409235495032327 0.6409235495032327 -28.089 23.2851 32.9071 0.0 0.0 0.0 -28.089 24.2851 31.9071 0.15667582526171991 0.15667582526171991 0.15667582526171991 -28.089 24.2851 32.9071 0.07471653143595476 0.07471653143595476 0.07471653143595476 -27.089 23.2851 33.9071 0.0 0.0 0.0 -27.089 24.2851 33.9071 0.0 0.0 0.0 -27.089 24.2851 34.9071 0.0 0.0 0.0 -27.089 25.2851 31.9071 0.3186932643772135 0.3186932643772135 0.3186932643772135 -27.089 25.2851 32.9071 0.1571155927548107 0.1571155927548107 0.1571155927548107 -27.089 26.2851 31.9071 0.3188601143052295 0.3188601143052295 0.3188601143052295 -27.089 26.2851 32.9071 0.09678278463665403 0.09678278463665403 0.09678278463665403 -28.089 25.2851 31.9071 0.0 0.0 0.0 -28.089 25.2851 32.9071 0.0 0.0 0.0 -28.089 26.2851 31.9071 0.3008064624201227 0.3008064624201227 0.3008064624201227 -28.089 26.2851 32.9071 0.0 0.0 0.0 -27.089 25.2851 33.9071 0.1041519057036868 0.1041519057036868 0.1041519057036868 -27.089 25.2851 34.9071 0.0 0.0 0.0 -27.089 26.2851 34.9071 0.05202366699402592 0.05202366699402592 0.05202366699402592 -28.089 25.2851 33.9071 0.0 0.0 0.0 -28.089 25.2851 34.9071 0.0 0.0 0.0 -28.089 26.2851 34.9071 0.0 0.0 0.0 -30.089 19.2851 28.9071 0.035952079886500475 0.035952079886500475 0.035952079886500475 -30.089 20.2851 28.9071 0.11929029786718848 0.11929029786718848 0.11929029786718848 -29.089 19.2851 29.9071 0.0 0.0 0.0 -29.089 20.2851 29.9071 0.05169678577662494 0.05169678577662494 0.05169678577662494 -29.089 20.2851 30.9071 0.0 0.0 0.0 -30.089 19.2851 29.9071 0.0332840184573051 0.0332840184573051 0.0332840184573051 -30.089 20.2851 29.9071 0.0 0.0 0.0 -29.089 21.2851 27.9071 0.0 0.0 0.0 -29.089 21.2851 28.9071 0.0 0.0 0.0 -29.089 22.2851 27.9071 0.0 0.0 0.0 -29.089 22.2851 28.9071 0.0 0.0 0.0 -30.089 21.2851 27.9071 0.0 0.0 0.0 -30.089 21.2851 28.9071 0.02225157981385352 0.02225157981385352 0.02225157981385352 -30.089 22.2851 28.9071 0.08941377002701413 0.08941377002701413 0.08941377002701413 -29.089 21.2851 29.9071 0.7270422018694362 0.7270422018694362 0.7270422018694362 -29.089 21.2851 30.9071 0.3014555063309247 0.3014555063309247 0.3014555063309247 -29.089 22.2851 29.9071 0.0 0.0 0.0 -29.089 22.2851 30.9071 0.5523960464734057 0.5523960464734057 0.5523960464734057 -30.089 21.2851 29.9071 0.2672997691048727 0.2672997691048727 0.2672997691048727 -30.089 21.2851 30.9071 0.0 0.0 0.0 -30.089 22.2851 29.9071 0.3382242271703225 0.3382242271703225 0.3382242271703225 -30.089 22.2851 30.9071 0.0 0.0 0.0 -31.089 19.2851 27.9071 0.0 0.0 0.0 -31.089 19.2851 28.9071 0.0 0.0 0.0 -31.089 20.2851 28.9071 0.28953515826942655 0.28953515826942655 0.28953515826942655 -32.089 19.2851 27.9071 0.0 0.0 0.0 -32.089 19.2851 28.9071 0.0 0.0 0.0 -32.089 20.2851 28.9071 0.0 0.0 0.0 -31.089 20.2851 29.9071 0.09350137609206305 0.09350137609206305 0.09350137609206305 -31.089 20.2851 30.9071 0.0 0.0 0.0 -32.089 19.2851 30.9071 0.0 0.0 0.0 -32.089 20.2851 29.9071 0.0 0.0 0.0 -32.089 20.2851 30.9071 0.0 0.0 0.0 -31.089 21.2851 27.9071 0.0 0.0 0.0 -31.089 21.2851 28.9071 0.07434309189984828 0.07434309189984828 0.07434309189984828 -31.089 22.2851 27.9071 0.0 0.0 0.0 -31.089 22.2851 28.9071 0.0 0.0 0.0 -32.089 21.2851 28.9071 0.04651558854478153 0.04651558854478153 0.04651558854478153 -32.089 22.2851 27.9071 0.0 0.0 0.0 -32.089 22.2851 28.9071 0.0 0.0 0.0 -31.089 21.2851 29.9071 0.0 0.0 0.0 -31.089 21.2851 30.9071 0.0 0.0 0.0 -31.089 22.2851 29.9071 0.05891340153693731 0.05891340153693731 0.05891340153693731 -31.089 22.2851 30.9071 0.0 0.0 0.0 -32.089 21.2851 29.9071 0.0 0.0 0.0 -32.089 21.2851 30.9071 0.0 0.0 0.0 -32.089 22.2851 29.9071 0.0 0.0 0.0 -32.089 22.2851 30.9071 0.0 0.0 0.0 -29.089 19.2851 31.9071 0.0 0.0 0.0 -29.089 19.2851 32.9071 0.0 0.0 0.0 -30.089 19.2851 32.9071 0.0 0.0 0.0 -30.089 20.2851 32.9071 0.0 0.0 0.0 -29.089 19.2851 33.9071 0.0 0.0 0.0 -29.089 20.2851 33.9071 0.0 0.0 0.0 -29.089 20.2851 34.9071 0.0 0.0 0.0 -30.089 19.2851 33.9071 0.0 0.0 0.0 -30.089 20.2851 33.9071 0.0 0.0 0.0 -29.089 22.2851 31.9071 0.0 0.0 0.0 -30.089 21.2851 31.9071 0.0 0.0 0.0 -30.089 21.2851 32.9071 0.0 0.0 0.0 -30.089 22.2851 31.9071 0.0 0.0 0.0 -30.089 22.2851 32.9071 0.0 0.0 0.0 -29.089 21.2851 33.9071 0.0 0.0 0.0 -29.089 21.2851 34.9071 0.0 0.0 0.0 -29.089 22.2851 33.9071 0.0 0.0 0.0 -29.089 22.2851 34.9071 0.0 0.0 0.0 -30.089 21.2851 33.9071 0.0 0.0 0.0 -30.089 21.2851 34.9071 0.0 0.0 0.0 -30.089 22.2851 33.9071 0.0 0.0 0.0 -30.089 22.2851 34.9071 0.0 0.0 0.0 -31.089 19.2851 31.9071 0.0 0.0 0.0 -31.089 19.2851 32.9071 0.0 0.0 0.0 -31.089 20.2851 31.9071 0.0 0.0 0.0 -31.089 20.2851 32.9071 0.0 0.0 0.0 -32.089 19.2851 31.9071 0.0 0.0 0.0 -32.089 20.2851 31.9071 0.0 0.0 0.0 -32.089 20.2851 32.9071 0.0 0.0 0.0 -31.089 20.2851 33.9071 0.0 0.0 0.0 -31.089 20.2851 34.9071 0.0 0.0 0.0 -32.089 19.2851 33.9071 0.0 0.0 0.0 -32.089 20.2851 33.9071 0.015375271729020283 0.015375271729020283 0.015375271729020283 -32.089 20.2851 34.9071 0.0 0.0 0.0 -31.089 21.2851 31.9071 0.0 0.0 0.0 -31.089 21.2851 32.9071 0.0 0.0 0.0 -31.089 22.2851 31.9071 0.0 0.0 0.0 -31.089 22.2851 32.9071 0.0 0.0 0.0 -32.089 21.2851 31.9071 0.0 0.0 0.0 -32.089 21.2851 32.9071 0.01449128837430043 0.01449128837430043 0.01449128837430043 -32.089 22.2851 31.9071 0.0 0.0 0.0 -32.089 22.2851 32.9071 0.0 0.0 0.0 -31.089 21.2851 33.9071 0.0 0.0 0.0 -31.089 21.2851 34.9071 0.0 0.0 0.0 -31.089 22.2851 33.9071 0.0 0.0 0.0 -31.089 22.2851 34.9071 0.0 0.0 0.0 -32.089 21.2851 34.9071 0.0 0.0 0.0 -29.089 23.2851 27.9071 0.0 0.0 0.0 -29.089 23.2851 28.9071 0.0 0.0 0.0 -29.089 24.2851 27.9071 0.0 0.0 0.0 -29.089 24.2851 28.9071 0.0 0.0 0.0 -30.089 23.2851 27.9071 0.0 0.0 0.0 -30.089 23.2851 28.9071 0.48890073229614206 0.48890073229614206 0.48890073229614206 -30.089 24.2851 27.9071 0.0 0.0 0.0 -30.089 24.2851 28.9071 0.0 0.0 0.0 -29.089 23.2851 29.9071 0.0 0.0 0.0 -29.089 23.2851 30.9071 0.0 0.0 0.0 -29.089 24.2851 29.9071 0.376244248877562 0.376244248877562 0.376244248877562 -30.089 23.2851 29.9071 0.2025412921985802 0.2025412921985802 0.2025412921985802 -30.089 23.2851 30.9071 0.0 0.0 0.0 -30.089 24.2851 29.9071 0.0 0.0 0.0 -29.089 25.2851 27.9071 0.0 0.0 0.0 -29.089 25.2851 28.9071 0.0 0.0 0.0 -29.089 26.2851 27.9071 0.05795091393867251 0.05795091393867251 0.05795091393867251 -29.089 26.2851 28.9071 0.0 0.0 0.0 -30.089 25.2851 27.9071 0.0 0.0 0.0 -30.089 25.2851 28.9071 0.0 0.0 0.0 -29.089 25.2851 29.9071 0.0 0.0 0.0 -29.089 25.2851 30.9071 0.0 0.0 0.0 -29.089 26.2851 29.9071 0.0 0.0 0.0 -29.089 26.2851 30.9071 0.0 0.0 0.0 -30.089 26.2851 29.9071 0.0 0.0 0.0 -31.089 23.2851 27.9071 0.0 0.0 0.0 -31.089 23.2851 28.9071 0.0 0.0 0.0 -31.089 24.2851 27.9071 0.0 0.0 0.0 -31.089 24.2851 28.9071 0.0 0.0 0.0 -32.089 23.2851 27.9071 0.0 0.0 0.0 -32.089 23.2851 28.9071 0.014664696413160136 0.014664696413160136 0.014664696413160136 -32.089 24.2851 27.9071 0.0 0.0 0.0 -31.089 23.2851 29.9071 0.26681233577360874 0.26681233577360874 0.26681233577360874 -31.089 23.2851 30.9071 0.0 0.0 0.0 -31.089 24.2851 29.9071 0.0 0.0 0.0 -31.089 24.2851 30.9071 0.26528565700360957 0.26528565700360957 0.26528565700360957 -32.089 23.2851 29.9071 0.0 0.0 0.0 -32.089 23.2851 30.9071 0.0 0.0 0.0 -32.089 24.2851 29.9071 0.12041597127623144 0.12041597127623144 0.12041597127623144 -32.089 24.2851 30.9071 0.0 0.0 0.0 -31.089 25.2851 27.9071 0.0 0.0 0.0 -32.089 25.2851 27.9071 0.0 0.0 0.0 -32.089 26.2851 27.9071 0.0 0.0 0.0 -32.089 26.2851 28.9071 0.0 0.0 0.0 -32.089 25.2851 29.9071 0.10045549588721935 0.10045549588721935 0.10045549588721935 -32.089 25.2851 30.9071 0.1317163404128195 0.1317163404128195 0.1317163404128195 -32.089 26.2851 29.9071 0.030062169765920698 0.030062169765920698 0.030062169765920698 -32.089 26.2851 30.9071 0.1780539308997622 0.1780539308997622 0.1780539308997622 -29.089 23.2851 31.9071 0.0 0.0 0.0 -29.089 23.2851 32.9071 0.0 0.0 0.0 -29.089 24.2851 31.9071 0.0 0.0 0.0 -29.089 24.2851 32.9071 0.14328936609887877 0.14328936609887877 0.14328936609887877 -30.089 23.2851 31.9071 0.22185127141843325 0.22185127141843325 0.22185127141843325 -30.089 23.2851 32.9071 0.0 0.0 0.0 -30.089 24.2851 31.9071 0.0 0.0 0.0 -30.089 24.2851 32.9071 0.0 0.0 0.0 -29.089 23.2851 33.9071 0.11719077209597217 0.11719077209597217 0.11719077209597217 -29.089 23.2851 34.9071 0.01446278681866503 0.01446278681866503 0.01446278681866503 -29.089 24.2851 33.9071 0.08222089772263379 0.08222089772263379 0.08222089772263379 -29.089 24.2851 34.9071 0.0 0.0 0.0 -30.089 23.2851 33.9071 0.0 0.0 0.0 -30.089 23.2851 34.9071 0.0 0.0 0.0 -30.089 24.2851 33.9071 0.0 0.0 0.0 -30.089 24.2851 34.9071 0.0 0.0 0.0 -29.089 25.2851 31.9071 0.1995865643227715 0.1995865643227715 0.1995865643227715 -29.089 25.2851 32.9071 0.0 0.0 0.0 -29.089 26.2851 31.9071 0.0 0.0 0.0 -29.089 25.2851 33.9071 0.285480630747126 0.285480630747126 0.285480630747126 -29.089 25.2851 34.9071 0.1075356174580439 0.1075356174580439 0.1075356174580439 -29.089 26.2851 34.9071 0.2628075448853712 0.2628075448853712 0.2628075448853712 -30.089 25.2851 33.9071 0.0 0.0 0.0 -30.089 25.2851 34.9071 0.0 0.0 0.0 -30.089 26.2851 34.9071 0.0 0.0 0.0 -31.089 23.2851 31.9071 0.0 0.0 0.0 -31.089 23.2851 32.9071 0.0 0.0 0.0 -31.089 24.2851 31.9071 0.0 0.0 0.0 -31.089 24.2851 32.9071 0.0 0.0 0.0 -32.089 23.2851 31.9071 0.0 0.0 0.0 -32.089 23.2851 32.9071 0.0 0.0 0.0 -32.089 24.2851 31.9071 0.0 0.0 0.0 -32.089 24.2851 32.9071 0.0 0.0 0.0 -31.089 24.2851 34.9071 0.0 0.0 0.0 -31.089 25.2851 31.9071 0.2574149907132369 0.2574149907132369 0.2574149907132369 -31.089 25.2851 32.9071 0.0 0.0 0.0 -32.089 25.2851 31.9071 0.0 0.0 0.0 -32.089 25.2851 32.9071 0.0 0.0 0.0 -32.089 26.2851 31.9071 0.05741227683676886 0.05741227683676886 0.05741227683676886 -32.089 26.2851 32.9071 0.0 0.0 0.0 -32.089 25.2851 34.9071 0.028177781434332676 0.028177781434332676 0.028177781434332676 -32.089 26.2851 33.9071 0.0 0.0 0.0 -32.089 26.2851 34.9071 0.0 0.0 0.0 -25.089 21.2851 35.9071 0.13621912973865538 0.13621912973865538 0.13621912973865538 -25.089 21.2851 36.9071 0.0 0.0 0.0 -25.089 22.2851 35.9071 0.2702524736713226 0.2702524736713226 0.2702524736713226 -25.089 22.2851 36.9071 0.0 0.0 0.0 -26.089 21.2851 35.9071 0.11412909594827686 0.11412909594827686 0.11412909594827686 -26.089 21.2851 36.9071 0.0 0.0 0.0 -26.089 22.2851 35.9071 0.04224880223674769 0.04224880223674769 0.04224880223674769 -25.089 21.2851 37.9071 0.0 0.0 0.0 -25.089 22.2851 37.9071 0.049943239191164376 0.049943239191164376 0.049943239191164376 -26.089 21.2851 37.9071 0.0 0.0 0.0 -26.089 22.2851 37.9071 0.0 0.0 0.0 -27.089 20.2851 35.9071 0.0 0.0 0.0 -28.089 20.2851 35.9071 0.0 0.0 0.0 -27.089 21.2851 35.9071 0.2209423723705897 0.2209423723705897 0.2209423723705897 -27.089 21.2851 36.9071 0.17292770154268786 0.17292770154268786 0.17292770154268786 -27.089 22.2851 35.9071 0.0 0.0 0.0 -28.089 21.2851 35.9071 0.0 0.0 0.0 -28.089 21.2851 36.9071 0.0 0.0 0.0 -28.089 22.2851 35.9071 0.0 0.0 0.0 -28.089 22.2851 36.9071 0.012675993612842874 0.012675993612842874 0.012675993612842874 -27.089 21.2851 37.9071 0.04531484678495982 0.04531484678495982 0.04531484678495982 -27.089 22.2851 37.9071 0.0 0.0 0.0 -28.089 22.2851 37.9071 0.0 0.0 0.0 -25.089 24.2851 36.9071 0.20209139617047484 0.20209139617047484 0.20209139617047484 -26.089 24.2851 35.9071 0.035084483765506866 0.035084483765506866 0.035084483765506866 -26.089 24.2851 36.9071 0.1833794024502999 0.1833794024502999 0.1833794024502999 -25.089 23.2851 37.9071 0.0 0.0 0.0 -25.089 24.2851 37.9071 0.06338589685471924 0.06338589685471924 0.06338589685471924 -26.089 23.2851 37.9071 0.0 0.0 0.0 -26.089 23.2851 38.9071 0.0014845246832289893 0.0014845246832289893 0.0014845246832289893 -26.089 24.2851 37.9071 0.053757638365746326 0.053757638365746326 0.053757638365746326 -26.089 24.2851 38.9071 0.0 0.0 0.0 -25.089 25.2851 35.9071 0.3446059416398082 0.3446059416398082 0.3446059416398082 -25.089 25.2851 36.9071 0.050351279463103 0.050351279463103 0.050351279463103 -25.089 26.2851 35.9071 0.4547204781593245 0.4547204781593245 0.4547204781593245 -25.089 26.2851 36.9071 0.15517210911980084 0.15517210911980084 0.15517210911980084 -26.089 25.2851 35.9071 0.4197503872759073 0.4197503872759073 0.4197503872759073 -26.089 25.2851 36.9071 0.08200351477899746 0.08200351477899746 0.08200351477899746 -26.089 26.2851 35.9071 0.0 0.0 0.0 -26.089 26.2851 36.9071 0.22562843273749164 0.22562843273749164 0.22562843273749164 -25.089 25.2851 37.9071 0.06648555013136206 0.06648555013136206 0.06648555013136206 -26.089 25.2851 37.9071 0.0 0.0 0.0 -26.089 25.2851 38.9071 0.05123793695136352 0.05123793695136352 0.05123793695136352 -27.089 24.2851 35.9071 0.0 0.0 0.0 -28.089 23.2851 36.9071 0.0 0.0 0.0 -28.089 24.2851 35.9071 0.03322619856921451 0.03322619856921451 0.03322619856921451 -27.089 23.2851 37.9071 0.0 0.0 0.0 -27.089 23.2851 38.9071 0.0 0.0 0.0 -27.089 24.2851 38.9071 0.0 0.0 0.0 -28.089 23.2851 37.9071 0.0 0.0 0.0 -28.089 23.2851 38.9071 0.0 0.0 0.0 -28.089 24.2851 38.9071 0.0 0.0 0.0 -27.089 25.2851 35.9071 0.0 0.0 0.0 -27.089 25.2851 36.9071 0.0 0.0 0.0 -27.089 26.2851 35.9071 0.5073578605209283 0.5073578605209283 0.5073578605209283 -27.089 26.2851 36.9071 0.058151367591674295 0.058151367591674295 0.058151367591674295 -28.089 25.2851 35.9071 0.2782509284326511 0.2782509284326511 0.2782509284326511 -28.089 26.2851 35.9071 0.0 0.0 0.0 -27.089 25.2851 37.9071 0.0 0.0 0.0 -27.089 25.2851 38.9071 0.02255636249633279 0.02255636249633279 0.02255636249633279 -27.089 26.2851 37.9071 0.0 0.0 0.0 -28.089 25.2851 37.9071 0.0 0.0 0.0 -28.089 25.2851 38.9071 0.0 0.0 0.0 -28.089 26.2851 37.9071 0.0 0.0 0.0 -29.089 20.2851 35.9071 0.0 0.0 0.0 -29.089 21.2851 35.9071 0.0 0.0 0.0 -29.089 22.2851 35.9071 0.0 0.0 0.0 -29.089 22.2851 36.9071 0.0 0.0 0.0 -30.089 22.2851 35.9071 0.0 0.0 0.0 -31.089 21.2851 35.9071 0.0 0.0 0.0 -31.089 22.2851 35.9071 0.0 0.0 0.0 -32.089 21.2851 35.9071 0.0 0.0 0.0 -32.089 22.2851 35.9071 0.0 0.0 0.0 -29.089 23.2851 35.9071 0.0 0.0 0.0 -29.089 23.2851 36.9071 0.0 0.0 0.0 -29.089 24.2851 35.9071 0.020543778386226324 0.020543778386226324 0.020543778386226324 -29.089 24.2851 36.9071 0.0 0.0 0.0 -30.089 23.2851 35.9071 0.0 0.0 0.0 -30.089 24.2851 35.9071 0.0 0.0 0.0 -29.089 23.2851 37.9071 0.0 0.0 0.0 -29.089 23.2851 38.9071 0.0 0.0 0.0 -29.089 24.2851 37.9071 0.0 0.0 0.0 -29.089 24.2851 38.9071 0.0 0.0 0.0 -29.089 25.2851 35.9071 0.0 0.0 0.0 -29.089 25.2851 36.9071 0.0 0.0 0.0 -29.089 26.2851 35.9071 0.0 0.0 0.0 -29.089 26.2851 36.9071 0.03468579615593607 0.03468579615593607 0.03468579615593607 -30.089 25.2851 35.9071 0.0 0.0 0.0 -30.089 26.2851 35.9071 0.0 0.0 0.0 -30.089 26.2851 36.9071 0.029317274707982986 0.029317274707982986 0.029317274707982986 -29.089 25.2851 37.9071 0.0 0.0 0.0 -29.089 25.2851 38.9071 0.0 0.0 0.0 -29.089 26.2851 37.9071 0.0 0.0 0.0 -30.089 26.2851 37.9071 0.001691478376620401 0.001691478376620401 0.001691478376620401 -31.089 23.2851 35.9071 0.0 0.0 0.0 -31.089 24.2851 35.9071 0.0 0.0 0.0 -32.089 23.2851 35.9071 0.023035495112501976 0.023035495112501976 0.023035495112501976 -32.089 24.2851 35.9071 0.0 0.0 0.0 -31.089 25.2851 35.9071 0.0 0.0 0.0 -31.089 26.2851 35.9071 0.0 0.0 0.0 -32.089 25.2851 35.9071 0.0 0.0 0.0 -32.089 26.2851 35.9071 0.0 0.0 0.0 -33.089 16.2851 27.9071 0.0 0.0 0.0 -33.089 16.2851 28.9071 0.0 0.0 0.0 -33.089 16.2851 29.9071 0.0 0.0 0.0 -33.089 16.2851 30.9071 0.0 0.0 0.0 -33.089 17.2851 27.9071 0.0 0.0 0.0 -33.089 17.2851 28.9071 0.0 0.0 0.0 -33.089 18.2851 27.9071 0.0 0.0 0.0 -33.089 18.2851 28.9071 0.1968530599432304 0.1968530599432304 0.1968530599432304 -33.089 17.2851 29.9071 0.0 0.0 0.0 -33.089 17.2851 30.9071 0.0 0.0 0.0 -33.089 18.2851 29.9071 0.0 0.0 0.0 -33.089 18.2851 30.9071 0.0 0.0 0.0 -33.089 19.2851 28.9071 0.0 0.0 0.0 -33.089 20.2851 28.9071 0.0 0.0 0.0 -34.089 20.2851 28.9071 0.001326612270431585 0.001326612270431585 0.001326612270431585 -33.089 19.2851 29.9071 0.0 0.0 0.0 -33.089 19.2851 30.9071 0.0 0.0 0.0 -33.089 20.2851 29.9071 0.0 0.0 0.0 -33.089 20.2851 30.9071 0.0 0.0 0.0 -34.089 20.2851 29.9071 0.0 0.0 0.0 -34.089 20.2851 30.9071 0.0 0.0 0.0 -33.089 21.2851 27.9071 0.0 0.0 0.0 -33.089 21.2851 28.9071 0.0 0.0 0.0 -33.089 22.2851 27.9071 0.0 0.0 0.0 -33.089 22.2851 28.9071 0.0 0.0 0.0 -34.089 21.2851 27.9071 0.0 0.0 0.0 -34.089 21.2851 28.9071 0.0 0.0 0.0 -34.089 22.2851 27.9071 0.0 0.0 0.0 -33.089 21.2851 30.9071 0.00027994591503675766 0.00027994591503675766 0.00027994591503675766 -34.089 21.2851 29.9071 0.0 0.0 0.0 -34.089 21.2851 30.9071 0.00955601271269964 0.00955601271269964 0.00955601271269964 -34.089 22.2851 30.9071 0.0394365107641475 0.0394365107641475 0.0394365107641475 -35.089 20.2851 28.9071 0.0 0.0 0.0 -35.089 20.2851 29.9071 0.08499873136883881 0.08499873136883881 0.08499873136883881 -35.089 21.2851 27.9071 0.0 0.0 0.0 -35.089 21.2851 28.9071 0.0 0.0 0.0 -35.089 22.2851 27.9071 0.0 0.0 0.0 -36.089 21.2851 27.9071 0.0 0.0 0.0 -36.089 21.2851 28.9071 0.0 0.0 0.0 -36.089 22.2851 27.9071 0.0 0.0 0.0 -36.089 22.2851 28.9071 0.0 0.0 0.0 -35.089 21.2851 29.9071 0.0 0.0 0.0 -35.089 21.2851 30.9071 0.0 0.0 0.0 -35.089 22.2851 30.9071 0.0 0.0 0.0 -36.089 21.2851 29.9071 0.0 0.0 0.0 -36.089 21.2851 30.9071 0.02117822950813672 0.02117822950813672 0.02117822950813672 -36.089 22.2851 30.9071 0.0 0.0 0.0 -33.089 19.2851 32.9071 0.0 0.0 0.0 -33.089 20.2851 31.9071 0.0 0.0 0.0 -33.089 20.2851 32.9071 0.15105073500502564 0.15105073500502564 0.15105073500502564 -34.089 19.2851 31.9071 0.0 0.0 0.0 -34.089 19.2851 32.9071 0.0 0.0 0.0 -34.089 20.2851 31.9071 0.0 0.0 0.0 -34.089 20.2851 32.9071 0.1941410421336235 0.1941410421336235 0.1941410421336235 -33.089 19.2851 33.9071 0.0 0.0 0.0 -33.089 19.2851 34.9071 0.0 0.0 0.0 -33.089 20.2851 33.9071 0.07824309249859296 0.07824309249859296 0.07824309249859296 -33.089 20.2851 34.9071 0.0 0.0 0.0 -34.089 19.2851 33.9071 0.0 0.0 0.0 -34.089 19.2851 34.9071 0.0 0.0 0.0 -34.089 20.2851 33.9071 0.0 0.0 0.0 -34.089 20.2851 34.9071 0.0 0.0 0.0 -33.089 21.2851 31.9071 0.0 0.0 0.0 -33.089 21.2851 32.9071 0.19131592030454714 0.19131592030454714 0.19131592030454714 -33.089 22.2851 31.9071 0.0 0.0 0.0 -34.089 21.2851 31.9071 0.047371819197883476 0.047371819197883476 0.047371819197883476 -34.089 22.2851 31.9071 0.0 0.0 0.0 -33.089 21.2851 34.9071 0.13841776655558366 0.13841776655558366 0.13841776655558366 -33.089 22.2851 34.9071 0.1697574273908541 0.1697574273908541 0.1697574273908541 -34.089 21.2851 34.9071 0.0 0.0 0.0 -34.089 22.2851 34.9071 0.0 0.0 0.0 -35.089 19.2851 32.9071 0.0 0.0 0.0 -35.089 20.2851 31.9071 0.0 0.0 0.0 -35.089 20.2851 32.9071 0.0 0.0 0.0 -36.089 20.2851 32.9071 0.011680409094730853 0.011680409094730853 0.011680409094730853 -35.089 19.2851 33.9071 0.0 0.0 0.0 -35.089 20.2851 33.9071 0.0 0.0 0.0 -35.089 20.2851 34.9071 0.04335913979325462 0.04335913979325462 0.04335913979325462 -36.089 20.2851 33.9071 0.0 0.0 0.0 -35.089 21.2851 31.9071 0.007652473909833931 0.007652473909833931 0.007652473909833931 -35.089 21.2851 32.9071 0.2192516082324474 0.2192516082324474 0.2192516082324474 -35.089 22.2851 31.9071 0.0 0.0 0.0 -35.089 22.2851 32.9071 0.26795291961547363 0.26795291961547363 0.26795291961547363 -36.089 21.2851 32.9071 0.0 0.0 0.0 -36.089 22.2851 31.9071 0.06016808293974955 0.06016808293974955 0.06016808293974955 -36.089 22.2851 32.9071 0.04691630748747291 0.04691630748747291 0.04691630748747291 -35.089 21.2851 33.9071 0.19399941266344545 0.19399941266344545 0.19399941266344545 -35.089 21.2851 34.9071 0.0 0.0 0.0 -35.089 22.2851 33.9071 0.0 0.0 0.0 -35.089 22.2851 34.9071 0.0 0.0 0.0 -36.089 21.2851 33.9071 0.08859835844283905 0.08859835844283905 0.08859835844283905 -36.089 21.2851 34.9071 0.0 0.0 0.0 -36.089 22.2851 34.9071 0.08100021733891276 0.08100021733891276 0.08100021733891276 -33.089 23.2851 29.9071 0.0 0.0 0.0 -33.089 23.2851 30.9071 0.0 0.0 0.0 -33.089 24.2851 29.9071 0.0 0.0 0.0 -33.089 24.2851 30.9071 0.0 0.0 0.0 -34.089 23.2851 29.9071 0.0 0.0 0.0 -34.089 23.2851 30.9071 0.0 0.0 0.0 -34.089 24.2851 29.9071 0.0 0.0 0.0 -34.089 24.2851 30.9071 0.005976844856871469 0.005976844856871469 0.005976844856871469 -33.089 25.2851 27.9071 0.0 0.0 0.0 -33.089 26.2851 27.9071 0.0 0.0 0.0 -33.089 26.2851 28.9071 0.0 0.0 0.0 -34.089 25.2851 27.9071 0.11495518189944537 0.11495518189944537 0.11495518189944537 -34.089 26.2851 27.9071 0.08773546383657103 0.08773546383657103 0.08773546383657103 -34.089 26.2851 28.9071 0.10885073975858088 0.10885073975858088 0.10885073975858088 -33.089 25.2851 29.9071 0.0 0.0 0.0 -33.089 25.2851 30.9071 0.008548838405999922 0.008548838405999922 0.008548838405999922 -33.089 26.2851 29.9071 0.0 0.0 0.0 -33.089 26.2851 30.9071 0.01725345398421746 0.01725345398421746 0.01725345398421746 -34.089 25.2851 30.9071 0.0 0.0 0.0 -34.089 26.2851 29.9071 0.05871258119548896 0.05871258119548896 0.05871258119548896 -34.089 26.2851 30.9071 0.0 0.0 0.0 -35.089 24.2851 27.9071 0.0500698261483205 0.0500698261483205 0.0500698261483205 -35.089 24.2851 28.9071 0.0 0.0 0.0 -36.089 23.2851 27.9071 0.0 0.0 0.0 -36.089 23.2851 28.9071 0.0046917535790440305 0.0046917535790440305 0.0046917535790440305 -36.089 24.2851 27.9071 0.0 0.0 0.0 -36.089 24.2851 28.9071 0.0 0.0 0.0 -35.089 23.2851 30.9071 0.0 0.0 0.0 -35.089 24.2851 29.9071 0.0 0.0 0.0 -35.089 24.2851 30.9071 0.025844358943095256 0.025844358943095256 0.025844358943095256 -36.089 23.2851 30.9071 0.0 0.0 0.0 -36.089 24.2851 29.9071 0.0 0.0 0.0 -36.089 24.2851 30.9071 0.0 0.0 0.0 -35.089 25.2851 27.9071 0.0 0.0 0.0 -35.089 25.2851 28.9071 0.03941221669890928 0.03941221669890928 0.03941221669890928 -35.089 26.2851 27.9071 0.0 0.0 0.0 -35.089 26.2851 28.9071 0.07695437888890021 0.07695437888890021 0.07695437888890021 -36.089 25.2851 27.9071 0.0 0.0 0.0 -36.089 25.2851 28.9071 0.07316740132706592 0.07316740132706592 0.07316740132706592 -36.089 26.2851 27.9071 0.0 0.0 0.0 -36.089 26.2851 28.9071 0.0 0.0 0.0 -35.089 25.2851 29.9071 0.0 0.0 0.0 -35.089 25.2851 30.9071 0.0 0.0 0.0 -35.089 26.2851 29.9071 0.0 0.0 0.0 -35.089 26.2851 30.9071 0.03233403292852228 0.03233403292852228 0.03233403292852228 -36.089 25.2851 29.9071 0.08146677259967472 0.08146677259967472 0.08146677259967472 -36.089 25.2851 30.9071 0.0 0.0 0.0 -36.089 26.2851 29.9071 0.0 0.0 0.0 -36.089 26.2851 30.9071 0.0 0.0 0.0 -33.089 23.2851 31.9071 0.0 0.0 0.0 -33.089 24.2851 31.9071 0.0 0.0 0.0 -34.089 23.2851 31.9071 0.04574618350739047 0.04574618350739047 0.04574618350739047 -34.089 24.2851 31.9071 0.1638065695623687 0.1638065695623687 0.1638065695623687 -33.089 23.2851 34.9071 0.0 0.0 0.0 -33.089 24.2851 34.9071 0.0 0.0 0.0 -34.089 23.2851 34.9071 0.0 0.0 0.0 -34.089 24.2851 33.9071 0.0 0.0 0.0 -34.089 24.2851 34.9071 0.0 0.0 0.0 -33.089 25.2851 31.9071 0.0 0.0 0.0 -33.089 26.2851 31.9071 0.0 0.0 0.0 -33.089 26.2851 32.9071 0.0 0.0 0.0 -34.089 25.2851 31.9071 0.07350216707414506 0.07350216707414506 0.07350216707414506 -34.089 25.2851 32.9071 0.14586114443870063 0.14586114443870063 0.14586114443870063 -34.089 26.2851 31.9071 0.08299619980331475 0.08299619980331475 0.08299619980331475 -34.089 26.2851 32.9071 0.0 0.0 0.0 -33.089 25.2851 33.9071 0.0 0.0 0.0 -33.089 25.2851 34.9071 0.0 0.0 0.0 -33.089 26.2851 33.9071 0.0 0.0 0.0 -33.089 26.2851 34.9071 0.016873512427063652 0.016873512427063652 0.016873512427063652 -34.089 25.2851 33.9071 0.12200639618815415 0.12200639618815415 0.12200639618815415 -34.089 25.2851 34.9071 0.0 0.0 0.0 -34.089 26.2851 33.9071 0.0 0.0 0.0 -35.089 23.2851 31.9071 0.02795980930508536 0.02795980930508536 0.02795980930508536 -35.089 23.2851 32.9071 0.17928800263273978 0.17928800263273978 0.17928800263273978 -35.089 24.2851 31.9071 0.0352776568793596 0.0352776568793596 0.0352776568793596 -35.089 24.2851 32.9071 0.26402044213175996 0.26402044213175996 0.26402044213175996 -36.089 23.2851 31.9071 0.0 0.0 0.0 -36.089 23.2851 32.9071 0.0 0.0 0.0 -36.089 24.2851 31.9071 0.15134733357053318 0.15134733357053318 0.15134733357053318 -35.089 23.2851 33.9071 0.0 0.0 0.0 -35.089 23.2851 34.9071 0.0 0.0 0.0 -35.089 24.2851 33.9071 0.20862515717796826 0.20862515717796826 0.20862515717796826 -35.089 24.2851 34.9071 0.0 0.0 0.0 -36.089 24.2851 34.9071 0.0 0.0 0.0 -35.089 25.2851 31.9071 0.2502047477771123 0.2502047477771123 0.2502047477771123 -35.089 25.2851 32.9071 0.0 0.0 0.0 -35.089 26.2851 31.9071 0.10223833065533985 0.10223833065533985 0.10223833065533985 -35.089 26.2851 32.9071 0.0 0.0 0.0 -36.089 25.2851 32.9071 0.193158689870733 0.193158689870733 0.193158689870733 -36.089 26.2851 32.9071 0.0 0.0 0.0 -35.089 25.2851 33.9071 0.2622340143692014 0.2622340143692014 0.2622340143692014 -35.089 25.2851 34.9071 0.175598606228494 0.175598606228494 0.175598606228494 -35.089 26.2851 33.9071 0.13051606919908462 0.13051606919908462 0.13051606919908462 -36.089 25.2851 34.9071 0.0 0.0 0.0 -36.089 26.2851 33.9071 0.26257150069736834 0.26257150069736834 0.26257150069736834 -36.089 26.2851 34.9071 0.0 0.0 0.0 -37.089 22.2851 27.9071 0.0 0.0 0.0 -37.089 22.2851 28.9071 0.0 0.0 0.0 -37.089 21.2851 29.9071 0.0 0.0 0.0 -37.089 21.2851 30.9071 0.0002394682942881074 0.0002394682942881074 0.0002394682942881074 -37.089 22.2851 29.9071 0.0 0.0 0.0 -37.089 22.2851 30.9071 0.0 0.0 0.0 -37.089 22.2851 32.9071 0.0 0.0 0.0 -38.089 22.2851 32.9071 0.0 0.0 0.0 -37.089 21.2851 33.9071 0.0 0.0 0.0 -37.089 21.2851 34.9071 0.0 0.0 0.0 -37.089 22.2851 33.9071 0.0 0.0 0.0 -37.089 22.2851 34.9071 0.013654987880721559 0.013654987880721559 0.013654987880721559 -38.089 21.2851 33.9071 0.0 0.0 0.0 -38.089 21.2851 34.9071 0.0 0.0 0.0 -38.089 22.2851 33.9071 0.0 0.0 0.0 -38.089 22.2851 34.9071 0.0 0.0 0.0 -39.089 22.2851 33.9071 0.0 0.0 0.0 -39.089 22.2851 34.9071 0.0 0.0 0.0 -37.089 23.2851 27.9071 0.06081531616595901 0.06081531616595901 0.06081531616595901 -37.089 23.2851 28.9071 0.0013733933557645958 0.0013733933557645958 0.0013733933557645958 -37.089 24.2851 27.9071 0.0 0.0 0.0 -37.089 24.2851 28.9071 0.0 0.0 0.0 -38.089 24.2851 27.9071 0.0 0.0 0.0 -38.089 24.2851 28.9071 0.0 0.0 0.0 -37.089 23.2851 29.9071 0.0 0.0 0.0 -37.089 23.2851 30.9071 0.0 0.0 0.0 -37.089 24.2851 29.9071 0.0 0.0 0.0 -37.089 24.2851 30.9071 0.0 0.0 0.0 -38.089 23.2851 30.9071 0.0 0.0 0.0 -38.089 24.2851 29.9071 0.030607877795692982 0.030607877795692982 0.030607877795692982 -38.089 24.2851 30.9071 0.007187595406337225 0.007187595406337225 0.007187595406337225 -37.089 25.2851 27.9071 0.029485205625013364 0.029485205625013364 0.029485205625013364 -37.089 25.2851 28.9071 0.0 0.0 0.0 -37.089 26.2851 27.9071 0.0 0.0 0.0 -37.089 26.2851 28.9071 0.0 0.0 0.0 -38.089 25.2851 28.9071 0.0 0.0 0.0 -37.089 25.2851 29.9071 0.0 0.0 0.0 -37.089 25.2851 30.9071 0.0 0.0 0.0 -37.089 26.2851 29.9071 0.0 0.0 0.0 -38.089 25.2851 29.9071 0.0 0.0 0.0 -39.089 24.2851 27.9071 0.0 0.0 0.0 -39.089 24.2851 28.9071 0.0 0.0 0.0 -40.089 24.2851 27.9071 0.012416781280321348 0.012416781280321348 0.012416781280321348 -39.089 24.2851 30.9071 0.0 0.0 0.0 -39.089 25.2851 27.9071 0.0 0.0 0.0 -39.089 25.2851 28.9071 0.0 0.0 0.0 -39.089 26.2851 28.9071 0.08797522428616635 0.08797522428616635 0.08797522428616635 -40.089 25.2851 27.9071 0.0 0.0 0.0 -40.089 25.2851 28.9071 0.0 0.0 0.0 -40.089 26.2851 27.9071 0.0 0.0 0.0 -40.089 26.2851 28.9071 0.056757522122927395 0.056757522122927395 0.056757522122927395 -39.089 25.2851 29.9071 0.0 0.0 0.0 -39.089 25.2851 30.9071 0.0 0.0 0.0 -39.089 26.2851 29.9071 0.0 0.0 0.0 -39.089 26.2851 30.9071 0.0 0.0 0.0 -40.089 25.2851 30.9071 0.0 0.0 0.0 -40.089 26.2851 29.9071 0.0 0.0 0.0 -40.089 26.2851 30.9071 0.0 0.0 0.0 -37.089 23.2851 31.9071 0.0 0.0 0.0 -37.089 23.2851 32.9071 0.0 0.0 0.0 -38.089 23.2851 31.9071 0.0 0.0 0.0 -38.089 23.2851 32.9071 0.0 0.0 0.0 -38.089 24.2851 31.9071 0.021986777493767307 0.021986777493767307 0.021986777493767307 -38.089 24.2851 32.9071 0.0 0.0 0.0 -37.089 24.2851 34.9071 0.0 0.0 0.0 -38.089 23.2851 33.9071 0.0 0.0 0.0 -38.089 23.2851 34.9071 0.0 0.0 0.0 -38.089 24.2851 33.9071 0.0 0.0 0.0 -38.089 24.2851 34.9071 0.0 0.0 0.0 -37.089 26.2851 32.9071 0.035909447137558774 0.035909447137558774 0.035909447137558774 -38.089 25.2851 31.9071 0.0 0.0 0.0 -38.089 25.2851 32.9071 0.006939298942717105 0.006939298942717105 0.006939298942717105 -38.089 26.2851 32.9071 0.036884128988468656 0.036884128988468656 0.036884128988468656 -37.089 25.2851 34.9071 0.0 0.0 0.0 -37.089 26.2851 33.9071 0.02720822781899514 0.02720822781899514 0.02720822781899514 -37.089 26.2851 34.9071 0.0 0.0 0.0 -38.089 25.2851 33.9071 0.0 0.0 0.0 -38.089 25.2851 34.9071 0.0 0.0 0.0 -38.089 26.2851 33.9071 0.0 0.0 0.0 -38.089 26.2851 34.9071 0.0 0.0 0.0 -39.089 24.2851 31.9071 0.0 0.0 0.0 -39.089 24.2851 32.9071 0.0 0.0 0.0 -39.089 23.2851 33.9071 0.0035069928678234338 0.0035069928678234338 0.0035069928678234338 -39.089 23.2851 34.9071 0.03539831684297919 0.03539831684297919 0.03539831684297919 -39.089 25.2851 31.9071 0.0 0.0 0.0 -39.089 25.2851 32.9071 0.0 0.0 0.0 -39.089 26.2851 31.9071 0.0 0.0 0.0 -39.089 26.2851 32.9071 0.0 0.0 0.0 -33.089 21.2851 35.9071 0.0 0.0 0.0 -33.089 22.2851 35.9071 0.0 0.0 0.0 -35.089 22.2851 35.9071 0.0 0.0 0.0 -36.089 22.2851 35.9071 0.0 0.0 0.0 -36.089 22.2851 36.9071 0.041280015779207674 0.041280015779207674 0.041280015779207674 -33.089 23.2851 35.9071 0.029133276537672607 0.029133276537672607 0.029133276537672607 -33.089 24.2851 35.9071 9.936297632454722e-05 9.936297632454722e-05 9.936297632454722e-05 -33.089 25.2851 35.9071 0.0 0.0 0.0 -35.089 23.2851 35.9071 0.017337790471290863 0.017337790471290863 0.017337790471290863 -35.089 24.2851 35.9071 0.0 0.0 0.0 -36.089 23.2851 35.9071 0.05640038436065005 0.05640038436065005 0.05640038436065005 -36.089 23.2851 36.9071 0.0026647392874428397 0.0026647392874428397 0.0026647392874428397 -36.089 24.2851 35.9071 0.0 0.0 0.0 -36.089 24.2851 36.9071 0.0 0.0 0.0 -36.089 25.2851 35.9071 0.0 0.0 0.0 -37.089 22.2851 35.9071 0.3251568620780399 0.3251568620780399 0.3251568620780399 -37.089 22.2851 36.9071 0.29552033749838136 0.29552033749838136 0.29552033749838136 -38.089 22.2851 35.9071 0.0 0.0 0.0 -37.089 23.2851 35.9071 0.0 0.0 0.0 -37.089 23.2851 36.9071 0.0 0.0 0.0 -37.089 24.2851 35.9071 0.0 0.0 0.0 -37.089 24.2851 36.9071 0.0 0.0 0.0 -38.089 23.2851 35.9071 0.0 0.0 0.0 -38.089 24.2851 35.9071 0.0 0.0 0.0 -37.089 25.2851 35.9071 0.017454060526610415 0.017454060526610415 0.017454060526610415 -41.089 24.2851 27.9071 0.03694483060471823 0.03694483060471823 0.03694483060471823 -42.089 24.2851 27.9071 0.004628613258033554 0.004628613258033554 0.004628613258033554 -41.089 25.2851 27.9071 0.029688505740219 0.029688505740219 0.029688505740219 -41.089 25.2851 28.9071 0.0 0.0 0.0 -41.089 26.2851 27.9071 0.000995755922296574 0.000995755922296574 0.000995755922296574 -41.089 26.2851 28.9071 0.0 0.0 0.0 -42.089 25.2851 27.9071 0.0 0.0 0.0 -42.089 25.2851 28.9071 0.032844133794268274 0.032844133794268274 0.032844133794268274 -42.089 26.2851 27.9071 0.04909538996964049 0.04909538996964049 0.04909538996964049 -42.089 26.2851 28.9071 0.0604482063710772 0.0604482063710772 0.0604482063710772 -43.089 25.2851 27.9071 0.032542556436387315 0.032542556436387315 0.032542556436387315 -43.089 26.2851 27.9071 0.05368052642374572 0.05368052642374572 0.05368052642374572 -29.089 34.2851 10.9071 0.0 0.0 0.0 -30.089 34.2851 10.9071 0.1313581095628276 0.1313581095628276 0.1313581095628276 -31.089 34.2851 10.9071 0.42291928345471563 0.42291928345471563 0.42291928345471563 -32.089 34.2851 10.9071 0.0 0.0 0.0 -29.089 35.2851 10.9071 0.0 0.0 0.0 -29.089 36.2851 10.9071 0.0 0.0 0.0 -30.089 35.2851 10.9071 0.0 0.0 0.0 -30.089 36.2851 10.9071 0.0 0.0 0.0 -31.089 35.2851 10.9071 0.0 0.0 0.0 -31.089 36.2851 10.9071 0.0 0.0 0.0 -32.089 35.2851 10.9071 0.0 0.0 0.0 -25.089 27.2851 13.9071 0.0 0.0 0.0 -25.089 27.2851 14.9071 0.0 0.0 0.0 -25.089 28.2851 13.9071 0.0 0.0 0.0 -25.089 28.2851 14.9071 0.0 0.0 0.0 -26.089 27.2851 13.9071 0.0 0.0 0.0 -26.089 27.2851 14.9071 0.0 0.0 0.0 -26.089 28.2851 13.9071 0.0 0.0 0.0 -26.089 28.2851 14.9071 0.0 0.0 0.0 -25.089 29.2851 13.9071 0.03155829825338541 0.03155829825338541 0.03155829825338541 -25.089 29.2851 14.9071 0.08015103579722999 0.08015103579722999 0.08015103579722999 -26.089 29.2851 14.9071 0.3341171452149958 0.3341171452149958 0.3341171452149958 -27.089 30.2851 14.9071 0.24828083700879464 0.24828083700879464 0.24828083700879464 -28.089 30.2851 13.9071 0.19129097021637662 0.19129097021637662 0.19129097021637662 -28.089 30.2851 14.9071 0.4989065262888447 0.4989065262888447 0.4989065262888447 -25.089 27.2851 15.9071 0.0 0.0 0.0 -25.089 27.2851 16.9071 0.0 0.0 0.0 -25.089 28.2851 15.9071 0.0 0.0 0.0 -25.089 28.2851 16.9071 0.0 0.0 0.0 -26.089 27.2851 15.9071 0.0 0.0 0.0 -26.089 27.2851 16.9071 0.0 0.0 0.0 -26.089 28.2851 15.9071 0.011245860678017205 0.011245860678017205 0.011245860678017205 -26.089 28.2851 16.9071 0.0 0.0 0.0 -25.089 27.2851 17.9071 0.0 0.0 0.0 -25.089 27.2851 18.9071 0.0 0.0 0.0 -25.089 28.2851 17.9071 0.009520361937923704 0.009520361937923704 0.009520361937923704 -25.089 28.2851 18.9071 0.0 0.0 0.0 -26.089 27.2851 17.9071 0.0 0.0 0.0 -26.089 27.2851 18.9071 0.0 0.0 0.0 -26.089 28.2851 17.9071 0.0 0.0 0.0 -25.089 29.2851 15.9071 0.0 0.0 0.0 -25.089 29.2851 16.9071 0.007237890308780727 0.007237890308780727 0.007237890308780727 -25.089 30.2851 15.9071 0.04290143045197562 0.04290143045197562 0.04290143045197562 -25.089 30.2851 16.9071 0.0 0.0 0.0 -26.089 29.2851 15.9071 0.2628040816237831 0.2628040816237831 0.2628040816237831 -26.089 29.2851 16.9071 0.0 0.0 0.0 -26.089 30.2851 16.9071 0.24831471500660723 0.24831471500660723 0.24831471500660723 -25.089 29.2851 17.9071 0.0 0.0 0.0 -25.089 30.2851 17.9071 0.0 0.0 0.0 -25.089 30.2851 18.9071 0.11813433392247152 0.11813433392247152 0.11813433392247152 -26.089 30.2851 17.9071 0.0 0.0 0.0 -26.089 30.2851 18.9071 0.0 0.0 0.0 -27.089 27.2851 15.9071 0.0 0.0 0.0 -27.089 27.2851 16.9071 0.0 0.0 0.0 -27.089 28.2851 15.9071 0.0 0.0 0.0 -28.089 27.2851 15.9071 0.0 0.0 0.0 -28.089 27.2851 16.9071 0.0 0.0 0.0 -28.089 28.2851 15.9071 0.0 0.0 0.0 -28.089 28.2851 16.9071 0.0 0.0 0.0 -27.089 27.2851 17.9071 0.0 0.0 0.0 -28.089 27.2851 18.9071 0.0 0.0 0.0 -27.089 29.2851 15.9071 0.0 0.0 0.0 -27.089 29.2851 16.9071 0.0 0.0 0.0 -27.089 30.2851 15.9071 0.0 0.0 0.0 -27.089 30.2851 16.9071 0.16908764687459737 0.16908764687459737 0.16908764687459737 -28.089 29.2851 15.9071 0.0 0.0 0.0 -28.089 29.2851 16.9071 0.0 0.0 0.0 -28.089 30.2851 15.9071 0.27291282571382375 0.27291282571382375 0.27291282571382375 -28.089 30.2851 16.9071 0.0 0.0 0.0 -27.089 29.2851 17.9071 0.0 0.0 0.0 -27.089 29.2851 18.9071 0.0 0.0 0.0 -27.089 30.2851 17.9071 0.0 0.0 0.0 -27.089 30.2851 18.9071 0.0 0.0 0.0 -28.089 29.2851 17.9071 0.0 0.0 0.0 -28.089 29.2851 18.9071 0.0 0.0 0.0 -28.089 30.2851 17.9071 0.0 0.0 0.0 -28.089 30.2851 18.9071 0.04754812603117021 0.04754812603117021 0.04754812603117021 -25.089 34.2851 14.9071 0.0 0.0 0.0 -26.089 34.2851 14.9071 0.0 0.0 0.0 -28.089 31.2851 12.9071 0.0 0.0 0.0 -28.089 32.2851 12.9071 0.0 0.0 0.0 -27.089 31.2851 13.9071 0.22716614305492303 0.22716614305492303 0.22716614305492303 -27.089 31.2851 14.9071 0.05823674288188104 0.05823674288188104 0.05823674288188104 -27.089 32.2851 13.9071 0.0 0.0 0.0 -27.089 32.2851 14.9071 0.1995395295351816 0.1995395295351816 0.1995395295351816 -28.089 31.2851 13.9071 0.0 0.0 0.0 -28.089 32.2851 13.9071 0.0 0.0 0.0 -27.089 33.2851 12.9071 0.5957096035715058 0.5957096035715058 0.5957096035715058 -27.089 34.2851 12.9071 0.6681175230760483 0.6681175230760483 0.6681175230760483 -28.089 33.2851 11.9071 0.0 0.0 0.0 -28.089 33.2851 12.9071 0.0 0.0 0.0 -28.089 34.2851 11.9071 0.6123496628691113 0.6123496628691113 0.6123496628691113 -28.089 34.2851 12.9071 0.4477880960419509 0.4477880960419509 0.4477880960419509 -27.089 33.2851 13.9071 0.3043096433423253 0.3043096433423253 0.3043096433423253 -27.089 33.2851 14.9071 0.0 0.0 0.0 -27.089 34.2851 13.9071 0.1736978504327953 0.1736978504327953 0.1736978504327953 -27.089 34.2851 14.9071 0.011171860848848992 0.011171860848848992 0.011171860848848992 -28.089 33.2851 13.9071 0.19072835479578532 0.19072835479578532 0.19072835479578532 -28.089 34.2851 13.9071 0.17530498524355587 0.17530498524355587 0.17530498524355587 -28.089 34.2851 14.9071 0.0 0.0 0.0 -25.089 31.2851 17.9071 0.0 0.0 0.0 -25.089 31.2851 18.9071 0.15680603299003568 0.15680603299003568 0.15680603299003568 -25.089 32.2851 18.9071 0.0 0.0 0.0 -26.089 31.2851 17.9071 0.0 0.0 0.0 -26.089 31.2851 18.9071 0.020398895921613584 0.020398895921613584 0.020398895921613584 -26.089 32.2851 18.9071 0.028374477688858014 0.028374477688858014 0.028374477688858014 -25.089 33.2851 15.9071 0.0 0.0 0.0 -25.089 33.2851 16.9071 0.0 0.0 0.0 -25.089 34.2851 15.9071 0.0 0.0 0.0 -25.089 34.2851 16.9071 0.0 0.0 0.0 -26.089 34.2851 15.9071 0.13780503646878794 0.13780503646878794 0.13780503646878794 -26.089 34.2851 16.9071 0.09828820784088438 0.09828820784088438 0.09828820784088438 -25.089 33.2851 18.9071 0.0 0.0 0.0 -25.089 34.2851 17.9071 0.01569820820732372 0.01569820820732372 0.01569820820732372 -25.089 34.2851 18.9071 0.12800947434576285 0.12800947434576285 0.12800947434576285 -26.089 33.2851 18.9071 0.0 0.0 0.0 -26.089 34.2851 17.9071 0.0 0.0 0.0 -26.089 34.2851 18.9071 0.049182566054578145 0.049182566054578145 0.049182566054578145 -27.089 31.2851 15.9071 0.36333812554136163 0.36333812554136163 0.36333812554136163 -27.089 31.2851 16.9071 0.0 0.0 0.0 -27.089 32.2851 15.9071 0.099941818627055 0.099941818627055 0.099941818627055 -27.089 32.2851 16.9071 0.026472231414231915 0.026472231414231915 0.026472231414231915 -27.089 31.2851 17.9071 0.25961655374367376 0.25961655374367376 0.25961655374367376 -27.089 31.2851 18.9071 0.03544490985073915 0.03544490985073915 0.03544490985073915 -27.089 32.2851 17.9071 0.016927705178162958 0.016927705178162958 0.016927705178162958 -27.089 32.2851 18.9071 0.09087988934560293 0.09087988934560293 0.09087988934560293 -28.089 31.2851 17.9071 0.0 0.0 0.0 -28.089 31.2851 18.9071 0.016602611888824857 0.016602611888824857 0.016602611888824857 -28.089 32.2851 18.9071 0.039300837081124154 0.039300837081124154 0.039300837081124154 -27.089 33.2851 15.9071 0.0 0.0 0.0 -27.089 33.2851 16.9071 0.13166567669823687 0.13166567669823687 0.13166567669823687 -27.089 34.2851 15.9071 0.015042233728666728 0.015042233728666728 0.015042233728666728 -27.089 34.2851 16.9071 0.13722893375647627 0.13722893375647627 0.13722893375647627 -28.089 34.2851 15.9071 0.2246408979489106 0.2246408979489106 0.2246408979489106 -28.089 34.2851 16.9071 0.0 0.0 0.0 -27.089 33.2851 17.9071 0.048376626707278145 0.048376626707278145 0.048376626707278145 -27.089 33.2851 18.9071 0.013549086135032862 0.013549086135032862 0.013549086135032862 -27.089 34.2851 17.9071 0.0 0.0 0.0 -27.089 34.2851 18.9071 0.0 0.0 0.0 -28.089 33.2851 17.9071 0.228332860202042 0.228332860202042 0.228332860202042 -28.089 33.2851 18.9071 0.028313376161990353 0.028313376161990353 0.028313376161990353 -28.089 34.2851 17.9071 0.0 0.0 0.0 -28.089 34.2851 18.9071 0.0 0.0 0.0 -29.089 30.2851 13.9071 0.0 0.0 0.0 -29.089 30.2851 14.9071 0.0 0.0 0.0 -30.089 30.2851 13.9071 0.3107281210831331 0.3107281210831331 0.3107281210831331 -30.089 30.2851 14.9071 0.30072260818455154 0.30072260818455154 0.30072260818455154 -31.089 30.2851 12.9071 0.3198770015459531 0.3198770015459531 0.3198770015459531 -32.089 30.2851 12.9071 0.0 0.0 0.0 -31.089 30.2851 13.9071 0.4223522911748515 0.4223522911748515 0.4223522911748515 -31.089 30.2851 14.9071 0.0 0.0 0.0 -32.089 30.2851 13.9071 0.0 0.0 0.0 -32.089 30.2851 14.9071 0.46672507354134973 0.46672507354134973 0.46672507354134973 -29.089 27.2851 16.9071 0.0 0.0 0.0 -29.089 28.2851 16.9071 0.0 0.0 0.0 -30.089 27.2851 16.9071 0.0 0.0 0.0 -29.089 27.2851 17.9071 0.0 0.0 0.0 -29.089 27.2851 18.9071 0.0 0.0 0.0 -29.089 28.2851 17.9071 0.0 0.0 0.0 -29.089 28.2851 18.9071 0.0 0.0 0.0 -30.089 27.2851 17.9071 0.0 0.0 0.0 -30.089 27.2851 18.9071 0.040603345391194874 0.040603345391194874 0.040603345391194874 -30.089 28.2851 17.9071 0.0 0.0 0.0 -30.089 28.2851 18.9071 0.0 0.0 0.0 -29.089 29.2851 15.9071 0.0 0.0 0.0 -29.089 29.2851 16.9071 0.0 0.0 0.0 -29.089 30.2851 15.9071 0.0 0.0 0.0 -29.089 30.2851 16.9071 0.0 0.0 0.0 -30.089 30.2851 15.9071 0.0 0.0 0.0 -30.089 30.2851 16.9071 0.0 0.0 0.0 -29.089 29.2851 17.9071 0.0 0.0 0.0 -29.089 29.2851 18.9071 0.0 0.0 0.0 -29.089 30.2851 17.9071 0.008923484135466954 0.008923484135466954 0.008923484135466954 -29.089 30.2851 18.9071 0.022547338431372972 0.022547338431372972 0.022547338431372972 -30.089 29.2851 17.9071 0.0 0.0 0.0 -30.089 29.2851 18.9071 0.0 0.0 0.0 -30.089 30.2851 17.9071 0.0 0.0 0.0 -30.089 30.2851 18.9071 0.0 0.0 0.0 -31.089 27.2851 18.9071 0.0 0.0 0.0 -31.089 28.2851 18.9071 0.0 0.0 0.0 -32.089 28.2851 18.9071 0.0 0.0 0.0 -31.089 29.2851 16.9071 0.0 0.0 0.0 -31.089 30.2851 16.9071 0.0 0.0 0.0 -32.089 30.2851 16.9071 0.0 0.0 0.0 -31.089 29.2851 17.9071 0.0 0.0 0.0 -31.089 29.2851 18.9071 0.0 0.0 0.0 -32.089 29.2851 17.9071 0.0037567193731955183 0.0037567193731955183 0.0037567193731955183 -32.089 29.2851 18.9071 0.0 0.0 0.0 -32.089 30.2851 17.9071 0.0 0.0 0.0 -32.089 30.2851 18.9071 0.0 0.0 0.0 -29.089 31.2851 12.9071 0.0 0.0 0.0 -29.089 32.2851 12.9071 0.6595720204704114 0.6595720204704114 0.6595720204704114 -30.089 31.2851 11.9071 0.07876725941190596 0.07876725941190596 0.07876725941190596 -30.089 31.2851 12.9071 0.0 0.0 0.0 -30.089 32.2851 11.9071 0.0 0.0 0.0 -30.089 32.2851 12.9071 0.4788974685604182 0.4788974685604182 0.4788974685604182 -29.089 31.2851 13.9071 0.0 0.0 0.0 -29.089 32.2851 13.9071 0.0 0.0 0.0 -30.089 31.2851 13.9071 0.4440376521278075 0.4440376521278075 0.4440376521278075 -30.089 31.2851 14.9071 0.5292756633137009 0.5292756633137009 0.5292756633137009 -30.089 32.2851 13.9071 0.0 0.0 0.0 -30.089 32.2851 14.9071 0.09393889392839998 0.09393889392839998 0.09393889392839998 -29.089 33.2851 11.9071 0.0 0.0 0.0 -29.089 33.2851 12.9071 0.3838452965790797 0.3838452965790797 0.3838452965790797 -29.089 34.2851 11.9071 0.6227197612078642 0.6227197612078642 0.6227197612078642 -30.089 33.2851 11.9071 0.0 0.0 0.0 -30.089 33.2851 12.9071 0.0 0.0 0.0 -30.089 34.2851 11.9071 0.0 0.0 0.0 -29.089 34.2851 14.9071 0.0 0.0 0.0 -30.089 33.2851 14.9071 0.0 0.0 0.0 -30.089 34.2851 14.9071 0.2576379103408533 0.2576379103408533 0.2576379103408533 -31.089 31.2851 11.9071 0.024444002915046236 0.024444002915046236 0.024444002915046236 -31.089 31.2851 12.9071 0.4112958433319171 0.4112958433319171 0.4112958433319171 -31.089 32.2851 11.9071 0.18225050989583627 0.18225050989583627 0.18225050989583627 -32.089 31.2851 11.9071 0.0 0.0 0.0 -32.089 31.2851 12.9071 0.0 0.0 0.0 -32.089 32.2851 11.9071 0.024269318589080158 0.024269318589080158 0.024269318589080158 -31.089 31.2851 13.9071 0.505250195648568 0.505250195648568 0.505250195648568 -31.089 31.2851 14.9071 0.0 0.0 0.0 -31.089 32.2851 14.9071 0.0 0.0 0.0 -32.089 31.2851 14.9071 0.0 0.0 0.0 -32.089 32.2851 14.9071 0.2983675524280597 0.2983675524280597 0.2983675524280597 -31.089 33.2851 11.9071 0.14376651979174354 0.14376651979174354 0.14376651979174354 -31.089 34.2851 11.9071 0.0 0.0 0.0 -32.089 33.2851 11.9071 0.11852318212488377 0.11852318212488377 0.11852318212488377 -32.089 33.2851 12.9071 0.3130468217248313 0.3130468217248313 0.3130468217248313 -32.089 34.2851 11.9071 0.09609801134191384 0.09609801134191384 0.09609801134191384 -32.089 34.2851 12.9071 0.0 0.0 0.0 -31.089 33.2851 14.9071 0.0 0.0 0.0 -31.089 34.2851 14.9071 0.0 0.0 0.0 -32.089 33.2851 13.9071 0.005379523347129413 0.005379523347129413 0.005379523347129413 -32.089 33.2851 14.9071 0.11660147959237353 0.11660147959237353 0.11660147959237353 -32.089 34.2851 13.9071 0.18714227967696184 0.18714227967696184 0.18714227967696184 -32.089 34.2851 14.9071 0.16822723964833883 0.16822723964833883 0.16822723964833883 -30.089 31.2851 15.9071 0.21422048545203062 0.21422048545203062 0.21422048545203062 -30.089 31.2851 16.9071 0.09955325403660162 0.09955325403660162 0.09955325403660162 -30.089 32.2851 15.9071 0.2180649941629082 0.2180649941629082 0.2180649941629082 -30.089 32.2851 16.9071 0.15367617978780265 0.15367617978780265 0.15367617978780265 -29.089 31.2851 17.9071 0.0 0.0 0.0 -29.089 31.2851 18.9071 0.0 0.0 0.0 -29.089 32.2851 17.9071 0.0 0.0 0.0 -29.089 32.2851 18.9071 0.0 0.0 0.0 -30.089 31.2851 17.9071 0.0 0.0 0.0 -30.089 31.2851 18.9071 0.0 0.0 0.0 -30.089 32.2851 17.9071 0.0 0.0 0.0 -30.089 32.2851 18.9071 0.0 0.0 0.0 -29.089 33.2851 16.9071 0.10275416391663966 0.10275416391663966 0.10275416391663966 -29.089 34.2851 15.9071 0.2221557784582943 0.2221557784582943 0.2221557784582943 -29.089 34.2851 16.9071 0.041126938981631486 0.041126938981631486 0.041126938981631486 -30.089 33.2851 15.9071 0.0 0.0 0.0 -30.089 33.2851 16.9071 0.1911313210897127 0.1911313210897127 0.1911313210897127 -30.089 34.2851 15.9071 0.0 0.0 0.0 -30.089 34.2851 16.9071 0.0 0.0 0.0 -29.089 33.2851 17.9071 0.0 0.0 0.0 -29.089 33.2851 18.9071 0.0 0.0 0.0 -29.089 34.2851 17.9071 0.07987229787108897 0.07987229787108897 0.07987229787108897 -29.089 34.2851 18.9071 0.0 0.0 0.0 -30.089 33.2851 17.9071 0.0 0.0 0.0 -30.089 33.2851 18.9071 0.0 0.0 0.0 -30.089 34.2851 17.9071 0.0 0.0 0.0 -30.089 34.2851 18.9071 0.0 0.0 0.0 -31.089 31.2851 15.9071 0.0 0.0 0.0 -31.089 31.2851 16.9071 0.11588817799527203 0.11588817799527203 0.11588817799527203 -31.089 32.2851 15.9071 0.0 0.0 0.0 -31.089 32.2851 16.9071 0.05172071842598688 0.05172071842598688 0.05172071842598688 -32.089 31.2851 15.9071 0.0 0.0 0.0 -32.089 31.2851 16.9071 0.0 0.0 0.0 -32.089 32.2851 15.9071 0.04387939449699182 0.04387939449699182 0.04387939449699182 -32.089 32.2851 16.9071 0.0011535690527033208 0.0011535690527033208 0.0011535690527033208 -31.089 31.2851 17.9071 0.012442183354969669 0.012442183354969669 0.012442183354969669 -31.089 32.2851 17.9071 0.005992539744139918 0.005992539744139918 0.005992539744139918 -32.089 31.2851 17.9071 0.0 0.0 0.0 -32.089 31.2851 18.9071 0.0 0.0 0.0 -31.089 33.2851 15.9071 0.21517872460598678 0.21517872460598678 0.21517872460598678 -31.089 34.2851 15.9071 0.0 0.0 0.0 -32.089 33.2851 15.9071 0.06813645178645225 0.06813645178645225 0.06813645178645225 -32.089 33.2851 16.9071 0.0 0.0 0.0 -32.089 34.2851 15.9071 0.0 0.0 0.0 -32.089 34.2851 16.9071 0.0 0.0 0.0 -31.089 33.2851 18.9071 0.0 0.0 0.0 -31.089 34.2851 18.9071 0.0014945573226442007 0.0014945573226442007 0.0014945573226442007 -32.089 34.2851 18.9071 0.0 0.0 0.0 -25.089 27.2851 19.9071 0.0 0.0 0.0 -25.089 27.2851 20.9071 0.0 0.0 0.0 -25.089 28.2851 20.9071 0.0 0.0 0.0 -26.089 27.2851 19.9071 0.0 0.0 0.0 -26.089 27.2851 20.9071 0.0 0.0 0.0 -26.089 28.2851 20.9071 0.0 0.0 0.0 -25.089 27.2851 21.9071 0.0 0.0 0.0 -25.089 27.2851 22.9071 0.0 0.0 0.0 -25.089 28.2851 21.9071 0.0 0.0 0.0 -25.089 28.2851 22.9071 0.0 0.0 0.0 -26.089 27.2851 21.9071 0.0 0.0 0.0 -26.089 27.2851 22.9071 0.0 0.0 0.0 -26.089 28.2851 21.9071 0.0 0.0 0.0 -26.089 28.2851 22.9071 0.0 0.0 0.0 -25.089 30.2851 20.9071 0.0 0.0 0.0 -26.089 29.2851 19.9071 0.0 0.0 0.0 -26.089 29.2851 20.9071 0.0 0.0 0.0 -26.089 30.2851 19.9071 0.04232609461677815 0.04232609461677815 0.04232609461677815 -26.089 30.2851 20.9071 0.0 0.0 0.0 -25.089 29.2851 21.9071 0.0 0.0 0.0 -25.089 29.2851 22.9071 0.00699023426776352 0.00699023426776352 0.00699023426776352 -25.089 30.2851 21.9071 0.004006581604597268 0.004006581604597268 0.004006581604597268 -25.089 30.2851 22.9071 0.0 0.0 0.0 -26.089 29.2851 21.9071 0.0 0.0 0.0 -26.089 30.2851 21.9071 0.0 0.0 0.0 -27.089 27.2851 20.9071 0.0 0.0 0.0 -27.089 28.2851 20.9071 0.0 0.0 0.0 -28.089 27.2851 19.9071 0.0 0.0 0.0 -28.089 27.2851 20.9071 0.0 0.0 0.0 -28.089 28.2851 19.9071 0.0 0.0 0.0 -28.089 28.2851 20.9071 0.0 0.0 0.0 -27.089 27.2851 21.9071 0.0 0.0 0.0 -27.089 27.2851 22.9071 0.0 0.0 0.0 -27.089 28.2851 21.9071 0.0 0.0 0.0 -28.089 27.2851 21.9071 0.0 0.0 0.0 -28.089 27.2851 22.9071 0.0 0.0 0.0 -28.089 28.2851 21.9071 0.0 0.0 0.0 -28.089 28.2851 22.9071 0.0 0.0 0.0 -27.089 29.2851 19.9071 0.0 0.0 0.0 -27.089 29.2851 20.9071 0.0 0.0 0.0 -27.089 30.2851 19.9071 0.08036262245769134 0.08036262245769134 0.08036262245769134 -27.089 30.2851 20.9071 0.0 0.0 0.0 -28.089 29.2851 19.9071 0.022921215671987946 0.022921215671987946 0.022921215671987946 -28.089 29.2851 20.9071 0.0 0.0 0.0 -28.089 30.2851 19.9071 0.09664012893304287 0.09664012893304287 0.09664012893304287 -28.089 30.2851 20.9071 0.023844744497516352 0.023844744497516352 0.023844744497516352 -28.089 29.2851 21.9071 0.0 0.0 0.0 -28.089 30.2851 21.9071 0.0 0.0 0.0 -25.089 27.2851 23.9071 0.0 0.0 0.0 -25.089 27.2851 24.9071 0.0 0.0 0.0 -25.089 28.2851 23.9071 0.0 0.0 0.0 -25.089 28.2851 24.9071 0.0 0.0 0.0 -26.089 27.2851 23.9071 0.0 0.0 0.0 -26.089 27.2851 24.9071 0.0 0.0 0.0 -26.089 28.2851 24.9071 0.0 0.0 0.0 -25.089 27.2851 25.9071 0.3452110595930469 0.3452110595930469 0.3452110595930469 -25.089 27.2851 26.9071 0.18014816223625177 0.18014816223625177 0.18014816223625177 -25.089 28.2851 25.9071 0.0 0.0 0.0 -26.089 27.2851 26.9071 0.0 0.0 0.0 -26.089 28.2851 25.9071 0.0 0.0 0.0 -25.089 29.2851 23.9071 0.0 0.0 0.0 -25.089 30.2851 23.9071 0.11159239181416195 0.11159239181416195 0.11159239181416195 -25.089 30.2851 24.9071 0.0 0.0 0.0 -26.089 29.2851 24.9071 0.0 0.0 0.0 -26.089 30.2851 24.9071 0.0 0.0 0.0 -25.089 29.2851 25.9071 0.0 0.0 0.0 -25.089 29.2851 26.9071 0.0 0.0 0.0 -25.089 30.2851 25.9071 0.0 0.0 0.0 -25.089 30.2851 26.9071 0.0 0.0 0.0 -26.089 29.2851 25.9071 0.0 0.0 0.0 -26.089 29.2851 26.9071 0.0 0.0 0.0 -26.089 30.2851 25.9071 0.0 0.0 0.0 -27.089 27.2851 23.9071 0.0 0.0 0.0 -27.089 27.2851 24.9071 0.0 0.0 0.0 -27.089 28.2851 23.9071 0.0 0.0 0.0 -27.089 28.2851 24.9071 0.0 0.0 0.0 -28.089 27.2851 23.9071 0.0 0.0 0.0 -28.089 28.2851 23.9071 0.0 0.0 0.0 -28.089 27.2851 25.9071 0.0 0.0 0.0 -28.089 27.2851 26.9071 0.2257865290368412 0.2257865290368412 0.2257865290368412 -28.089 28.2851 26.9071 0.0 0.0 0.0 -27.089 29.2851 23.9071 0.0 0.0 0.0 -27.089 29.2851 24.9071 0.0 0.0 0.0 -27.089 30.2851 24.9071 0.0 0.0 0.0 -28.089 29.2851 23.9071 0.0 0.0 0.0 -28.089 29.2851 24.9071 0.0 0.0 0.0 -28.089 30.2851 23.9071 0.0 0.0 0.0 -28.089 30.2851 24.9071 0.0 0.0 0.0 -27.089 30.2851 25.9071 0.0 0.0 0.0 -25.089 31.2851 20.9071 0.0 0.0 0.0 -25.089 32.2851 20.9071 0.0 0.0 0.0 -26.089 31.2851 19.9071 0.10918666887128259 0.10918666887128259 0.10918666887128259 -26.089 31.2851 20.9071 0.0 0.0 0.0 -26.089 32.2851 19.9071 0.0 0.0 0.0 -26.089 32.2851 20.9071 0.08945689326810195 0.08945689326810195 0.08945689326810195 -25.089 31.2851 21.9071 0.0 0.0 0.0 -25.089 31.2851 22.9071 0.0 0.0 0.0 -25.089 32.2851 21.9071 0.0 0.0 0.0 -25.089 32.2851 22.9071 0.06291928170299714 0.06291928170299714 0.06291928170299714 -26.089 31.2851 21.9071 0.0 0.0 0.0 -26.089 31.2851 22.9071 0.0 0.0 0.0 -26.089 32.2851 21.9071 0.0 0.0 0.0 -25.089 33.2851 19.9071 0.0 0.0 0.0 -25.089 33.2851 20.9071 0.0 0.0 0.0 -25.089 34.2851 19.9071 0.0 0.0 0.0 -25.089 34.2851 20.9071 0.0 0.0 0.0 -25.089 33.2851 21.9071 0.0 0.0 0.0 -25.089 33.2851 22.9071 0.0 0.0 0.0 -25.089 34.2851 21.9071 0.0 0.0 0.0 -25.089 34.2851 22.9071 0.0 0.0 0.0 -26.089 33.2851 21.9071 0.0 0.0 0.0 -26.089 33.2851 22.9071 0.0 0.0 0.0 -26.089 34.2851 21.9071 0.0 0.0 0.0 -26.089 34.2851 22.9071 0.014417437458802244 0.014417437458802244 0.014417437458802244 -27.089 31.2851 19.9071 0.10551486864076846 0.10551486864076846 0.10551486864076846 -27.089 31.2851 20.9071 0.19659208206394638 0.19659208206394638 0.19659208206394638 -27.089 32.2851 19.9071 0.0 0.0 0.0 -27.089 32.2851 20.9071 0.029072146123311975 0.029072146123311975 0.029072146123311975 -28.089 31.2851 20.9071 0.050580984762554196 0.050580984762554196 0.050580984762554196 -27.089 31.2851 21.9071 0.0 0.0 0.0 -27.089 31.2851 22.9071 0.0 0.0 0.0 -28.089 31.2851 21.9071 0.019888526118313897 0.019888526118313897 0.019888526118313897 -28.089 31.2851 22.9071 0.0 0.0 0.0 -28.089 32.2851 21.9071 0.042766116109076206 0.042766116109076206 0.042766116109076206 -28.089 32.2851 22.9071 0.0 0.0 0.0 -27.089 33.2851 19.9071 0.0 0.0 0.0 -27.089 34.2851 19.9071 0.0 0.0 0.0 -27.089 34.2851 20.9071 0.0 0.0 0.0 -28.089 33.2851 19.9071 0.0 0.0 0.0 -28.089 34.2851 19.9071 0.0 0.0 0.0 -28.089 34.2851 20.9071 0.0 0.0 0.0 -27.089 34.2851 21.9071 0.0 0.0 0.0 -27.089 34.2851 22.9071 0.0 0.0 0.0 -28.089 33.2851 22.9071 0.013986462164137542 0.013986462164137542 0.013986462164137542 -28.089 34.2851 21.9071 0.0 0.0 0.0 -28.089 34.2851 22.9071 0.0 0.0 0.0 -25.089 31.2851 23.9071 0.14875814013062813 0.14875814013062813 0.14875814013062813 -25.089 31.2851 24.9071 0.0 0.0 0.0 -25.089 32.2851 23.9071 0.0 0.0 0.0 -25.089 32.2851 24.9071 0.0 0.0 0.0 -26.089 31.2851 23.9071 0.2182713602399996 0.2182713602399996 0.2182713602399996 -26.089 32.2851 23.9071 0.0 0.0 0.0 -25.089 31.2851 25.9071 0.0 0.0 0.0 -25.089 31.2851 26.9071 0.0 0.0 0.0 -25.089 32.2851 25.9071 0.0 0.0 0.0 -25.089 32.2851 26.9071 0.0 0.0 0.0 -26.089 31.2851 25.9071 0.0 0.0 0.0 -26.089 31.2851 26.9071 0.0 0.0 0.0 -26.089 32.2851 25.9071 0.0 0.0 0.0 -26.089 32.2851 26.9071 0.0 0.0 0.0 -25.089 33.2851 23.9071 0.0 0.0 0.0 -25.089 33.2851 24.9071 0.0 0.0 0.0 -25.089 34.2851 23.9071 0.0 0.0 0.0 -25.089 34.2851 24.9071 0.03930236521378622 0.03930236521378622 0.03930236521378622 -26.089 33.2851 23.9071 0.010682684654435079 0.010682684654435079 0.010682684654435079 -26.089 33.2851 24.9071 0.0 0.0 0.0 -26.089 34.2851 23.9071 0.0 0.0 0.0 -26.089 34.2851 24.9071 0.019445801850161114 0.019445801850161114 0.019445801850161114 -25.089 33.2851 26.9071 0.0 0.0 0.0 -25.089 34.2851 25.9071 0.0 0.0 0.0 -25.089 34.2851 26.9071 0.03822057111317602 0.03822057111317602 0.03822057111317602 -26.089 33.2851 25.9071 0.0 0.0 0.0 -26.089 33.2851 26.9071 0.0 0.0 0.0 -26.089 34.2851 25.9071 0.03471888861891908 0.03471888861891908 0.03471888861891908 -26.089 34.2851 26.9071 0.0 0.0 0.0 -27.089 31.2851 23.9071 0.15699974898421992 0.15699974898421992 0.15699974898421992 -27.089 31.2851 24.9071 0.0 0.0 0.0 -27.089 32.2851 23.9071 0.0 0.0 0.0 -28.089 31.2851 23.9071 0.0 0.0 0.0 -28.089 31.2851 24.9071 0.0 0.0 0.0 -28.089 32.2851 23.9071 0.0 0.0 0.0 -28.089 32.2851 24.9071 0.0 0.0 0.0 -27.089 31.2851 25.9071 0.0 0.0 0.0 -27.089 32.2851 25.9071 0.0 0.0 0.0 -28.089 31.2851 25.9071 0.0 0.0 0.0 -28.089 31.2851 26.9071 0.054828043766984094 0.054828043766984094 0.054828043766984094 -28.089 32.2851 25.9071 0.0071741798643357255 0.0071741798643357255 0.0071741798643357255 -27.089 33.2851 23.9071 0.014662071761766138 0.014662071761766138 0.014662071761766138 -27.089 34.2851 23.9071 0.0 0.0 0.0 -27.089 34.2851 24.9071 0.13911058894874467 0.13911058894874467 0.13911058894874467 -28.089 33.2851 23.9071 0.0 0.0 0.0 -28.089 33.2851 24.9071 0.0 0.0 0.0 -28.089 34.2851 23.9071 0.0 0.0 0.0 -28.089 34.2851 24.9071 0.0018045556032835633 0.0018045556032835633 0.0018045556032835633 -27.089 33.2851 25.9071 0.0 0.0 0.0 -27.089 33.2851 26.9071 0.0 0.0 0.0 -27.089 34.2851 25.9071 0.0 0.0 0.0 -27.089 34.2851 26.9071 0.0 0.0 0.0 -28.089 33.2851 25.9071 0.0 0.0 0.0 -28.089 33.2851 26.9071 0.02540300050768498 0.02540300050768498 0.02540300050768498 -28.089 34.2851 25.9071 0.01590264772606267 0.01590264772606267 0.01590264772606267 -28.089 34.2851 26.9071 0.01616078746903414 0.01616078746903414 0.01616078746903414 -29.089 27.2851 19.9071 0.0 0.0 0.0 -29.089 27.2851 20.9071 0.0 0.0 0.0 -29.089 28.2851 19.9071 0.0 0.0 0.0 -29.089 28.2851 20.9071 0.0 0.0 0.0 -30.089 28.2851 19.9071 0.0 0.0 0.0 -29.089 27.2851 21.9071 0.0 0.0 0.0 -29.089 27.2851 22.9071 0.0 0.0 0.0 -29.089 28.2851 21.9071 0.016474225836707036 0.016474225836707036 0.016474225836707036 -29.089 28.2851 22.9071 0.008895032335417885 0.008895032335417885 0.008895032335417885 -30.089 27.2851 21.9071 0.0 0.0 0.0 -30.089 27.2851 22.9071 0.0 0.0 0.0 -30.089 28.2851 21.9071 0.004492101065743788 0.004492101065743788 0.004492101065743788 -30.089 28.2851 22.9071 0.0 0.0 0.0 -29.089 29.2851 19.9071 0.0 0.0 0.0 -29.089 30.2851 19.9071 0.0 0.0 0.0 -30.089 29.2851 19.9071 0.0 0.0 0.0 -30.089 30.2851 19.9071 0.0 0.0 0.0 -29.089 29.2851 21.9071 0.0 0.0 0.0 -29.089 29.2851 22.9071 0.0 0.0 0.0 -29.089 30.2851 21.9071 0.0 0.0 0.0 -29.089 30.2851 22.9071 0.0 0.0 0.0 -30.089 29.2851 21.9071 0.0 0.0 0.0 -30.089 29.2851 22.9071 0.0 0.0 0.0 -30.089 30.2851 21.9071 0.0 0.0 0.0 -30.089 30.2851 22.9071 0.0 0.0 0.0 -31.089 27.2851 19.9071 0.0 0.0 0.0 -31.089 27.2851 20.9071 0.0 0.0 0.0 -32.089 27.2851 19.9071 0.0 0.0 0.0 -32.089 27.2851 20.9071 0.0 0.0 0.0 -32.089 28.2851 19.9071 0.0 0.0 0.0 -31.089 27.2851 21.9071 0.0 0.0 0.0 -31.089 27.2851 22.9071 0.0 0.0 0.0 -31.089 28.2851 21.9071 0.0 0.0 0.0 -31.089 28.2851 22.9071 0.0 0.0 0.0 -32.089 27.2851 21.9071 0.0 0.0 0.0 -32.089 27.2851 22.9071 0.0 0.0 0.0 -32.089 28.2851 21.9071 0.0 0.0 0.0 -32.089 28.2851 22.9071 0.0 0.0 0.0 -32.089 29.2851 19.9071 0.0 0.0 0.0 -32.089 30.2851 19.9071 0.0 0.0 0.0 -32.089 30.2851 20.9071 0.0 0.0 0.0 -31.089 29.2851 21.9071 0.0 0.0 0.0 -31.089 29.2851 22.9071 0.0 0.0 0.0 -31.089 30.2851 21.9071 0.0 0.0 0.0 -31.089 30.2851 22.9071 0.0 0.0 0.0 -32.089 29.2851 21.9071 0.0 0.0 0.0 -32.089 29.2851 22.9071 0.0 0.0 0.0 -32.089 30.2851 21.9071 0.0 0.0 0.0 -32.089 30.2851 22.9071 0.0 0.0 0.0 -29.089 28.2851 23.9071 0.008190676783646617 0.008190676783646617 0.008190676783646617 -30.089 27.2851 24.9071 0.07044714526956214 0.07044714526956214 0.07044714526956214 -30.089 28.2851 23.9071 0.012729081189964195 0.012729081189964195 0.012729081189964195 -30.089 28.2851 24.9071 0.0 0.0 0.0 -29.089 27.2851 25.9071 0.07248468116509629 0.07248468116509629 0.07248468116509629 -29.089 27.2851 26.9071 0.0 0.0 0.0 -29.089 28.2851 26.9071 0.0 0.0 0.0 -30.089 27.2851 25.9071 0.07647174126883037 0.07647174126883037 0.07647174126883037 -30.089 27.2851 26.9071 0.0 0.0 0.0 -30.089 28.2851 25.9071 0.0014659613949369484 0.0014659613949369484 0.0014659613949369484 -30.089 28.2851 26.9071 0.0 0.0 0.0 -29.089 29.2851 23.9071 0.0 0.0 0.0 -29.089 30.2851 23.9071 0.0 0.0 0.0 -30.089 30.2851 23.9071 0.0 0.0 0.0 -30.089 30.2851 24.9071 0.0 0.0 0.0 -29.089 29.2851 26.9071 0.0 0.0 0.0 -29.089 30.2851 26.9071 0.0 0.0 0.0 -30.089 29.2851 25.9071 0.0 0.0 0.0 -30.089 29.2851 26.9071 0.0 0.0 0.0 -30.089 30.2851 26.9071 0.0 0.0 0.0 -31.089 27.2851 23.9071 0.0 0.0 0.0 -31.089 27.2851 24.9071 0.0018775985950994591 0.0018775985950994591 0.0018775985950994591 -31.089 28.2851 23.9071 0.0 0.0 0.0 -31.089 28.2851 24.9071 0.0 0.0 0.0 -32.089 27.2851 23.9071 0.0 0.0 0.0 -32.089 27.2851 24.9071 0.0 0.0 0.0 -32.089 28.2851 23.9071 0.0 0.0 0.0 -32.089 28.2851 24.9071 0.0 0.0 0.0 -31.089 27.2851 25.9071 0.0 0.0 0.0 -31.089 28.2851 25.9071 0.0 0.0 0.0 -31.089 28.2851 26.9071 0.0 0.0 0.0 -32.089 27.2851 25.9071 0.006562181941008315 0.006562181941008315 0.006562181941008315 -32.089 27.2851 26.9071 0.0 0.0 0.0 -32.089 28.2851 25.9071 0.08875653909081288 0.08875653909081288 0.08875653909081288 -32.089 28.2851 26.9071 0.0 0.0 0.0 -31.089 29.2851 23.9071 0.0 0.0 0.0 -31.089 29.2851 24.9071 0.0 0.0 0.0 -31.089 30.2851 23.9071 0.0 0.0 0.0 -31.089 30.2851 24.9071 0.0 0.0 0.0 -32.089 29.2851 23.9071 0.0 0.0 0.0 -32.089 29.2851 24.9071 0.0 0.0 0.0 -32.089 30.2851 23.9071 0.0 0.0 0.0 -32.089 30.2851 24.9071 0.0 0.0 0.0 -31.089 29.2851 25.9071 0.0 0.0 0.0 -31.089 30.2851 25.9071 0.0 0.0 0.0 -31.089 30.2851 26.9071 0.018855464682720032 0.018855464682720032 0.018855464682720032 -32.089 29.2851 25.9071 0.00019703004994366322 0.00019703004994366322 0.00019703004994366322 -32.089 29.2851 26.9071 0.0 0.0 0.0 -32.089 30.2851 25.9071 0.0 0.0 0.0 -32.089 30.2851 26.9071 0.01447312097413223 0.01447312097413223 0.01447312097413223 -29.089 31.2851 19.9071 0.0 0.0 0.0 -29.089 32.2851 19.9071 0.0 0.0 0.0 -30.089 32.2851 19.9071 0.0 0.0 0.0 -29.089 31.2851 21.9071 0.0 0.0 0.0 -29.089 31.2851 22.9071 0.0 0.0 0.0 -29.089 32.2851 22.9071 0.0 0.0 0.0 -30.089 31.2851 21.9071 0.0 0.0 0.0 -30.089 31.2851 22.9071 0.0 0.0 0.0 -30.089 32.2851 22.9071 0.0 0.0 0.0 -29.089 33.2851 19.9071 0.0 0.0 0.0 -29.089 33.2851 20.9071 0.0 0.0 0.0 -29.089 34.2851 19.9071 0.0 0.0 0.0 -29.089 34.2851 20.9071 0.0 0.0 0.0 -30.089 33.2851 19.9071 0.0 0.0 0.0 -30.089 33.2851 20.9071 0.0 0.0 0.0 -30.089 34.2851 19.9071 0.0 0.0 0.0 -30.089 34.2851 20.9071 0.0 0.0 0.0 -29.089 33.2851 21.9071 0.0 0.0 0.0 -29.089 33.2851 22.9071 0.0 0.0 0.0 -29.089 34.2851 21.9071 0.0 0.0 0.0 -29.089 34.2851 22.9071 0.0 0.0 0.0 -30.089 33.2851 21.9071 0.0 0.0 0.0 -30.089 33.2851 22.9071 0.010962195352121526 0.010962195352121526 0.010962195352121526 -30.089 34.2851 21.9071 0.0 0.0 0.0 -30.089 34.2851 22.9071 0.0 0.0 0.0 -31.089 32.2851 20.9071 0.0 0.0 0.0 -32.089 31.2851 19.9071 0.0 0.0 0.0 -32.089 31.2851 20.9071 0.0 0.0 0.0 -32.089 32.2851 20.9071 0.0 0.0 0.0 -31.089 31.2851 21.9071 0.0 0.0 0.0 -31.089 31.2851 22.9071 0.05827200249966573 0.05827200249966573 0.05827200249966573 -31.089 32.2851 21.9071 0.018341953824659845 0.018341953824659845 0.018341953824659845 -31.089 32.2851 22.9071 0.0 0.0 0.0 -32.089 31.2851 21.9071 0.0 0.0 0.0 -32.089 32.2851 21.9071 0.0 0.0 0.0 -31.089 33.2851 19.9071 0.0 0.0 0.0 -31.089 33.2851 20.9071 0.0 0.0 0.0 -31.089 34.2851 19.9071 0.0057948962479425475 0.0057948962479425475 0.0057948962479425475 -31.089 34.2851 20.9071 0.0 0.0 0.0 -32.089 33.2851 20.9071 0.0026661109471199738 0.0026661109471199738 0.0026661109471199738 -32.089 34.2851 19.9071 0.0 0.0 0.0 -32.089 34.2851 20.9071 0.0 0.0 0.0 -31.089 33.2851 21.9071 0.010335272764201054 0.010335272764201054 0.010335272764201054 -31.089 33.2851 22.9071 0.0 0.0 0.0 -31.089 34.2851 21.9071 0.0 0.0 0.0 -31.089 34.2851 22.9071 0.0 0.0 0.0 -32.089 33.2851 21.9071 0.0011196600780953765 0.0011196600780953765 0.0011196600780953765 -32.089 33.2851 22.9071 0.0 0.0 0.0 -32.089 34.2851 22.9071 0.0 0.0 0.0 -29.089 31.2851 23.9071 0.012288206476848532 0.012288206476848532 0.012288206476848532 -29.089 31.2851 24.9071 0.0 0.0 0.0 -29.089 32.2851 23.9071 0.058288695375636315 0.058288695375636315 0.058288695375636315 -29.089 32.2851 24.9071 0.0 0.0 0.0 -30.089 31.2851 23.9071 0.04199661243053991 0.04199661243053991 0.04199661243053991 -30.089 31.2851 24.9071 0.0 0.0 0.0 -30.089 32.2851 23.9071 0.11656484989803978 0.11656484989803978 0.11656484989803978 -30.089 32.2851 24.9071 0.0 0.0 0.0 -29.089 31.2851 26.9071 0.0 0.0 0.0 -29.089 32.2851 25.9071 0.0 0.0 0.0 -29.089 32.2851 26.9071 0.0 0.0 0.0 -30.089 31.2851 25.9071 0.0 0.0 0.0 -30.089 31.2851 26.9071 0.0 0.0 0.0 -30.089 32.2851 25.9071 0.0 0.0 0.0 -30.089 32.2851 26.9071 0.0 0.0 0.0 -29.089 33.2851 24.9071 0.0 0.0 0.0 -29.089 34.2851 23.9071 0.0034783245538067145 0.0034783245538067145 0.0034783245538067145 -29.089 34.2851 24.9071 0.0 0.0 0.0 -30.089 33.2851 24.9071 0.0 0.0 0.0 -30.089 34.2851 24.9071 0.0 0.0 0.0 -29.089 33.2851 25.9071 0.0 0.0 0.0 -29.089 33.2851 26.9071 0.0 0.0 0.0 -29.089 34.2851 25.9071 0.06914226103782142 0.06914226103782142 0.06914226103782142 -29.089 34.2851 26.9071 0.0 0.0 0.0 -30.089 33.2851 25.9071 0.0 0.0 0.0 -30.089 33.2851 26.9071 0.0 0.0 0.0 -30.089 34.2851 25.9071 0.0 0.0 0.0 -30.089 34.2851 26.9071 0.0 0.0 0.0 -31.089 31.2851 24.9071 0.0 0.0 0.0 -31.089 32.2851 23.9071 0.0 0.0 0.0 -31.089 32.2851 24.9071 0.0 0.0 0.0 -32.089 31.2851 24.9071 0.04700790394037474 0.04700790394037474 0.04700790394037474 -32.089 32.2851 23.9071 0.20801317632430505 0.20801317632430505 0.20801317632430505 -32.089 32.2851 24.9071 0.14708244261844458 0.14708244261844458 0.14708244261844458 -31.089 31.2851 25.9071 0.0 0.0 0.0 -31.089 31.2851 26.9071 0.0 0.0 0.0 -31.089 32.2851 25.9071 0.0 0.0 0.0 -31.089 32.2851 26.9071 0.0 0.0 0.0 -32.089 31.2851 25.9071 0.18080144442100915 0.18080144442100915 0.18080144442100915 -32.089 31.2851 26.9071 0.0 0.0 0.0 -32.089 32.2851 25.9071 0.0 0.0 0.0 -31.089 33.2851 23.9071 0.0 0.0 0.0 -31.089 33.2851 24.9071 0.0 0.0 0.0 -31.089 34.2851 23.9071 0.0 0.0 0.0 -31.089 34.2851 24.9071 0.015467229486326724 0.015467229486326724 0.015467229486326724 -32.089 33.2851 23.9071 0.16819278776630148 0.16819278776630148 0.16819278776630148 -32.089 33.2851 24.9071 0.0 0.0 0.0 -32.089 34.2851 23.9071 0.024749656959917717 0.024749656959917717 0.024749656959917717 -31.089 33.2851 25.9071 0.0 0.0 0.0 -31.089 34.2851 25.9071 0.0 0.0 0.0 -32.089 34.2851 26.9071 0.0 0.0 0.0 -25.089 35.2851 14.9071 0.0 0.0 0.0 -25.089 36.2851 14.9071 0.0 0.0 0.0 -26.089 35.2851 14.9071 0.11025556941353923 0.11025556941353923 0.11025556941353923 -26.089 36.2851 14.9071 0.14014351276590545 0.14014351276590545 0.14014351276590545 -25.089 37.2851 14.9071 0.0 0.0 0.0 -25.089 38.2851 14.9071 0.0 0.0 0.0 -26.089 37.2851 14.9071 0.003290379030418768 0.003290379030418768 0.003290379030418768 -26.089 38.2851 14.9071 0.02365866725548673 0.02365866725548673 0.02365866725548673 -28.089 35.2851 12.9071 0.035386240400846 0.035386240400846 0.035386240400846 -28.089 35.2851 13.9071 0.11379823108587914 0.11379823108587914 0.11379823108587914 -28.089 35.2851 14.9071 0.0820227545014482 0.0820227545014482 0.0820227545014482 -27.089 37.2851 14.9071 0.10855373758499783 0.10855373758499783 0.10855373758499783 -27.089 38.2851 14.9071 0.06104094948790681 0.06104094948790681 0.06104094948790681 -26.089 35.2851 15.9071 0.0 0.0 0.0 -26.089 35.2851 16.9071 0.07468853139906027 0.07468853139906027 0.07468853139906027 -26.089 36.2851 15.9071 0.12361101589275253 0.12361101589275253 0.12361101589275253 -26.089 36.2851 16.9071 0.000719404282607589 0.000719404282607589 0.000719404282607589 -26.089 35.2851 17.9071 0.0625847837973421 0.0625847837973421 0.0625847837973421 -26.089 35.2851 18.9071 0.0 0.0 0.0 -25.089 38.2851 16.9071 0.059753165462297655 0.059753165462297655 0.059753165462297655 -26.089 37.2851 16.9071 0.07389586341855289 0.07389586341855289 0.07389586341855289 -26.089 38.2851 15.9071 0.014167162628307969 0.014167162628307969 0.014167162628307969 -26.089 38.2851 16.9071 0.19060198143947024 0.19060198143947024 0.19060198143947024 -25.089 37.2851 17.9071 0.10777633998294933 0.10777633998294933 0.10777633998294933 -25.089 37.2851 18.9071 0.11750346760813811 0.11750346760813811 0.11750346760813811 -25.089 38.2851 17.9071 0.010075523364537823 0.010075523364537823 0.010075523364537823 -25.089 38.2851 18.9071 0.0 0.0 0.0 -26.089 37.2851 17.9071 0.0163888994315908 0.0163888994315908 0.0163888994315908 -26.089 37.2851 18.9071 0.12058005907249895 0.12058005907249895 0.12058005907249895 -26.089 38.2851 17.9071 0.13559859889461826 0.13559859889461826 0.13559859889461826 -27.089 35.2851 16.9071 0.05070359598021986 0.05070359598021986 0.05070359598021986 -27.089 36.2851 15.9071 0.1663228586289224 0.1663228586289224 0.1663228586289224 -27.089 36.2851 16.9071 0.12128440883654901 0.12128440883654901 0.12128440883654901 -28.089 35.2851 15.9071 0.05108441527821282 0.05108441527821282 0.05108441527821282 -28.089 35.2851 16.9071 0.0 0.0 0.0 -28.089 36.2851 16.9071 0.12515941514112078 0.12515941514112078 0.12515941514112078 -27.089 35.2851 17.9071 0.05934171425403803 0.05934171425403803 0.05934171425403803 -27.089 35.2851 18.9071 0.0 0.0 0.0 -27.089 36.2851 17.9071 0.0746413632610394 0.0746413632610394 0.0746413632610394 -27.089 36.2851 18.9071 0.0 0.0 0.0 -28.089 35.2851 17.9071 0.0 0.0 0.0 -28.089 35.2851 18.9071 0.0 0.0 0.0 -28.089 36.2851 17.9071 0.0339098893098728 0.0339098893098728 0.0339098893098728 -28.089 36.2851 18.9071 0.0 0.0 0.0 -27.089 37.2851 15.9071 0.0 0.0 0.0 -27.089 37.2851 16.9071 0.19837956874446208 0.19837956874446208 0.19837956874446208 -27.089 38.2851 15.9071 0.0 0.0 0.0 -27.089 38.2851 16.9071 0.009934140311149553 0.009934140311149553 0.009934140311149553 -28.089 37.2851 16.9071 0.4646612558066246 0.4646612558066246 0.4646612558066246 -28.089 38.2851 16.9071 0.0 0.0 0.0 -27.089 37.2851 17.9071 0.0 0.0 0.0 -27.089 37.2851 18.9071 0.1022011641371908 0.1022011641371908 0.1022011641371908 -28.089 37.2851 17.9071 0.03878885294201603 0.03878885294201603 0.03878885294201603 -28.089 37.2851 18.9071 0.1576950657970342 0.1576950657970342 0.1576950657970342 -28.089 38.2851 17.9071 0.1458453247722843 0.1458453247722843 0.1458453247722843 -28.089 38.2851 18.9071 0.1437710941358254 0.1437710941358254 0.1437710941358254 -25.089 39.2851 14.9071 0.0 0.0 0.0 -26.089 39.2851 14.9071 0.0 0.0 0.0 -25.089 39.2851 15.9071 0.03651665097563899 0.03651665097563899 0.03651665097563899 -25.089 39.2851 16.9071 0.09881832788208933 0.09881832788208933 0.09881832788208933 -26.089 39.2851 15.9071 0.0 0.0 0.0 -26.089 39.2851 16.9071 0.12168299749920619 0.12168299749920619 0.12168299749920619 -25.089 39.2851 17.9071 0.41888431645292407 0.41888431645292407 0.41888431645292407 -26.089 39.2851 17.9071 0.33155455464491906 0.33155455464491906 0.33155455464491906 -29.089 35.2851 11.9071 0.0 0.0 0.0 -29.089 35.2851 12.9071 0.04244196888660769 0.04244196888660769 0.04244196888660769 -29.089 36.2851 11.9071 0.0 0.0 0.0 -29.089 36.2851 12.9071 0.0 0.0 0.0 -30.089 35.2851 12.9071 0.10708545785144719 0.10708545785144719 0.10708545785144719 -30.089 36.2851 11.9071 0.004344699045751256 0.004344699045751256 0.004344699045751256 -30.089 36.2851 12.9071 0.20379063860480015 0.20379063860480015 0.20379063860480015 -29.089 35.2851 13.9071 0.05632531619969918 0.05632531619969918 0.05632531619969918 -29.089 35.2851 14.9071 0.0 0.0 0.0 -30.089 35.2851 13.9071 0.08553994373153026 0.08553994373153026 0.08553994373153026 -30.089 35.2851 14.9071 0.0 0.0 0.0 -30.089 36.2851 13.9071 0.0 0.0 0.0 -30.089 36.2851 14.9071 0.10430642428954838 0.10430642428954838 0.10430642428954838 -30.089 37.2851 14.9071 0.0 0.0 0.0 -30.089 38.2851 14.9071 0.0733682237756511 0.0733682237756511 0.0733682237756511 -31.089 36.2851 11.9071 0.0 0.0 0.0 -31.089 36.2851 12.9071 0.0 0.0 0.0 -32.089 35.2851 11.9071 0.09744189662909075 0.09744189662909075 0.09744189662909075 -32.089 35.2851 12.9071 0.16792820873319134 0.16792820873319134 0.16792820873319134 -32.089 36.2851 11.9071 0.0 0.0 0.0 -32.089 36.2851 12.9071 0.0 0.0 0.0 -31.089 35.2851 13.9071 0.0 0.0 0.0 -31.089 35.2851 14.9071 0.0 0.0 0.0 -31.089 36.2851 13.9071 0.0 0.0 0.0 -31.089 36.2851 14.9071 0.0 0.0 0.0 -32.089 35.2851 13.9071 0.100824298046335 0.100824298046335 0.100824298046335 -32.089 35.2851 14.9071 0.0 0.0 0.0 -32.089 36.2851 13.9071 0.0 0.0 0.0 -32.089 36.2851 14.9071 0.0 0.0 0.0 -31.089 37.2851 14.9071 0.07407821474223171 0.07407821474223171 0.07407821474223171 -31.089 38.2851 14.9071 0.1375563370576441 0.1375563370576441 0.1375563370576441 -32.089 37.2851 14.9071 0.0 0.0 0.0 -29.089 35.2851 15.9071 0.0 0.0 0.0 -29.089 35.2851 16.9071 0.020537125102564013 0.020537125102564013 0.020537125102564013 -29.089 36.2851 15.9071 0.16815170161028595 0.16815170161028595 0.16815170161028595 -29.089 36.2851 16.9071 0.11242628299135397 0.11242628299135397 0.11242628299135397 -30.089 35.2851 15.9071 0.0 0.0 0.0 -30.089 35.2851 16.9071 0.0 0.0 0.0 -30.089 36.2851 15.9071 0.13159701200968726 0.13159701200968726 0.13159701200968726 -30.089 36.2851 16.9071 0.0 0.0 0.0 -29.089 35.2851 17.9071 0.0 0.0 0.0 -29.089 36.2851 17.9071 0.0 0.0 0.0 -29.089 37.2851 15.9071 0.12935136655506804 0.12935136655506804 0.12935136655506804 -29.089 37.2851 16.9071 0.05030277198796034 0.05030277198796034 0.05030277198796034 -29.089 38.2851 15.9071 0.0 0.0 0.0 -29.089 38.2851 16.9071 0.07875995011940184 0.07875995011940184 0.07875995011940184 -30.089 37.2851 15.9071 0.0 0.0 0.0 -30.089 38.2851 15.9071 0.0 0.0 0.0 -30.089 38.2851 16.9071 0.0 0.0 0.0 -29.089 38.2851 17.9071 0.04903011061977723 0.04903011061977723 0.04903011061977723 -29.089 38.2851 18.9071 0.23593590362660663 0.23593590362660663 0.23593590362660663 -30.089 38.2851 18.9071 0.08490339429937621 0.08490339429937621 0.08490339429937621 -31.089 35.2851 15.9071 0.19368547570472208 0.19368547570472208 0.19368547570472208 -32.089 35.2851 15.9071 0.070914315790467 0.070914315790467 0.070914315790467 -32.089 35.2851 16.9071 0.05220358385202701 0.05220358385202701 0.05220358385202701 -32.089 36.2851 15.9071 0.0 0.0 0.0 -31.089 35.2851 18.9071 0.05955801122929206 0.05955801122929206 0.05955801122929206 -31.089 36.2851 17.9071 0.0 0.0 0.0 -31.089 36.2851 18.9071 0.034526522036127494 0.034526522036127494 0.034526522036127494 -32.089 35.2851 17.9071 0.0 0.0 0.0 -32.089 35.2851 18.9071 0.02382804364561331 0.02382804364561331 0.02382804364561331 -32.089 36.2851 17.9071 0.0 0.0 0.0 -32.089 36.2851 18.9071 0.0 0.0 0.0 -31.089 38.2851 15.9071 0.0 0.0 0.0 -31.089 38.2851 16.9071 0.0 0.0 0.0 -32.089 37.2851 15.9071 0.0 0.0 0.0 -32.089 37.2851 16.9071 0.0 0.0 0.0 -32.089 38.2851 15.9071 0.0 0.0 0.0 -32.089 38.2851 16.9071 0.0 0.0 0.0 -31.089 37.2851 17.9071 0.0693044019420225 0.0693044019420225 0.0693044019420225 -31.089 37.2851 18.9071 0.10925528285354387 0.10925528285354387 0.10925528285354387 -31.089 38.2851 17.9071 0.0 0.0 0.0 -31.089 38.2851 18.9071 0.22603196037000184 0.22603196037000184 0.22603196037000184 -32.089 37.2851 17.9071 0.0 0.0 0.0 -32.089 38.2851 17.9071 0.0 0.0 0.0 -29.089 39.2851 16.9071 0.0 0.0 0.0 -30.089 39.2851 15.9071 0.010441425269643131 0.010441425269643131 0.010441425269643131 -30.089 39.2851 16.9071 0.0 0.0 0.0 -29.089 39.2851 17.9071 0.5740238050712405 0.5740238050712405 0.5740238050712405 -29.089 39.2851 18.9071 0.4615533293609183 0.4615533293609183 0.4615533293609183 -30.089 39.2851 17.9071 0.6109283882022226 0.6109283882022226 0.6109283882022226 -30.089 39.2851 18.9071 0.12470152850561177 0.12470152850561177 0.12470152850561177 -31.089 39.2851 15.9071 0.008174364843575484 0.008174364843575484 0.008174364843575484 -31.089 39.2851 16.9071 0.4259983764478324 0.4259983764478324 0.4259983764478324 -31.089 39.2851 17.9071 0.0 0.0 0.0 -31.089 39.2851 18.9071 0.0 0.0 0.0 -25.089 35.2851 20.9071 0.0 0.0 0.0 -25.089 36.2851 19.9071 0.10734466032909448 0.10734466032909448 0.10734466032909448 -25.089 36.2851 20.9071 0.0 0.0 0.0 -26.089 36.2851 19.9071 0.0 0.0 0.0 -25.089 35.2851 21.9071 0.0 0.0 0.0 -25.089 35.2851 22.9071 0.0 0.0 0.0 -25.089 36.2851 21.9071 0.12254205308112368 0.12254205308112368 0.12254205308112368 -25.089 36.2851 22.9071 0.0 0.0 0.0 -26.089 35.2851 21.9071 0.0 0.0 0.0 -26.089 35.2851 22.9071 0.0 0.0 0.0 -26.089 36.2851 22.9071 0.10033734531697491 0.10033734531697491 0.10033734531697491 -25.089 37.2851 19.9071 0.11965135837167212 0.11965135837167212 0.11965135837167212 -25.089 37.2851 20.9071 0.0 0.0 0.0 -25.089 38.2851 19.9071 0.0 0.0 0.0 -26.089 37.2851 19.9071 0.09581788372823095 0.09581788372823095 0.09581788372823095 -26.089 37.2851 20.9071 0.0 0.0 0.0 -26.089 38.2851 20.9071 0.0 0.0 0.0 -25.089 37.2851 21.9071 0.0021638245637542633 0.0021638245637542633 0.0021638245637542633 -25.089 37.2851 22.9071 0.0 0.0 0.0 -25.089 38.2851 21.9071 0.0 0.0 0.0 -25.089 38.2851 22.9071 0.0 0.0 0.0 -26.089 37.2851 21.9071 0.10167863883583818 0.10167863883583818 0.10167863883583818 -26.089 38.2851 21.9071 0.024570441272200098 0.024570441272200098 0.024570441272200098 -27.089 35.2851 19.9071 0.0 0.0 0.0 -27.089 35.2851 20.9071 0.0 0.0 0.0 -27.089 36.2851 19.9071 0.0 0.0 0.0 -27.089 36.2851 20.9071 0.0 0.0 0.0 -28.089 35.2851 19.9071 0.0 0.0 0.0 -28.089 35.2851 20.9071 0.0 0.0 0.0 -28.089 36.2851 19.9071 0.0500508896824515 0.0500508896824515 0.0500508896824515 -28.089 36.2851 20.9071 0.0 0.0 0.0 -27.089 35.2851 21.9071 0.01997873668477143 0.01997873668477143 0.01997873668477143 -27.089 35.2851 22.9071 0.0 0.0 0.0 -27.089 36.2851 21.9071 0.0 0.0 0.0 -27.089 36.2851 22.9071 0.06678215695945376 0.06678215695945376 0.06678215695945376 -28.089 35.2851 21.9071 0.0064040211207481166 0.0064040211207481166 0.0064040211207481166 -28.089 36.2851 21.9071 0.0 0.0 0.0 -28.089 36.2851 22.9071 0.039759784823172696 0.039759784823172696 0.039759784823172696 -27.089 37.2851 19.9071 0.0 0.0 0.0 -27.089 37.2851 20.9071 0.0 0.0 0.0 -28.089 37.2851 19.9071 0.14512135737117968 0.14512135737117968 0.14512135737117968 -28.089 38.2851 19.9071 0.0 0.0 0.0 -27.089 37.2851 21.9071 0.0 0.0 0.0 -27.089 37.2851 22.9071 0.0 0.0 0.0 -27.089 38.2851 21.9071 0.0 0.0 0.0 -27.089 38.2851 22.9071 0.006270909803668551 0.006270909803668551 0.006270909803668551 -28.089 37.2851 22.9071 0.04245752210456868 0.04245752210456868 0.04245752210456868 -28.089 38.2851 21.9071 0.0 0.0 0.0 -28.089 38.2851 22.9071 0.0 0.0 0.0 -25.089 36.2851 23.9071 0.0 0.0 0.0 -26.089 35.2851 23.9071 0.0 0.0 0.0 -25.089 35.2851 25.9071 0.041223829968556426 0.041223829968556426 0.041223829968556426 -25.089 35.2851 26.9071 0.040872153993891644 0.040872153993891644 0.040872153993891644 -25.089 36.2851 25.9071 0.0 0.0 0.0 -25.089 36.2851 26.9071 0.0 0.0 0.0 -26.089 35.2851 25.9071 0.0075159953716528675 0.0075159953716528675 0.0075159953716528675 -26.089 35.2851 26.9071 0.0 0.0 0.0 -26.089 36.2851 25.9071 0.0 0.0 0.0 -26.089 36.2851 26.9071 0.0 0.0 0.0 -25.089 37.2851 23.9071 0.0 0.0 0.0 -25.089 37.2851 24.9071 0.0 0.0 0.0 -25.089 38.2851 23.9071 0.0 0.0 0.0 -25.089 38.2851 24.9071 0.0 0.0 0.0 -25.089 37.2851 25.9071 0.0 0.0 0.0 -25.089 37.2851 26.9071 0.0 0.0 0.0 -25.089 38.2851 25.9071 0.0 0.0 0.0 -25.089 38.2851 26.9071 0.0 0.0 0.0 -26.089 37.2851 25.9071 0.0 0.0 0.0 -26.089 37.2851 26.9071 0.0 0.0 0.0 -26.089 38.2851 25.9071 0.0 0.0 0.0 -26.089 38.2851 26.9071 0.0 0.0 0.0 -27.089 35.2851 23.9071 0.019447047473090746 0.019447047473090746 0.019447047473090746 -27.089 36.2851 23.9071 0.004011855919059415 0.004011855919059415 0.004011855919059415 -28.089 35.2851 23.9071 0.0 0.0 0.0 -28.089 35.2851 24.9071 0.0 0.0 0.0 -28.089 36.2851 23.9071 0.0 0.0 0.0 -28.089 36.2851 24.9071 0.0243023313113997 0.0243023313113997 0.0243023313113997 -27.089 35.2851 26.9071 0.0 0.0 0.0 -27.089 36.2851 26.9071 0.0 0.0 0.0 -28.089 35.2851 25.9071 0.0 0.0 0.0 -28.089 35.2851 26.9071 0.0 0.0 0.0 -28.089 36.2851 25.9071 0.0 0.0 0.0 -28.089 36.2851 26.9071 0.0 0.0 0.0 -27.089 37.2851 23.9071 0.0 0.0 0.0 -28.089 37.2851 23.9071 0.0452596798175593 0.0452596798175593 0.0452596798175593 -27.089 37.2851 25.9071 0.0 0.0 0.0 -27.089 37.2851 26.9071 0.0 0.0 0.0 -27.089 38.2851 26.9071 0.05261653396565216 0.05261653396565216 0.05261653396565216 -28.089 37.2851 25.9071 0.11424737428343136 0.11424737428343136 0.11424737428343136 -28.089 37.2851 26.9071 0.0 0.0 0.0 -28.089 38.2851 26.9071 0.0 0.0 0.0 -25.089 39.2851 21.9071 0.0 0.0 0.0 -25.089 39.2851 22.9071 0.0 0.0 0.0 -26.089 39.2851 21.9071 0.00575134176717704 0.00575134176717704 0.00575134176717704 -26.089 39.2851 22.9071 0.0 0.0 0.0 -27.089 39.2851 21.9071 0.0 0.0 0.0 -27.089 39.2851 22.9071 0.0 0.0 0.0 -28.089 39.2851 22.9071 0.0 0.0 0.0 -25.089 39.2851 23.9071 0.14494879196608218 0.14494879196608218 0.14494879196608218 -25.089 39.2851 24.9071 0.1697094836099038 0.1697094836099038 0.1697094836099038 -26.089 39.2851 23.9071 0.0 0.0 0.0 -26.089 39.2851 24.9071 0.0 0.0 0.0 -26.089 40.2851 24.9071 0.07996493015062384 0.07996493015062384 0.07996493015062384 -25.089 39.2851 25.9071 0.0 0.0 0.0 -25.089 40.2851 25.9071 0.0837589176701724 0.0837589176701724 0.0837589176701724 -25.089 40.2851 26.9071 0.0 0.0 0.0 -26.089 39.2851 25.9071 0.0 0.0 0.0 -26.089 39.2851 26.9071 0.0 0.0 0.0 -26.089 40.2851 25.9071 0.0632665759777845 0.0632665759777845 0.0632665759777845 -26.089 40.2851 26.9071 0.0 0.0 0.0 -26.089 41.2851 26.9071 0.04202150593702793 0.04202150593702793 0.04202150593702793 -26.089 42.2851 26.9071 0.10240316142606701 0.10240316142606701 0.10240316142606701 -27.089 39.2851 23.9071 0.0 0.0 0.0 -27.089 39.2851 24.9071 0.011009777403318322 0.011009777403318322 0.011009777403318322 -27.089 40.2851 23.9071 0.0 0.0 0.0 -27.089 40.2851 24.9071 0.0 0.0 0.0 -28.089 39.2851 23.9071 0.0 0.0 0.0 -28.089 39.2851 24.9071 0.0443485789195307 0.0443485789195307 0.0443485789195307 -28.089 40.2851 23.9071 0.0 0.0 0.0 -28.089 40.2851 24.9071 0.0 0.0 0.0 -27.089 40.2851 25.9071 0.012197637892597838 0.012197637892597838 0.012197637892597838 -27.089 40.2851 26.9071 0.0 0.0 0.0 -28.089 41.2851 24.9071 0.0 0.0 0.0 -27.089 41.2851 25.9071 0.024029106503303983 0.024029106503303983 0.024029106503303983 -27.089 41.2851 26.9071 0.0 0.0 0.0 -27.089 42.2851 25.9071 0.022927015367483736 0.022927015367483736 0.022927015367483736 -27.089 42.2851 26.9071 0.011889976237776361 0.011889976237776361 0.011889976237776361 -28.089 41.2851 25.9071 0.0 0.0 0.0 -28.089 42.2851 25.9071 0.0008456380278431493 0.0008456380278431493 0.0008456380278431493 -28.089 42.2851 26.9071 0.0028182809063111 0.0028182809063111 0.0028182809063111 -29.089 35.2851 19.9071 0.0 0.0 0.0 -29.089 36.2851 19.9071 0.0 0.0 0.0 -29.089 36.2851 20.9071 0.0 0.0 0.0 -30.089 35.2851 19.9071 0.0 0.0 0.0 -30.089 35.2851 20.9071 0.0 0.0 0.0 -30.089 36.2851 19.9071 0.0 0.0 0.0 -30.089 36.2851 20.9071 0.10820106034794745 0.10820106034794745 0.10820106034794745 -29.089 35.2851 22.9071 0.0 0.0 0.0 -30.089 35.2851 21.9071 0.0 0.0 0.0 -30.089 35.2851 22.9071 0.0 0.0 0.0 -30.089 36.2851 21.9071 0.0 0.0 0.0 -30.089 36.2851 22.9071 0.035043915791204194 0.035043915791204194 0.035043915791204194 -29.089 37.2851 19.9071 0.0 0.0 0.0 -29.089 37.2851 20.9071 0.0 0.0 0.0 -29.089 38.2851 19.9071 0.02032455042747209 0.02032455042747209 0.02032455042747209 -30.089 37.2851 19.9071 0.18164804430681367 0.18164804430681367 0.18164804430681367 -30.089 37.2851 20.9071 0.14955716547013878 0.14955716547013878 0.14955716547013878 -30.089 38.2851 19.9071 0.04271081660559815 0.04271081660559815 0.04271081660559815 -30.089 38.2851 20.9071 0.2960835372255202 0.2960835372255202 0.2960835372255202 -29.089 37.2851 22.9071 0.017187532736998905 0.017187532736998905 0.017187532736998905 -29.089 38.2851 22.9071 0.01189651301788934 0.01189651301788934 0.01189651301788934 -30.089 37.2851 21.9071 0.0 0.0 0.0 -30.089 37.2851 22.9071 0.0 0.0 0.0 -30.089 38.2851 21.9071 0.08178781920031543 0.08178781920031543 0.08178781920031543 -30.089 38.2851 22.9071 0.0 0.0 0.0 -31.089 35.2851 19.9071 0.05291651593194747 0.05291651593194747 0.05291651593194747 -31.089 35.2851 20.9071 0.0 0.0 0.0 -31.089 36.2851 19.9071 0.0 0.0 0.0 -31.089 36.2851 20.9071 0.05677938699791026 0.05677938699791026 0.05677938699791026 -32.089 35.2851 19.9071 0.0 0.0 0.0 -32.089 35.2851 20.9071 0.0 0.0 0.0 -32.089 36.2851 19.9071 0.0 0.0 0.0 -32.089 36.2851 20.9071 0.0 0.0 0.0 -31.089 35.2851 21.9071 0.0 0.0 0.0 -31.089 35.2851 22.9071 0.0 0.0 0.0 -31.089 36.2851 21.9071 0.0792478911129954 0.0792478911129954 0.0792478911129954 -31.089 36.2851 22.9071 0.0 0.0 0.0 -32.089 35.2851 22.9071 0.0 0.0 0.0 -32.089 36.2851 21.9071 0.0 0.0 0.0 -32.089 36.2851 22.9071 0.15479754108773372 0.15479754108773372 0.15479754108773372 -31.089 37.2851 19.9071 0.0 0.0 0.0 -31.089 37.2851 20.9071 0.0 0.0 0.0 -31.089 38.2851 20.9071 0.25857091067608656 0.25857091067608656 0.25857091067608656 -32.089 37.2851 20.9071 0.0 0.0 0.0 -32.089 38.2851 20.9071 0.0 0.0 0.0 -31.089 37.2851 21.9071 0.15596362349993415 0.15596362349993415 0.15596362349993415 -31.089 38.2851 21.9071 0.23795197582514435 0.23795197582514435 0.23795197582514435 -32.089 37.2851 21.9071 0.0 0.0 0.0 -32.089 37.2851 22.9071 0.16148560060884537 0.16148560060884537 0.16148560060884537 -32.089 38.2851 21.9071 0.0 0.0 0.0 -32.089 38.2851 22.9071 0.14754634294321992 0.14754634294321992 0.14754634294321992 -29.089 35.2851 23.9071 0.019174354987739155 0.019174354987739155 0.019174354987739155 -29.089 35.2851 24.9071 0.0 0.0 0.0 -29.089 36.2851 23.9071 0.0 0.0 0.0 -29.089 36.2851 24.9071 0.00768987515098644 0.00768987515098644 0.00768987515098644 -30.089 35.2851 23.9071 0.0 0.0 0.0 -30.089 35.2851 24.9071 0.05378218425491468 0.05378218425491468 0.05378218425491468 -30.089 36.2851 23.9071 0.0 0.0 0.0 -30.089 36.2851 24.9071 0.0 0.0 0.0 -29.089 35.2851 25.9071 0.0 0.0 0.0 -29.089 35.2851 26.9071 0.0 0.0 0.0 -29.089 36.2851 25.9071 0.0 0.0 0.0 -29.089 36.2851 26.9071 0.0 0.0 0.0 -30.089 35.2851 25.9071 0.028650129463653005 0.028650129463653005 0.028650129463653005 -30.089 36.2851 25.9071 0.01278545283203001 0.01278545283203001 0.01278545283203001 -30.089 36.2851 26.9071 0.018950427999320646 0.018950427999320646 0.018950427999320646 -29.089 37.2851 23.9071 0.0 0.0 0.0 -29.089 37.2851 24.9071 0.0 0.0 0.0 -30.089 37.2851 23.9071 0.0 0.0 0.0 -30.089 37.2851 24.9071 0.0 0.0 0.0 -30.089 38.2851 23.9071 0.0 0.0 0.0 -30.089 38.2851 24.9071 0.0 0.0 0.0 -29.089 37.2851 25.9071 0.21725707125711338 0.21725707125711338 0.21725707125711338 -29.089 37.2851 26.9071 0.03979469744316749 0.03979469744316749 0.03979469744316749 -29.089 38.2851 25.9071 0.0 0.0 0.0 -29.089 38.2851 26.9071 0.03250168065619568 0.03250168065619568 0.03250168065619568 -30.089 37.2851 25.9071 0.0 0.0 0.0 -30.089 37.2851 26.9071 0.0 0.0 0.0 -30.089 38.2851 25.9071 0.546701959159199 0.546701959159199 0.546701959159199 -31.089 35.2851 23.9071 0.0 0.0 0.0 -31.089 35.2851 24.9071 0.15415087585205045 0.15415087585205045 0.15415087585205045 -31.089 36.2851 23.9071 0.0 0.0 0.0 -31.089 36.2851 24.9071 0.0 0.0 0.0 -32.089 35.2851 23.9071 0.0 0.0 0.0 -32.089 36.2851 23.9071 0.0 0.0 0.0 -32.089 36.2851 24.9071 0.0 0.0 0.0 -31.089 36.2851 25.9071 0.0 0.0 0.0 -31.089 36.2851 26.9071 0.0 0.0 0.0 -32.089 35.2851 26.9071 0.13570164204786606 0.13570164204786606 0.13570164204786606 -32.089 36.2851 25.9071 0.0 0.0 0.0 -32.089 36.2851 26.9071 0.033085739980034445 0.033085739980034445 0.033085739980034445 -31.089 37.2851 23.9071 0.13824471954272108 0.13824471954272108 0.13824471954272108 -31.089 38.2851 23.9071 0.0 0.0 0.0 -31.089 38.2851 24.9071 0.0 0.0 0.0 -32.089 37.2851 23.9071 0.06873190629702247 0.06873190629702247 0.06873190629702247 -32.089 37.2851 24.9071 0.04829366358880809 0.04829366358880809 0.04829366358880809 -32.089 38.2851 23.9071 0.020416238636478175 0.020416238636478175 0.020416238636478175 -32.089 38.2851 24.9071 0.0 0.0 0.0 -31.089 37.2851 25.9071 0.0 0.0 0.0 -31.089 37.2851 26.9071 0.030814831274308646 0.030814831274308646 0.030814831274308646 -31.089 38.2851 25.9071 0.0 0.0 0.0 -31.089 38.2851 26.9071 0.06054635837475887 0.06054635837475887 0.06054635837475887 -32.089 37.2851 25.9071 0.0 0.0 0.0 -32.089 37.2851 26.9071 0.0 0.0 0.0 -32.089 38.2851 25.9071 0.0 0.0 0.0 -29.089 39.2851 22.9071 0.0 0.0 0.0 -30.089 39.2851 21.9071 0.0011068499551912536 0.0011068499551912536 0.0011068499551912536 -30.089 39.2851 22.9071 0.0 0.0 0.0 -31.089 39.2851 21.9071 0.12469727530634665 0.12469727530634665 0.12469727530634665 -31.089 39.2851 22.9071 0.0 0.0 0.0 -32.089 39.2851 21.9071 0.0 0.0 0.0 -32.089 39.2851 22.9071 0.0 0.0 0.0 -29.089 39.2851 23.9071 0.0 0.0 0.0 -29.089 39.2851 24.9071 0.0 0.0 0.0 -29.089 40.2851 24.9071 0.0 0.0 0.0 -30.089 39.2851 23.9071 0.022734453807145494 0.022734453807145494 0.022734453807145494 -30.089 39.2851 24.9071 0.0 0.0 0.0 -30.089 40.2851 24.9071 0.0 0.0 0.0 -29.089 40.2851 25.9071 0.017311942133031645 0.017311942133031645 0.017311942133031645 -30.089 39.2851 25.9071 0.0 0.0 0.0 -30.089 40.2851 25.9071 0.0 0.0 0.0 -30.089 40.2851 26.9071 0.16897752485004394 0.16897752485004394 0.16897752485004394 -29.089 41.2851 24.9071 0.0 0.0 0.0 -30.089 41.2851 24.9071 0.11594937143657554 0.11594937143657554 0.11594937143657554 -29.089 41.2851 25.9071 0.0 0.0 0.0 -29.089 41.2851 26.9071 0.0 0.0 0.0 -29.089 42.2851 25.9071 0.0 0.0 0.0 -29.089 42.2851 26.9071 0.0 0.0 0.0 -30.089 41.2851 25.9071 0.0 0.0 0.0 -30.089 41.2851 26.9071 0.267513014175009 0.267513014175009 0.267513014175009 -30.089 42.2851 25.9071 0.0 0.0 0.0 -30.089 42.2851 26.9071 0.07628323135572447 0.07628323135572447 0.07628323135572447 -31.089 39.2851 23.9071 0.0 0.0 0.0 -31.089 39.2851 24.9071 0.0 0.0 0.0 -31.089 40.2851 23.9071 0.082872828880411 0.082872828880411 0.082872828880411 -31.089 40.2851 24.9071 0.045985517467098516 0.045985517467098516 0.045985517467098516 -32.089 39.2851 23.9071 0.13100242171334625 0.13100242171334625 0.13100242171334625 -32.089 39.2851 24.9071 0.0 0.0 0.0 -32.089 40.2851 24.9071 0.162795249705482 0.162795249705482 0.162795249705482 -31.089 40.2851 25.9071 0.0 0.0 0.0 -31.089 40.2851 26.9071 0.06779709522785765 0.06779709522785765 0.06779709522785765 -32.089 40.2851 25.9071 0.0 0.0 0.0 -32.089 40.2851 26.9071 0.15133273462997543 0.15133273462997543 0.15133273462997543 -31.089 41.2851 24.9071 0.25558599003519833 0.25558599003519833 0.25558599003519833 -31.089 41.2851 25.9071 0.0 0.0 0.0 -31.089 41.2851 26.9071 0.0 0.0 0.0 -31.089 42.2851 26.9071 0.27650545352791456 0.27650545352791456 0.27650545352791456 -32.089 41.2851 26.9071 0.0 0.0 0.0 -32.089 42.2851 26.9071 0.3419713958817255 0.3419713958817255 0.3419713958817255 -33.089 30.2851 12.9071 0.0 0.0 0.0 -33.089 30.2851 13.9071 0.0 0.0 0.0 -33.089 30.2851 14.9071 0.0 0.0 0.0 -33.089 27.2851 16.9071 0.0 0.0 0.0 -33.089 28.2851 16.9071 0.0 0.0 0.0 -34.089 27.2851 15.9071 0.0 0.0 0.0 -34.089 27.2851 16.9071 0.0 0.0 0.0 -34.089 28.2851 15.9071 0.0 0.0 0.0 -34.089 28.2851 16.9071 0.0 0.0 0.0 -33.089 27.2851 17.9071 0.0 0.0 0.0 -33.089 27.2851 18.9071 0.0 0.0 0.0 -33.089 28.2851 17.9071 0.0 0.0 0.0 -33.089 28.2851 18.9071 0.0 0.0 0.0 -34.089 27.2851 17.9071 0.0 0.0 0.0 -34.089 27.2851 18.9071 0.0 0.0 0.0 -34.089 28.2851 18.9071 0.0 0.0 0.0 -33.089 29.2851 16.9071 0.0 0.0 0.0 -34.089 29.2851 15.9071 0.0 0.0 0.0 -34.089 29.2851 16.9071 0.0 0.0 0.0 -34.089 30.2851 16.9071 0.0 0.0 0.0 -33.089 29.2851 17.9071 0.0 0.0 0.0 -33.089 29.2851 18.9071 0.0 0.0 0.0 -33.089 30.2851 17.9071 0.0 0.0 0.0 -33.089 30.2851 18.9071 0.0015925591928326022 0.0015925591928326022 0.0015925591928326022 -34.089 29.2851 17.9071 0.0 0.0 0.0 -34.089 29.2851 18.9071 0.0 0.0 0.0 -34.089 30.2851 17.9071 0.0 0.0 0.0 -34.089 30.2851 18.9071 0.0 0.0 0.0 -35.089 27.2851 15.9071 0.0 0.0 0.0 -35.089 27.2851 16.9071 0.0 0.0 0.0 -35.089 28.2851 15.9071 0.001918723473522036 0.001918723473522036 0.001918723473522036 -36.089 27.2851 15.9071 0.0 0.0 0.0 -36.089 27.2851 16.9071 0.0 0.0 0.0 -36.089 28.2851 15.9071 0.0 0.0 0.0 -36.089 28.2851 16.9071 0.0 0.0 0.0 -35.089 27.2851 17.9071 0.0 0.0 0.0 -36.089 28.2851 17.9071 0.0 0.0 0.0 -35.089 29.2851 15.9071 0.0 0.0 0.0 -35.089 29.2851 16.9071 0.0 0.0 0.0 -35.089 30.2851 16.9071 0.0 0.0 0.0 -36.089 29.2851 15.9071 0.0 0.0 0.0 -36.089 29.2851 16.9071 0.0 0.0 0.0 -36.089 30.2851 16.9071 0.00947842213999543 0.00947842213999543 0.00947842213999543 -35.089 29.2851 17.9071 0.0 0.0 0.0 -35.089 29.2851 18.9071 0.0 0.0 0.0 -35.089 30.2851 17.9071 0.0 0.0 0.0 -35.089 30.2851 18.9071 0.0 0.0 0.0 -36.089 29.2851 17.9071 0.1442400883739472 0.1442400883739472 0.1442400883739472 -36.089 29.2851 18.9071 0.0 0.0 0.0 -36.089 30.2851 17.9071 0.039970124329276616 0.039970124329276616 0.039970124329276616 -36.089 30.2851 18.9071 0.0 0.0 0.0 -33.089 31.2851 12.9071 0.0 0.0 0.0 -33.089 32.2851 11.9071 0.03871345860840895 0.03871345860840895 0.03871345860840895 -33.089 32.2851 12.9071 0.0 0.0 0.0 -33.089 31.2851 13.9071 0.06839006563900969 0.06839006563900969 0.06839006563900969 -33.089 31.2851 14.9071 0.0 0.0 0.0 -33.089 32.2851 13.9071 0.0 0.0 0.0 -33.089 32.2851 14.9071 0.0 0.0 0.0 -33.089 33.2851 11.9071 0.1692391980039352 0.1692391980039352 0.1692391980039352 -33.089 33.2851 12.9071 0.0 0.0 0.0 -33.089 33.2851 13.9071 0.0 0.0 0.0 -33.089 33.2851 14.9071 0.0 0.0 0.0 -33.089 31.2851 16.9071 0.0 0.0 0.0 -33.089 32.2851 16.9071 0.0 0.0 0.0 -34.089 32.2851 16.9071 0.0 0.0 0.0 -33.089 31.2851 17.9071 0.0 0.0 0.0 -33.089 31.2851 18.9071 0.0 0.0 0.0 -33.089 32.2851 17.9071 0.0 0.0 0.0 -33.089 32.2851 18.9071 0.0 0.0 0.0 -34.089 31.2851 18.9071 0.0 0.0 0.0 -34.089 32.2851 17.9071 0.0 0.0 0.0 -34.089 32.2851 18.9071 0.0 0.0 0.0 -33.089 33.2851 15.9071 0.06565466917009506 0.06565466917009506 0.06565466917009506 -33.089 33.2851 16.9071 0.0 0.0 0.0 -33.089 34.2851 15.9071 0.0 0.0 0.0 -33.089 34.2851 16.9071 0.0 0.0 0.0 -34.089 33.2851 16.9071 0.0 0.0 0.0 -34.089 34.2851 16.9071 0.0 0.0 0.0 -34.089 33.2851 17.9071 0.0 0.0 0.0 -35.089 32.2851 16.9071 0.0 0.0 0.0 -36.089 31.2851 16.9071 0.0 0.0 0.0 -36.089 32.2851 16.9071 0.0 0.0 0.0 -35.089 31.2851 17.9071 0.0 0.0 0.0 -35.089 31.2851 18.9071 0.0 0.0 0.0 -35.089 32.2851 17.9071 0.0 0.0 0.0 -35.089 32.2851 18.9071 0.0 0.0 0.0 -36.089 31.2851 17.9071 0.0 0.0 0.0 -36.089 31.2851 18.9071 0.0 0.0 0.0 -36.089 32.2851 17.9071 0.0 0.0 0.0 -35.089 33.2851 16.9071 0.0 0.0 0.0 -35.089 34.2851 16.9071 0.0 0.0 0.0 -36.089 33.2851 16.9071 0.0 0.0 0.0 -35.089 33.2851 17.9071 0.0 0.0 0.0 -35.089 34.2851 17.9071 0.0 0.0 0.0 -35.089 34.2851 18.9071 0.0 0.0 0.0 -36.089 33.2851 17.9071 0.0 0.0 0.0 -36.089 34.2851 17.9071 0.0 0.0 0.0 -36.089 34.2851 18.9071 0.0 0.0 0.0 -37.089 27.2851 16.9071 0.0 0.0 0.0 -37.089 28.2851 16.9071 0.0 0.0 0.0 -38.089 27.2851 16.9071 0.0 0.0 0.0 -38.089 28.2851 16.9071 0.01780916414227614 0.01780916414227614 0.01780916414227614 -37.089 28.2851 17.9071 0.0 0.0 0.0 -37.089 28.2851 18.9071 0.0 0.0 0.0 -38.089 27.2851 17.9071 0.0 0.0 0.0 -38.089 27.2851 18.9071 0.07159132331450137 0.07159132331450137 0.07159132331450137 -38.089 28.2851 17.9071 0.0 0.0 0.0 -38.089 28.2851 18.9071 0.0 0.0 0.0 -37.089 29.2851 16.9071 0.0 0.0 0.0 -37.089 30.2851 16.9071 0.0043586739835527535 0.0043586739835527535 0.0043586739835527535 -38.089 29.2851 16.9071 0.0 0.0 0.0 -38.089 30.2851 16.9071 0.0 0.0 0.0 -37.089 29.2851 17.9071 0.0 0.0 0.0 -37.089 29.2851 18.9071 0.0 0.0 0.0 -37.089 30.2851 17.9071 0.0 0.0 0.0 -37.089 30.2851 18.9071 0.011655253847272047 0.011655253847272047 0.011655253847272047 -38.089 29.2851 17.9071 0.0 0.0 0.0 -38.089 29.2851 18.9071 0.0 0.0 0.0 -38.089 30.2851 17.9071 0.0 0.0 0.0 -38.089 30.2851 18.9071 0.0 0.0 0.0 -39.089 27.2851 17.9071 0.0 0.0 0.0 -39.089 27.2851 18.9071 0.04451920935795931 0.04451920935795931 0.04451920935795931 -39.089 30.2851 16.9071 0.0 0.0 0.0 -40.089 30.2851 16.9071 0.0 0.0 0.0 -39.089 29.2851 17.9071 0.0 0.0 0.0 -39.089 29.2851 18.9071 0.0 0.0 0.0 -39.089 30.2851 17.9071 0.0 0.0 0.0 -39.089 30.2851 18.9071 0.0 0.0 0.0 -40.089 30.2851 17.9071 0.0 0.0 0.0 -40.089 30.2851 18.9071 0.0 0.0 0.0 -37.089 31.2851 16.9071 0.0 0.0 0.0 -37.089 32.2851 16.9071 0.0 0.0 0.0 -38.089 31.2851 16.9071 0.0 0.0 0.0 -38.089 32.2851 16.9071 0.0 0.0 0.0 -37.089 32.2851 17.9071 0.0 0.0 0.0 -38.089 32.2851 17.9071 0.0 0.0 0.0 -38.089 32.2851 18.9071 0.0 0.0 0.0 -37.089 33.2851 16.9071 0.0 0.0 0.0 -37.089 33.2851 17.9071 0.0 0.0 0.0 -37.089 33.2851 18.9071 0.0 0.0 0.0 -37.089 34.2851 17.9071 0.0 0.0 0.0 -37.089 34.2851 18.9071 0.0 0.0 0.0 -38.089 33.2851 17.9071 0.0 0.0 0.0 -38.089 33.2851 18.9071 0.0 0.0 0.0 -39.089 31.2851 16.9071 0.0 0.0 0.0 -39.089 32.2851 16.9071 0.0 0.0 0.0 -40.089 31.2851 16.9071 0.0 0.0 0.0 -40.089 32.2851 16.9071 0.0 0.0 0.0 -39.089 31.2851 18.9071 0.0 0.0 0.0 -39.089 32.2851 17.9071 0.0 0.0 0.0 -39.089 32.2851 18.9071 0.0 0.0 0.0 -40.089 31.2851 17.9071 0.00952545535271957 0.00952545535271957 0.00952545535271957 -40.089 31.2851 18.9071 0.0 0.0 0.0 -40.089 32.2851 17.9071 0.0 0.0 0.0 -40.089 32.2851 18.9071 0.0 0.0 0.0 -33.089 27.2851 19.9071 0.0 0.0 0.0 -33.089 27.2851 20.9071 0.0 0.0 0.0 -33.089 28.2851 19.9071 0.013824406153028518 0.013824406153028518 0.013824406153028518 -33.089 28.2851 20.9071 0.0 0.0 0.0 -34.089 27.2851 19.9071 0.0 0.0 0.0 -34.089 27.2851 20.9071 0.0 0.0 0.0 -34.089 28.2851 19.9071 0.0 0.0 0.0 -34.089 28.2851 20.9071 0.0 0.0 0.0 -33.089 27.2851 21.9071 0.0 0.0 0.0 -33.089 27.2851 22.9071 0.0 0.0 0.0 -33.089 28.2851 21.9071 0.0 0.0 0.0 -34.089 27.2851 21.9071 0.0 0.0 0.0 -34.089 27.2851 22.9071 0.0 0.0 0.0 -34.089 28.2851 21.9071 0.0 0.0 0.0 -34.089 28.2851 22.9071 0.0 0.0 0.0 -33.089 29.2851 19.9071 0.0 0.0 0.0 -33.089 29.2851 20.9071 0.0 0.0 0.0 -33.089 30.2851 19.9071 0.0 0.0 0.0 -33.089 30.2851 20.9071 0.0 0.0 0.0 -34.089 29.2851 19.9071 0.0 0.0 0.0 -34.089 29.2851 20.9071 0.0 0.0 0.0 -34.089 30.2851 19.9071 0.0 0.0 0.0 -34.089 30.2851 20.9071 0.0 0.0 0.0 -33.089 29.2851 21.9071 0.0 0.0 0.0 -33.089 30.2851 21.9071 0.0 0.0 0.0 -33.089 30.2851 22.9071 0.0 0.0 0.0 -34.089 29.2851 21.9071 0.0 0.0 0.0 -35.089 28.2851 20.9071 0.03610934832042993 0.03610934832042993 0.03610934832042993 -36.089 28.2851 19.9071 0.0 0.0 0.0 -36.089 28.2851 20.9071 0.0 0.0 0.0 -35.089 27.2851 21.9071 0.0 0.0 0.0 -35.089 27.2851 22.9071 0.0 0.0 0.0 -35.089 28.2851 21.9071 0.0 0.0 0.0 -35.089 28.2851 22.9071 0.0 0.0 0.0 -36.089 27.2851 22.9071 0.0 0.0 0.0 -36.089 28.2851 21.9071 0.0 0.0 0.0 -36.089 28.2851 22.9071 0.0 0.0 0.0 -35.089 29.2851 19.9071 0.0 0.0 0.0 -35.089 29.2851 20.9071 0.0 0.0 0.0 -35.089 30.2851 19.9071 0.0 0.0 0.0 -35.089 30.2851 20.9071 0.0 0.0 0.0 -36.089 29.2851 19.9071 0.0 0.0 0.0 -36.089 29.2851 20.9071 0.0 0.0 0.0 -36.089 30.2851 20.9071 0.0 0.0 0.0 -35.089 29.2851 21.9071 0.0 0.0 0.0 -35.089 29.2851 22.9071 0.0 0.0 0.0 -35.089 30.2851 22.9071 0.010276444413156493 0.010276444413156493 0.010276444413156493 -36.089 29.2851 21.9071 0.0 0.0 0.0 -36.089 29.2851 22.9071 0.0 0.0 0.0 -36.089 30.2851 21.9071 0.0 0.0 0.0 -36.089 30.2851 22.9071 0.0 0.0 0.0 -33.089 27.2851 23.9071 0.0 0.0 0.0 -33.089 27.2851 24.9071 0.0 0.0 0.0 -33.089 28.2851 24.9071 0.0 0.0 0.0 -34.089 27.2851 23.9071 0.0 0.0 0.0 -34.089 27.2851 24.9071 0.0 0.0 0.0 -33.089 27.2851 25.9071 0.0 0.0 0.0 -33.089 27.2851 26.9071 0.0 0.0 0.0 -33.089 28.2851 25.9071 0.0 0.0 0.0 -33.089 28.2851 26.9071 0.0 0.0 0.0 -34.089 27.2851 25.9071 0.0 0.0 0.0 -34.089 27.2851 26.9071 0.001994420890910119 0.001994420890910119 0.001994420890910119 -33.089 29.2851 23.9071 0.0 0.0 0.0 -33.089 29.2851 24.9071 0.0 0.0 0.0 -33.089 30.2851 23.9071 0.0 0.0 0.0 -33.089 30.2851 24.9071 0.0 0.0 0.0 -34.089 29.2851 23.9071 0.0 0.0 0.0 -34.089 30.2851 23.9071 0.0 0.0 0.0 -34.089 30.2851 24.9071 0.0 0.0 0.0 -33.089 29.2851 25.9071 0.0984668081513847 0.0984668081513847 0.0984668081513847 -33.089 29.2851 26.9071 0.10538271077726498 0.10538271077726498 0.10538271077726498 -33.089 30.2851 25.9071 0.0 0.0 0.0 -33.089 30.2851 26.9071 0.0 0.0 0.0 -34.089 30.2851 25.9071 0.0 0.0 0.0 -34.089 30.2851 26.9071 0.0 0.0 0.0 -35.089 27.2851 23.9071 0.0 0.0 0.0 -35.089 27.2851 24.9071 0.0 0.0 0.0 -35.089 28.2851 23.9071 0.0 0.0 0.0 -35.089 28.2851 24.9071 0.0 0.0 0.0 -36.089 27.2851 23.9071 0.011492462845489989 0.011492462845489989 0.011492462845489989 -36.089 27.2851 24.9071 0.0 0.0 0.0 -36.089 28.2851 23.9071 0.0 0.0 0.0 -36.089 28.2851 24.9071 0.0 0.0 0.0 -35.089 27.2851 25.9071 0.0 0.0 0.0 -35.089 27.2851 26.9071 0.0 0.0 0.0 -35.089 28.2851 25.9071 0.0 0.0 0.0 -36.089 27.2851 25.9071 0.022981492548994086 0.022981492548994086 0.022981492548994086 -36.089 27.2851 26.9071 0.0 0.0 0.0 -36.089 28.2851 25.9071 0.0 0.0 0.0 -36.089 28.2851 26.9071 0.0 0.0 0.0 -35.089 29.2851 23.9071 0.0 0.0 0.0 -35.089 29.2851 24.9071 0.0 0.0 0.0 -35.089 30.2851 23.9071 0.0 0.0 0.0 -35.089 30.2851 24.9071 0.0 0.0 0.0 -36.089 29.2851 23.9071 0.0 0.0 0.0 -36.089 29.2851 24.9071 0.0 0.0 0.0 -36.089 30.2851 24.9071 0.0 0.0 0.0 -35.089 29.2851 25.9071 0.0 0.0 0.0 -35.089 30.2851 25.9071 0.02530170749822593 0.02530170749822593 0.02530170749822593 -35.089 30.2851 26.9071 0.0 0.0 0.0 -36.089 29.2851 25.9071 0.0 0.0 0.0 -36.089 29.2851 26.9071 0.0 0.0 0.0 -36.089 30.2851 25.9071 0.0 0.0 0.0 -36.089 30.2851 26.9071 0.0 0.0 0.0 -33.089 31.2851 19.9071 0.0 0.0 0.0 -33.089 31.2851 20.9071 0.0 0.0 0.0 -33.089 32.2851 19.9071 0.0 0.0 0.0 -33.089 32.2851 20.9071 0.0 0.0 0.0 -34.089 31.2851 19.9071 0.0 0.0 0.0 -34.089 31.2851 20.9071 0.0 0.0 0.0 -34.089 32.2851 19.9071 0.0 0.0 0.0 -34.089 32.2851 20.9071 0.0 0.0 0.0 -33.089 31.2851 21.9071 0.0 0.0 0.0 -33.089 31.2851 22.9071 0.01170424217012709 0.01170424217012709 0.01170424217012709 -33.089 32.2851 21.9071 0.0 0.0 0.0 -33.089 32.2851 22.9071 0.0047647305123100624 0.0047647305123100624 0.0047647305123100624 -34.089 31.2851 22.9071 0.0 0.0 0.0 -34.089 32.2851 21.9071 0.0 0.0 0.0 -34.089 32.2851 22.9071 0.0 0.0 0.0 -33.089 33.2851 19.9071 0.0 0.0 0.0 -33.089 33.2851 20.9071 0.0 0.0 0.0 -33.089 34.2851 19.9071 0.0 0.0 0.0 -33.089 34.2851 20.9071 0.0 0.0 0.0 -34.089 33.2851 19.9071 0.0 0.0 0.0 -34.089 33.2851 20.9071 0.24093472075417055 0.24093472075417055 0.24093472075417055 -34.089 34.2851 19.9071 0.33277479650965436 0.33277479650965436 0.33277479650965436 -34.089 34.2851 20.9071 0.2050198222027442 0.2050198222027442 0.2050198222027442 -33.089 33.2851 21.9071 0.0 0.0 0.0 -33.089 33.2851 22.9071 0.0 0.0 0.0 -33.089 34.2851 21.9071 0.0 0.0 0.0 -33.089 34.2851 22.9071 0.0 0.0 0.0 -34.089 33.2851 21.9071 0.12421684631627555 0.12421684631627555 0.12421684631627555 -34.089 33.2851 22.9071 0.0 0.0 0.0 -34.089 34.2851 21.9071 0.0 0.0 0.0 -34.089 34.2851 22.9071 0.0 0.0 0.0 -35.089 31.2851 19.9071 0.0 0.0 0.0 -35.089 32.2851 19.9071 0.0 0.0 0.0 -36.089 32.2851 20.9071 0.3616112553022003 0.3616112553022003 0.3616112553022003 -35.089 31.2851 22.9071 0.0 0.0 0.0 -35.089 32.2851 22.9071 0.0 0.0 0.0 -36.089 31.2851 22.9071 0.0 0.0 0.0 -36.089 32.2851 21.9071 0.5689157289670679 0.5689157289670679 0.5689157289670679 -36.089 32.2851 22.9071 0.0 0.0 0.0 -35.089 33.2851 19.9071 0.0 0.0 0.0 -35.089 34.2851 19.9071 0.0 0.0 0.0 -35.089 34.2851 20.9071 0.14564557203150164 0.14564557203150164 0.14564557203150164 -36.089 33.2851 19.9071 0.0 0.0 0.0 -36.089 33.2851 20.9071 0.0 0.0 0.0 -36.089 34.2851 19.9071 0.0 0.0 0.0 -36.089 34.2851 20.9071 0.0 0.0 0.0 -35.089 33.2851 22.9071 0.0 0.0 0.0 -35.089 34.2851 21.9071 0.23865008808364965 0.23865008808364965 0.23865008808364965 -35.089 34.2851 22.9071 0.0 0.0 0.0 -36.089 33.2851 21.9071 0.4988281796530624 0.4988281796530624 0.4988281796530624 -36.089 33.2851 22.9071 0.0 0.0 0.0 -36.089 34.2851 21.9071 0.41520175261653575 0.41520175261653575 0.41520175261653575 -33.089 31.2851 23.9071 0.0 0.0 0.0 -33.089 31.2851 24.9071 0.0 0.0 0.0 -33.089 32.2851 23.9071 0.0 0.0 0.0 -33.089 32.2851 24.9071 0.0 0.0 0.0 -34.089 31.2851 23.9071 0.0 0.0 0.0 -34.089 31.2851 24.9071 0.0 0.0 0.0 -34.089 32.2851 24.9071 0.03937278368545304 0.03937278368545304 0.03937278368545304 -33.089 31.2851 25.9071 0.0 0.0 0.0 -33.089 31.2851 26.9071 0.053856695624144045 0.053856695624144045 0.053856695624144045 -33.089 32.2851 25.9071 0.0 0.0 0.0 -33.089 32.2851 26.9071 0.0 0.0 0.0 -34.089 31.2851 25.9071 0.0 0.0 0.0 -34.089 31.2851 26.9071 0.0 0.0 0.0 -34.089 32.2851 25.9071 0.0 0.0 0.0 -34.089 32.2851 26.9071 0.0 0.0 0.0 -33.089 33.2851 23.9071 0.20918107088573448 0.20918107088573448 0.20918107088573448 -33.089 34.2851 23.9071 0.0 0.0 0.0 -33.089 34.2851 24.9071 0.0 0.0 0.0 -34.089 33.2851 23.9071 0.0 0.0 0.0 -34.089 33.2851 24.9071 0.0 0.0 0.0 -34.089 34.2851 23.9071 0.0 0.0 0.0 -34.089 34.2851 24.9071 0.0 0.0 0.0 -33.089 34.2851 26.9071 0.0 0.0 0.0 -34.089 33.2851 25.9071 0.0 0.0 0.0 -34.089 33.2851 26.9071 0.0 0.0 0.0 -34.089 34.2851 25.9071 0.0 0.0 0.0 -34.089 34.2851 26.9071 0.0 0.0 0.0 -35.089 31.2851 23.9071 0.0 0.0 0.0 -35.089 31.2851 24.9071 0.0 0.0 0.0 -35.089 32.2851 23.9071 0.0 0.0 0.0 -35.089 32.2851 24.9071 0.0 0.0 0.0 -36.089 31.2851 23.9071 0.0 0.0 0.0 -36.089 31.2851 24.9071 0.0 0.0 0.0 -36.089 32.2851 23.9071 0.0 0.0 0.0 -35.089 31.2851 25.9071 0.02842919935055174 0.02842919935055174 0.02842919935055174 -35.089 31.2851 26.9071 0.0 0.0 0.0 -35.089 32.2851 25.9071 0.005482430414001562 0.005482430414001562 0.005482430414001562 -35.089 32.2851 26.9071 0.0 0.0 0.0 -36.089 31.2851 25.9071 0.0 0.0 0.0 -36.089 31.2851 26.9071 0.0 0.0 0.0 -36.089 32.2851 25.9071 0.0 0.0 0.0 -36.089 32.2851 26.9071 0.0 0.0 0.0 -35.089 33.2851 23.9071 0.0 0.0 0.0 -35.089 33.2851 24.9071 0.0 0.0 0.0 -35.089 34.2851 23.9071 0.0 0.0 0.0 -35.089 34.2851 24.9071 0.0 0.0 0.0 -36.089 33.2851 23.9071 0.0 0.0 0.0 -36.089 34.2851 23.9071 0.0 0.0 0.0 -36.089 34.2851 24.9071 0.0 0.0 0.0 -35.089 33.2851 25.9071 0.0 0.0 0.0 -35.089 33.2851 26.9071 0.0 0.0 0.0 -35.089 34.2851 25.9071 0.0 0.0 0.0 -35.089 34.2851 26.9071 0.0 0.0 0.0 -36.089 34.2851 25.9071 0.0 0.0 0.0 -36.089 34.2851 26.9071 0.0 0.0 0.0 -37.089 28.2851 19.9071 0.0 0.0 0.0 -37.089 28.2851 20.9071 0.0 0.0 0.0 -38.089 27.2851 19.9071 0.007098111069408831 0.007098111069408831 0.007098111069408831 -38.089 27.2851 20.9071 0.1250244680091178 0.1250244680091178 0.1250244680091178 -38.089 28.2851 19.9071 0.0 0.0 0.0 -38.089 28.2851 20.9071 0.10054454484509694 0.10054454484509694 0.10054454484509694 -37.089 27.2851 21.9071 0.0 0.0 0.0 -37.089 27.2851 22.9071 0.0 0.0 0.0 -37.089 28.2851 21.9071 0.0 0.0 0.0 -38.089 27.2851 21.9071 0.0 0.0 0.0 -38.089 27.2851 22.9071 0.0 0.0 0.0 -38.089 28.2851 21.9071 0.003960330933293763 0.003960330933293763 0.003960330933293763 -38.089 28.2851 22.9071 0.0 0.0 0.0 -37.089 29.2851 19.9071 0.0 0.0 0.0 -37.089 29.2851 20.9071 0.0 0.0 0.0 -37.089 30.2851 19.9071 0.0034845022919123645 0.0034845022919123645 0.0034845022919123645 -37.089 30.2851 20.9071 0.0 0.0 0.0 -38.089 30.2851 19.9071 0.0 0.0 0.0 -38.089 30.2851 20.9071 0.0 0.0 0.0 -37.089 30.2851 21.9071 0.0 0.0 0.0 -37.089 30.2851 22.9071 0.0 0.0 0.0 -38.089 29.2851 22.9071 0.005974018617520276 0.005974018617520276 0.005974018617520276 -38.089 30.2851 22.9071 0.0 0.0 0.0 -39.089 27.2851 19.9071 0.0 0.0 0.0 -39.089 27.2851 20.9071 0.0 0.0 0.0 -39.089 27.2851 21.9071 0.0 0.0 0.0 -39.089 27.2851 22.9071 0.03795491413082206 0.03795491413082206 0.03795491413082206 -39.089 28.2851 22.9071 0.0 0.0 0.0 -40.089 27.2851 22.9071 0.0 0.0 0.0 -40.089 28.2851 22.9071 0.0 0.0 0.0 -39.089 30.2851 19.9071 0.0 0.0 0.0 -39.089 29.2851 22.9071 0.015766810768493456 0.015766810768493456 0.015766810768493456 -39.089 30.2851 22.9071 0.0 0.0 0.0 -40.089 29.2851 22.9071 0.0 0.0 0.0 -37.089 27.2851 23.9071 0.0 0.0 0.0 -37.089 27.2851 24.9071 0.0 0.0 0.0 -37.089 28.2851 23.9071 0.0 0.0 0.0 -37.089 28.2851 24.9071 0.0 0.0 0.0 -38.089 27.2851 23.9071 0.0 0.0 0.0 -38.089 27.2851 24.9071 0.0 0.0 0.0 -38.089 28.2851 23.9071 0.0 0.0 0.0 -37.089 27.2851 25.9071 0.0 0.0 0.0 -37.089 27.2851 26.9071 0.0 0.0 0.0 -37.089 28.2851 25.9071 0.0 0.0 0.0 -37.089 28.2851 26.9071 0.0 0.0 0.0 -38.089 27.2851 25.9071 0.019301404913554143 0.019301404913554143 0.019301404913554143 -38.089 27.2851 26.9071 0.006011445746707669 0.006011445746707669 0.006011445746707669 -38.089 28.2851 25.9071 0.0 0.0 0.0 -38.089 28.2851 26.9071 0.0 0.0 0.0 -37.089 29.2851 23.9071 0.0 0.0 0.0 -37.089 29.2851 24.9071 0.0 0.0 0.0 -37.089 30.2851 23.9071 0.0 0.0 0.0 -37.089 30.2851 24.9071 0.0 0.0 0.0 -38.089 29.2851 23.9071 0.0 0.0 0.0 -38.089 30.2851 23.9071 0.0 0.0 0.0 -37.089 29.2851 25.9071 0.0 0.0 0.0 -37.089 29.2851 26.9071 0.0 0.0 0.0 -37.089 30.2851 25.9071 0.0 0.0 0.0 -38.089 29.2851 25.9071 0.0 0.0 0.0 -38.089 29.2851 26.9071 0.0 0.0 0.0 -38.089 30.2851 25.9071 0.0 0.0 0.0 -38.089 30.2851 26.9071 0.010052337247979428 0.010052337247979428 0.010052337247979428 -39.089 27.2851 23.9071 0.0 0.0 0.0 -39.089 27.2851 24.9071 0.0 0.0 0.0 -39.089 28.2851 23.9071 0.0 0.0 0.0 -40.089 28.2851 23.9071 0.0 0.0 0.0 -39.089 28.2851 26.9071 0.06888153649836848 0.06888153649836848 0.06888153649836848 -40.089 28.2851 26.9071 0.0 0.0 0.0 -39.089 29.2851 23.9071 0.0 0.0 0.0 -39.089 30.2851 23.9071 0.0 0.0 0.0 -40.089 29.2851 23.9071 0.0 0.0 0.0 -40.089 29.2851 24.9071 0.0 0.0 0.0 -40.089 30.2851 23.9071 0.004962480242383342 0.004962480242383342 0.004962480242383342 -40.089 30.2851 24.9071 0.0 0.0 0.0 -39.089 29.2851 25.9071 0.0 0.0 0.0 -39.089 29.2851 26.9071 0.013384623198403485 0.013384623198403485 0.013384623198403485 -39.089 30.2851 26.9071 0.0 0.0 0.0 -40.089 29.2851 25.9071 0.0 0.0 0.0 -40.089 29.2851 26.9071 0.05520769155348798 0.05520769155348798 0.05520769155348798 -40.089 30.2851 25.9071 0.0 0.0 0.0 -40.089 30.2851 26.9071 0.009286646400507293 0.009286646400507293 0.009286646400507293 -37.089 31.2851 20.9071 0.0 0.0 0.0 -37.089 32.2851 20.9071 0.0 0.0 0.0 -38.089 31.2851 19.9071 0.0 0.0 0.0 -38.089 31.2851 20.9071 0.0 0.0 0.0 -38.089 32.2851 19.9071 0.0 0.0 0.0 -38.089 32.2851 20.9071 0.0 0.0 0.0 -37.089 31.2851 21.9071 0.0 0.0 0.0 -37.089 31.2851 22.9071 0.0 0.0 0.0 -37.089 32.2851 21.9071 0.0 0.0 0.0 -37.089 32.2851 22.9071 0.0 0.0 0.0 -38.089 31.2851 22.9071 0.0 0.0 0.0 -37.089 33.2851 19.9071 0.0 0.0 0.0 -37.089 33.2851 20.9071 0.0 0.0 0.0 -37.089 34.2851 19.9071 0.0 0.0 0.0 -38.089 33.2851 19.9071 0.0 0.0 0.0 -37.089 33.2851 22.9071 0.016386427415986476 0.016386427415986476 0.016386427415986476 -39.089 31.2851 19.9071 0.0 0.0 0.0 -39.089 32.2851 19.9071 0.0 0.0 0.0 -40.089 31.2851 19.9071 0.0 0.0 0.0 -39.089 31.2851 22.9071 0.0 0.0 0.0 -37.089 31.2851 23.9071 0.0 0.0 0.0 -37.089 31.2851 24.9071 0.0 0.0 0.0 -37.089 32.2851 23.9071 0.0 0.0 0.0 -38.089 31.2851 23.9071 0.0 0.0 0.0 -38.089 31.2851 24.9071 0.0 0.0 0.0 -38.089 32.2851 23.9071 0.0 0.0 0.0 -38.089 32.2851 24.9071 0.0023920617441870484 0.0023920617441870484 0.0023920617441870484 -37.089 31.2851 25.9071 0.0 0.0 0.0 -37.089 31.2851 26.9071 0.0 0.0 0.0 -37.089 32.2851 26.9071 0.0 0.0 0.0 -38.089 31.2851 25.9071 0.0 0.0 0.0 -38.089 31.2851 26.9071 0.015957874204924498 0.015957874204924498 0.015957874204924498 -38.089 32.2851 25.9071 0.0 0.0 0.0 -38.089 32.2851 26.9071 0.015617975888461836 0.015617975888461836 0.015617975888461836 -37.089 33.2851 23.9071 0.0 0.0 0.0 -37.089 34.2851 23.9071 0.0 0.0 0.0 -37.089 34.2851 24.9071 0.0 0.0 0.0 -38.089 33.2851 23.9071 0.0 0.0 0.0 -38.089 33.2851 24.9071 0.0 0.0 0.0 -38.089 34.2851 23.9071 0.0 0.0 0.0 -38.089 34.2851 24.9071 0.0 0.0 0.0 -38.089 33.2851 25.9071 0.0 0.0 0.0 -38.089 33.2851 26.9071 0.0 0.0 0.0 -39.089 31.2851 23.9071 0.0 0.0 0.0 -39.089 31.2851 24.9071 0.0 0.0 0.0 -39.089 32.2851 23.9071 0.0 0.0 0.0 -39.089 32.2851 24.9071 0.011769294416052314 0.011769294416052314 0.011769294416052314 -40.089 31.2851 23.9071 0.0 0.0 0.0 -40.089 31.2851 24.9071 0.0 0.0 0.0 -40.089 32.2851 24.9071 0.07368994802404066 0.07368994802404066 0.07368994802404066 -39.089 31.2851 25.9071 0.0 0.0 0.0 -39.089 31.2851 26.9071 0.0 0.0 0.0 -39.089 32.2851 25.9071 0.012867679977426268 0.012867679977426268 0.012867679977426268 -39.089 32.2851 26.9071 0.0 0.0 0.0 -40.089 31.2851 25.9071 0.0 0.0 0.0 -39.089 33.2851 24.9071 0.0 0.0 0.0 -39.089 34.2851 24.9071 0.0 0.0 0.0 -39.089 33.2851 25.9071 0.0 0.0 0.0 -39.089 33.2851 26.9071 0.0 0.0 0.0 -39.089 34.2851 25.9071 0.1754156279079305 0.1754156279079305 0.1754156279079305 -39.089 34.2851 26.9071 0.35775655014978397 0.35775655014978397 0.35775655014978397 -33.089 35.2851 15.9071 0.012973980728834995 0.012973980728834995 0.012973980728834995 -33.089 35.2851 16.9071 0.0 0.0 0.0 -33.089 36.2851 15.9071 0.0 0.0 0.0 -33.089 36.2851 16.9071 0.0 0.0 0.0 -34.089 35.2851 16.9071 0.0 0.0 0.0 -33.089 35.2851 17.9071 0.0 0.0 0.0 -33.089 35.2851 18.9071 0.019538576367490075 0.019538576367490075 0.019538576367490075 -33.089 36.2851 17.9071 0.07626020096956518 0.07626020096956518 0.07626020096956518 -33.089 36.2851 18.9071 0.011342031401737278 0.011342031401737278 0.011342031401737278 -34.089 35.2851 17.9071 0.0 0.0 0.0 -34.089 35.2851 18.9071 0.0 0.0 0.0 -34.089 36.2851 17.9071 0.04582461533143399 0.04582461533143399 0.04582461533143399 -34.089 36.2851 18.9071 0.0 0.0 0.0 -33.089 37.2851 15.9071 0.0 0.0 0.0 -33.089 37.2851 16.9071 0.0 0.0 0.0 -35.089 35.2851 17.9071 0.0 0.0 0.0 -35.089 35.2851 18.9071 0.0 0.0 0.0 -35.089 36.2851 18.9071 0.0 0.0 0.0 -33.089 35.2851 19.9071 0.003699528403545191 0.003699528403545191 0.003699528403545191 -33.089 35.2851 20.9071 0.0 0.0 0.0 -33.089 36.2851 19.9071 0.0015930508664083558 0.0015930508664083558 0.0015930508664083558 -33.089 36.2851 20.9071 0.0 0.0 0.0 -34.089 35.2851 19.9071 0.0 0.0 0.0 -34.089 35.2851 20.9071 0.0 0.0 0.0 -34.089 36.2851 19.9071 0.002942845041259312 0.002942845041259312 0.002942845041259312 -34.089 36.2851 20.9071 0.0 0.0 0.0 -33.089 35.2851 21.9071 0.0 0.0 0.0 -33.089 35.2851 22.9071 0.0 0.0 0.0 -33.089 36.2851 21.9071 0.0 0.0 0.0 -33.089 36.2851 22.9071 0.0 0.0 0.0 -33.089 37.2851 21.9071 0.0 0.0 0.0 -33.089 37.2851 22.9071 0.0 0.0 0.0 -33.089 38.2851 21.9071 0.0 0.0 0.0 -33.089 38.2851 22.9071 0.0 0.0 0.0 -35.089 35.2851 19.9071 0.0 0.0 0.0 -35.089 36.2851 19.9071 0.0 0.0 0.0 -33.089 35.2851 23.9071 0.0 0.0 0.0 -33.089 35.2851 24.9071 0.0 0.0 0.0 -33.089 36.2851 23.9071 0.0 0.0 0.0 -33.089 36.2851 24.9071 0.0 0.0 0.0 -34.089 35.2851 24.9071 0.06499632699710148 0.06499632699710148 0.06499632699710148 -34.089 36.2851 23.9071 0.0 0.0 0.0 -34.089 36.2851 24.9071 0.18238858715564693 0.18238858715564693 0.18238858715564693 -33.089 35.2851 25.9071 0.0 0.0 0.0 -33.089 35.2851 26.9071 0.10994179130545736 0.10994179130545736 0.10994179130545736 -33.089 36.2851 25.9071 0.0 0.0 0.0 -33.089 36.2851 26.9071 0.0 0.0 0.0 -34.089 35.2851 25.9071 0.0 0.0 0.0 -34.089 35.2851 26.9071 0.0 0.0 0.0 -34.089 36.2851 25.9071 0.1517934703226696 0.1517934703226696 0.1517934703226696 -34.089 36.2851 26.9071 0.0 0.0 0.0 -33.089 37.2851 24.9071 0.0 0.0 0.0 -33.089 38.2851 23.9071 0.0 0.0 0.0 -33.089 38.2851 24.9071 0.0 0.0 0.0 -34.089 37.2851 23.9071 0.0 0.0 0.0 -34.089 37.2851 24.9071 0.09929527039345729 0.09929527039345729 0.09929527039345729 -34.089 38.2851 23.9071 0.0 0.0 0.0 -34.089 38.2851 24.9071 0.0 0.0 0.0 -33.089 37.2851 25.9071 0.010154950608408982 0.010154950608408982 0.010154950608408982 -33.089 37.2851 26.9071 0.0 0.0 0.0 -34.089 37.2851 25.9071 0.0 0.0 0.0 -35.089 36.2851 23.9071 0.0 0.0 0.0 -35.089 36.2851 24.9071 0.0 0.0 0.0 -36.089 36.2851 23.9071 0.0 0.0 0.0 -36.089 36.2851 24.9071 0.010847313902485526 0.010847313902485526 0.010847313902485526 -35.089 35.2851 26.9071 0.0 0.0 0.0 -35.089 36.2851 25.9071 0.23095942252507828 0.23095942252507828 0.23095942252507828 -35.089 36.2851 26.9071 0.0 0.0 0.0 -36.089 35.2851 25.9071 0.15982430841445128 0.15982430841445128 0.15982430841445128 -36.089 35.2851 26.9071 0.0 0.0 0.0 -36.089 36.2851 25.9071 0.17403392248429805 0.17403392248429805 0.17403392248429805 -36.089 36.2851 26.9071 0.0 0.0 0.0 -35.089 37.2851 23.9071 0.0 0.0 0.0 -35.089 38.2851 23.9071 0.0 0.0 0.0 -36.089 37.2851 23.9071 0.0 0.0 0.0 -36.089 37.2851 24.9071 0.0 0.0 0.0 -36.089 38.2851 23.9071 0.0 0.0 0.0 -36.089 38.2851 24.9071 0.005270576072560939 0.005270576072560939 0.005270576072560939 -36.089 37.2851 25.9071 0.0 0.0 0.0 -36.089 37.2851 26.9071 0.0 0.0 0.0 -36.089 38.2851 25.9071 0.0 0.0 0.0 -36.089 38.2851 26.9071 0.0 0.0 0.0 -33.089 39.2851 23.9071 0.0 0.0 0.0 -33.089 39.2851 24.9071 0.018325030076854317 0.018325030076854317 0.018325030076854317 -33.089 40.2851 24.9071 0.0 0.0 0.0 -34.089 39.2851 23.9071 0.217236575102527 0.217236575102527 0.217236575102527 -34.089 39.2851 24.9071 0.0 0.0 0.0 -34.089 40.2851 24.9071 0.11214263739893114 0.11214263739893114 0.11214263739893114 -33.089 40.2851 25.9071 0.0 0.0 0.0 -33.089 40.2851 26.9071 0.0 0.0 0.0 -34.089 39.2851 25.9071 0.028650129463653005 0.028650129463653005 0.028650129463653005 -34.089 39.2851 26.9071 0.0 0.0 0.0 -34.089 40.2851 25.9071 0.0 0.0 0.0 -34.089 40.2851 26.9071 0.0 0.0 0.0 -33.089 41.2851 26.9071 0.0 0.0 0.0 -33.089 42.2851 26.9071 0.0 0.0 0.0 -34.089 41.2851 26.9071 0.0 0.0 0.0 -34.089 42.2851 26.9071 0.0 0.0 0.0 -35.089 39.2851 23.9071 0.0 0.0 0.0 -35.089 39.2851 24.9071 0.0 0.0 0.0 -36.089 39.2851 23.9071 0.0 0.0 0.0 -36.089 39.2851 24.9071 0.09083618722461385 0.09083618722461385 0.09083618722461385 -35.089 39.2851 25.9071 0.0 0.0 0.0 -35.089 39.2851 26.9071 0.0 0.0 0.0 -35.089 40.2851 25.9071 0.0 0.0 0.0 -35.089 40.2851 26.9071 0.0 0.0 0.0 -36.089 39.2851 25.9071 0.0031389633011904565 0.0031389633011904565 0.0031389633011904565 -36.089 39.2851 26.9071 0.0 0.0 0.0 -37.089 35.2851 24.9071 0.0 0.0 0.0 -37.089 36.2851 24.9071 0.0 0.0 0.0 -38.089 35.2851 24.9071 0.0 0.0 0.0 -37.089 35.2851 25.9071 0.0 0.0 0.0 -37.089 35.2851 26.9071 0.0 0.0 0.0 -37.089 36.2851 25.9071 0.0 0.0 0.0 -37.089 36.2851 26.9071 0.0 0.0 0.0 -38.089 35.2851 25.9071 0.0 0.0 0.0 -38.089 36.2851 25.9071 0.0 0.0 0.0 -38.089 36.2851 26.9071 0.11224582641959031 0.11224582641959031 0.11224582641959031 -37.089 37.2851 24.9071 0.0 0.0 0.0 -37.089 38.2851 24.9071 0.0 0.0 0.0 -37.089 37.2851 25.9071 0.0 0.0 0.0 -37.089 38.2851 25.9071 0.0 0.0 0.0 -39.089 35.2851 24.9071 0.0 0.0 0.0 -39.089 35.2851 25.9071 0.0 0.0 0.0 -39.089 35.2851 26.9071 0.19311218282081274 0.19311218282081274 0.19311218282081274 -39.089 36.2851 25.9071 0.0 0.0 0.0 -39.089 36.2851 26.9071 0.0 0.0 0.0 -28.089 43.2851 26.9071 0.01757654846512993 0.01757654846512993 0.01757654846512993 -28.089 44.2851 26.9071 0.0 0.0 0.0 -29.089 43.2851 25.9071 0.0 0.0 0.0 -29.089 43.2851 26.9071 0.01040087123707452 0.01040087123707452 0.01040087123707452 -29.089 44.2851 26.9071 0.0 0.0 0.0 -30.089 43.2851 25.9071 0.041599476700342725 0.041599476700342725 0.041599476700342725 -30.089 43.2851 26.9071 0.0 0.0 0.0 -30.089 44.2851 26.9071 0.0 0.0 0.0 -29.089 45.2851 26.9071 0.029981433586772237 0.029981433586772237 0.029981433586772237 -29.089 46.2851 26.9071 0.0669647615846407 0.0669647615846407 0.0669647615846407 -30.089 45.2851 26.9071 0.0 0.0 0.0 -30.089 46.2851 26.9071 0.5208450752333096 0.5208450752333096 0.5208450752333096 -31.089 43.2851 26.9071 0.2980698965506174 0.2980698965506174 0.2980698965506174 -31.089 44.2851 26.9071 0.0 0.0 0.0 -32.089 43.2851 26.9071 0.0 0.0 0.0 -32.089 44.2851 26.9071 0.0 0.0 0.0 -31.089 45.2851 26.9071 0.0 0.0 0.0 -31.089 46.2851 26.9071 0.4638470208958956 0.4638470208958956 0.4638470208958956 -32.089 45.2851 26.9071 0.529158198953756 0.529158198953756 0.529158198953756 -32.089 46.2851 26.9071 0.6112781664510708 0.6112781664510708 0.6112781664510708 -33.089 43.2851 26.9071 0.06227204544626869 0.06227204544626869 0.06227204544626869 -33.089 44.2851 26.9071 0.0 0.0 0.0 -33.089 45.2851 26.9071 0.3132352996603233 0.3132352996603233 0.3132352996603233 -41.089 27.2851 22.9071 0.0 0.0 0.0 -41.089 28.2851 22.9071 0.01591005252294328 0.01591005252294328 0.01591005252294328 -42.089 27.2851 22.9071 0.060180405532465286 0.060180405532465286 0.060180405532465286 -42.089 28.2851 22.9071 0.0 0.0 0.0 -41.089 29.2851 22.9071 0.0 0.0 0.0 -42.089 27.2851 23.9071 0.0 0.0 0.0 -42.089 27.2851 24.9071 0.0 0.0 0.0 -42.089 28.2851 23.9071 0.0 0.0 0.0 -42.089 28.2851 24.9071 0.0 0.0 0.0 -41.089 27.2851 25.9071 0.0 0.0 0.0 -41.089 27.2851 26.9071 0.0 0.0 0.0 -41.089 28.2851 25.9071 0.022652539143062058 0.022652539143062058 0.022652539143062058 -41.089 28.2851 26.9071 0.0 0.0 0.0 -42.089 27.2851 25.9071 0.0 0.0 0.0 -42.089 27.2851 26.9071 0.0 0.0 0.0 -42.089 28.2851 25.9071 0.006467326176896398 0.006467326176896398 0.006467326176896398 -41.089 29.2851 23.9071 0.0 0.0 0.0 -41.089 29.2851 24.9071 0.0 0.0 0.0 -42.089 29.2851 23.9071 0.0 0.0 0.0 -42.089 29.2851 24.9071 0.0 0.0 0.0 -41.089 29.2851 25.9071 0.02958864806552266 0.02958864806552266 0.02958864806552266 -41.089 29.2851 26.9071 0.06342170136699284 0.06342170136699284 0.06342170136699284 -43.089 27.2851 25.9071 0.0 0.0 0.0 -43.089 27.2851 26.9071 0.0 0.0 0.0 -25.089 27.2851 27.9071 0.5963147005917461 0.5963147005917461 0.5963147005917461 -25.089 27.2851 28.9071 0.20392344656182992 0.20392344656182992 0.20392344656182992 -25.089 28.2851 27.9071 0.0 0.0 0.0 -25.089 28.2851 28.9071 0.0 0.0 0.0 -26.089 27.2851 27.9071 0.0 0.0 0.0 -26.089 27.2851 28.9071 0.4291083674490408 0.4291083674490408 0.4291083674490408 -26.089 28.2851 27.9071 0.0 0.0 0.0 -26.089 28.2851 28.9071 0.0 0.0 0.0 -25.089 27.2851 29.9071 0.0 0.0 0.0 -25.089 27.2851 30.9071 0.0 0.0 0.0 -25.089 28.2851 29.9071 0.0 0.0 0.0 -25.089 28.2851 30.9071 0.0 0.0 0.0 -26.089 28.2851 29.9071 0.016636161264461803 0.016636161264461803 0.016636161264461803 -25.089 29.2851 28.9071 0.0 0.0 0.0 -26.089 29.2851 28.9071 0.0 0.0 0.0 -26.089 30.2851 28.9071 0.0 0.0 0.0 -25.089 29.2851 29.9071 0.0 0.0 0.0 -25.089 29.2851 30.9071 0.0 0.0 0.0 -25.089 30.2851 29.9071 0.0 0.0 0.0 -25.089 30.2851 30.9071 0.0 0.0 0.0 -26.089 29.2851 29.9071 0.0 0.0 0.0 -26.089 29.2851 30.9071 0.036715856591282084 0.036715856591282084 0.036715856591282084 -26.089 30.2851 29.9071 0.0 0.0 0.0 -27.089 27.2851 27.9071 0.0 0.0 0.0 -27.089 27.2851 28.9071 0.0 0.0 0.0 -27.089 28.2851 27.9071 0.0 0.0 0.0 -27.089 28.2851 28.9071 0.008836443375727879 0.008836443375727879 0.008836443375727879 -28.089 27.2851 27.9071 0.1436116836199875 0.1436116836199875 0.1436116836199875 -28.089 27.2851 28.9071 0.0 0.0 0.0 -28.089 28.2851 27.9071 0.03362579887135676 0.03362579887135676 0.03362579887135676 -28.089 28.2851 28.9071 0.08427545349185918 0.08427545349185918 0.08427545349185918 -27.089 27.2851 29.9071 0.0 0.0 0.0 -27.089 28.2851 29.9071 0.032718804543309825 0.032718804543309825 0.032718804543309825 -27.089 28.2851 30.9071 0.026418237420224085 0.026418237420224085 0.026418237420224085 -28.089 27.2851 29.9071 0.0 0.0 0.0 -28.089 27.2851 30.9071 0.0 0.0 0.0 -28.089 28.2851 29.9071 0.06060782893892261 0.06060782893892261 0.06060782893892261 -28.089 28.2851 30.9071 0.0 0.0 0.0 -27.089 29.2851 27.9071 0.0 0.0 0.0 -27.089 29.2851 28.9071 0.033042399448667575 0.033042399448667575 0.033042399448667575 -27.089 30.2851 28.9071 0.0 0.0 0.0 -28.089 29.2851 27.9071 0.0 0.0 0.0 -28.089 29.2851 28.9071 0.0 0.0 0.0 -28.089 30.2851 27.9071 0.0 0.0 0.0 -28.089 30.2851 28.9071 0.0 0.0 0.0 -27.089 29.2851 29.9071 0.0 0.0 0.0 -27.089 29.2851 30.9071 0.0 0.0 0.0 -27.089 30.2851 29.9071 0.0 0.0 0.0 -27.089 30.2851 30.9071 0.0 0.0 0.0 -28.089 29.2851 29.9071 0.14360252643081461 0.14360252643081461 0.14360252643081461 -28.089 29.2851 30.9071 0.1252739108451352 0.1252739108451352 0.1252739108451352 -28.089 30.2851 29.9071 0.0 0.0 0.0 -28.089 30.2851 30.9071 0.04262579000709099 0.04262579000709099 0.04262579000709099 -25.089 27.2851 31.9071 0.0 0.0 0.0 -25.089 27.2851 32.9071 0.7136321204934644 0.7136321204934644 0.7136321204934644 -25.089 28.2851 31.9071 0.1867120916837625 0.1867120916837625 0.1867120916837625 -25.089 28.2851 32.9071 0.26174494609472165 0.26174494609472165 0.26174494609472165 -26.089 27.2851 31.9071 0.0 0.0 0.0 -26.089 27.2851 32.9071 0.40290499819912 0.40290499819912 0.40290499819912 -26.089 28.2851 31.9071 0.0 0.0 0.0 -26.089 28.2851 32.9071 0.04646866676796863 0.04646866676796863 0.04646866676796863 -25.089 27.2851 33.9071 0.0 0.0 0.0 -25.089 27.2851 34.9071 0.4408936412210055 0.4408936412210055 0.4408936412210055 -25.089 28.2851 33.9071 0.0 0.0 0.0 -25.089 28.2851 34.9071 0.2149048282937407 0.2149048282937407 0.2149048282937407 -26.089 27.2851 33.9071 0.0 0.0 0.0 -26.089 28.2851 33.9071 0.0 0.0 0.0 -25.089 29.2851 31.9071 0.2026364600910414 0.2026364600910414 0.2026364600910414 -25.089 29.2851 32.9071 0.21412024825959866 0.21412024825959866 0.21412024825959866 -25.089 30.2851 31.9071 0.0 0.0 0.0 -25.089 30.2851 32.9071 0.0 0.0 0.0 -26.089 29.2851 31.9071 0.06869213181531476 0.06869213181531476 0.06869213181531476 -26.089 29.2851 32.9071 0.24351635612711373 0.24351635612711373 0.24351635612711373 -26.089 30.2851 31.9071 0.13966255640178113 0.13966255640178113 0.13966255640178113 -26.089 30.2851 32.9071 0.16657249881815508 0.16657249881815508 0.16657249881815508 -25.089 29.2851 33.9071 0.640319470700231 0.640319470700231 0.640319470700231 -25.089 29.2851 34.9071 0.1256803979573333 0.1256803979573333 0.1256803979573333 -25.089 30.2851 33.9071 0.0 0.0 0.0 -25.089 30.2851 34.9071 0.0 0.0 0.0 -26.089 29.2851 33.9071 0.0 0.0 0.0 -26.089 29.2851 34.9071 0.2598049656632902 0.2598049656632902 0.2598049656632902 -26.089 30.2851 33.9071 0.11661146007084498 0.11661146007084498 0.11661146007084498 -26.089 30.2851 34.9071 0.09531307934637732 0.09531307934637732 0.09531307934637732 -27.089 27.2851 31.9071 0.0 0.0 0.0 -27.089 27.2851 32.9071 0.0 0.0 0.0 -27.089 28.2851 31.9071 0.0 0.0 0.0 -27.089 28.2851 32.9071 0.0 0.0 0.0 -28.089 27.2851 31.9071 0.06024816420685343 0.06024816420685343 0.06024816420685343 -28.089 27.2851 32.9071 0.03194913364293855 0.03194913364293855 0.03194913364293855 -28.089 28.2851 31.9071 0.0 0.0 0.0 -28.089 28.2851 32.9071 0.04281649691543976 0.04281649691543976 0.04281649691543976 -27.089 27.2851 33.9071 0.0 0.0 0.0 -27.089 28.2851 33.9071 0.0 0.0 0.0 -28.089 28.2851 33.9071 0.056751112932268366 0.056751112932268366 0.056751112932268366 -27.089 29.2851 31.9071 0.0 0.0 0.0 -27.089 30.2851 31.9071 0.04504233180629362 0.04504233180629362 0.04504233180629362 -27.089 30.2851 32.9071 0.06958189020740466 0.06958189020740466 0.06958189020740466 -28.089 29.2851 31.9071 0.0 0.0 0.0 -28.089 29.2851 32.9071 0.06118606399062168 0.06118606399062168 0.06118606399062168 -28.089 30.2851 31.9071 0.0 0.0 0.0 -28.089 30.2851 32.9071 0.0 0.0 0.0 -27.089 29.2851 33.9071 0.12248089387995026 0.12248089387995026 0.12248089387995026 -27.089 29.2851 34.9071 0.1745074258068657 0.1745074258068657 0.1745074258068657 -27.089 30.2851 33.9071 0.16991364562549321 0.16991364562549321 0.16991364562549321 -27.089 30.2851 34.9071 0.02487210052268357 0.02487210052268357 0.02487210052268357 -28.089 29.2851 33.9071 0.06369434815821243 0.06369434815821243 0.06369434815821243 -28.089 29.2851 34.9071 0.0 0.0 0.0 -28.089 30.2851 33.9071 0.0 0.0 0.0 -28.089 30.2851 34.9071 0.0 0.0 0.0 -25.089 32.2851 28.9071 0.0 0.0 0.0 -26.089 31.2851 28.9071 0.0 0.0 0.0 -25.089 31.2851 29.9071 0.0 0.0 0.0 -25.089 31.2851 30.9071 0.012924588695366649 0.012924588695366649 0.012924588695366649 -25.089 32.2851 29.9071 0.0410099107538948 0.0410099107538948 0.0410099107538948 -25.089 32.2851 30.9071 0.0 0.0 0.0 -26.089 31.2851 29.9071 0.0 0.0 0.0 -26.089 31.2851 30.9071 0.0 0.0 0.0 -26.089 32.2851 29.9071 0.026089425180560694 0.026089425180560694 0.026089425180560694 -26.089 32.2851 30.9071 0.0 0.0 0.0 -25.089 33.2851 27.9071 0.0 0.0 0.0 -25.089 33.2851 28.9071 0.0 0.0 0.0 -25.089 34.2851 27.9071 0.0 0.0 0.0 -25.089 34.2851 28.9071 0.0 0.0 0.0 -26.089 33.2851 28.9071 0.0 0.0 0.0 -26.089 34.2851 27.9071 0.0 0.0 0.0 -26.089 34.2851 28.9071 0.0 0.0 0.0 -25.089 33.2851 29.9071 0.06768689781527132 0.06768689781527132 0.06768689781527132 -25.089 33.2851 30.9071 0.0 0.0 0.0 -25.089 34.2851 29.9071 0.028677744483690308 0.028677744483690308 0.028677744483690308 -26.089 33.2851 29.9071 0.002849438859969861 0.002849438859969861 0.002849438859969861 -26.089 33.2851 30.9071 0.0 0.0 0.0 -26.089 34.2851 29.9071 0.0 0.0 0.0 -26.089 34.2851 30.9071 0.0 0.0 0.0 -27.089 31.2851 28.9071 0.0 0.0 0.0 -27.089 32.2851 28.9071 0.0037899926001258764 0.0037899926001258764 0.0037899926001258764 -28.089 31.2851 27.9071 0.0 0.0 0.0 -28.089 31.2851 28.9071 0.0 0.0 0.0 -28.089 32.2851 27.9071 0.0 0.0 0.0 -28.089 32.2851 28.9071 0.0 0.0 0.0 -27.089 31.2851 29.9071 0.0 0.0 0.0 -27.089 31.2851 30.9071 0.0 0.0 0.0 -27.089 32.2851 29.9071 0.04197992358168598 0.04197992358168598 0.04197992358168598 -27.089 32.2851 30.9071 0.0 0.0 0.0 -28.089 32.2851 29.9071 0.0 0.0 0.0 -28.089 32.2851 30.9071 0.0 0.0 0.0 -27.089 33.2851 27.9071 0.0 0.0 0.0 -27.089 33.2851 28.9071 0.0012038512852770534 0.0012038512852770534 0.0012038512852770534 -27.089 34.2851 27.9071 0.0 0.0 0.0 -27.089 34.2851 28.9071 0.0 0.0 0.0 -28.089 33.2851 27.9071 0.0 0.0 0.0 -28.089 33.2851 28.9071 0.0 0.0 0.0 -28.089 34.2851 27.9071 0.0 0.0 0.0 -28.089 34.2851 28.9071 0.0 0.0 0.0 -27.089 33.2851 29.9071 0.0 0.0 0.0 -27.089 33.2851 30.9071 0.0 0.0 0.0 -27.089 34.2851 29.9071 0.0 0.0 0.0 -27.089 34.2851 30.9071 0.0 0.0 0.0 -28.089 33.2851 29.9071 0.0 0.0 0.0 -28.089 33.2851 30.9071 0.0 0.0 0.0 -28.089 34.2851 29.9071 0.0 0.0 0.0 -28.089 34.2851 30.9071 0.0 0.0 0.0 -25.089 31.2851 31.9071 0.07251223429234763 0.07251223429234763 0.07251223429234763 -25.089 32.2851 31.9071 0.0 0.0 0.0 -26.089 31.2851 31.9071 0.0 0.0 0.0 -26.089 31.2851 32.9071 0.09118632238492218 0.09118632238492218 0.09118632238492218 -26.089 32.2851 31.9071 0.0 0.0 0.0 -26.089 32.2851 32.9071 0.0 0.0 0.0 -25.089 31.2851 33.9071 0.0 0.0 0.0 -25.089 31.2851 34.9071 0.0 0.0 0.0 -25.089 32.2851 33.9071 0.0 0.0 0.0 -25.089 32.2851 34.9071 0.049977083108771796 0.049977083108771796 0.049977083108771796 -26.089 31.2851 33.9071 0.0 0.0 0.0 -26.089 31.2851 34.9071 0.0 0.0 0.0 -26.089 32.2851 33.9071 0.0 0.0 0.0 -26.089 32.2851 34.9071 0.0 0.0 0.0 -26.089 33.2851 31.9071 0.0 0.0 0.0 -26.089 33.2851 32.9071 0.0 0.0 0.0 -26.089 34.2851 31.9071 0.0 0.0 0.0 -26.089 34.2851 32.9071 0.00205559863908907 0.00205559863908907 0.00205559863908907 -25.089 33.2851 34.9071 0.0 0.0 0.0 -25.089 34.2851 33.9071 0.2318346394441944 0.2318346394441944 0.2318346394441944 -25.089 34.2851 34.9071 0.0 0.0 0.0 -26.089 33.2851 33.9071 0.04167678374322403 0.04167678374322403 0.04167678374322403 -26.089 33.2851 34.9071 0.0 0.0 0.0 -26.089 34.2851 33.9071 0.0 0.0 0.0 -26.089 34.2851 34.9071 0.0 0.0 0.0 -27.089 31.2851 31.9071 0.050904117338784194 0.050904117338784194 0.050904117338784194 -27.089 31.2851 32.9071 0.0 0.0 0.0 -27.089 32.2851 31.9071 0.0 0.0 0.0 -27.089 32.2851 32.9071 0.0 0.0 0.0 -28.089 31.2851 32.9071 0.03885488326083136 0.03885488326083136 0.03885488326083136 -27.089 31.2851 33.9071 0.08963999595463563 0.08963999595463563 0.08963999595463563 -27.089 31.2851 34.9071 0.0 0.0 0.0 -27.089 32.2851 33.9071 0.0 0.0 0.0 -27.089 32.2851 34.9071 0.0 0.0 0.0 -27.089 33.2851 31.9071 0.0 0.0 0.0 -27.089 33.2851 32.9071 0.0 0.0 0.0 -27.089 34.2851 31.9071 0.0 0.0 0.0 -27.089 34.2851 32.9071 0.0 0.0 0.0 -28.089 34.2851 31.9071 0.0 0.0 0.0 -28.089 34.2851 32.9071 0.0 0.0 0.0 -27.089 33.2851 33.9071 0.0 0.0 0.0 -27.089 33.2851 34.9071 0.0 0.0 0.0 -27.089 34.2851 33.9071 0.0 0.0 0.0 -27.089 34.2851 34.9071 0.1528090422771415 0.1528090422771415 0.1528090422771415 -29.089 27.2851 27.9071 0.0 0.0 0.0 -29.089 27.2851 28.9071 0.0 0.0 0.0 -29.089 28.2851 27.9071 0.0 0.0 0.0 -29.089 28.2851 28.9071 0.1675595153750437 0.1675595153750437 0.1675595153750437 -30.089 27.2851 27.9071 0.0 0.0 0.0 -30.089 28.2851 27.9071 0.0 0.0 0.0 -29.089 27.2851 29.9071 0.0 0.0 0.0 -29.089 27.2851 30.9071 0.0017452200729933056 0.0017452200729933056 0.0017452200729933056 -29.089 28.2851 29.9071 0.12172540212747598 0.12172540212747598 0.12172540212747598 -29.089 28.2851 30.9071 0.0 0.0 0.0 -30.089 27.2851 29.9071 0.0 0.0 0.0 -30.089 27.2851 30.9071 0.0 0.0 0.0 -30.089 28.2851 30.9071 0.1584941345200662 0.1584941345200662 0.1584941345200662 -29.089 29.2851 27.9071 0.0 0.0 0.0 -29.089 29.2851 28.9071 0.0 0.0 0.0 -29.089 30.2851 27.9071 0.0 0.0 0.0 -29.089 30.2851 28.9071 0.0 0.0 0.0 -30.089 29.2851 27.9071 0.0 0.0 0.0 -30.089 29.2851 28.9071 0.0 0.0 0.0 -30.089 30.2851 27.9071 0.0 0.0 0.0 -29.089 29.2851 29.9071 0.13033415971796655 0.13033415971796655 0.13033415971796655 -29.089 29.2851 30.9071 0.15915560655057664 0.15915560655057664 0.15915560655057664 -29.089 30.2851 29.9071 0.0 0.0 0.0 -29.089 30.2851 30.9071 0.5893054411230757 0.5893054411230757 0.5893054411230757 -30.089 29.2851 29.9071 0.028872697050186198 0.028872697050186198 0.028872697050186198 -30.089 29.2851 30.9071 0.08546429865032845 0.08546429865032845 0.08546429865032845 -30.089 30.2851 29.9071 0.0 0.0 0.0 -30.089 30.2851 30.9071 0.0 0.0 0.0 -31.089 28.2851 27.9071 0.0 0.0 0.0 -32.089 27.2851 27.9071 0.0 0.0 0.0 -32.089 27.2851 28.9071 0.0 0.0 0.0 -32.089 28.2851 27.9071 0.0 0.0 0.0 -32.089 28.2851 28.9071 0.0 0.0 0.0 -31.089 27.2851 29.9071 0.0 0.0 0.0 -31.089 27.2851 30.9071 0.0 0.0 0.0 -31.089 28.2851 29.9071 0.0 0.0 0.0 -31.089 28.2851 30.9071 0.0 0.0 0.0 -32.089 27.2851 29.9071 0.0 0.0 0.0 -32.089 27.2851 30.9071 0.0 0.0 0.0 -32.089 28.2851 29.9071 0.0 0.0 0.0 -32.089 28.2851 30.9071 0.0 0.0 0.0 -31.089 29.2851 27.9071 0.0 0.0 0.0 -31.089 29.2851 28.9071 0.0 0.0 0.0 -32.089 29.2851 27.9071 0.0 0.0 0.0 -32.089 29.2851 28.9071 0.0 0.0 0.0 -32.089 30.2851 27.9071 0.0133441846474669 0.0133441846474669 0.0133441846474669 -32.089 30.2851 28.9071 0.0 0.0 0.0 -31.089 29.2851 29.9071 0.0 0.0 0.0 -31.089 29.2851 30.9071 0.0 0.0 0.0 -31.089 30.2851 29.9071 0.0 0.0 0.0 -31.089 30.2851 30.9071 0.0 0.0 0.0 -32.089 29.2851 29.9071 0.014224017257526584 0.014224017257526584 0.014224017257526584 -32.089 29.2851 30.9071 0.0 0.0 0.0 -32.089 30.2851 29.9071 0.011410154174706056 0.011410154174706056 0.011410154174706056 -32.089 30.2851 30.9071 0.0 0.0 0.0 -29.089 27.2851 31.9071 0.0 0.0 0.0 -29.089 28.2851 31.9071 0.0 0.0 0.0 -30.089 27.2851 31.9071 0.0 0.0 0.0 -30.089 28.2851 31.9071 0.0 0.0 0.0 -29.089 27.2851 34.9071 0.3678648061923077 0.3678648061923077 0.3678648061923077 -29.089 28.2851 34.9071 0.0 0.0 0.0 -30.089 27.2851 34.9071 0.0 0.0 0.0 -30.089 28.2851 34.9071 0.0 0.0 0.0 -29.089 29.2851 31.9071 0.0 0.0 0.0 -29.089 29.2851 32.9071 0.013133875343543702 0.013133875343543702 0.013133875343543702 -29.089 30.2851 31.9071 0.0 0.0 0.0 -29.089 30.2851 32.9071 0.009301154505713047 0.009301154505713047 0.009301154505713047 -30.089 29.2851 31.9071 0.0 0.0 0.0 -30.089 30.2851 31.9071 0.0 0.0 0.0 -30.089 30.2851 32.9071 0.01269596809469064 0.01269596809469064 0.01269596809469064 -29.089 29.2851 33.9071 0.0 0.0 0.0 -29.089 29.2851 34.9071 0.0 0.0 0.0 -29.089 30.2851 33.9071 0.0 0.0 0.0 -29.089 30.2851 34.9071 0.0 0.0 0.0 -30.089 29.2851 33.9071 0.0 0.0 0.0 -30.089 29.2851 34.9071 0.0 0.0 0.0 -30.089 30.2851 33.9071 0.0 0.0 0.0 -31.089 27.2851 32.9071 0.033463396763733194 0.033463396763733194 0.033463396763733194 -31.089 28.2851 31.9071 0.0 0.0 0.0 -31.089 28.2851 32.9071 0.12702938071910605 0.12702938071910605 0.12702938071910605 -32.089 27.2851 31.9071 0.0 0.0 0.0 -32.089 27.2851 32.9071 0.0015160016180466287 0.0015160016180466287 0.0015160016180466287 -32.089 28.2851 31.9071 0.0 0.0 0.0 -32.089 28.2851 32.9071 0.006914603746974035 0.006914603746974035 0.006914603746974035 -31.089 27.2851 33.9071 0.0 0.0 0.0 -31.089 27.2851 34.9071 0.0 0.0 0.0 -31.089 28.2851 33.9071 0.00559156557961782 0.00559156557961782 0.00559156557961782 -31.089 28.2851 34.9071 0.002230821425000839 0.002230821425000839 0.002230821425000839 -32.089 27.2851 33.9071 0.0 0.0 0.0 -32.089 27.2851 34.9071 0.0 0.0 0.0 -32.089 28.2851 33.9071 0.0 0.0 0.0 -32.089 28.2851 34.9071 0.0 0.0 0.0 -31.089 29.2851 31.9071 0.0 0.0 0.0 -31.089 29.2851 32.9071 0.0 0.0 0.0 -32.089 29.2851 31.9071 0.0 0.0 0.0 -32.089 29.2851 32.9071 0.0 0.0 0.0 -31.089 29.2851 33.9071 0.0 0.0 0.0 -31.089 29.2851 34.9071 0.03717589456194889 0.03717589456194889 0.03717589456194889 -31.089 30.2851 33.9071 0.0 0.0 0.0 -31.089 30.2851 34.9071 0.01472463652077902 0.01472463652077902 0.01472463652077902 -32.089 29.2851 33.9071 0.0 0.0 0.0 -32.089 29.2851 34.9071 0.0 0.0 0.0 -32.089 30.2851 33.9071 0.0 0.0 0.0 -32.089 30.2851 34.9071 0.0 0.0 0.0 -29.089 31.2851 27.9071 0.0 0.0 0.0 -29.089 31.2851 28.9071 0.0 0.0 0.0 -29.089 32.2851 27.9071 0.0 0.0 0.0 -29.089 32.2851 28.9071 0.0 0.0 0.0 -30.089 31.2851 27.9071 0.0 0.0 0.0 -30.089 32.2851 27.9071 0.0 0.0 0.0 -30.089 32.2851 28.9071 0.0 0.0 0.0 -29.089 31.2851 29.9071 0.0 0.0 0.0 -29.089 32.2851 29.9071 0.0 0.0 0.0 -29.089 32.2851 30.9071 0.0 0.0 0.0 -30.089 31.2851 29.9071 0.0 0.0 0.0 -30.089 32.2851 29.9071 0.0 0.0 0.0 -30.089 32.2851 30.9071 0.015604844310930358 0.015604844310930358 0.015604844310930358 -29.089 33.2851 27.9071 0.02743026558345187 0.02743026558345187 0.02743026558345187 -29.089 33.2851 28.9071 0.0 0.0 0.0 -29.089 34.2851 27.9071 0.010931769368793056 0.010931769368793056 0.010931769368793056 -29.089 34.2851 28.9071 0.0 0.0 0.0 -30.089 33.2851 27.9071 0.0 0.0 0.0 -30.089 33.2851 28.9071 0.0 0.0 0.0 -29.089 33.2851 29.9071 0.0 0.0 0.0 -29.089 33.2851 30.9071 0.0 0.0 0.0 -29.089 34.2851 29.9071 0.0 0.0 0.0 -29.089 34.2851 30.9071 0.0 0.0 0.0 -30.089 33.2851 29.9071 0.0 0.0 0.0 -30.089 33.2851 30.9071 0.06478176566666599 0.06478176566666599 0.06478176566666599 -30.089 34.2851 29.9071 0.0 0.0 0.0 -30.089 34.2851 30.9071 0.0 0.0 0.0 -31.089 31.2851 27.9071 0.0 0.0 0.0 -31.089 32.2851 27.9071 0.0 0.0 0.0 -31.089 32.2851 28.9071 0.0 0.0 0.0 -32.089 31.2851 27.9071 0.017121113131767982 0.017121113131767982 0.017121113131767982 -32.089 32.2851 27.9071 0.005630625784522485 0.005630625784522485 0.005630625784522485 -32.089 32.2851 28.9071 0.023703647818108794 0.023703647818108794 0.023703647818108794 -31.089 31.2851 29.9071 0.004456212597682696 0.004456212597682696 0.004456212597682696 -31.089 31.2851 30.9071 0.0 0.0 0.0 -31.089 32.2851 29.9071 0.0 0.0 0.0 -32.089 31.2851 29.9071 0.0 0.0 0.0 -32.089 31.2851 30.9071 0.0 0.0 0.0 -32.089 32.2851 29.9071 0.028986527467741552 0.028986527467741552 0.028986527467741552 -32.089 32.2851 30.9071 0.0 0.0 0.0 -31.089 33.2851 28.9071 0.0 0.0 0.0 -31.089 34.2851 28.9071 0.0 0.0 0.0 -32.089 33.2851 28.9071 0.013582069592780556 0.013582069592780556 0.013582069592780556 -32.089 34.2851 27.9071 0.0 0.0 0.0 -32.089 34.2851 28.9071 0.0 0.0 0.0 -31.089 33.2851 29.9071 0.0 0.0 0.0 -31.089 34.2851 29.9071 0.0 0.0 0.0 -32.089 33.2851 29.9071 0.0 0.0 0.0 -32.089 33.2851 30.9071 0.0 0.0 0.0 -32.089 34.2851 29.9071 0.0 0.0 0.0 -32.089 34.2851 30.9071 0.0 0.0 0.0 -29.089 31.2851 32.9071 0.0 0.0 0.0 -30.089 31.2851 32.9071 0.0 0.0 0.0 -30.089 32.2851 32.9071 0.08934729348388813 0.08934729348388813 0.08934729348388813 -29.089 31.2851 33.9071 0.0 0.0 0.0 -29.089 31.2851 34.9071 0.0 0.0 0.0 -29.089 32.2851 34.9071 0.032735106776568317 0.032735106776568317 0.032735106776568317 -30.089 31.2851 33.9071 0.0 0.0 0.0 -30.089 31.2851 34.9071 0.0 0.0 0.0 -30.089 32.2851 33.9071 0.02860936346131615 0.02860936346131615 0.02860936346131615 -30.089 32.2851 34.9071 0.0 0.0 0.0 -29.089 33.2851 31.9071 0.0 0.0 0.0 -29.089 33.2851 32.9071 0.0956483040247916 0.0956483040247916 0.0956483040247916 -29.089 34.2851 31.9071 0.0 0.0 0.0 -29.089 34.2851 32.9071 0.0 0.0 0.0 -30.089 33.2851 31.9071 0.0 0.0 0.0 -30.089 33.2851 32.9071 0.0 0.0 0.0 -30.089 34.2851 31.9071 0.0 0.0 0.0 -30.089 34.2851 32.9071 0.0 0.0 0.0 -30.089 33.2851 33.9071 0.0 0.0 0.0 -30.089 34.2851 33.9071 0.0 0.0 0.0 -31.089 31.2851 32.9071 0.0 0.0 0.0 -31.089 32.2851 32.9071 0.010847183033414056 0.010847183033414056 0.010847183033414056 -32.089 31.2851 32.9071 0.0 0.0 0.0 -32.089 32.2851 31.9071 0.0 0.0 0.0 -32.089 32.2851 32.9071 0.0 0.0 0.0 -31.089 31.2851 33.9071 0.0 0.0 0.0 -31.089 32.2851 33.9071 0.0 0.0 0.0 -31.089 32.2851 34.9071 0.0 0.0 0.0 -32.089 31.2851 33.9071 0.0 0.0 0.0 -32.089 31.2851 34.9071 0.0 0.0 0.0 -32.089 32.2851 34.9071 0.0 0.0 0.0 -31.089 33.2851 31.9071 0.0 0.0 0.0 -31.089 33.2851 32.9071 0.040096704002071624 0.040096704002071624 0.040096704002071624 -31.089 34.2851 31.9071 0.0 0.0 0.0 -31.089 34.2851 32.9071 0.0 0.0 0.0 -32.089 33.2851 31.9071 0.028459362858629676 0.028459362858629676 0.028459362858629676 -32.089 33.2851 32.9071 0.0 0.0 0.0 -32.089 34.2851 31.9071 0.0 0.0 0.0 -32.089 34.2851 32.9071 0.0 0.0 0.0 -31.089 33.2851 33.9071 0.0 0.0 0.0 -31.089 33.2851 34.9071 0.07153984532904184 0.07153984532904184 0.07153984532904184 -31.089 34.2851 33.9071 0.0 0.0 0.0 -31.089 34.2851 34.9071 0.0 0.0 0.0 -32.089 33.2851 34.9071 0.0 0.0 0.0 -32.089 34.2851 33.9071 0.0 0.0 0.0 -32.089 34.2851 34.9071 0.0 0.0 0.0 -25.089 27.2851 35.9071 0.4851396886876601 0.4851396886876601 0.4851396886876601 -25.089 27.2851 36.9071 0.31961951814614187 0.31961951814614187 0.31961951814614187 -26.089 27.2851 36.9071 0.30427659267332335 0.30427659267332335 0.30427659267332335 -26.089 28.2851 36.9071 0.18072870441504255 0.18072870441504255 0.18072870441504255 -25.089 27.2851 37.9071 0.0 0.0 0.0 -25.089 28.2851 37.9071 0.3474112933840427 0.3474112933840427 0.3474112933840427 -26.089 27.2851 37.9071 0.0 0.0 0.0 -26.089 28.2851 37.9071 0.09940173620116638 0.09940173620116638 0.09940173620116638 -25.089 29.2851 36.9071 0.0 0.0 0.0 -25.089 30.2851 35.9071 0.0 0.0 0.0 -25.089 30.2851 36.9071 0.13611081587407972 0.13611081587407972 0.13611081587407972 -26.089 29.2851 35.9071 0.0 0.0 0.0 -26.089 29.2851 36.9071 0.0 0.0 0.0 -26.089 30.2851 35.9071 0.0 0.0 0.0 -26.089 30.2851 36.9071 0.3181528353337005 0.3181528353337005 0.3181528353337005 -25.089 29.2851 37.9071 0.33739458027233904 0.33739458027233904 0.33739458027233904 -25.089 30.2851 37.9071 0.0 0.0 0.0 -26.089 29.2851 37.9071 0.08721771342677188 0.08721771342677188 0.08721771342677188 -26.089 30.2851 37.9071 0.0880778177880687 0.0880778177880687 0.0880778177880687 -27.089 27.2851 35.9071 0.490620768226067 0.490620768226067 0.490620768226067 -27.089 27.2851 36.9071 0.0 0.0 0.0 -27.089 28.2851 36.9071 0.14634858896848743 0.14634858896848743 0.14634858896848743 -27.089 27.2851 37.9071 0.0 0.0 0.0 -27.089 28.2851 37.9071 0.0 0.0 0.0 -28.089 27.2851 37.9071 0.015506031252720409 0.015506031252720409 0.015506031252720409 -28.089 28.2851 37.9071 0.0 0.0 0.0 -27.089 29.2851 35.9071 0.0 0.0 0.0 -27.089 29.2851 36.9071 0.0 0.0 0.0 -27.089 30.2851 35.9071 0.1456478346663336 0.1456478346663336 0.1456478346663336 -27.089 30.2851 36.9071 0.0 0.0 0.0 -28.089 29.2851 35.9071 0.0 0.0 0.0 -28.089 29.2851 36.9071 0.0 0.0 0.0 -28.089 30.2851 35.9071 0.12904382844282947 0.12904382844282947 0.12904382844282947 -28.089 30.2851 36.9071 0.026735977865147573 0.026735977865147573 0.026735977865147573 -27.089 29.2851 37.9071 0.0 0.0 0.0 -28.089 29.2851 37.9071 0.011906220171322054 0.011906220171322054 0.011906220171322054 -25.089 31.2851 35.9071 0.0 0.0 0.0 -25.089 31.2851 36.9071 0.23148581750617936 0.23148581750617936 0.23148581750617936 -25.089 32.2851 35.9071 0.11435537198615783 0.11435537198615783 0.11435537198615783 -25.089 32.2851 36.9071 0.04770969424630256 0.04770969424630256 0.04770969424630256 -26.089 32.2851 35.9071 0.0 0.0 0.0 -26.089 32.2851 36.9071 0.0 0.0 0.0 -25.089 31.2851 37.9071 0.0 0.0 0.0 -25.089 31.2851 38.9071 0.0 0.0 0.0 -25.089 32.2851 37.9071 0.022237483530290668 0.022237483530290668 0.022237483530290668 -25.089 32.2851 38.9071 0.049008170212306364 0.049008170212306364 0.049008170212306364 -26.089 31.2851 37.9071 0.0 0.0 0.0 -26.089 31.2851 38.9071 0.0 0.0 0.0 -26.089 32.2851 37.9071 0.0 0.0 0.0 -26.089 32.2851 38.9071 0.0 0.0 0.0 -25.089 33.2851 35.9071 0.0 0.0 0.0 -25.089 34.2851 35.9071 0.0 0.0 0.0 -25.089 34.2851 36.9071 0.0668521385081246 0.0668521385081246 0.0668521385081246 -26.089 33.2851 35.9071 0.06533986559207151 0.06533986559207151 0.06533986559207151 -26.089 33.2851 36.9071 0.0 0.0 0.0 -25.089 34.2851 37.9071 0.0 0.0 0.0 -26.089 33.2851 38.9071 0.0 0.0 0.0 -27.089 31.2851 35.9071 0.020234518911495983 0.020234518911495983 0.020234518911495983 -27.089 31.2851 36.9071 0.0 0.0 0.0 -27.089 32.2851 35.9071 0.0 0.0 0.0 -27.089 32.2851 36.9071 0.0 0.0 0.0 -28.089 31.2851 35.9071 0.0 0.0 0.0 -28.089 31.2851 36.9071 0.0 0.0 0.0 -28.089 32.2851 35.9071 0.028835671381526352 0.028835671381526352 0.028835671381526352 -28.089 32.2851 36.9071 0.03228746759222699 0.03228746759222699 0.03228746759222699 -27.089 32.2851 37.9071 0.0 0.0 0.0 -27.089 32.2851 38.9071 0.0 0.0 0.0 -28.089 32.2851 37.9071 0.0 0.0 0.0 -27.089 33.2851 36.9071 0.0 0.0 0.0 -28.089 33.2851 36.9071 0.02187441768939713 0.02187441768939713 0.02187441768939713 -28.089 34.2851 35.9071 0.0 0.0 0.0 -28.089 34.2851 36.9071 0.0 0.0 0.0 -27.089 33.2851 37.9071 0.0 0.0 0.0 -27.089 33.2851 38.9071 0.07142367539168909 0.07142367539168909 0.07142367539168909 -27.089 34.2851 38.9071 0.0 0.0 0.0 -28.089 33.2851 37.9071 0.0 0.0 0.0 -28.089 33.2851 38.9071 0.14170503004868154 0.14170503004868154 0.14170503004868154 -28.089 34.2851 37.9071 0.15345349011084208 0.15345349011084208 0.15345349011084208 -28.089 34.2851 38.9071 0.11053390680225304 0.11053390680225304 0.11053390680225304 -25.089 32.2851 39.9071 0.006425986707152672 0.006425986707152672 0.006425986707152672 -25.089 32.2851 40.9071 0.0 0.0 0.0 -26.089 32.2851 39.9071 0.0 0.0 0.0 -26.089 32.2851 40.9071 0.0 0.0 0.0 -25.089 33.2851 40.9071 0.0 0.0 0.0 -25.089 34.2851 40.9071 0.0 0.0 0.0 -26.089 33.2851 39.9071 0.04375404675947026 0.04375404675947026 0.04375404675947026 -26.089 33.2851 40.9071 0.0 0.0 0.0 -26.089 34.2851 39.9071 0.0495934384772711 0.0495934384772711 0.0495934384772711 -26.089 34.2851 40.9071 0.058649318912727774 0.058649318912727774 0.058649318912727774 -27.089 33.2851 39.9071 0.03439411088574648 0.03439411088574648 0.03439411088574648 -27.089 34.2851 39.9071 0.1032719367757895 0.1032719367757895 0.1032719367757895 -29.089 27.2851 35.9071 0.1513670401986664 0.1513670401986664 0.1513670401986664 -29.089 28.2851 36.9071 0.0 0.0 0.0 -30.089 27.2851 35.9071 0.0 0.0 0.0 -30.089 27.2851 36.9071 0.0 0.0 0.0 -30.089 28.2851 35.9071 0.0 0.0 0.0 -30.089 28.2851 36.9071 0.0 0.0 0.0 -29.089 27.2851 37.9071 0.04237360011125552 0.04237360011125552 0.04237360011125552 -29.089 28.2851 37.9071 0.0 0.0 0.0 -30.089 27.2851 37.9071 0.014113355884558677 0.014113355884558677 0.014113355884558677 -30.089 28.2851 37.9071 0.0 0.0 0.0 -29.089 29.2851 35.9071 0.0 0.0 0.0 -29.089 29.2851 36.9071 0.0 0.0 0.0 -29.089 30.2851 35.9071 0.0 0.0 0.0 -30.089 29.2851 35.9071 0.0 0.0 0.0 -30.089 29.2851 36.9071 0.02139346039659026 0.02139346039659026 0.02139346039659026 -29.089 29.2851 37.9071 0.0 0.0 0.0 -31.089 27.2851 35.9071 0.0 0.0 0.0 -32.089 27.2851 35.9071 0.0 0.0 0.0 -29.089 31.2851 35.9071 0.01878702149720434 0.01878702149720434 0.01878702149720434 -29.089 32.2851 35.9071 0.07502095358710438 0.07502095358710438 0.07502095358710438 -29.089 32.2851 36.9071 0.14580087134886902 0.14580087134886902 0.14580087134886902 -30.089 32.2851 35.9071 0.0 0.0 0.0 -30.089 32.2851 36.9071 0.0 0.0 0.0 -29.089 33.2851 35.9071 0.20980201154161027 0.20980201154161027 0.20980201154161027 -29.089 33.2851 36.9071 0.1545927608235458 0.1545927608235458 0.1545927608235458 -29.089 34.2851 35.9071 0.09909180068872889 0.09909180068872889 0.09909180068872889 -29.089 34.2851 36.9071 0.0 0.0 0.0 -30.089 33.2851 36.9071 0.19825528558549166 0.19825528558549166 0.19825528558549166 -30.089 34.2851 36.9071 0.07012344019399694 0.07012344019399694 0.07012344019399694 -30.089 33.2851 37.9071 0.0 0.0 0.0 -30.089 34.2851 37.9071 0.0 0.0 0.0 -31.089 32.2851 35.9071 0.0 0.0 0.0 -31.089 32.2851 36.9071 0.27180437901215604 0.27180437901215604 0.27180437901215604 -32.089 32.2851 35.9071 0.01901896307492932 0.01901896307492932 0.01901896307492932 -32.089 32.2851 36.9071 0.15949933362136215 0.15949933362136215 0.15949933362136215 -31.089 33.2851 36.9071 0.024600827237400848 0.024600827237400848 0.024600827237400848 -31.089 34.2851 35.9071 0.0 0.0 0.0 -31.089 34.2851 36.9071 0.0 0.0 0.0 -32.089 33.2851 35.9071 0.15206191312930797 0.15206191312930797 0.15206191312930797 -32.089 33.2851 36.9071 0.19433559472472967 0.19433559472472967 0.19433559472472967 -32.089 34.2851 35.9071 0.025806383311342794 0.025806383311342794 0.025806383311342794 -32.089 34.2851 36.9071 0.1294250618236469 0.1294250618236469 0.1294250618236469 -31.089 33.2851 37.9071 0.32283363662888115 0.32283363662888115 0.32283363662888115 -25.089 35.2851 27.9071 0.0 0.0 0.0 -25.089 35.2851 28.9071 0.0 0.0 0.0 -25.089 36.2851 27.9071 0.0 0.0 0.0 -25.089 36.2851 28.9071 0.0 0.0 0.0 -26.089 35.2851 27.9071 0.0 0.0 0.0 -26.089 35.2851 28.9071 0.0 0.0 0.0 -26.089 36.2851 27.9071 0.0 0.0 0.0 -26.089 36.2851 28.9071 0.0 0.0 0.0 -25.089 35.2851 29.9071 0.0 0.0 0.0 -25.089 35.2851 30.9071 0.0 0.0 0.0 -25.089 36.2851 29.9071 0.0 0.0 0.0 -25.089 36.2851 30.9071 0.0 0.0 0.0 -25.089 37.2851 27.9071 0.0 0.0 0.0 -26.089 37.2851 27.9071 0.0 0.0 0.0 -26.089 38.2851 27.9071 0.0 0.0 0.0 -25.089 37.2851 29.9071 0.0 0.0 0.0 -25.089 37.2851 30.9071 0.0 0.0 0.0 -25.089 38.2851 30.9071 0.0 0.0 0.0 -27.089 35.2851 27.9071 0.0 0.0 0.0 -27.089 35.2851 28.9071 0.0 0.0 0.0 -27.089 36.2851 27.9071 0.0 0.0 0.0 -27.089 36.2851 28.9071 0.0 0.0 0.0 -28.089 35.2851 27.9071 0.0 0.0 0.0 -28.089 35.2851 28.9071 0.0 0.0 0.0 -28.089 36.2851 27.9071 0.0 0.0 0.0 -28.089 36.2851 28.9071 0.0 0.0 0.0 -27.089 36.2851 29.9071 0.07659031145328243 0.07659031145328243 0.07659031145328243 -28.089 35.2851 29.9071 0.0 0.0 0.0 -28.089 35.2851 30.9071 0.0 0.0 0.0 -28.089 36.2851 29.9071 0.0 0.0 0.0 -27.089 37.2851 27.9071 0.011625860750058227 0.011625860750058227 0.011625860750058227 -27.089 37.2851 28.9071 0.09005389507003368 0.09005389507003368 0.09005389507003368 -27.089 38.2851 27.9071 0.0 0.0 0.0 -27.089 38.2851 28.9071 0.10870887602363687 0.10870887602363687 0.10870887602363687 -28.089 37.2851 27.9071 0.0 0.0 0.0 -28.089 37.2851 28.9071 0.04499003645428714 0.04499003645428714 0.04499003645428714 -28.089 38.2851 27.9071 0.0 0.0 0.0 -28.089 38.2851 28.9071 0.0 0.0 0.0 -27.089 38.2851 29.9071 0.0 0.0 0.0 -27.089 38.2851 30.9071 0.0 0.0 0.0 -28.089 38.2851 29.9071 0.04265250155303312 0.04265250155303312 0.04265250155303312 -28.089 38.2851 30.9071 0.0 0.0 0.0 -25.089 35.2851 32.9071 0.17561702047627836 0.17561702047627836 0.17561702047627836 -25.089 36.2851 31.9071 0.0 0.0 0.0 -25.089 36.2851 32.9071 0.0 0.0 0.0 -26.089 35.2851 32.9071 0.020483115787424885 0.020483115787424885 0.020483115787424885 -26.089 36.2851 32.9071 0.0 0.0 0.0 -25.089 35.2851 33.9071 0.2289714945778283 0.2289714945778283 0.2289714945778283 -25.089 35.2851 34.9071 0.0 0.0 0.0 -25.089 36.2851 33.9071 0.21330194878725275 0.21330194878725275 0.21330194878725275 -25.089 36.2851 34.9071 0.07816843177402048 0.07816843177402048 0.07816843177402048 -26.089 35.2851 33.9071 0.0 0.0 0.0 -26.089 35.2851 34.9071 0.0 0.0 0.0 -26.089 36.2851 33.9071 0.0 0.0 0.0 -25.089 37.2851 31.9071 0.18016053437450932 0.18016053437450932 0.18016053437450932 -25.089 37.2851 32.9071 0.07003578283559686 0.07003578283559686 0.07003578283559686 -25.089 38.2851 31.9071 0.0 0.0 0.0 -25.089 38.2851 32.9071 0.0 0.0 0.0 -26.089 37.2851 31.9071 0.0 0.0 0.0 -26.089 37.2851 32.9071 0.0 0.0 0.0 -26.089 38.2851 31.9071 0.0 0.0 0.0 -26.089 38.2851 32.9071 0.16455919315603512 0.16455919315603512 0.16455919315603512 -25.089 37.2851 34.9071 0.030008984803343554 0.030008984803343554 0.030008984803343554 -25.089 38.2851 33.9071 0.0 0.0 0.0 -25.089 38.2851 34.9071 0.0 0.0 0.0 -26.089 37.2851 34.9071 0.131428505305748 0.131428505305748 0.131428505305748 -26.089 38.2851 33.9071 0.0 0.0 0.0 -26.089 38.2851 34.9071 0.0 0.0 0.0 -27.089 35.2851 31.9071 0.0 0.0 0.0 -27.089 35.2851 32.9071 0.06193947209233771 0.06193947209233771 0.06193947209233771 -27.089 36.2851 31.9071 0.1472013368064722 0.1472013368064722 0.1472013368064722 -27.089 36.2851 32.9071 0.0 0.0 0.0 -28.089 35.2851 31.9071 0.0 0.0 0.0 -28.089 35.2851 32.9071 0.0 0.0 0.0 -28.089 36.2851 31.9071 0.09327298323767225 0.09327298323767225 0.09327298323767225 -28.089 36.2851 32.9071 0.12870582231101427 0.12870582231101427 0.12870582231101427 -27.089 35.2851 33.9071 0.0335881913497267 0.0335881913497267 0.0335881913497267 -27.089 35.2851 34.9071 0.0 0.0 0.0 -27.089 36.2851 33.9071 0.11758022460167404 0.11758022460167404 0.11758022460167404 -27.089 36.2851 34.9071 0.0 0.0 0.0 -28.089 35.2851 33.9071 0.0 0.0 0.0 -28.089 35.2851 34.9071 0.15102221739217978 0.15102221739217978 0.15102221739217978 -28.089 36.2851 33.9071 0.0 0.0 0.0 -28.089 36.2851 34.9071 0.0 0.0 0.0 -27.089 37.2851 32.9071 0.0 0.0 0.0 -27.089 38.2851 31.9071 0.0 0.0 0.0 -27.089 38.2851 32.9071 0.09609650756191698 0.09609650756191698 0.09609650756191698 -28.089 37.2851 31.9071 0.052347486705565764 0.052347486705565764 0.052347486705565764 -28.089 37.2851 32.9071 0.37430274343612346 0.37430274343612346 0.37430274343612346 -28.089 38.2851 31.9071 0.0 0.0 0.0 -28.089 38.2851 32.9071 0.37117239387740775 0.37117239387740775 0.37117239387740775 -27.089 37.2851 33.9071 0.043413826753347685 0.043413826753347685 0.043413826753347685 -27.089 37.2851 34.9071 0.0 0.0 0.0 -27.089 38.2851 33.9071 0.0 0.0 0.0 -27.089 38.2851 34.9071 0.03491503197725859 0.03491503197725859 0.03491503197725859 -28.089 37.2851 34.9071 0.0 0.0 0.0 -28.089 38.2851 33.9071 0.0 0.0 0.0 -25.089 40.2851 27.9071 0.0 0.0 0.0 -25.089 40.2851 28.9071 0.09422489613208021 0.09422489613208021 0.09422489613208021 -26.089 39.2851 27.9071 0.0 0.0 0.0 -26.089 39.2851 28.9071 0.0 0.0 0.0 -26.089 40.2851 27.9071 0.0 0.0 0.0 -26.089 40.2851 28.9071 0.0 0.0 0.0 -25.089 39.2851 29.9071 0.0 0.0 0.0 -25.089 39.2851 30.9071 0.0 0.0 0.0 -25.089 40.2851 29.9071 0.17595321412685275 0.17595321412685275 0.17595321412685275 -25.089 40.2851 30.9071 0.13469335633896434 0.13469335633896434 0.13469335633896434 -26.089 39.2851 29.9071 0.3743506030105418 0.3743506030105418 0.3743506030105418 -26.089 39.2851 30.9071 0.36893152561928844 0.36893152561928844 0.36893152561928844 -26.089 40.2851 29.9071 0.24851533834460218 0.24851533834460218 0.24851533834460218 -26.089 40.2851 30.9071 0.07508860613497437 0.07508860613497437 0.07508860613497437 -25.089 41.2851 27.9071 0.0 0.0 0.0 -25.089 41.2851 28.9071 0.0 0.0 0.0 -26.089 41.2851 27.9071 0.04864660953047468 0.04864660953047468 0.04864660953047468 -26.089 41.2851 28.9071 0.0 0.0 0.0 -26.089 42.2851 27.9071 0.013253357160972621 0.013253357160972621 0.013253357160972621 -25.089 41.2851 29.9071 0.0 0.0 0.0 -27.089 39.2851 27.9071 0.0 0.0 0.0 -27.089 39.2851 28.9071 0.15190628127049188 0.15190628127049188 0.15190628127049188 -27.089 40.2851 27.9071 0.06801822340798515 0.06801822340798515 0.06801822340798515 -27.089 40.2851 28.9071 0.0 0.0 0.0 -28.089 39.2851 27.9071 0.0 0.0 0.0 -28.089 39.2851 28.9071 0.07540355691504329 0.07540355691504329 0.07540355691504329 -28.089 40.2851 28.9071 0.02416039278857486 0.02416039278857486 0.02416039278857486 -27.089 39.2851 29.9071 0.4997689802162751 0.4997689802162751 0.4997689802162751 -27.089 39.2851 30.9071 0.2515526986662552 0.2515526986662552 0.2515526986662552 -27.089 40.2851 29.9071 0.3093109729223962 0.3093109729223962 0.3093109729223962 -27.089 40.2851 30.9071 0.2922879304902816 0.2922879304902816 0.2922879304902816 -28.089 39.2851 29.9071 0.19145627043321614 0.19145627043321614 0.19145627043321614 -28.089 39.2851 30.9071 0.0 0.0 0.0 -28.089 40.2851 29.9071 0.2109751102766424 0.2109751102766424 0.2109751102766424 -28.089 40.2851 30.9071 0.0 0.0 0.0 -27.089 41.2851 27.9071 0.036388711926394306 0.036388711926394306 0.036388711926394306 -27.089 41.2851 28.9071 0.0 0.0 0.0 -27.089 42.2851 27.9071 0.0 0.0 0.0 -27.089 42.2851 28.9071 0.0 0.0 0.0 -28.089 41.2851 28.9071 0.0 0.0 0.0 -28.089 42.2851 27.9071 0.0 0.0 0.0 -28.089 42.2851 28.9071 0.0 0.0 0.0 -28.089 41.2851 29.9071 0.05070151413246919 0.05070151413246919 0.05070151413246919 -28.089 41.2851 30.9071 0.5401883516398739 0.5401883516398739 0.5401883516398739 -28.089 42.2851 29.9071 0.0 0.0 0.0 -28.089 42.2851 30.9071 0.0 0.0 0.0 -25.089 39.2851 31.9071 0.1932545355836742 0.1932545355836742 0.1932545355836742 -26.089 39.2851 31.9071 0.0 0.0 0.0 -27.089 39.2851 31.9071 0.0 0.0 0.0 -28.089 39.2851 31.9071 0.0 0.0 0.0 -28.089 39.2851 32.9071 0.0 0.0 0.0 -28.089 40.2851 31.9071 0.7036553404458794 0.7036553404458794 0.7036553404458794 -28.089 40.2851 32.9071 0.2540886819362373 0.2540886819362373 0.2540886819362373 -28.089 39.2851 33.9071 0.48233796002153645 0.48233796002153645 0.48233796002153645 -28.089 41.2851 31.9071 0.16290047159045415 0.16290047159045415 0.16290047159045415 -28.089 41.2851 32.9071 0.0 0.0 0.0 -28.089 42.2851 31.9071 0.0063160974719045655 0.0063160974719045655 0.0063160974719045655 -29.089 35.2851 27.9071 0.0 0.0 0.0 -29.089 36.2851 27.9071 0.0 0.0 0.0 -29.089 36.2851 28.9071 0.0 0.0 0.0 -30.089 36.2851 27.9071 0.0 0.0 0.0 -30.089 36.2851 28.9071 0.0 0.0 0.0 -30.089 36.2851 30.9071 0.0 0.0 0.0 -29.089 37.2851 27.9071 0.0 0.0 0.0 -29.089 37.2851 28.9071 0.0 0.0 0.0 -30.089 37.2851 27.9071 0.04679565634452374 0.04679565634452374 0.04679565634452374 -30.089 37.2851 28.9071 0.0 0.0 0.0 -30.089 38.2851 28.9071 0.0 0.0 0.0 -29.089 37.2851 30.9071 0.04545020693079536 0.04545020693079536 0.04545020693079536 -29.089 38.2851 29.9071 0.0 0.0 0.0 -29.089 38.2851 30.9071 0.0 0.0 0.0 -30.089 37.2851 29.9071 0.0 0.0 0.0 -30.089 37.2851 30.9071 0.0 0.0 0.0 -30.089 38.2851 29.9071 0.0 0.0 0.0 -30.089 38.2851 30.9071 0.0 0.0 0.0 -31.089 35.2851 27.9071 0.0722227087464026 0.0722227087464026 0.0722227087464026 -31.089 35.2851 28.9071 0.0 0.0 0.0 -31.089 36.2851 27.9071 0.0 0.0 0.0 -31.089 36.2851 28.9071 0.03643150995351159 0.03643150995351159 0.03643150995351159 -32.089 35.2851 27.9071 0.07108488523983336 0.07108488523983336 0.07108488523983336 -32.089 35.2851 28.9071 0.03900913499572431 0.03900913499572431 0.03900913499572431 -32.089 36.2851 27.9071 0.02851346664566316 0.02851346664566316 0.02851346664566316 -32.089 36.2851 28.9071 0.0 0.0 0.0 -31.089 36.2851 30.9071 0.0 0.0 0.0 -31.089 37.2851 27.9071 0.0 0.0 0.0 -31.089 37.2851 28.9071 0.0 0.0 0.0 -31.089 38.2851 27.9071 0.05853441858870337 0.05853441858870337 0.05853441858870337 -31.089 38.2851 28.9071 0.0 0.0 0.0 -32.089 37.2851 27.9071 0.0 0.0 0.0 -32.089 37.2851 28.9071 0.0 0.0 0.0 -32.089 38.2851 27.9071 0.0 0.0 0.0 -32.089 38.2851 28.9071 0.0 0.0 0.0 -31.089 37.2851 29.9071 0.06411673511917886 0.06411673511917886 0.06411673511917886 -31.089 37.2851 30.9071 0.0979410709200679 0.0979410709200679 0.0979410709200679 -31.089 38.2851 29.9071 0.0874888421976422 0.0874888421976422 0.0874888421976422 -31.089 38.2851 30.9071 0.2156147524293934 0.2156147524293934 0.2156147524293934 -32.089 37.2851 30.9071 0.04303147267320753 0.04303147267320753 0.04303147267320753 -32.089 38.2851 29.9071 0.0 0.0 0.0 -32.089 38.2851 30.9071 0.0 0.0 0.0 -29.089 35.2851 32.9071 0.0 0.0 0.0 -29.089 36.2851 31.9071 0.0 0.0 0.0 -29.089 36.2851 32.9071 0.0 0.0 0.0 -30.089 35.2851 31.9071 0.0 0.0 0.0 -30.089 35.2851 32.9071 0.26982167402728013 0.26982167402728013 0.26982167402728013 -30.089 36.2851 31.9071 0.0 0.0 0.0 -30.089 36.2851 32.9071 0.2559265914895766 0.2559265914895766 0.2559265914895766 -29.089 35.2851 33.9071 0.0 0.0 0.0 -29.089 36.2851 33.9071 0.0 0.0 0.0 -30.089 35.2851 33.9071 0.36130600018041353 0.36130600018041353 0.36130600018041353 -30.089 36.2851 33.9071 0.0 0.0 0.0 -29.089 37.2851 31.9071 0.0043281246399272345 0.0043281246399272345 0.0043281246399272345 -29.089 37.2851 32.9071 0.3798317950563266 0.3798317950563266 0.3798317950563266 -29.089 38.2851 31.9071 0.09101650393592915 0.09101650393592915 0.09101650393592915 -30.089 37.2851 31.9071 0.012955799754547031 0.012955799754547031 0.012955799754547031 -30.089 37.2851 32.9071 0.3011809923590438 0.3011809923590438 0.3011809923590438 -30.089 38.2851 31.9071 0.039332925050693864 0.039332925050693864 0.039332925050693864 -29.089 37.2851 33.9071 0.38425244705641415 0.38425244705641415 0.38425244705641415 -29.089 37.2851 34.9071 0.0 0.0 0.0 -29.089 38.2851 33.9071 0.2668036863485195 0.2668036863485195 0.2668036863485195 -30.089 37.2851 33.9071 0.2605511235328262 0.2605511235328262 0.2605511235328262 -30.089 37.2851 34.9071 0.11498189815338487 0.11498189815338487 0.11498189815338487 -30.089 38.2851 33.9071 0.0 0.0 0.0 -31.089 35.2851 31.9071 0.0 0.0 0.0 -31.089 35.2851 32.9071 0.034559359270027096 0.034559359270027096 0.034559359270027096 -31.089 36.2851 31.9071 0.0 0.0 0.0 -31.089 36.2851 32.9071 0.05631133180837013 0.05631133180837013 0.05631133180837013 -32.089 35.2851 31.9071 0.0 0.0 0.0 -32.089 35.2851 32.9071 0.003681375375060626 0.003681375375060626 0.003681375375060626 -32.089 36.2851 31.9071 0.00974969806828263 0.00974969806828263 0.00974969806828263 -32.089 36.2851 32.9071 0.04621571128341456 0.04621571128341456 0.04621571128341456 -31.089 35.2851 33.9071 0.0 0.0 0.0 -31.089 35.2851 34.9071 0.0 0.0 0.0 -31.089 36.2851 33.9071 0.0 0.0 0.0 -31.089 36.2851 34.9071 0.0 0.0 0.0 -32.089 35.2851 34.9071 0.13399479142320753 0.13399479142320753 0.13399479142320753 -32.089 36.2851 33.9071 0.11851216480641205 0.11851216480641205 0.11851216480641205 -32.089 36.2851 34.9071 0.2075407503595056 0.2075407503595056 0.2075407503595056 -31.089 37.2851 31.9071 0.23775434871090703 0.23775434871090703 0.23775434871090703 -31.089 37.2851 32.9071 0.06705362310687434 0.06705362310687434 0.06705362310687434 -31.089 38.2851 31.9071 0.2828677027898168 0.2828677027898168 0.2828677027898168 -31.089 38.2851 32.9071 0.0 0.0 0.0 -32.089 37.2851 31.9071 0.1332302465703837 0.1332302465703837 0.1332302465703837 -32.089 37.2851 32.9071 0.014813756471402241 0.014813756471402241 0.014813756471402241 -32.089 38.2851 31.9071 0.0 0.0 0.0 -32.089 38.2851 32.9071 0.035698395893019756 0.035698395893019756 0.035698395893019756 -31.089 37.2851 33.9071 0.0 0.0 0.0 -31.089 37.2851 34.9071 0.0 0.0 0.0 -31.089 38.2851 33.9071 0.13772849068850915 0.13772849068850915 0.13772849068850915 -32.089 37.2851 33.9071 0.18889307938774372 0.18889307938774372 0.18889307938774372 -32.089 37.2851 34.9071 0.0 0.0 0.0 -29.089 39.2851 28.9071 0.052284705015125894 0.052284705015125894 0.052284705015125894 -29.089 40.2851 28.9071 0.0 0.0 0.0 -30.089 39.2851 28.9071 0.05324919564198238 0.05324919564198238 0.05324919564198238 -30.089 40.2851 27.9071 0.1806244729716935 0.1806244729716935 0.1806244729716935 -30.089 40.2851 28.9071 0.0011102372474821836 0.0011102372474821836 0.0011102372474821836 -29.089 39.2851 29.9071 0.0 0.0 0.0 -29.089 39.2851 30.9071 0.0 0.0 0.0 -29.089 40.2851 29.9071 0.07468989182881718 0.07468989182881718 0.07468989182881718 -29.089 40.2851 30.9071 0.0 0.0 0.0 -30.089 39.2851 29.9071 0.007505006429664137 0.007505006429664137 0.007505006429664137 -30.089 39.2851 30.9071 0.0 0.0 0.0 -30.089 40.2851 29.9071 0.0 0.0 0.0 -30.089 41.2851 27.9071 0.23186819624887411 0.23186819624887411 0.23186819624887411 -30.089 41.2851 28.9071 0.0 0.0 0.0 -30.089 42.2851 28.9071 0.0 0.0 0.0 -29.089 41.2851 29.9071 0.0 0.0 0.0 -29.089 41.2851 30.9071 0.0 0.0 0.0 -29.089 42.2851 29.9071 0.0 0.0 0.0 -29.089 42.2851 30.9071 0.0 0.0 0.0 -30.089 41.2851 29.9071 0.0 0.0 0.0 -30.089 42.2851 29.9071 0.0 0.0 0.0 -30.089 42.2851 30.9071 0.0 0.0 0.0 -31.089 39.2851 27.9071 0.0 0.0 0.0 -31.089 39.2851 28.9071 0.009565999554193556 0.009565999554193556 0.009565999554193556 -31.089 40.2851 27.9071 0.0 0.0 0.0 -31.089 40.2851 28.9071 0.0014638965750631986 0.0014638965750631986 0.0014638965750631986 -32.089 40.2851 28.9071 0.03476024535424914 0.03476024535424914 0.03476024535424914 -31.089 39.2851 29.9071 0.0 0.0 0.0 -31.089 39.2851 30.9071 0.11982185438505007 0.11982185438505007 0.11982185438505007 -31.089 40.2851 29.9071 0.0 0.0 0.0 -31.089 40.2851 30.9071 0.0 0.0 0.0 -32.089 40.2851 29.9071 0.0 0.0 0.0 -31.089 41.2851 27.9071 0.0 0.0 0.0 -31.089 41.2851 28.9071 0.10869992410584849 0.10869992410584849 0.10869992410584849 -31.089 42.2851 27.9071 0.32320015247141837 0.32320015247141837 0.32320015247141837 -31.089 42.2851 28.9071 0.0 0.0 0.0 -32.089 41.2851 27.9071 0.0 0.0 0.0 -32.089 41.2851 28.9071 0.18942821886011216 0.18942821886011216 0.18942821886011216 -32.089 42.2851 27.9071 0.0 0.0 0.0 -32.089 42.2851 28.9071 0.0 0.0 0.0 -31.089 41.2851 29.9071 0.005336725938170813 0.005336725938170813 0.005336725938170813 -31.089 41.2851 30.9071 0.0 0.0 0.0 -31.089 42.2851 29.9071 0.03399383739035756 0.03399383739035756 0.03399383739035756 -31.089 42.2851 30.9071 0.0 0.0 0.0 -32.089 41.2851 29.9071 0.0 0.0 0.0 -32.089 41.2851 30.9071 0.0 0.0 0.0 -29.089 39.2851 31.9071 0.0 0.0 0.0 -29.089 40.2851 31.9071 0.6779433349120028 0.6779433349120028 0.6779433349120028 -29.089 40.2851 32.9071 0.0 0.0 0.0 -29.089 39.2851 33.9071 0.0 0.0 0.0 -29.089 40.2851 33.9071 0.0 0.0 0.0 -30.089 39.2851 33.9071 0.0 0.0 0.0 -30.089 40.2851 33.9071 0.0 0.0 0.0 -29.089 41.2851 31.9071 0.693879418960848 0.693879418960848 0.693879418960848 -29.089 41.2851 32.9071 0.0 0.0 0.0 -29.089 42.2851 31.9071 0.0 0.0 0.0 -29.089 42.2851 32.9071 0.0 0.0 0.0 -30.089 41.2851 32.9071 0.0 0.0 0.0 -30.089 42.2851 31.9071 0.0 0.0 0.0 -30.089 42.2851 32.9071 0.0 0.0 0.0 -30.089 41.2851 33.9071 0.09717588104652637 0.09717588104652637 0.09717588104652637 -31.089 39.2851 32.9071 0.0 0.0 0.0 -32.089 39.2851 32.9071 0.0 0.0 0.0 -32.089 40.2851 32.9071 0.0 0.0 0.0 -31.089 39.2851 33.9071 0.2951267047945259 0.2951267047945259 0.2951267047945259 -31.089 40.2851 33.9071 0.0 0.0 0.0 -32.089 39.2851 33.9071 0.0 0.0 0.0 -32.089 40.2851 33.9071 0.30218533221491206 0.30218533221491206 0.30218533221491206 -31.089 41.2851 31.9071 0.0 0.0 0.0 -31.089 41.2851 32.9071 0.15269102061186351 0.15269102061186351 0.15269102061186351 -31.089 42.2851 31.9071 0.0 0.0 0.0 -31.089 42.2851 32.9071 0.02932006998038547 0.02932006998038547 0.02932006998038547 -32.089 41.2851 31.9071 0.0 0.0 0.0 -32.089 41.2851 32.9071 0.14330847737573488 0.14330847737573488 0.14330847737573488 -31.089 41.2851 33.9071 0.0 0.0 0.0 -25.089 35.2851 35.9071 0.0 0.0 0.0 -25.089 35.2851 36.9071 0.0014575396765215878 0.0014575396765215878 0.0014575396765215878 -25.089 36.2851 35.9071 0.15318718601225204 0.15318718601225204 0.15318718601225204 -25.089 36.2851 36.9071 0.13464194485321615 0.13464194485321615 0.13464194485321615 -26.089 36.2851 36.9071 0.0009995504449454233 0.0009995504449454233 0.0009995504449454233 -25.089 35.2851 37.9071 0.003386298090171601 0.003386298090171601 0.003386298090171601 -25.089 35.2851 38.9071 0.0 0.0 0.0 -25.089 36.2851 37.9071 0.0 0.0 0.0 -25.089 36.2851 38.9071 0.0 0.0 0.0 -26.089 36.2851 37.9071 0.0 0.0 0.0 -25.089 37.2851 35.9071 0.04007748088613932 0.04007748088613932 0.04007748088613932 -25.089 37.2851 36.9071 0.0 0.0 0.0 -26.089 37.2851 35.9071 0.0 0.0 0.0 -26.089 37.2851 36.9071 0.0 0.0 0.0 -25.089 37.2851 37.9071 0.0 0.0 0.0 -25.089 37.2851 38.9071 0.10129714649691529 0.10129714649691529 0.10129714649691529 -26.089 37.2851 37.9071 0.06379044618933277 0.06379044618933277 0.06379044618933277 -26.089 37.2851 38.9071 0.30927797428364623 0.30927797428364623 0.30927797428364623 -27.089 35.2851 36.9071 0.0 0.0 0.0 -27.089 36.2851 35.9071 0.0 0.0 0.0 -27.089 36.2851 36.9071 0.0 0.0 0.0 -28.089 35.2851 35.9071 0.22037176872519723 0.22037176872519723 0.22037176872519723 -28.089 35.2851 36.9071 0.0 0.0 0.0 -28.089 36.2851 35.9071 0.21347368187890048 0.21347368187890048 0.21347368187890048 -28.089 36.2851 36.9071 0.17080494768521406 0.17080494768521406 0.17080494768521406 -27.089 35.2851 37.9071 0.0 0.0 0.0 -27.089 36.2851 37.9071 0.0 0.0 0.0 -27.089 36.2851 38.9071 0.17652262599622312 0.17652262599622312 0.17652262599622312 -28.089 35.2851 37.9071 0.16369849442380996 0.16369849442380996 0.16369849442380996 -28.089 35.2851 38.9071 0.17861028350370217 0.17861028350370217 0.17861028350370217 -28.089 36.2851 37.9071 0.0 0.0 0.0 -28.089 36.2851 38.9071 0.150191698563846 0.150191698563846 0.150191698563846 -27.089 37.2851 35.9071 0.0 0.0 0.0 -27.089 37.2851 36.9071 0.06200215999044904 0.06200215999044904 0.06200215999044904 -28.089 37.2851 35.9071 0.0 0.0 0.0 -28.089 37.2851 36.9071 0.35122597046617965 0.35122597046617965 0.35122597046617965 -27.089 37.2851 37.9071 0.0 0.0 0.0 -27.089 37.2851 38.9071 0.18156645332061477 0.18156645332061477 0.18156645332061477 -25.089 35.2851 39.9071 0.0 0.0 0.0 -25.089 35.2851 40.9071 0.0 0.0 0.0 -25.089 36.2851 39.9071 0.0 0.0 0.0 -26.089 35.2851 39.9071 0.0 0.0 0.0 -26.089 36.2851 39.9071 0.043895631661026606 0.043895631661026606 0.043895631661026606 -25.089 37.2851 39.9071 0.26033736956452974 0.26033736956452974 0.26033736956452974 -26.089 37.2851 39.9071 0.0 0.0 0.0 -27.089 35.2851 39.9071 0.31878591652198024 0.31878591652198024 0.31878591652198024 -27.089 36.2851 39.9071 0.0 0.0 0.0 -28.089 35.2851 39.9071 0.14528695009165535 0.14528695009165535 0.14528695009165535 -28.089 36.2851 39.9071 0.0 0.0 0.0 -27.089 37.2851 39.9071 0.11209691855062241 0.11209691855062241 0.11209691855062241 -29.089 35.2851 35.9071 0.0 0.0 0.0 -29.089 35.2851 36.9071 0.2906002345987944 0.2906002345987944 0.2906002345987944 -29.089 36.2851 36.9071 0.13260057717974247 0.13260057717974247 0.13260057717974247 -30.089 35.2851 36.9071 0.0866593694221816 0.0866593694221816 0.0866593694221816 -30.089 36.2851 36.9071 0.07559550237776465 0.07559550237776465 0.07559550237776465 -29.089 37.2851 35.9071 0.0 0.0 0.0 -29.089 37.2851 36.9071 0.0 0.0 0.0 -30.089 37.2851 35.9071 0.0 0.0 0.0 -30.089 37.2851 36.9071 0.01733148635238967 0.01733148635238967 0.01733148635238967 -31.089 35.2851 35.9071 0.2766700592976308 0.2766700592976308 0.2766700592976308 -31.089 35.2851 36.9071 0.07178129073413426 0.07178129073413426 0.07178129073413426 -31.089 36.2851 35.9071 0.2814435569047934 0.2814435569047934 0.2814435569047934 -31.089 36.2851 36.9071 0.0 0.0 0.0 -31.089 37.2851 35.9071 0.0 0.0 0.0 -31.089 37.2851 36.9071 0.12423561132301425 0.12423561132301425 0.12423561132301425 -33.089 27.2851 27.9071 0.07271759727382843 0.07271759727382843 0.07271759727382843 -33.089 27.2851 28.9071 0.007359466775444126 0.007359466775444126 0.007359466775444126 -33.089 28.2851 27.9071 0.0 0.0 0.0 -33.089 28.2851 28.9071 0.0 0.0 0.0 -34.089 27.2851 27.9071 0.0 0.0 0.0 -34.089 27.2851 28.9071 0.0336514878896656 0.0336514878896656 0.0336514878896656 -34.089 28.2851 27.9071 0.0 0.0 0.0 -33.089 27.2851 29.9071 0.09337443764646601 0.09337443764646601 0.09337443764646601 -33.089 27.2851 30.9071 0.0 0.0 0.0 -33.089 28.2851 29.9071 0.0 0.0 0.0 -34.089 27.2851 29.9071 0.0 0.0 0.0 -34.089 27.2851 30.9071 0.0 0.0 0.0 -34.089 28.2851 30.9071 0.0 0.0 0.0 -33.089 29.2851 27.9071 0.0368300289723685 0.0368300289723685 0.0368300289723685 -33.089 29.2851 28.9071 0.0 0.0 0.0 -33.089 30.2851 27.9071 0.026316635459979427 0.026316635459979427 0.026316635459979427 -33.089 30.2851 28.9071 0.03270033645273399 0.03270033645273399 0.03270033645273399 -34.089 30.2851 28.9071 0.0 0.0 0.0 -33.089 29.2851 29.9071 0.0 0.0 0.0 -33.089 30.2851 29.9071 0.0 0.0 0.0 -35.089 27.2851 27.9071 0.05108571357751305 0.05108571357751305 0.05108571357751305 -35.089 27.2851 28.9071 0.014645634782838677 0.014645634782838677 0.014645634782838677 -35.089 28.2851 27.9071 0.0 0.0 0.0 -36.089 27.2851 27.9071 0.0 0.0 0.0 -36.089 28.2851 27.9071 0.0 0.0 0.0 -35.089 27.2851 29.9071 0.0 0.0 0.0 -35.089 27.2851 30.9071 0.021516286158108196 0.021516286158108196 0.021516286158108196 -35.089 28.2851 29.9071 0.0 0.0 0.0 -35.089 28.2851 30.9071 0.0 0.0 0.0 -36.089 27.2851 30.9071 0.0 0.0 0.0 -36.089 28.2851 30.9071 0.0 0.0 0.0 -35.089 30.2851 27.9071 0.0 0.0 0.0 -35.089 30.2851 28.9071 0.0 0.0 0.0 -36.089 29.2851 27.9071 0.0 0.0 0.0 -36.089 30.2851 27.9071 0.0 0.0 0.0 -36.089 30.2851 28.9071 0.0 0.0 0.0 -35.089 29.2851 30.9071 0.0 0.0 0.0 -35.089 30.2851 29.9071 0.0 0.0 0.0 -35.089 30.2851 30.9071 0.0 0.0 0.0 -36.089 29.2851 30.9071 0.03819526793295459 0.03819526793295459 0.03819526793295459 -36.089 30.2851 29.9071 0.02487662822644414 0.02487662822644414 0.02487662822644414 -36.089 30.2851 30.9071 0.0 0.0 0.0 -33.089 27.2851 31.9071 0.0 0.0 0.0 -33.089 27.2851 32.9071 0.010794565696699288 0.010794565696699288 0.010794565696699288 -33.089 28.2851 32.9071 0.0 0.0 0.0 -34.089 27.2851 31.9071 0.07214852654114573 0.07214852654114573 0.07214852654114573 -34.089 27.2851 32.9071 0.09812914391554557 0.09812914391554557 0.09812914391554557 -34.089 28.2851 31.9071 0.0 0.0 0.0 -34.089 28.2851 32.9071 0.0 0.0 0.0 -33.089 28.2851 33.9071 0.0 0.0 0.0 -33.089 28.2851 34.9071 0.0 0.0 0.0 -34.089 27.2851 33.9071 0.001663371762591697 0.001663371762591697 0.001663371762591697 -34.089 27.2851 34.9071 0.04823454968472727 0.04823454968472727 0.04823454968472727 -34.089 28.2851 33.9071 0.0 0.0 0.0 -34.089 28.2851 34.9071 0.0 0.0 0.0 -34.089 29.2851 31.9071 0.0 0.0 0.0 -34.089 29.2851 32.9071 0.0 0.0 0.0 -34.089 30.2851 31.9071 0.0 0.0 0.0 -34.089 30.2851 32.9071 0.0 0.0 0.0 -33.089 29.2851 34.9071 0.0 0.0 0.0 -33.089 30.2851 34.9071 0.0 0.0 0.0 -34.089 29.2851 34.9071 0.0 0.0 0.0 -35.089 27.2851 31.9071 0.0 0.0 0.0 -35.089 27.2851 32.9071 0.0 0.0 0.0 -35.089 28.2851 31.9071 0.0 0.0 0.0 -35.089 28.2851 32.9071 0.025565878862014932 0.025565878862014932 0.025565878862014932 -36.089 27.2851 31.9071 0.0 0.0 0.0 -36.089 27.2851 32.9071 0.0 0.0 0.0 -36.089 28.2851 32.9071 0.0 0.0 0.0 -35.089 27.2851 33.9071 0.0006643216649162342 0.0006643216649162342 0.0006643216649162342 -35.089 27.2851 34.9071 0.009386841551959593 0.009386841551959593 0.009386841551959593 -35.089 28.2851 33.9071 0.038244193415143644 0.038244193415143644 0.038244193415143644 -35.089 28.2851 34.9071 0.0 0.0 0.0 -36.089 27.2851 33.9071 0.05091347456258119 0.05091347456258119 0.05091347456258119 -36.089 27.2851 34.9071 0.0 0.0 0.0 -36.089 28.2851 33.9071 0.12390436776639084 0.12390436776639084 0.12390436776639084 -36.089 28.2851 34.9071 0.0 0.0 0.0 -35.089 29.2851 31.9071 0.0 0.0 0.0 -35.089 29.2851 32.9071 0.0 0.0 0.0 -35.089 30.2851 31.9071 0.3152752744762022 0.3152752744762022 0.3152752744762022 -35.089 30.2851 32.9071 0.0 0.0 0.0 -36.089 29.2851 32.9071 0.0 0.0 0.0 -36.089 30.2851 31.9071 0.0 0.0 0.0 -36.089 30.2851 32.9071 0.0 0.0 0.0 -36.089 29.2851 33.9071 0.0 0.0 0.0 -36.089 30.2851 33.9071 0.0 0.0 0.0 -36.089 30.2851 34.9071 0.0 0.0 0.0 -33.089 31.2851 27.9071 0.0017237160761529246 0.0017237160761529246 0.0017237160761529246 -33.089 31.2851 28.9071 0.011773167163181192 0.011773167163181192 0.011773167163181192 -33.089 32.2851 27.9071 0.028873139540443318 0.028873139540443318 0.028873139540443318 -33.089 32.2851 28.9071 0.0 0.0 0.0 -34.089 31.2851 27.9071 0.0 0.0 0.0 -34.089 31.2851 28.9071 0.019259636763246 0.019259636763246 0.019259636763246 -34.089 32.2851 27.9071 0.012380268424701201 0.012380268424701201 0.012380268424701201 -34.089 32.2851 28.9071 0.09204658678994432 0.09204658678994432 0.09204658678994432 -33.089 31.2851 29.9071 0.03009439517119493 0.03009439517119493 0.03009439517119493 -33.089 31.2851 30.9071 0.0 0.0 0.0 -33.089 32.2851 29.9071 0.030881768483534987 0.030881768483534987 0.030881768483534987 -33.089 32.2851 30.9071 0.0 0.0 0.0 -34.089 31.2851 29.9071 0.014868306334446784 0.014868306334446784 0.014868306334446784 -34.089 31.2851 30.9071 0.0 0.0 0.0 -34.089 32.2851 30.9071 0.11846676609955 0.11846676609955 0.11846676609955 -33.089 33.2851 27.9071 0.0 0.0 0.0 -33.089 33.2851 28.9071 0.04291177209122512 0.04291177209122512 0.04291177209122512 -33.089 34.2851 27.9071 0.0 0.0 0.0 -33.089 34.2851 28.9071 0.0 0.0 0.0 -34.089 33.2851 27.9071 0.01796375470749882 0.01796375470749882 0.01796375470749882 -34.089 33.2851 28.9071 0.12359731976677539 0.12359731976677539 0.12359731976677539 -34.089 34.2851 27.9071 0.0 0.0 0.0 -34.089 34.2851 28.9071 0.0010408503445430992 0.0010408503445430992 0.0010408503445430992 -33.089 33.2851 29.9071 0.0 0.0 0.0 -33.089 33.2851 30.9071 0.0 0.0 0.0 -33.089 34.2851 29.9071 0.0 0.0 0.0 -34.089 33.2851 30.9071 0.09172110591667038 0.09172110591667038 0.09172110591667038 -35.089 31.2851 27.9071 0.0 0.0 0.0 -35.089 31.2851 28.9071 0.0 0.0 0.0 -35.089 32.2851 27.9071 0.0 0.0 0.0 -35.089 32.2851 28.9071 0.0 0.0 0.0 -36.089 31.2851 27.9071 0.0 0.0 0.0 -36.089 31.2851 28.9071 0.05652475495449448 0.05652475495449448 0.05652475495449448 -36.089 32.2851 27.9071 0.0 0.0 0.0 -36.089 32.2851 28.9071 0.0 0.0 0.0 -35.089 31.2851 29.9071 0.14722525538499084 0.14722525538499084 0.14722525538499084 -35.089 31.2851 30.9071 0.2618165557369534 0.2618165557369534 0.2618165557369534 -35.089 32.2851 30.9071 0.0 0.0 0.0 -36.089 31.2851 29.9071 0.2487361745222446 0.2487361745222446 0.2487361745222446 -36.089 31.2851 30.9071 0.12243350226213093 0.12243350226213093 0.12243350226213093 -36.089 32.2851 29.9071 0.0 0.0 0.0 -36.089 32.2851 30.9071 0.02355194389553235 0.02355194389553235 0.02355194389553235 -35.089 34.2851 27.9071 0.0 0.0 0.0 -35.089 34.2851 28.9071 0.0 0.0 0.0 -36.089 34.2851 27.9071 0.0 0.0 0.0 -36.089 33.2851 30.9071 0.05693085777515789 0.05693085777515789 0.05693085777515789 -36.089 34.2851 29.9071 0.054553868213013945 0.054553868213013945 0.054553868213013945 -36.089 34.2851 30.9071 0.07123435792962694 0.07123435792962694 0.07123435792962694 -33.089 31.2851 31.9071 0.0 0.0 0.0 -33.089 31.2851 32.9071 0.444606072242449 0.444606072242449 0.444606072242449 -33.089 32.2851 31.9071 0.0 0.0 0.0 -33.089 32.2851 32.9071 0.0 0.0 0.0 -34.089 31.2851 31.9071 0.4562979775766374 0.4562979775766374 0.4562979775766374 -34.089 31.2851 32.9071 0.28837683221460025 0.28837683221460025 0.28837683221460025 -34.089 32.2851 31.9071 0.0 0.0 0.0 -34.089 32.2851 32.9071 0.0 0.0 0.0 -33.089 31.2851 33.9071 0.6098197687311656 0.6098197687311656 0.6098197687311656 -33.089 31.2851 34.9071 0.0 0.0 0.0 -33.089 32.2851 33.9071 0.28086833119875837 0.28086833119875837 0.28086833119875837 -34.089 31.2851 34.9071 0.14304455629258087 0.14304455629258087 0.14304455629258087 -34.089 32.2851 33.9071 0.3744675602395124 0.3744675602395124 0.3744675602395124 -34.089 32.2851 34.9071 0.0 0.0 0.0 -33.089 33.2851 31.9071 0.0 0.0 0.0 -33.089 33.2851 32.9071 0.0 0.0 0.0 -33.089 34.2851 31.9071 0.0 0.0 0.0 -33.089 34.2851 32.9071 0.0 0.0 0.0 -34.089 33.2851 31.9071 0.0 0.0 0.0 -34.089 33.2851 32.9071 0.0 0.0 0.0 -34.089 34.2851 32.9071 0.04009214043286473 0.04009214043286473 0.04009214043286473 -33.089 33.2851 33.9071 0.2288522796892108 0.2288522796892108 0.2288522796892108 -33.089 34.2851 33.9071 0.0 0.0 0.0 -33.089 34.2851 34.9071 0.0 0.0 0.0 -34.089 33.2851 33.9071 0.23276767837896764 0.23276767837896764 0.23276767837896764 -34.089 33.2851 34.9071 0.0 0.0 0.0 -34.089 34.2851 33.9071 0.0 0.0 0.0 -34.089 34.2851 34.9071 0.0 0.0 0.0 -35.089 31.2851 31.9071 0.0 0.0 0.0 -35.089 32.2851 31.9071 0.0 0.0 0.0 -35.089 32.2851 32.9071 0.0 0.0 0.0 -36.089 31.2851 31.9071 0.11062412777742389 0.11062412777742389 0.11062412777742389 -36.089 31.2851 32.9071 0.05700390849665967 0.05700390849665967 0.05700390849665967 -36.089 32.2851 31.9071 0.0 0.0 0.0 -36.089 32.2851 32.9071 0.0 0.0 0.0 -35.089 31.2851 34.9071 0.0 0.0 0.0 -35.089 32.2851 34.9071 0.0 0.0 0.0 -36.089 31.2851 33.9071 0.0 0.0 0.0 -36.089 31.2851 34.9071 0.12916077351070898 0.12916077351070898 0.12916077351070898 -36.089 32.2851 33.9071 0.057249696055688463 0.057249696055688463 0.057249696055688463 -36.089 32.2851 34.9071 0.0 0.0 0.0 -35.089 33.2851 31.9071 0.30514232649800993 0.30514232649800993 0.30514232649800993 -35.089 33.2851 32.9071 0.35093928335716706 0.35093928335716706 0.35093928335716706 -35.089 34.2851 31.9071 0.03494936284508861 0.03494936284508861 0.03494936284508861 -36.089 33.2851 31.9071 0.0 0.0 0.0 -36.089 33.2851 32.9071 0.2090490710133024 0.2090490710133024 0.2090490710133024 -36.089 34.2851 31.9071 0.0 0.0 0.0 -36.089 34.2851 32.9071 0.0 0.0 0.0 -35.089 33.2851 33.9071 0.11064146551259174 0.11064146551259174 0.11064146551259174 -35.089 33.2851 34.9071 0.0 0.0 0.0 -35.089 34.2851 33.9071 0.018939965830835175 0.018939965830835175 0.018939965830835175 -35.089 34.2851 34.9071 0.0 0.0 0.0 -36.089 33.2851 33.9071 0.15855647323937916 0.15855647323937916 0.15855647323937916 -36.089 33.2851 34.9071 0.0 0.0 0.0 -36.089 34.2851 33.9071 0.0 0.0 0.0 -36.089 34.2851 34.9071 0.18724327621798273 0.18724327621798273 0.18724327621798273 -37.089 27.2851 27.9071 0.0 0.0 0.0 -37.089 28.2851 27.9071 0.0 0.0 0.0 -37.089 28.2851 28.9071 0.0 0.0 0.0 -38.089 28.2851 27.9071 0.0 0.0 0.0 -38.089 28.2851 28.9071 0.0 0.0 0.0 -37.089 27.2851 30.9071 0.0 0.0 0.0 -37.089 28.2851 30.9071 0.0601419561584094 0.0601419561584094 0.0601419561584094 -38.089 28.2851 29.9071 0.0 0.0 0.0 -38.089 28.2851 30.9071 0.0009942187016272269 0.0009942187016272269 0.0009942187016272269 -37.089 29.2851 27.9071 0.0 0.0 0.0 -37.089 29.2851 28.9071 0.0 0.0 0.0 -37.089 30.2851 27.9071 0.0 0.0 0.0 -37.089 30.2851 28.9071 0.0 0.0 0.0 -38.089 29.2851 27.9071 0.0 0.0 0.0 -38.089 29.2851 28.9071 0.0 0.0 0.0 -38.089 30.2851 27.9071 0.0 0.0 0.0 -38.089 30.2851 28.9071 0.0 0.0 0.0 -37.089 29.2851 29.9071 0.012159699008548377 0.012159699008548377 0.012159699008548377 -37.089 29.2851 30.9071 0.0 0.0 0.0 -37.089 30.2851 29.9071 0.17775501752450332 0.17775501752450332 0.17775501752450332 -37.089 30.2851 30.9071 0.0 0.0 0.0 -38.089 29.2851 29.9071 0.0 0.0 0.0 -38.089 29.2851 30.9071 0.0 0.0 0.0 -38.089 30.2851 29.9071 0.0 0.0 0.0 -38.089 30.2851 30.9071 0.0 0.0 0.0 -39.089 27.2851 28.9071 0.0 0.0 0.0 -39.089 28.2851 28.9071 0.009590370975292391 0.009590370975292391 0.009590370975292391 -40.089 27.2851 27.9071 0.0 0.0 0.0 -40.089 27.2851 28.9071 0.0 0.0 0.0 -40.089 28.2851 27.9071 0.0 0.0 0.0 -40.089 28.2851 28.9071 0.0 0.0 0.0 -39.089 27.2851 29.9071 0.017414997408217683 0.017414997408217683 0.017414997408217683 -39.089 27.2851 30.9071 0.0 0.0 0.0 -39.089 28.2851 29.9071 0.0 0.0 0.0 -39.089 28.2851 30.9071 0.0 0.0 0.0 -40.089 27.2851 29.9071 0.0 0.0 0.0 -40.089 28.2851 29.9071 0.0 0.0 0.0 -39.089 29.2851 27.9071 0.0032282835742912194 0.0032282835742912194 0.0032282835742912194 -39.089 29.2851 28.9071 0.0 0.0 0.0 -40.089 29.2851 27.9071 0.0 0.0 0.0 -40.089 29.2851 28.9071 0.0 0.0 0.0 -37.089 27.2851 31.9071 0.0 0.0 0.0 -37.089 27.2851 32.9071 0.0 0.0 0.0 -37.089 28.2851 31.9071 0.0 0.0 0.0 -38.089 27.2851 31.9071 0.0 0.0 0.0 -38.089 27.2851 32.9071 0.0 0.0 0.0 -38.089 28.2851 31.9071 0.0 0.0 0.0 -37.089 28.2851 33.9071 0.13326669113851633 0.13326669113851633 0.13326669113851633 -37.089 28.2851 34.9071 0.0 0.0 0.0 -37.089 29.2851 32.9071 0.4698892975484041 0.4698892975484041 0.4698892975484041 -37.089 29.2851 33.9071 0.41831030902621263 0.41831030902621263 0.41831030902621263 -37.089 29.2851 34.9071 0.0 0.0 0.0 -37.089 30.2851 33.9071 0.0 0.0 0.0 -37.089 30.2851 34.9071 0.0 0.0 0.0 -39.089 27.2851 31.9071 0.0 0.0 0.0 -37.089 31.2851 27.9071 0.0 0.0 0.0 -37.089 31.2851 28.9071 0.0 0.0 0.0 -37.089 32.2851 27.9071 0.007879023975512935 0.007879023975512935 0.007879023975512935 -38.089 31.2851 27.9071 0.0 0.0 0.0 -38.089 31.2851 28.9071 0.07260978323014768 0.07260978323014768 0.07260978323014768 -38.089 32.2851 27.9071 0.0241178038152646 0.0241178038152646 0.0241178038152646 -38.089 32.2851 28.9071 0.11599632550127777 0.11599632550127777 0.11599632550127777 -37.089 31.2851 29.9071 0.11917847065602957 0.11917847065602957 0.11917847065602957 -37.089 31.2851 30.9071 0.33907402702037137 0.33907402702037137 0.33907402702037137 -37.089 32.2851 30.9071 0.34631429487434506 0.34631429487434506 0.34631429487434506 -38.089 31.2851 29.9071 0.0 0.0 0.0 -38.089 31.2851 30.9071 0.0 0.0 0.0 -38.089 32.2851 29.9071 0.0 0.0 0.0 -38.089 32.2851 30.9071 0.0 0.0 0.0 -37.089 34.2851 27.9071 0.0 0.0 0.0 -37.089 34.2851 28.9071 0.0 0.0 0.0 -38.089 33.2851 27.9071 0.07171430099395328 0.07171430099395328 0.07171430099395328 -38.089 33.2851 28.9071 0.0 0.0 0.0 -38.089 34.2851 27.9071 0.1174708400694207 0.1174708400694207 0.1174708400694207 -38.089 34.2851 28.9071 0.01636075440969828 0.01636075440969828 0.01636075440969828 -37.089 33.2851 29.9071 0.0 0.0 0.0 -37.089 33.2851 30.9071 0.0 0.0 0.0 -37.089 34.2851 29.9071 0.0 0.0 0.0 -37.089 34.2851 30.9071 0.0 0.0 0.0 -38.089 33.2851 29.9071 0.026124192437896352 0.026124192437896352 0.026124192437896352 -38.089 33.2851 30.9071 0.0 0.0 0.0 -38.089 34.2851 29.9071 0.0 0.0 0.0 -39.089 32.2851 28.9071 0.0 0.0 0.0 -39.089 31.2851 29.9071 0.10634589207862755 0.10634589207862755 0.10634589207862755 -39.089 32.2851 29.9071 0.09604296453043637 0.09604296453043637 0.09604296453043637 -39.089 33.2851 27.9071 0.007268885177396502 0.007268885177396502 0.007268885177396502 -39.089 33.2851 28.9071 0.06930954680019859 0.06930954680019859 0.06930954680019859 -39.089 34.2851 27.9071 0.0 0.0 0.0 -39.089 33.2851 29.9071 0.0 0.0 0.0 -37.089 31.2851 32.9071 0.0 0.0 0.0 -37.089 32.2851 32.9071 0.0 0.0 0.0 -37.089 31.2851 33.9071 0.0 0.0 0.0 -37.089 31.2851 34.9071 0.0 0.0 0.0 -37.089 32.2851 33.9071 0.18568499121021695 0.18568499121021695 0.18568499121021695 -37.089 34.2851 31.9071 0.0 0.0 0.0 -37.089 34.2851 32.9071 0.0 0.0 0.0 -37.089 34.2851 33.9071 0.41793816003540524 0.41793816003540524 0.41793816003540524 -34.089 28.2851 35.9071 0.0 0.0 0.0 -33.089 29.2851 35.9071 0.0 0.0 0.0 -33.089 30.2851 35.9071 0.017266067645702796 0.017266067645702796 0.017266067645702796 -34.089 29.2851 35.9071 0.0 0.0 0.0 -34.089 30.2851 35.9071 0.0430121629196398 0.0430121629196398 0.0430121629196398 -35.089 27.2851 35.9071 0.0 0.0 0.0 -35.089 28.2851 35.9071 0.0 0.0 0.0 -36.089 27.2851 35.9071 0.0 0.0 0.0 -36.089 28.2851 35.9071 0.0 0.0 0.0 -35.089 29.2851 35.9071 0.0 0.0 0.0 -35.089 30.2851 35.9071 0.0 0.0 0.0 -36.089 29.2851 35.9071 0.0 0.0 0.0 -36.089 30.2851 35.9071 0.10943180699333484 0.10943180699333484 0.10943180699333484 -33.089 31.2851 35.9071 0.0 0.0 0.0 -34.089 31.2851 35.9071 0.0 0.0 0.0 -35.089 31.2851 35.9071 0.0 0.0 0.0 -37.089 28.2851 35.9071 0.1397733642827927 0.1397733642827927 0.1397733642827927 -37.089 29.2851 35.9071 0.02791813978718708 0.02791813978718708 0.02791813978718708 -33.089 35.2851 27.9071 0.0 0.0 0.0 -33.089 35.2851 28.9071 0.0 0.0 0.0 -33.089 36.2851 27.9071 0.0 0.0 0.0 -33.089 36.2851 28.9071 0.0 0.0 0.0 -34.089 35.2851 27.9071 0.0 0.0 0.0 -34.089 35.2851 28.9071 0.04847325724583875 0.04847325724583875 0.04847325724583875 -34.089 36.2851 27.9071 0.01196755621483679 0.01196755621483679 0.01196755621483679 -34.089 36.2851 28.9071 0.05769649089026584 0.05769649089026584 0.05769649089026584 -33.089 35.2851 29.9071 0.0 0.0 0.0 -34.089 35.2851 29.9071 0.03881824927791116 0.03881824927791116 0.03881824927791116 -34.089 36.2851 29.9071 0.10028695044574752 0.10028695044574752 0.10028695044574752 -34.089 36.2851 30.9071 0.13279718761634446 0.13279718761634446 0.13279718761634446 -33.089 37.2851 27.9071 0.0 0.0 0.0 -33.089 37.2851 28.9071 0.0 0.0 0.0 -33.089 38.2851 27.9071 0.0 0.0 0.0 -33.089 38.2851 28.9071 0.0010397998377946005 0.0010397998377946005 0.0010397998377946005 -34.089 37.2851 28.9071 0.0 0.0 0.0 -34.089 38.2851 27.9071 0.0030216747602500684 0.0030216747602500684 0.0030216747602500684 -34.089 38.2851 28.9071 0.0 0.0 0.0 -33.089 37.2851 30.9071 0.06430263669155048 0.06430263669155048 0.06430263669155048 -33.089 38.2851 29.9071 0.09633053987875223 0.09633053987875223 0.09633053987875223 -33.089 38.2851 30.9071 0.0 0.0 0.0 -34.089 37.2851 29.9071 0.0 0.0 0.0 -34.089 37.2851 30.9071 0.022858322357061433 0.022858322357061433 0.022858322357061433 -34.089 38.2851 29.9071 0.0 0.0 0.0 -34.089 38.2851 30.9071 0.0 0.0 0.0 -35.089 35.2851 27.9071 0.028908830050684287 0.028908830050684287 0.028908830050684287 -35.089 35.2851 28.9071 0.0 0.0 0.0 -35.089 36.2851 27.9071 0.050416847387312475 0.050416847387312475 0.050416847387312475 -35.089 36.2851 28.9071 0.05572398208421938 0.05572398208421938 0.05572398208421938 -36.089 35.2851 27.9071 0.0 0.0 0.0 -36.089 35.2851 28.9071 0.029409053880220082 0.029409053880220082 0.029409053880220082 -36.089 36.2851 27.9071 0.0 0.0 0.0 -36.089 36.2851 28.9071 0.0 0.0 0.0 -35.089 35.2851 30.9071 0.08991548399778135 0.08991548399778135 0.08991548399778135 -35.089 36.2851 29.9071 0.0 0.0 0.0 -35.089 36.2851 30.9071 0.08270931695308534 0.08270931695308534 0.08270931695308534 -36.089 35.2851 29.9071 0.11454664157599323 0.11454664157599323 0.11454664157599323 -36.089 35.2851 30.9071 0.0 0.0 0.0 -36.089 36.2851 29.9071 0.05989182803846101 0.05989182803846101 0.05989182803846101 -36.089 36.2851 30.9071 0.06652001000810313 0.06652001000810313 0.06652001000810313 -35.089 37.2851 28.9071 0.0 0.0 0.0 -35.089 38.2851 27.9071 0.0 0.0 0.0 -35.089 38.2851 28.9071 0.0 0.0 0.0 -36.089 37.2851 27.9071 0.0 0.0 0.0 -36.089 37.2851 28.9071 0.0 0.0 0.0 -36.089 38.2851 27.9071 0.014561521026163397 0.014561521026163397 0.014561521026163397 -35.089 37.2851 29.9071 0.0 0.0 0.0 -35.089 37.2851 30.9071 0.0035132378386201414 0.0035132378386201414 0.0035132378386201414 -35.089 38.2851 29.9071 0.0 0.0 0.0 -35.089 38.2851 30.9071 0.0 0.0 0.0 -33.089 36.2851 31.9071 0.0 0.0 0.0 -33.089 36.2851 32.9071 0.08467970312164332 0.08467970312164332 0.08467970312164332 -34.089 36.2851 31.9071 0.019158447731025482 0.019158447731025482 0.019158447731025482 -33.089 35.2851 34.9071 0.0 0.0 0.0 -33.089 36.2851 34.9071 0.0 0.0 0.0 -34.089 35.2851 34.9071 0.0 0.0 0.0 -34.089 36.2851 33.9071 0.0 0.0 0.0 -34.089 36.2851 34.9071 0.01715882238270014 0.01715882238270014 0.01715882238270014 -33.089 37.2851 31.9071 0.12151760732607748 0.12151760732607748 0.12151760732607748 -33.089 37.2851 32.9071 0.0 0.0 0.0 -33.089 38.2851 31.9071 0.0 0.0 0.0 -33.089 38.2851 32.9071 0.0 0.0 0.0 -34.089 37.2851 31.9071 0.011212056143006155 0.011212056143006155 0.011212056143006155 -34.089 37.2851 32.9071 0.0 0.0 0.0 -34.089 38.2851 31.9071 0.03169926842894598 0.03169926842894598 0.03169926842894598 -33.089 37.2851 33.9071 0.0 0.0 0.0 -33.089 37.2851 34.9071 0.0 0.0 0.0 -34.089 37.2851 33.9071 0.008837750715269708 0.008837750715269708 0.008837750715269708 -35.089 35.2851 31.9071 0.0 0.0 0.0 -35.089 36.2851 31.9071 0.0730317122437787 0.0730317122437787 0.0730317122437787 -35.089 36.2851 32.9071 0.03192174283243148 0.03192174283243148 0.03192174283243148 -36.089 35.2851 31.9071 0.0 0.0 0.0 -36.089 36.2851 31.9071 0.0 0.0 0.0 -36.089 36.2851 32.9071 0.0 0.0 0.0 -35.089 35.2851 34.9071 0.0 0.0 0.0 -35.089 36.2851 33.9071 0.12046661709520984 0.12046661709520984 0.12046661709520984 -35.089 36.2851 34.9071 0.07597527107268781 0.07597527107268781 0.07597527107268781 -36.089 35.2851 33.9071 0.0 0.0 0.0 -36.089 35.2851 34.9071 0.16527556429469764 0.16527556429469764 0.16527556429469764 -36.089 36.2851 33.9071 0.035823441687823004 0.035823441687823004 0.035823441687823004 -36.089 36.2851 34.9071 0.0 0.0 0.0 -35.089 37.2851 31.9071 0.0 0.0 0.0 -35.089 37.2851 32.9071 0.0 0.0 0.0 -35.089 38.2851 31.9071 0.06098515116974998 0.06098515116974998 0.06098515116974998 -35.089 37.2851 33.9071 0.07643695134434138 0.07643695134434138 0.07643695134434138 -34.089 39.2851 27.9071 0.0 0.0 0.0 -34.089 39.2851 28.9071 0.0 0.0 0.0 -34.089 40.2851 27.9071 0.0 0.0 0.0 -34.089 40.2851 28.9071 0.17106389064932018 0.17106389064932018 0.17106389064932018 -34.089 39.2851 29.9071 0.0 0.0 0.0 -33.089 41.2851 28.9071 0.14601248856748625 0.14601248856748625 0.14601248856748625 -33.089 42.2851 27.9071 0.0 0.0 0.0 -33.089 42.2851 28.9071 0.0 0.0 0.0 -34.089 41.2851 27.9071 0.004484957898917619 0.004484957898917619 0.004484957898917619 -34.089 41.2851 28.9071 0.24324703523461116 0.24324703523461116 0.24324703523461116 -34.089 42.2851 27.9071 0.13765270089009946 0.13765270089009946 0.13765270089009946 -34.089 42.2851 28.9071 0.0 0.0 0.0 -33.089 41.2851 29.9071 0.4233513532436401 0.4233513532436401 0.4233513532436401 -33.089 41.2851 30.9071 0.0 0.0 0.0 -33.089 42.2851 29.9071 0.0 0.0 0.0 -33.089 42.2851 30.9071 0.11767537047121093 0.11767537047121093 0.11767537047121093 -34.089 41.2851 29.9071 0.0 0.0 0.0 -34.089 42.2851 29.9071 0.0 0.0 0.0 -34.089 42.2851 30.9071 0.1960915310086444 0.1960915310086444 0.1960915310086444 -35.089 39.2851 27.9071 0.015434872140640148 0.015434872140640148 0.015434872140640148 -35.089 40.2851 28.9071 0.119380830546875 0.119380830546875 0.119380830546875 -36.089 39.2851 27.9071 0.035879272139307486 0.035879272139307486 0.035879272139307486 -35.089 39.2851 29.9071 0.0 0.0 0.0 -35.089 39.2851 30.9071 0.0 0.0 0.0 -35.089 40.2851 29.9071 0.09779568824946279 0.09779568824946279 0.09779568824946279 -36.089 39.2851 29.9071 0.0 0.0 0.0 -36.089 39.2851 30.9071 0.011058098041955875 0.011058098041955875 0.011058098041955875 -36.089 40.2851 29.9071 0.0 0.0 0.0 -36.089 40.2851 30.9071 0.10198187510622515 0.10198187510622515 0.10198187510622515 -35.089 41.2851 29.9071 0.1187468151285659 0.1187468151285659 0.1187468151285659 -35.089 42.2851 29.9071 0.15227041619924317 0.15227041619924317 0.15227041619924317 -35.089 42.2851 30.9071 0.0884206523460399 0.0884206523460399 0.0884206523460399 -36.089 41.2851 29.9071 0.0 0.0 0.0 -36.089 41.2851 30.9071 0.15209171457431092 0.15209171457431092 0.15209171457431092 -36.089 42.2851 29.9071 0.008814283304503179 0.008814283304503179 0.008814283304503179 -36.089 42.2851 30.9071 0.24913039438406576 0.24913039438406576 0.24913039438406576 -33.089 39.2851 31.9071 0.0 0.0 0.0 -33.089 39.2851 32.9071 0.2447048123107895 0.2447048123107895 0.2447048123107895 -33.089 40.2851 31.9071 0.0 0.0 0.0 -33.089 40.2851 32.9071 0.0 0.0 0.0 -34.089 39.2851 31.9071 0.0 0.0 0.0 -34.089 39.2851 32.9071 0.10521801441426909 0.10521801441426909 0.10521801441426909 -34.089 40.2851 32.9071 0.0 0.0 0.0 -33.089 41.2851 31.9071 0.0 0.0 0.0 -33.089 41.2851 32.9071 0.0 0.0 0.0 -33.089 42.2851 31.9071 0.18709829816800652 0.18709829816800652 0.18709829816800652 -34.089 41.2851 31.9071 0.0 0.0 0.0 -34.089 41.2851 32.9071 0.0 0.0 0.0 -34.089 42.2851 31.9071 0.21016789276009795 0.21016789276009795 0.21016789276009795 -34.089 42.2851 32.9071 0.2374060682525284 0.2374060682525284 0.2374060682525284 -35.089 39.2851 31.9071 0.005152399629131471 0.005152399629131471 0.005152399629131471 -35.089 39.2851 32.9071 0.0 0.0 0.0 -35.089 40.2851 31.9071 0.1772059877949685 0.1772059877949685 0.1772059877949685 -35.089 40.2851 32.9071 0.2842721298437278 0.2842721298437278 0.2842721298437278 -36.089 39.2851 31.9071 0.0 0.0 0.0 -36.089 40.2851 31.9071 0.0 0.0 0.0 -35.089 41.2851 31.9071 0.18300797470699257 0.18300797470699257 0.18300797470699257 -35.089 41.2851 32.9071 0.13444258182817512 0.13444258182817512 0.13444258182817512 -35.089 42.2851 31.9071 0.0 0.0 0.0 -35.089 42.2851 32.9071 0.0 0.0 0.0 -36.089 41.2851 31.9071 0.0 0.0 0.0 -36.089 42.2851 31.9071 0.3481670875679597 0.3481670875679597 0.3481670875679597 -37.089 35.2851 27.9071 0.01729980469898373 0.01729980469898373 0.01729980469898373 -37.089 35.2851 28.9071 0.0 0.0 0.0 -37.089 36.2851 27.9071 0.012419829076514061 0.012419829076514061 0.012419829076514061 -38.089 35.2851 27.9071 0.32468552080798146 0.32468552080798146 0.32468552080798146 -38.089 36.2851 27.9071 0.1657640554807102 0.1657640554807102 0.1657640554807102 -37.089 35.2851 29.9071 0.0 0.0 0.0 -39.089 35.2851 27.9071 0.46089099046823895 0.46089099046823895 0.46089099046823895 -37.089 35.2851 31.9071 0.0 0.0 0.0 -37.089 35.2851 32.9071 0.3704052016291218 0.3704052016291218 0.3704052016291218 -37.089 36.2851 32.9071 0.0 0.0 0.0 -37.089 35.2851 33.9071 0.2529631953801571 0.2529631953801571 0.2529631953801571 -37.089 36.2851 33.9071 0.0627214531435888 0.0627214531435888 0.0627214531435888 -28.089 43.2851 27.9071 0.0 0.0 0.0 -28.089 43.2851 28.9071 0.0546092213446798 0.0546092213446798 0.0546092213446798 -28.089 44.2851 27.9071 0.0 0.0 0.0 -28.089 44.2851 28.9071 0.0 0.0 0.0 -28.089 43.2851 29.9071 0.14875591755861928 0.14875591755861928 0.14875591755861928 -28.089 44.2851 29.9071 0.06818612143299627 0.06818612143299627 0.06818612143299627 -29.089 43.2851 28.9071 0.055695662524335054 0.055695662524335054 0.055695662524335054 -29.089 44.2851 27.9071 0.05502349251016309 0.05502349251016309 0.05502349251016309 -29.089 44.2851 28.9071 0.20061592777741818 0.20061592777741818 0.20061592777741818 -30.089 44.2851 27.9071 0.0 0.0 0.0 -29.089 43.2851 29.9071 0.0 0.0 0.0 -29.089 43.2851 30.9071 0.06235469411649281 0.06235469411649281 0.06235469411649281 -29.089 44.2851 29.9071 0.10382989448036258 0.10382989448036258 0.10382989448036258 -29.089 44.2851 30.9071 0.028184297133268435 0.028184297133268435 0.028184297133268435 -30.089 43.2851 29.9071 0.0 0.0 0.0 -30.089 43.2851 30.9071 0.0 0.0 0.0 -30.089 44.2851 29.9071 0.0 0.0 0.0 -30.089 44.2851 30.9071 0.0 0.0 0.0 -29.089 45.2851 27.9071 0.0 0.0 0.0 -29.089 45.2851 28.9071 0.1224041991720981 0.1224041991720981 0.1224041991720981 -29.089 46.2851 27.9071 0.0 0.0 0.0 -30.089 45.2851 27.9071 0.0 0.0 0.0 -30.089 45.2851 28.9071 0.0 0.0 0.0 -30.089 46.2851 27.9071 0.04995304023013905 0.04995304023013905 0.04995304023013905 -30.089 46.2851 28.9071 0.019173575254128616 0.019173575254128616 0.019173575254128616 -29.089 45.2851 29.9071 0.16555631145218402 0.16555631145218402 0.16555631145218402 -30.089 45.2851 29.9071 0.0 0.0 0.0 -30.089 46.2851 29.9071 0.0 0.0 0.0 -31.089 43.2851 27.9071 0.3223895719880115 0.3223895719880115 0.3223895719880115 -31.089 43.2851 28.9071 0.2797397310208443 0.2797397310208443 0.2797397310208443 -32.089 43.2851 27.9071 0.38239133147067844 0.38239133147067844 0.38239133147067844 -32.089 43.2851 28.9071 0.3288981434887567 0.3288981434887567 0.3288981434887567 -32.089 44.2851 28.9071 0.289391861778442 0.289391861778442 0.289391861778442 -31.089 43.2851 29.9071 0.0 0.0 0.0 -31.089 43.2851 30.9071 0.0 0.0 0.0 -31.089 44.2851 29.9071 0.0 0.0 0.0 -31.089 44.2851 30.9071 0.0 0.0 0.0 -32.089 43.2851 29.9071 0.0 0.0 0.0 -32.089 44.2851 29.9071 0.34171233897238307 0.34171233897238307 0.34171233897238307 -31.089 46.2851 27.9071 0.02402213009715018 0.02402213009715018 0.02402213009715018 -31.089 46.2851 28.9071 0.0 0.0 0.0 -32.089 45.2851 27.9071 0.005926588149087338 0.005926588149087338 0.005926588149087338 -32.089 45.2851 28.9071 0.0 0.0 0.0 -32.089 46.2851 27.9071 0.04786436784157308 0.04786436784157308 0.04786436784157308 -32.089 46.2851 28.9071 0.0 0.0 0.0 -31.089 45.2851 29.9071 0.022276551949004665 0.022276551949004665 0.022276551949004665 -31.089 46.2851 29.9071 0.0 0.0 0.0 -32.089 45.2851 29.9071 0.36183973699029576 0.36183973699029576 0.36183973699029576 -32.089 46.2851 29.9071 0.0 0.0 0.0 -33.089 43.2851 27.9071 0.41252541117172253 0.41252541117172253 0.41252541117172253 -33.089 43.2851 28.9071 0.27478325825528754 0.27478325825528754 0.27478325825528754 -33.089 44.2851 27.9071 0.0 0.0 0.0 -33.089 44.2851 28.9071 0.2551397968824914 0.2551397968824914 0.2551397968824914 -34.089 43.2851 29.9071 0.0 0.0 0.0 -34.089 43.2851 30.9071 0.28279018452704047 0.28279018452704047 0.28279018452704047 -33.089 45.2851 27.9071 0.0 0.0 0.0 -33.089 45.2851 28.9071 0.0 0.0 0.0 -33.089 45.2851 29.9071 0.3359039754637451 0.3359039754637451 0.3359039754637451 -35.089 43.2851 30.9071 0.5913230515880817 0.5913230515880817 0.5913230515880817 -34.089 43.2851 31.9071 0.0 0.0 0.0 -35.089 43.2851 31.9071 0.0 0.0 0.0 -41.089 27.2851 27.9071 0.0 0.0 0.0 -41.089 27.2851 28.9071 0.00374927334111691 0.00374927334111691 0.00374927334111691 -41.089 28.2851 27.9071 0.0 0.0 0.0 -41.089 28.2851 28.9071 0.0 0.0 0.0 -42.089 27.2851 27.9071 0.0 0.0 0.0 -42.089 27.2851 28.9071 0.0 0.0 0.0 -41.089 29.2851 27.9071 0.0 0.0 0.0 -43.089 27.2851 27.9071 0.08923293196386449 0.08923293196386449 0.08923293196386449 diff --git a/tensorflow/script/ocnn_lrp_results/molecule_heatmap-1.ply b/tensorflow/script/ocnn_lrp_results/molecule_heatmap-1.ply deleted file mode 100644 index 4556f22..0000000 --- a/tensorflow/script/ocnn_lrp_results/molecule_heatmap-1.ply +++ /dev/null @@ -1,6985 +0,0 @@ -ply -format ascii 1.0 -element vertex 6973 -property float x -property float y -property float z -property float nx -property float ny -property float nz -element face 0 -property list uchar int vertex_indices -end_header --3.281250000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 7.539046869681699514e-02 7.539046869681699514e-02 7.539046869681699514e-02 --3.281250000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 1.175019737539851339e-01 1.175019737539851339e-01 1.175019737539851339e-01 --3.281250000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 1.641576814399685891e-01 1.641576814399685891e-01 1.641576814399685891e-01 --3.281250000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.111928795957568550e-01 1.111928795957568550e-01 1.111928795957568550e-01 --2.968750000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 9.077350681894853779e-02 9.077350681894853779e-02 9.077350681894853779e-02 --2.968750000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 1.089183350412203377e-01 1.089183350412203377e-01 1.089183350412203377e-01 --2.968750000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 1.394068295399742419e-01 1.394068295399742419e-01 1.394068295399742419e-01 --2.968750000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.022180577569941906e-01 1.022180577569941906e-01 1.022180577569941906e-01 --2.656250000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 9.864311624493515840e-02 9.864311624493515840e-02 9.864311624493515840e-02 --2.656250000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.220995159119338536e-01 1.220995159119338536e-01 1.220995159119338536e-01 --3.281250000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 9.290230689501444150e-02 9.290230689501444150e-02 9.290230689501444150e-02 --3.281250000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.144017179483217822e-01 1.144017179483217822e-01 1.144017179483217822e-01 --3.281250000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 1.006993899407035570e-01 1.006993899407035570e-01 1.006993899407035570e-01 --2.968750000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 9.816419540403580057e-02 9.816419540403580057e-02 9.816419540403580057e-02 --2.968750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.157473994978779758e-01 1.157473994978779758e-01 1.157473994978779758e-01 --2.656250000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 7.788490676557656422e-02 7.788490676557656422e-02 7.788490676557656422e-02 --2.656250000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 9.781625280378537790e-02 9.781625280378537790e-02 9.781625280378537790e-02 --2.968750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 1.195151880987105897e-01 1.195151880987105897e-01 1.195151880987105897e-01 --2.656250000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 9.699580944493081669e-02 9.699580944493081669e-02 9.699580944493081669e-02 --4.843750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 5.403371099740653105e-02 5.403371099740653105e-02 5.403371099740653105e-02 --4.531250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 5.058020821570668318e-02 5.058020821570668318e-02 5.058020821570668318e-02 --4.531250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 4.910840639823602777e-02 4.910840639823602777e-02 4.910840639823602777e-02 --4.843750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 3.195705585947523908e-02 3.195705585947523908e-02 3.195705585947523908e-02 --4.843750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 2.818017804092118675e-02 2.818017804092118675e-02 2.818017804092118675e-02 --4.843750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 5.135256172998133722e-02 5.135256172998133722e-02 5.135256172998133722e-02 --4.843750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 3.901186784339424896e-02 3.901186784339424896e-02 3.901186784339424896e-02 --4.531250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 5.189375151408482517e-02 5.189375151408482517e-02 5.189375151408482517e-02 --4.531250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 4.251757195085604374e-02 4.251757195085604374e-02 4.251757195085604374e-02 --4.843750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 4.709656534062948291e-02 4.709656534062948291e-02 4.709656534062948291e-02 --4.531250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 6.430771477449195861e-02 6.430771477449195861e-02 6.430771477449195861e-02 --4.843750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 5.130584765875142311e-02 5.130584765875142311e-02 5.130584765875142311e-02 --4.843750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 3.341300689274472741e-02 3.341300689274472741e-02 3.341300689274472741e-02 --4.843750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 3.214677169660658251e-02 3.214677169660658251e-02 3.214677169660658251e-02 --4.843750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 2.910812803952768021e-02 2.910812803952768021e-02 2.910812803952768021e-02 --4.531250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 4.598718084351815366e-02 4.598718084351815366e-02 4.598718084351815366e-02 --4.531250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 4.718396781792828093e-02 4.718396781792828093e-02 4.718396781792828093e-02 --4.218750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 5.462521290107957839e-02 5.462521290107957839e-02 5.462521290107957839e-02 --4.218750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 8.326399401074854878e-02 8.326399401074854878e-02 8.326399401074854878e-02 --3.906250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 7.944009357724872433e-02 7.944009357724872433e-02 7.944009357724872433e-02 --3.906250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 8.314022262425974086e-02 8.314022262425974086e-02 8.314022262425974086e-02 --3.906250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 9.597446229008485541e-02 9.597446229008485541e-02 9.597446229008485541e-02 --4.218750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 5.646690506069143578e-02 5.646690506069143578e-02 5.646690506069143578e-02 --4.218750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 4.316608956008197856e-02 4.316608956008197856e-02 4.316608956008197856e-02 --4.218750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 6.482566527978557425e-02 6.482566527978557425e-02 6.482566527978557425e-02 --3.906250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 7.500087154446441473e-02 7.500087154446441473e-02 7.500087154446441473e-02 --3.906250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 7.545091355738328676e-02 7.545091355738328676e-02 7.545091355738328676e-02 --3.906250000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 7.677289238809258121e-02 7.677289238809258121e-02 7.677289238809258121e-02 --4.218750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 5.859460317302751797e-02 5.859460317302751797e-02 5.859460317302751797e-02 --4.218750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 6.243219637735447636e-02 6.243219637735447636e-02 6.243219637735447636e-02 --3.906250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 5.223650584117987827e-02 5.223650584117987827e-02 5.223650584117987827e-02 --3.906250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 6.111512704369874427e-02 6.111512704369874427e-02 6.111512704369874427e-02 --4.218750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 5.004914051998748253e-02 5.004914051998748253e-02 5.004914051998748253e-02 --3.906250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 6.773490469432279226e-02 6.773490469432279226e-02 6.773490469432279226e-02 --4.843750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 2.561269742777864955e-02 2.561269742777864955e-02 2.561269742777864955e-02 --4.531250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 3.122561227465975309e-02 3.122561227465975309e-02 3.122561227465975309e-02 --4.531250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 3.269910843276818690e-02 3.269910843276818690e-02 3.269910843276818690e-02 --4.531250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 4.466147967649419792e-02 4.466147967649419792e-02 4.466147967649419792e-02 --4.218750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 6.050550387671495972e-02 6.050550387671495972e-02 6.050550387671495972e-02 --3.906250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 8.401224424675746150e-02 8.401224424675746150e-02 8.401224424675746150e-02 --4.218750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 6.285344820861407666e-02 6.285344820861407666e-02 6.285344820861407666e-02 --4.218750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 5.954656203035946921e-02 5.954656203035946921e-02 5.954656203035946921e-02 --3.906250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 8.768427584005888953e-02 8.768427584005888953e-02 8.768427584005888953e-02 --3.906250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 7.309939816674426716e-02 7.309939816674426716e-02 7.309939816674426716e-02 --3.906250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 7.098148845942285623e-02 7.098148845942285623e-02 7.098148845942285623e-02 --4.531250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 7.378408165981772959e-02 7.378408165981772959e-02 7.378408165981772959e-02 --4.531250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 8.179319184565937706e-02 8.179319184565937706e-02 8.179319184565937706e-02 --4.531250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 6.092379124444410182e-02 6.092379124444410182e-02 6.092379124444410182e-02 --4.531250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 8.047828802049517005e-02 8.047828802049517005e-02 8.047828802049517005e-02 --4.531250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 7.765896855075937744e-02 7.765896855075937744e-02 7.765896855075937744e-02 --4.531250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.167580517959369985e-01 1.167580517959369985e-01 1.167580517959369985e-01 --4.531250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.067160390026334060e-01 1.067160390026334060e-01 1.067160390026334060e-01 --4.531250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.103950689230784599e-01 1.103950689230784599e-01 1.103950689230784599e-01 --4.531250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.022702865635182201e-01 1.022702865635182201e-01 1.022702865635182201e-01 --4.218750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 7.631377506646458420e-02 7.631377506646458420e-02 7.631377506646458420e-02 --4.218750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 7.712639164985303497e-02 7.712639164985303497e-02 7.712639164985303497e-02 --3.906250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 5.623696718941598172e-02 5.623696718941598172e-02 5.623696718941598172e-02 --3.906250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 5.731686550145202036e-02 5.731686550145202036e-02 5.731686550145202036e-02 --3.906250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 5.183602263315287978e-02 5.183602263315287978e-02 5.183602263315287978e-02 --4.218750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 6.553895717294182244e-02 6.553895717294182244e-02 6.553895717294182244e-02 --4.218750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 6.000103178662628128e-02 6.000103178662628128e-02 6.000103178662628128e-02 --4.218750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 9.216297916449225913e-02 9.216297916449225913e-02 9.216297916449225913e-02 --4.218750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.142715672554850403e-01 1.142715672554850403e-01 1.142715672554850403e-01 --3.906250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 4.615917383209790226e-02 4.615917383209790226e-02 4.615917383209790226e-02 --3.906250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 5.403009298951191169e-02 5.403009298951191169e-02 5.403009298951191169e-02 --3.906250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 5.664980971627568002e-02 5.664980971627568002e-02 5.664980971627568002e-02 --3.906250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 8.507714262604669508e-02 8.507714262604669508e-02 8.507714262604669508e-02 --4.218750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 8.582216126298233827e-02 8.582216126298233827e-02 8.582216126298233827e-02 --4.218750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 7.236294294634364188e-02 7.236294294634364188e-02 7.236294294634364188e-02 --3.906250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 7.512393204131480318e-02 7.512393204131480318e-02 7.512393204131480318e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 7.277321090800634162e-02 7.277321090800634162e-02 7.277321090800634162e-02 --4.218750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.205185630296818772e-01 1.205185630296818772e-01 1.205185630296818772e-01 --4.218750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 9.774875337218995319e-02 9.774875337218995319e-02 9.774875337218995319e-02 --4.531250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 6.972203401123031052e-02 6.972203401123031052e-02 6.972203401123031052e-02 --4.531250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 7.682963884991118875e-02 7.682963884991118875e-02 7.682963884991118875e-02 --4.218750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 7.763742762771028150e-02 7.763742762771028150e-02 7.763742762771028150e-02 --3.906250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 9.391003179501908327e-02 9.391003179501908327e-02 9.391003179501908327e-02 --3.906250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.118155360037002416e-01 1.118155360037002416e-01 1.118155360037002416e-01 --3.906250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.097667774070022195e-01 1.097667774070022195e-01 1.097667774070022195e-01 --3.906250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 9.863749135227350973e-02 9.863749135227350973e-02 9.863749135227350973e-02 --3.906250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.123674867516349513e-01 1.123674867516349513e-01 1.123674867516349513e-01 --3.906250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 9.147668408202326573e-02 9.147668408202326573e-02 9.147668408202326573e-02 --4.218750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 1.036491147932930290e-01 1.036491147932930290e-01 1.036491147932930290e-01 --4.218750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 7.504813451392355894e-02 7.504813451392355894e-02 7.504813451392355894e-02 --3.906250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 1.317243422670899278e-01 1.317243422670899278e-01 1.317243422670899278e-01 --3.906250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.104890711959757021e-01 1.104890711959757021e-01 1.104890711959757021e-01 --3.906250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.357459929668519416e-01 1.357459929668519416e-01 1.357459929668519416e-01 --3.906250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.172416821881615417e-01 1.172416821881615417e-01 1.172416821881615417e-01 --3.593750000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 7.710798529187476436e-02 7.710798529187476436e-02 7.710798529187476436e-02 --3.593750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 8.367468861087096199e-02 8.367468861087096199e-02 8.367468861087096199e-02 --3.593750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 8.635660943353773433e-02 8.635660943353773433e-02 8.635660943353773433e-02 --3.593750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 6.700209817896385367e-02 6.700209817896385367e-02 6.700209817896385367e-02 --3.281250000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 1.140867850459621052e-01 1.140867850459621052e-01 1.140867850459621052e-01 --3.281250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 9.533320072354814489e-02 9.533320072354814489e-02 9.533320072354814489e-02 --3.281250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.179743525929298625e-01 1.179743525929298625e-01 1.179743525929298625e-01 --3.593750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 6.376146350018589704e-02 6.376146350018589704e-02 6.376146350018589704e-02 --3.593750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 8.661941196869003823e-02 8.661941196869003823e-02 8.661941196869003823e-02 --3.281250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 1.205225797176225078e-01 1.205225797176225078e-01 1.205225797176225078e-01 --3.281250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 9.061599426948757641e-02 9.061599426948757641e-02 9.061599426948757641e-02 --3.593750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 7.637984568275578423e-02 7.637984568275578423e-02 7.637984568275578423e-02 --3.593750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 7.649743838506456450e-02 7.649743838506456450e-02 7.649743838506456450e-02 --3.281250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.182956971567590831e-01 1.182956971567590831e-01 1.182956971567590831e-01 --3.281250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 7.998294306672920628e-02 7.998294306672920628e-02 7.998294306672920628e-02 --3.281250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 6.049481151302564530e-02 6.049481151302564530e-02 6.049481151302564530e-02 --3.281250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 6.630425373832714298e-02 6.630425373832714298e-02 6.630425373832714298e-02 --3.593750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 7.183234054619754005e-02 7.183234054619754005e-02 7.183234054619754005e-02 --3.281250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 5.028134738657665664e-02 5.028134738657665664e-02 5.028134738657665664e-02 --3.281250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 4.771762743415977615e-02 4.771762743415977615e-02 4.771762743415977615e-02 --2.968750000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 1.086636398955340421e-01 1.086636398955340421e-01 1.086636398955340421e-01 --2.656250000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 8.557542985709029604e-02 8.557542985709029604e-02 8.557542985709029604e-02 --2.656250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 9.182626134852857336e-02 9.182626134852857336e-02 9.182626134852857336e-02 --2.656250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 7.572420092396336955e-02 7.572420092396336955e-02 7.572420092396336955e-02 --2.656250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 9.558954524619013571e-02 9.558954524619013571e-02 9.558954524619013571e-02 --2.968750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.062813576153642525e-01 1.062813576153642525e-01 1.062813576153642525e-01 --2.656250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.567080118886687856e-01 1.567080118886687856e-01 1.567080118886687856e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.291419301094637873e-01 1.291419301094637873e-01 1.291419301094637873e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 9.567874330546206896e-02 9.567874330546206896e-02 9.567874330546206896e-02 --2.968750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 7.389235403833800675e-02 7.389235403833800675e-02 7.389235403833800675e-02 --2.968750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 8.709840153711861932e-02 8.709840153711861932e-02 8.709840153711861932e-02 --2.656250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.252798041543660423e-01 1.252798041543660423e-01 1.252798041543660423e-01 --2.656250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 1.319034614048701648e-01 1.319034614048701648e-01 1.319034614048701648e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 1.066308705609191054e-01 1.066308705609191054e-01 1.066308705609191054e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.058273902583171944e-01 1.058273902583171944e-01 1.058273902583171944e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.018934348760753283e-01 1.018934348760753283e-01 1.018934348760753283e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 8.123862011445982800e-02 8.123862011445982800e-02 8.123862011445982800e-02 --2.968750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 7.100351346392462515e-02 7.100351346392462515e-02 7.100351346392462515e-02 --2.968750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 7.634134468546750762e-02 7.634134468546750762e-02 7.634134468546750762e-02 --2.656250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.101660885679393159e-01 1.101660885679393159e-01 1.101660885679393159e-01 --2.656250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 9.841812023177953783e-02 9.841812023177953783e-02 9.841812023177953783e-02 --2.656250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.045297526253822218e-01 1.045297526253822218e-01 1.045297526253822218e-01 --3.593750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 8.143553370307941852e-02 8.143553370307941852e-02 8.143553370307941852e-02 --3.593750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.017471934473214018e-01 1.017471934473214018e-01 1.017471934473214018e-01 --3.281250000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 9.368341533385730890e-02 9.368341533385730890e-02 9.368341533385730890e-02 --3.281250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.291379138518225222e-01 1.291379138518225222e-01 1.291379138518225222e-01 --3.593750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 9.351224715811509713e-02 9.351224715811509713e-02 9.351224715811509713e-02 --3.593750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 6.180634392560215018e-02 6.180634392560215018e-02 6.180634392560215018e-02 --3.593750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 9.347045956695618218e-02 9.347045956695618218e-02 9.347045956695618218e-02 --3.281250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.367716544115360477e-01 1.367716544115360477e-01 1.367716544115360477e-01 --3.281250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 6.819157900753458623e-02 6.819157900753458623e-02 6.819157900753458623e-02 --3.281250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.183969204285269944e-01 1.183969204285269944e-01 1.183969204285269944e-01 --3.281250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.007242995382536532e-01 1.007242995382536532e-01 1.007242995382536532e-01 --3.281250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.220601531329286171e-01 1.220601531329286171e-01 1.220601531329286171e-01 --2.968750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.060579899261717141e-01 1.060579899261717141e-01 1.060579899261717141e-01 --2.968750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.005362720629816020e-01 1.005362720629816020e-01 1.005362720629816020e-01 --2.656250000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.456534801999835316e-01 1.456534801999835316e-01 1.456534801999835316e-01 --2.656250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.504397344165026296e-01 1.504397344165026296e-01 1.504397344165026296e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.198349198194488541e-01 1.198349198194488541e-01 1.198349198194488541e-01 --2.968750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.351452079117143878e-01 1.351452079117143878e-01 1.351452079117143878e-01 --2.968750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.152517092709241381e-01 1.152517092709241381e-01 1.152517092709241381e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.001144139489896778e-01 1.001144139489896778e-01 1.001144139489896778e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.293298907431288947e-01 1.293298907431288947e-01 1.293298907431288947e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.119304256271954207e-01 1.119304256271954207e-01 1.119304256271954207e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.239053631049327475e-01 1.239053631049327475e-01 1.239053631049327475e-01 --2.968750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.317982390000548287e-01 1.317982390000548287e-01 1.317982390000548287e-01 --2.968750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.235727946473194894e-01 1.235727946473194894e-01 1.235727946473194894e-01 --2.656250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.248428131696481813e-01 1.248428131696481813e-01 1.248428131696481813e-01 --2.656250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.340930200678367712e-01 1.340930200678367712e-01 1.340930200678367712e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.151697634286966421e-01 1.151697634286966421e-01 1.151697634286966421e-01 --3.593750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 6.136796293764334304e-02 6.136796293764334304e-02 6.136796293764334304e-02 --3.593750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 4.447139129889229187e-02 4.447139129889229187e-02 4.447139129889229187e-02 --3.593750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 5.720961597492155160e-02 5.720961597492155160e-02 5.720961597492155160e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 4.451746606108814702e-02 4.451746606108814702e-02 4.451746606108814702e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 6.792662622757748847e-02 6.792662622757748847e-02 6.792662622757748847e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 5.533135933629136638e-02 5.533135933629136638e-02 5.533135933629136638e-02 --3.593750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 3.846809851212539683e-02 3.846809851212539683e-02 3.846809851212539683e-02 --3.593750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 5.578054660788777513e-02 5.578054660788777513e-02 5.578054660788777513e-02 --3.593750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 5.007165368042569564e-02 5.007165368042569564e-02 5.007165368042569564e-02 --3.593750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 5.991010588303691264e-02 5.991010588303691264e-02 5.991010588303691264e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 4.667072817760125475e-02 4.667072817760125475e-02 4.667072817760125475e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 7.787397558230028938e-02 7.787397558230028938e-02 7.787397558230028938e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 7.347694741603734425e-02 7.347694741603734425e-02 7.347694741603734425e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.188580470550487656e-01 1.188580470550487656e-01 1.188580470550487656e-01 --3.593750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 7.365531209343945118e-02 7.365531209343945118e-02 7.365531209343945118e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 8.594351747492760818e-02 8.594351747492760818e-02 8.594351747492760818e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 6.852485878352326809e-02 6.852485878352326809e-02 6.852485878352326809e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 5.780889298109218033e-02 5.780889298109218033e-02 5.780889298109218033e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 7.995529432131956438e-02 7.995529432131956438e-02 7.995529432131956438e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 8.393348139172385203e-02 8.393348139172385203e-02 8.393348139172385203e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 8.069690432685774906e-02 8.069690432685774906e-02 8.069690432685774906e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 5.472908909477083861e-02 5.472908909477083861e-02 5.472908909477083861e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 5.063649073352008423e-02 5.063649073352008423e-02 5.063649073352008423e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 6.596839233949158832e-02 6.596839233949158832e-02 6.596839233949158832e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 9.849285112023019317e-02 9.849285112023019317e-02 9.849285112023019317e-02 --2.656250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 7.227114681112394023e-02 7.227114681112394023e-02 7.227114681112394023e-02 --2.656250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.271506449748849854e-01 1.271506449748849854e-01 1.271506449748849854e-01 --2.656250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.174079796745758769e-01 1.174079796745758769e-01 1.174079796745758769e-01 --2.968750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 7.864309322780621558e-02 7.864309322780621558e-02 7.864309322780621558e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 9.492256563248709089e-02 9.492256563248709089e-02 9.492256563248709089e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.497932855039379452e-01 1.497932855039379452e-01 1.497932855039379452e-01 --2.968750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 6.757999979266543500e-02 6.757999979266543500e-02 6.757999979266543500e-02 --2.968750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.087568407363945638e-01 1.087568407363945638e-01 1.087568407363945638e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 8.063180173891798530e-02 8.063180173891798530e-02 8.063180173891798530e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 7.865064853240633092e-02 7.865064853240633092e-02 7.865064853240633092e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 8.006130791850910033e-02 8.006130791850910033e-02 8.006130791850910033e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 6.158799785276943689e-02 6.158799785276943689e-02 6.158799785276943689e-02 --2.968750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.304375643618217451e-01 1.304375643618217451e-01 1.304375643618217451e-01 --2.968750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 9.929801177347451213e-02 9.929801177347451213e-02 9.929801177347451213e-02 --2.968750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 8.820504941661384823e-02 8.820504941661384823e-02 8.820504941661384823e-02 --2.968750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 6.289179487837580351e-02 6.289179487837580351e-02 6.289179487837580351e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 9.990227874727386492e-02 9.990227874727386492e-02 9.990227874727386492e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 5.814832587075402515e-02 5.814832587075402515e-02 5.814832587075402515e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 7.723707084022596314e-02 7.723707084022596314e-02 7.723707084022596314e-02 --3.593750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.249311755087571391e-01 1.249311755087571391e-01 1.249311755087571391e-01 --3.593750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.056683002067157900e-01 1.056683002067157900e-01 1.056683002067157900e-01 --3.281250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.160671461924461800e-01 1.160671461924461800e-01 1.160671461924461800e-01 --3.593750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.026246380325121638e-01 1.026246380325121638e-01 1.026246380325121638e-01 --3.593750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.005748418373216962e-01 1.005748418373216962e-01 1.005748418373216962e-01 --3.281250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 8.696097361373121559e-02 8.696097361373121559e-02 8.696097361373121559e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 9.549391838810647459e-02 9.549391838810647459e-02 9.549391838810647459e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 9.157070846165298039e-02 9.157070846165298039e-02 9.157070846165298039e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 8.697463604937784309e-02 8.697463604937784309e-02 8.697463604937784309e-02 --3.593750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 7.757457311031001890e-02 7.757457311031001890e-02 7.757457311031001890e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.041006839368706222e-01 1.041006839368706222e-01 1.041006839368706222e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 8.066153996463532039e-02 8.066153996463532039e-02 8.066153996463532039e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 8.279784104376547438e-02 8.279784104376547438e-02 8.279784104376547438e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 4.308407026281656227e-02 4.308407026281656227e-02 4.308407026281656227e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 4.698656834373797497e-02 4.698656834373797497e-02 4.698656834373797497e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.425350342025105688e-01 1.425350342025105688e-01 1.425350342025105688e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 7.459672379430262734e-02 7.459672379430262734e-02 7.459672379430262734e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 6.200145606003656940e-02 6.200145606003656940e-02 6.200145606003656940e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 7.681629620101755596e-02 7.681629620101755596e-02 7.681629620101755596e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.155835087397172473e-01 1.155835087397172473e-01 1.155835087397172473e-01 --2.968750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.085905253672205112e-01 1.085905253672205112e-01 1.085905253672205112e-01 --2.968750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 6.561934580979411624e-02 6.561934580979411624e-02 6.561934580979411624e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.055959864428938355e-01 1.055959864428938355e-01 1.055959864428938355e-01 --2.968750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.076111056638396901e-01 1.076111056638396901e-01 1.076111056638396901e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 6.735756965876936453e-02 6.735756965876936453e-02 6.735756965876936453e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 8.784018680139805968e-02 8.784018680139805968e-02 8.784018680139805968e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 6.978674350566080320e-02 6.978674350566080320e-02 6.978674350566080320e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 7.426780968770103908e-02 7.426780968770103908e-02 7.426780968770103908e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.194926943619859239e-01 1.194926943619859239e-01 1.194926943619859239e-01 --2.968750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 9.036445573218365723e-02 9.036445573218365723e-02 9.036445573218365723e-02 --2.968750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.076191403284552095e-01 1.076191403284552095e-01 1.076191403284552095e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 3.967191298978430675e-02 3.967191298978430675e-02 3.967191298978430675e-02 --2.968750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 6.912766884156869296e-02 6.912766884156869296e-02 6.912766884156869296e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 8.408377371155002777e-02 8.408377371155002777e-02 8.408377371155002777e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 9.825258704893054251e-02 9.825258704893054251e-02 9.825258704893054251e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 6.473836235517212156e-02 6.473836235517212156e-02 6.473836235517212156e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 7.751421022193796806e-02 7.751421022193796806e-02 7.751421022193796806e-02 --2.031250000000000000e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 7.306362855902058528e-02 7.306362855902058528e-02 7.306362855902058528e-02 --1.718750000000000000e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 9.557508068671696777e-02 9.557508068671696777e-02 9.557508068671696777e-02 --1.406250000000000000e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 7.043391597124482040e-02 7.043391597124482040e-02 7.043391597124482040e-02 --2.343750000000000000e-01 -2.968750000000000000e-01 -2.343750000000000000e-01 5.086154000764064181e-02 5.086154000764064181e-02 5.086154000764064181e-02 --2.343750000000000000e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 5.312944516184188448e-02 5.312944516184188448e-02 5.312944516184188448e-02 --2.343750000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 7.451586184874961494e-02 7.451586184874961494e-02 7.451586184874961494e-02 --2.343750000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 8.600459735338961131e-02 8.600459735338961131e-02 8.600459735338961131e-02 --2.031250000000000000e-01 -2.968750000000000000e-01 -2.343750000000000000e-01 7.260666037332275113e-02 7.260666037332275113e-02 7.260666037332275113e-02 --2.031250000000000000e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 6.541435462706142456e-02 6.541435462706142456e-02 6.541435462706142456e-02 --2.031250000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 7.163114317492519367e-02 7.163114317492519367e-02 7.163114317492519367e-02 --2.343750000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 1.076392269864567403e-01 1.076392269864567403e-01 1.076392269864567403e-01 --2.343750000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.272165132019492662e-01 1.272165132019492662e-01 1.272165132019492662e-01 --2.031250000000000000e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 7.778017632368337819e-02 7.778017632368337819e-02 7.778017632368337819e-02 --2.031250000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 1.157939958289341265e-01 1.157939958289341265e-01 1.157939958289341265e-01 --1.718750000000000000e-01 -2.968750000000000000e-01 -2.343750000000000000e-01 6.146250486749712388e-02 6.146250486749712388e-02 6.146250486749712388e-02 --1.718750000000000000e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 5.353973081357209229e-02 5.353973081357209229e-02 5.353973081357209229e-02 --1.718750000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 7.589661262324587376e-02 7.589661262324587376e-02 7.589661262324587376e-02 --1.718750000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 1.196220332623368909e-01 1.196220332623368909e-01 1.196220332623368909e-01 --1.406250000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 9.095753894782467042e-02 9.095753894782467042e-02 9.095753894782467042e-02 --1.406250000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 9.508569489217566506e-02 9.508569489217566506e-02 9.508569489217566506e-02 --1.718750000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 8.300841392538808872e-02 8.300841392538808872e-02 8.300841392538808872e-02 --1.718750000000000000e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 1.443404227702736742e-01 1.443404227702736742e-01 1.443404227702736742e-01 --1.406250000000000000e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 1.276157377657625158e-01 1.276157377657625158e-01 1.276157377657625158e-01 --1.406250000000000000e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 2.073301794920948404e-01 2.073301794920948404e-01 2.073301794920948404e-01 --1.093750000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 6.521925076921332443e-02 6.521925076921332443e-02 6.521925076921332443e-02 --1.093750000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 7.646070575488277121e-02 7.646070575488277121e-02 7.646070575488277121e-02 --1.093750000000000000e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 1.351917930095947462e-01 1.351917930095947462e-01 1.351917930095947462e-01 --1.093750000000000000e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 2.249296590175056676e-01 2.249296590175056676e-01 2.249296590175056676e-01 --7.812500000000000000e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 2.225516193068741988e-01 2.225516193068741988e-01 2.225516193068741988e-01 --4.687500000000000000e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 1.033960099833951402e-01 1.033960099833951402e-01 1.033960099833951402e-01 --4.687500000000000000e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 1.875355934433045324e-01 1.875355934433045324e-01 1.875355934433045324e-01 --4.687500000000000000e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 1.323195303294078251e-01 1.323195303294078251e-01 1.323195303294078251e-01 --4.687500000000000000e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 2.291496239231368415e-01 2.291496239231368415e-01 2.291496239231368415e-01 --1.562500000000000000e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 9.889382534696079807e-02 9.889382534696079807e-02 9.889382534696079807e-02 --1.562500000000000000e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 2.306859250078792112e-01 2.306859250078792112e-01 2.306859250078792112e-01 --1.562500000000000000e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 1.337789674417829699e-01 1.337789674417829699e-01 1.337789674417829699e-01 --2.343750000000000000e-01 -2.343750000000000000e-01 -2.968750000000000000e-01 7.126942070666066054e-02 7.126942070666066054e-02 7.126942070666066054e-02 --2.343750000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 9.742330888939297606e-02 9.742330888939297606e-02 9.742330888939297606e-02 --2.343750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 7.393801005330528919e-02 7.393801005330528919e-02 7.393801005330528919e-02 --2.343750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.012739157925411360e-01 1.012739157925411360e-01 1.012739157925411360e-01 --2.031250000000000000e-01 -2.343750000000000000e-01 -2.968750000000000000e-01 7.842728449364909371e-02 7.842728449364909371e-02 7.842728449364909371e-02 --2.031250000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 7.851296505106361567e-02 7.851296505106361567e-02 7.851296505106361567e-02 --2.031250000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 6.385785159569373759e-02 6.385785159569373759e-02 6.385785159569373759e-02 --2.343750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 6.833699719824046226e-02 6.833699719824046226e-02 6.833699719824046226e-02 --2.343750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 1.166367420554483836e-01 1.166367420554483836e-01 1.166367420554483836e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 8.799690112298655387e-02 8.799690112298655387e-02 8.799690112298655387e-02 --2.031250000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 7.904722065229091710e-02 7.904722065229091710e-02 7.904722065229091710e-02 --2.031250000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 7.917493671335561201e-02 7.917493671335561201e-02 7.917493671335561201e-02 --2.031250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 1.158012262916912755e-01 1.158012262916912755e-01 1.158012262916912755e-01 --1.718750000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 5.128880224218856226e-02 5.128880224218856226e-02 5.128880224218856226e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 5.794114495230300727e-02 5.794114495230300727e-02 5.794114495230300727e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 6.942983583236694844e-02 6.942983583236694844e-02 6.942983583236694844e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 7.717694882978377857e-02 7.717694882978377857e-02 7.717694882978377857e-02 --1.406250000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 8.871296113924574678e-02 8.871296113924574678e-02 8.871296113924574678e-02 --1.718750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 7.344656348835799931e-02 7.344656348835799931e-02 7.344656348835799931e-02 --1.718750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 7.558876303626239912e-02 7.558876303626239912e-02 7.558876303626239912e-02 --1.718750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 1.154413091349223014e-01 1.154413091349223014e-01 1.154413091349223014e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 6.622675975351371980e-02 6.622675975351371980e-02 6.622675975351371980e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 1.216898207386566816e-01 1.216898207386566816e-01 1.216898207386566816e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 1.210808973911134123e-01 1.210808973911134123e-01 1.210808973911134123e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -3.906250000000000000e-01 1.035309993144325480e-01 1.035309993144325480e-01 1.035309993144325480e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -3.906250000000000000e-01 1.067787100625342267e-01 1.067787100625342267e-01 1.067787100625342267e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 -3.906250000000000000e-01 1.039311449292296824e-01 1.039311449292296824e-01 1.039311449292296824e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -3.906250000000000000e-01 1.046486701340781089e-01 1.046486701340781089e-01 1.046486701340781089e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -3.906250000000000000e-01 9.688571993446168373e-02 9.688571993446168373e-02 9.688571993446168373e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 -3.906250000000000000e-01 1.225373251146741060e-01 1.225373251146741060e-01 1.225373251146741060e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 -3.906250000000000000e-01 1.373346783536121829e-01 1.373346783536121829e-01 1.373346783536121829e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 -4.218750000000000000e-01 8.748014453704415494e-02 8.748014453704415494e-02 8.748014453704415494e-02 --1.406250000000000000e-01 -4.687500000000000000e-02 -3.906250000000000000e-01 1.065248116206679585e-01 1.065248116206679585e-01 1.065248116206679585e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 -4.218750000000000000e-01 9.827026536625600717e-02 9.827026536625600717e-02 9.827026536625600717e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 -3.906250000000000000e-01 1.617762388936173912e-01 1.617762388936173912e-01 1.617762388936173912e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 1.103645382467207808e-01 1.103645382467207808e-01 1.103645382467207808e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 1.162856658155271422e-01 1.162856658155271422e-01 1.162856658155271422e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.174746592465067546e-01 1.174746592465067546e-01 1.174746592465067546e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 1.034377924195813148e-01 1.034377924195813148e-01 1.034377924195813148e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 1.221734214857738837e-01 1.221734214857738837e-01 1.221734214857738837e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.299885527459669343e-01 1.299885527459669343e-01 1.299885527459669343e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -3.593750000000000000e-01 1.042919170806991536e-01 1.042919170806991536e-01 1.042919170806991536e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 9.675955877738641464e-02 9.675955877738641464e-02 9.675955877738641464e-02 --2.031250000000000000e-01 -1.562500000000000000e-02 -3.593750000000000000e-01 1.207274305370263506e-01 1.207274305370263506e-01 1.207274305370263506e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 1.268012211611443119e-01 1.268012211611443119e-01 1.268012211611443119e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.120742382813361554e-01 1.120742382813361554e-01 1.120742382813361554e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 1.156791117225386412e-01 1.156791117225386412e-01 1.156791117225386412e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 1.223485452919000488e-01 1.223485452919000488e-01 1.223485452919000488e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.303837473593484897e-01 1.303837473593484897e-01 1.303837473593484897e-01 --1.718750000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 9.222566156174957785e-02 9.222566156174957785e-02 9.222566156174957785e-02 --1.718750000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 1.049515875884298316e-01 1.049515875884298316e-01 1.049515875884298316e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 1.346448180042184029e-01 1.346448180042184029e-01 1.346448180042184029e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 1.557877957427626914e-01 1.557877957427626914e-01 1.557877957427626914e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 1.102263466193265234e-01 1.102263466193265234e-01 1.102263466193265234e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 1.099620142987030175e-01 1.099620142987030175e-01 1.099620142987030175e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 1.321902118400765380e-01 1.321902118400765380e-01 1.321902118400765380e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 1.686337355178923747e-01 1.686337355178923747e-01 1.686337355178923747e-01 --1.718750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 1.237519319341922608e-01 1.237519319341922608e-01 1.237519319341922608e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 1.482449991643404463e-01 1.482449991643404463e-01 1.482449991643404463e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.487316525420604718e-01 1.487316525420604718e-01 1.487316525420604718e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 1.281081387749275768e-01 1.281081387749275768e-01 1.281081387749275768e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 1.444062769254942924e-01 1.444062769254942924e-01 1.444062769254942924e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.650818163225419299e-01 1.650818163225419299e-01 1.650818163225419299e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 -3.593750000000000000e-01 1.505666144628587111e-01 1.505666144628587111e-01 1.505666144628587111e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 1.311974244645730536e-01 1.311974244645730536e-01 1.311974244645730536e-01 --1.718750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.520787201193249394e-01 1.520787201193249394e-01 1.520787201193249394e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.180900367837738885e-01 1.180900367837738885e-01 1.180900367837738885e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.395602308587965967e-01 1.395602308587965967e-01 1.395602308587965967e-01 --1.093750000000000000e-01 -2.031250000000000000e-01 -3.281250000000000000e-01 4.475362895679715208e-02 4.475362895679715208e-02 4.475362895679715208e-02 --7.812500000000000000e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 7.397667296122235892e-02 7.397667296122235892e-02 7.397667296122235892e-02 --1.093750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 5.527926084714889637e-02 5.527926084714889637e-02 5.527926084714889637e-02 --1.093750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.379137616359640828e-01 1.379137616359640828e-01 1.379137616359640828e-01 --7.812500000000000000e-02 -2.031250000000000000e-01 -2.968750000000000000e-01 7.624609683635440172e-02 7.624609683635440172e-02 7.624609683635440172e-02 --7.812500000000000000e-02 -2.031250000000000000e-01 -2.656250000000000000e-01 8.168951133427515554e-02 8.168951133427515554e-02 8.168951133427515554e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 5.302243125667358004e-02 5.302243125667358004e-02 5.302243125667358004e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 5.223353096824834285e-02 5.223353096824834285e-02 5.223353096824834285e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 -3.593750000000000000e-01 3.955000447425485038e-02 3.955000447425485038e-02 3.955000447425485038e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 -3.281250000000000000e-01 6.952452905855803500e-02 6.952452905855803500e-02 6.952452905855803500e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 4.149086903189980191e-02 4.149086903189980191e-02 4.149086903189980191e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 7.203908378508010191e-02 7.203908378508010191e-02 7.203908378508010191e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 6.954631330789730337e-02 6.954631330789730337e-02 6.954631330789730337e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 6.178447718802487082e-02 6.178447718802487082e-02 6.178447718802487082e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 6.917823104810416623e-02 6.917823104810416623e-02 6.917823104810416623e-02 --4.687500000000000000e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 6.900363455004823732e-02 6.900363455004823732e-02 6.900363455004823732e-02 --4.687500000000000000e-02 -2.031250000000000000e-01 -2.968750000000000000e-01 8.735879064292766116e-02 8.735879064292766116e-02 8.735879064292766116e-02 --4.687500000000000000e-02 -2.031250000000000000e-01 -2.656250000000000000e-01 8.353404001125652734e-02 8.353404001125652734e-02 8.353404001125652734e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 -3.281250000000000000e-01 5.935594605439842297e-02 5.935594605439842297e-02 5.935594605439842297e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 6.741440314864165229e-02 6.741440314864165229e-02 6.741440314864165229e-02 --1.562500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 9.211476190258588437e-02 9.211476190258588437e-02 9.211476190258588437e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 -2.968750000000000000e-01 8.362726996762134823e-02 8.362726996762134823e-02 8.362726996762134823e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 8.401385165114953757e-02 8.401385165114953757e-02 8.401385165114953757e-02 --1.562500000000000000e-02 -1.718750000000000000e-01 -2.968750000000000000e-01 8.914371920126011595e-02 8.914371920126011595e-02 8.914371920126011595e-02 --1.562500000000000000e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 1.052207573136724611e-01 1.052207573136724611e-01 1.052207573136724611e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 1.494865215940259506e-01 1.494865215940259506e-01 1.494865215940259506e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 1.556504851012942559e-01 1.556504851012942559e-01 1.556504851012942559e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -4.218750000000000000e-01 9.148873849580703432e-02 9.148873849580703432e-02 9.148873849580703432e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 -3.906250000000000000e-01 1.263047957541343636e-01 1.263047957541343636e-01 1.263047957541343636e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 1.152894686015088904e-01 1.152894686015088904e-01 1.152894686015088904e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 -4.218750000000000000e-01 9.744179095701969995e-02 9.744179095701969995e-02 9.744179095701969995e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 -4.218750000000000000e-01 1.191488607462209970e-01 1.191488607462209970e-01 1.191488607462209970e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 -3.906250000000000000e-01 1.668007913733142167e-01 1.668007913733142167e-01 1.668007913733142167e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -4.218750000000000000e-01 1.030922831604431517e-01 1.030922831604431517e-01 1.030922831604431517e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 1.306223090217441818e-01 1.306223090217441818e-01 1.306223090217441818e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 -4.218750000000000000e-01 1.490576925972403044e-01 1.490576925972403044e-01 1.490576925972403044e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 -3.906250000000000000e-01 1.526456520365795932e-01 1.526456520365795932e-01 1.526456520365795932e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 9.282114190005988363e-02 9.282114190005988363e-02 9.282114190005988363e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 -4.218750000000000000e-01 6.178134188324158060e-02 6.178134188324158060e-02 6.178134188324158060e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 9.017961860606259206e-02 9.017961860606259206e-02 9.017961860606259206e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 -4.218750000000000000e-01 6.770299125428674847e-02 6.770299125428674847e-02 6.770299125428674847e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 9.173063001736261879e-02 9.173063001736261879e-02 9.173063001736261879e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 -4.218750000000000000e-01 1.182491022745633530e-01 1.182491022745633530e-01 1.182491022745633530e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 -4.218750000000000000e-01 5.339195425123115235e-02 5.339195425123115235e-02 5.339195425123115235e-02 --1.562500000000000000e-02 -1.562500000000000000e-02 -4.218750000000000000e-01 6.568003917741353781e-02 6.568003917741353781e-02 6.568003917741353781e-02 --1.093750000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 1.039311449292296824e-01 1.039311449292296824e-01 1.039311449292296824e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 1.418989623870391681e-01 1.418989623870391681e-01 1.418989623870391681e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 1.397465608630986400e-01 1.397465608630986400e-01 1.397465608630986400e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 6.087692194355685121e-02 6.087692194355685121e-02 6.087692194355685121e-02 --7.812500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 8.998353006024467637e-02 8.998353006024467637e-02 8.998353006024467637e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -3.593750000000000000e-01 1.187761048859415636e-01 1.187761048859415636e-01 1.187761048859415636e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 -3.281250000000000000e-01 7.890576020956538428e-02 7.890576020956538428e-02 7.890576020956538428e-02 --1.093750000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 1.145077665053362004e-01 1.145077665053362004e-01 1.145077665053362004e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 1.745875051141830836e-01 1.745875051141830836e-01 1.745875051141830836e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 9.802196500793147749e-02 9.802196500793147749e-02 9.802196500793147749e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.283997222911621994e-01 1.283997222911621994e-01 1.283997222911621994e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 -2.968750000000000000e-01 5.883739756705946150e-02 5.883739756705946150e-02 5.883739756705946150e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 7.623580845435012909e-02 7.623580845435012909e-02 7.623580845435012909e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 8.629392246349407158e-02 8.629392246349407158e-02 8.629392246349407158e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 -3.593750000000000000e-01 1.211797071657592373e-01 1.211797071657592373e-01 1.211797071657592373e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -3.281250000000000000e-01 1.370591906688170825e-01 1.370591906688170825e-01 1.370591906688170825e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 6.827019650313012611e-02 6.827019650313012611e-02 6.827019650313012611e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.108208903068074874e-01 1.108208903068074874e-01 1.108208903068074874e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 5.260989172221697263e-02 5.260989172221697263e-02 5.260989172221697263e-02 --4.687500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 5.132948610782936405e-02 5.132948610782936405e-02 5.132948610782936405e-02 --4.687500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 8.828863004706896667e-02 8.828863004706896667e-02 8.828863004706896667e-02 --4.687500000000000000e-02 -7.812500000000000000e-02 -3.593750000000000000e-01 9.285328646230832372e-02 9.285328646230832372e-02 9.285328646230832372e-02 --4.687500000000000000e-02 -7.812500000000000000e-02 -3.281250000000000000e-01 6.651101118322948202e-02 6.651101118322948202e-02 6.651101118322948202e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 1.070776021381713849e-01 1.070776021381713849e-01 1.070776021381713849e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 -3.593750000000000000e-01 7.904826552963292730e-02 7.904826552963292730e-02 7.904826552963292730e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 -3.281250000000000000e-01 9.142444826807780145e-02 9.142444826807780145e-02 9.142444826807780145e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 -2.968750000000000000e-01 1.292190422174359365e-01 1.292190422174359365e-01 1.292190422174359365e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 1.013494475574340248e-01 1.013494475574340248e-01 1.013494475574340248e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 -2.968750000000000000e-01 8.509803860418087285e-02 8.509803860418087285e-02 8.509803860418087285e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 7.763453407043567622e-02 7.763453407043567622e-02 7.763453407043567622e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 -3.593750000000000000e-01 8.163164308376782974e-02 8.163164308376782974e-02 8.163164308376782974e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 -3.281250000000000000e-01 6.384571265091808223e-02 6.384571265091808223e-02 6.384571265091808223e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 -3.281250000000000000e-01 1.492994110956117615e-01 1.492994110956117615e-01 1.492994110956117615e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 -3.281250000000000000e-01 5.646063403655454671e-02 5.646063403655454671e-02 5.646063403655454671e-02 --1.562500000000000000e-02 -1.562500000000000000e-02 -3.281250000000000000e-01 7.163307235706166398e-02 7.163307235706166398e-02 7.163307235706166398e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 3.896981068966572787e-02 3.896981068966572787e-02 3.896981068966572787e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 8.400340352197349647e-02 8.400340352197349647e-02 8.400340352197349647e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 6.945684511707671260e-02 6.945684511707671260e-02 6.945684511707671260e-02 --1.562500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 6.281325251837364954e-02 6.281325251837364954e-02 6.281325251837364954e-02 --1.562500000000000000e-02 -4.687500000000000000e-02 -2.656250000000000000e-01 6.310201791094674495e-02 6.310201791094674495e-02 6.310201791094674495e-02 --1.562500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 8.580528389451916316e-02 8.580528389451916316e-02 8.580528389451916316e-02 --1.562500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 7.627093362813047728e-02 7.627093362813047728e-02 7.627093362813047728e-02 --2.343750000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 8.089623044139360175e-02 8.089623044139360175e-02 8.089623044139360175e-02 --2.343750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 8.657440609085537142e-02 8.657440609085537142e-02 8.657440609085537142e-02 --2.343750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 8.761998257216209451e-02 8.761998257216209451e-02 8.761998257216209451e-02 --2.031250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 9.233415021083697660e-02 9.233415021083697660e-02 9.233415021083697660e-02 --2.343750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 1.242507829943763215e-01 1.242507829943763215e-01 1.242507829943763215e-01 --2.343750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.572476101782647184e-01 1.572476101782647184e-01 1.572476101782647184e-01 --2.343750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.082731593368084222e-01 1.082731593368084222e-01 1.082731593368084222e-01 --2.343750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.514451328387952378e-01 1.514451328387952378e-01 1.514451328387952378e-01 --2.031250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 9.835142486413352148e-02 9.835142486413352148e-02 9.835142486413352148e-02 --2.031250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 8.331623512323041436e-02 8.331623512323041436e-02 8.331623512323041436e-02 --2.031250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 8.085363256323779835e-02 8.085363256323779835e-02 8.085363256323779835e-02 --2.031250000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 9.509774876523519049e-02 9.509774876523519049e-02 9.509774876523519049e-02 --2.343750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 9.284846477878355708e-02 9.284846477878355708e-02 9.284846477878355708e-02 --2.343750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 7.483641548536720811e-02 7.483641548536720811e-02 7.483641548536720811e-02 --2.343750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 7.518928022343471240e-02 7.518928022343471240e-02 7.518928022343471240e-02 --2.343750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.256621693189716726e-01 1.256621693189716726e-01 1.256621693189716726e-01 --2.031250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 5.275196121795594495e-02 5.275196121795594495e-02 5.275196121795594495e-02 --2.343750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.064733890538454159e-01 1.064733890538454159e-01 1.064733890538454159e-01 --2.343750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.238499351241273000e-01 1.238499351241273000e-01 1.238499351241273000e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 8.084881016052843095e-02 8.084881016052843095e-02 8.084881016052843095e-02 --2.343750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.567361160555965083e-01 1.567361160555965083e-01 1.567361160555965083e-01 --2.031250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 8.653984798902454589e-02 8.653984798902454589e-02 8.653984798902454589e-02 --2.031250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 8.890101624848044393e-02 8.890101624848044393e-02 8.890101624848044393e-02 --2.031250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 6.150294241072164214e-02 6.150294241072164214e-02 6.150294241072164214e-02 --2.031250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.000252208073302562e-01 1.000252208073302562e-01 1.000252208073302562e-01 --1.718750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 6.280143498162860105e-02 6.280143498162860105e-02 6.280143498162860105e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 9.421138248330546139e-02 9.421138248330546139e-02 9.421138248330546139e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 9.392931827286818414e-02 9.392931827286818414e-02 9.392931827286818414e-02 --1.406250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 6.976487893697833065e-02 6.976487893697833065e-02 6.976487893697833065e-02 --1.406250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 7.156595286801743783e-02 7.156595286801743783e-02 7.156595286801743783e-02 --1.718750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 9.585954987899167334e-02 9.585954987899167334e-02 9.585954987899167334e-02 --1.718750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 6.941600964739975954e-02 6.941600964739975954e-02 6.941600964739975954e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 7.499524499863050031e-02 7.499524499863050031e-02 7.499524499863050031e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 8.926507040311121299e-02 8.926507040311121299e-02 8.926507040311121299e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 6.288906157338486347e-02 6.288906157338486347e-02 6.288906157338486347e-02 --1.406250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 5.818466488256675284e-02 5.818466488256675284e-02 5.818466488256675284e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 9.349617501024477806e-02 9.349617501024477806e-02 9.349617501024477806e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 8.220710883486612164e-02 8.220710883486612164e-02 8.220710883486612164e-02 --1.406250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 1.180924468693172746e-01 1.180924468693172746e-01 1.180924468693172746e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 9.203038162474691530e-02 9.203038162474691530e-02 9.203038162474691530e-02 --1.718750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 9.185920993209682750e-02 9.185920993209682750e-02 9.185920993209682750e-02 --1.718750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.044927917422926317e-01 1.044927917422926317e-01 1.044927917422926317e-01 --1.718750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.057124919192717338e-01 1.057124919192717338e-01 1.057124919192717338e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 9.842695937274144324e-02 9.842695937274144324e-02 9.842695937274144324e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.315717292341713751e-01 1.315717292341713751e-01 1.315717292341713751e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 8.865750890773117787e-02 8.865750890773117787e-02 8.865750890773117787e-02 --1.406250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.106939475640552617e-01 1.106939475640552617e-01 1.106939475640552617e-01 --2.343750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.408805945148082772e-01 1.408805945148082772e-01 1.408805945148082772e-01 --2.343750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 2.638472766944958275e-02 2.638472766944958275e-02 2.638472766944958275e-02 --2.343750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.483606398375743041e-01 1.483606398375743041e-01 1.483606398375743041e-01 --2.343750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.285483250540796485e-01 1.285483250540796485e-01 1.285483250540796485e-01 --2.031250000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 9.288141294372928569e-02 9.288141294372928569e-02 9.288141294372928569e-02 --2.031250000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.292776795000612766e-01 1.292776795000612766e-01 1.292776795000612766e-01 --2.031250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.196646106188170161e-01 1.196646106188170161e-01 1.196646106188170161e-01 --2.343750000000000000e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 1.296600256649342309e-01 1.296600256649342309e-01 1.296600256649342309e-01 --2.343750000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.618573343540823106e-01 1.618573343540823106e-01 1.618573343540823106e-01 --2.343750000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 1.376695994287303881e-01 1.376695994287303881e-01 1.376695994287303881e-01 --2.031250000000000000e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 1.642219135735042135e-01 1.642219135735042135e-01 1.642219135735042135e-01 --2.031250000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 1.804605602614018367e-01 1.804605602614018367e-01 1.804605602614018367e-01 --2.343750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.288069735327325716e-01 1.288069735327325716e-01 1.288069735327325716e-01 --2.343750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.460188838076717788e-01 1.460188838076717788e-01 1.460188838076717788e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.060354924266912607e-01 1.060354924266912607e-01 1.060354924266912607e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.011140132052601309e-01 1.011140132052601309e-01 1.011140132052601309e-01 --2.031250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.431381734128575056e-01 1.431381734128575056e-01 1.431381734128575056e-01 --2.031250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.395273018045299906e-01 1.395273018045299906e-01 1.395273018045299906e-01 --2.031250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.631074787831292006e-01 1.631074787831292006e-01 1.631074787831292006e-01 --2.343750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.670617255243636023e-01 1.670617255243636023e-01 1.670617255243636023e-01 --2.343750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.196051629827737661e-01 1.196051629827737661e-01 1.196051629827737661e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.416821185732613786e-01 1.416821185732613786e-01 1.416821185732613786e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.446785270683475233e-01 1.446785270683475233e-01 1.446785270683475233e-01 --2.031250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.323781653523543600e-01 1.323781653523543600e-01 1.323781653523543600e-01 --2.031250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.283306419944182097e-01 1.283306419944182097e-01 1.283306419944182097e-01 --1.718750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 3.280309336096205730e-02 3.280309336096205730e-02 3.280309336096205730e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.463730426436523624e-01 1.463730426436523624e-01 1.463730426436523624e-01 --1.718750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.962087641300807039e-01 1.962087641300807039e-01 1.962087641300807039e-01 --1.406250000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.756383607164624661e-01 1.756383607164624661e-01 1.756383607164624661e-01 --1.718750000000000000e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 1.777392279781046802e-01 1.777392279781046802e-01 1.777392279781046802e-01 --1.718750000000000000e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 1.725459641250368659e-01 1.725459641250368659e-01 1.725459641250368659e-01 --1.718750000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 2.168124235691231694e-01 2.168124235691231694e-01 2.168124235691231694e-01 --1.718750000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 2.083701755235670972e-01 2.083701755235670972e-01 2.083701755235670972e-01 --1.406250000000000000e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 1.996694241290424832e-01 1.996694241290424832e-01 1.996694241290424832e-01 --1.406250000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.581886866306736750e-01 1.581886866306736750e-01 1.581886866306736750e-01 --1.406250000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 1.379667704383377436e-01 1.379667704383377436e-01 1.379667704383377436e-01 --1.718750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.771756839477653389e-01 1.771756839477653389e-01 1.771756839477653389e-01 --1.718750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.953387603258261718e-01 1.953387603258261718e-01 1.953387603258261718e-01 --1.718750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.572042497351411328e-01 1.572042497351411328e-01 1.572042497351411328e-01 --1.718750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.395441679071769137e-01 1.395441679071769137e-01 1.395441679071769137e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.914284425589312666e-01 1.914284425589312666e-01 1.914284425589312666e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.969623852823601529e-01 1.969623852823601529e-01 1.969623852823601529e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.643070210714476231e-01 1.643070210714476231e-01 1.643070210714476231e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.717543814046426642e-01 1.717543814046426642e-01 1.717543814046426642e-01 --1.718750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.736120997398408750e-01 1.736120997398408750e-01 1.736120997398408750e-01 --1.718750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.270614818011013558e-01 1.270614818011013558e-01 1.270614818011013558e-01 --1.718750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 7.143275869815933488e-02 7.143275869815933488e-02 7.143275869815933488e-02 --1.718750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 6.127486796959811383e-02 6.127486796959811383e-02 6.127486796959811383e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 6.571653556450700318e-02 6.571653556450700318e-02 6.571653556450700318e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 5.925416610329706929e-02 5.925416610329706929e-02 5.925416610329706929e-02 --1.406250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 5.124868117668618384e-02 5.124868117668618384e-02 5.124868117668618384e-02 --1.406250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 6.959068563516662698e-02 6.959068563516662698e-02 6.959068563516662698e-02 --2.343750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.185166207998571281e-01 1.185166207998571281e-01 1.185166207998571281e-01 --2.343750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 7.166651150676163484e-02 7.166651150676163484e-02 7.166651150676163484e-02 --2.343750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.434995729038259504e-01 1.434995729038259504e-01 1.434995729038259504e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 9.046249960064235707e-02 9.046249960064235707e-02 9.046249960064235707e-02 --2.343750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 9.057259790065365357e-02 9.057259790065365357e-02 9.057259790065365357e-02 --2.031250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.129491600066324930e-01 1.129491600066324930e-01 1.129491600066324930e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 8.556015981036714513e-02 8.556015981036714513e-02 8.556015981036714513e-02 --2.343750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.641103102086342025e-01 1.641103102086342025e-01 1.641103102086342025e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.323853943248366194e-01 1.323853943248366194e-01 1.323853943248366194e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.287523521841491270e-01 1.287523521841491270e-01 1.287523521841491270e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.009444679037626580e-01 1.009444679037626580e-01 1.009444679037626580e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 5.452431136162801117e-02 5.452431136162801117e-02 5.452431136162801117e-02 --2.031250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 6.463136389017887229e-02 6.463136389017887229e-02 6.463136389017887229e-02 --2.031250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 7.229638673965149698e-02 7.229638673965149698e-02 7.229638673965149698e-02 --1.718750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.076777933557881844e-01 1.076777933557881844e-01 1.076777933557881844e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.105324568233501115e-01 1.105324568233501115e-01 1.105324568233501115e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.451748391174633723e-01 1.451748391174633723e-01 1.451748391174633723e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 1.077734057333732676e-01 1.077734057333732676e-01 1.077734057333732676e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.317612906420655150e-01 1.317612906420655150e-01 1.317612906420655150e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.234884473561856238e-01 1.234884473561856238e-01 1.234884473561856238e-01 --1.718750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 7.564671601195813166e-02 7.564671601195813166e-02 7.564671601195813166e-02 --1.718750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 8.589770753563218120e-02 8.589770753563218120e-02 8.589770753563218120e-02 --1.406250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.083350257245151993e-01 1.083350257245151993e-01 1.083350257245151993e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 9.371877397266178966e-02 9.371877397266178966e-02 9.371877397266178966e-02 --1.406250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 1.051588885311576377e-01 1.051588885311576377e-01 1.051588885311576377e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 9.656830772888796988e-02 9.656830772888796988e-02 9.656830772888796988e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.008568827502318299e-01 1.008568827502318299e-01 1.008568827502318299e-01 --1.718750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 4.860297837802454030e-02 4.860297837802454030e-02 4.860297837802454030e-02 --1.718750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 7.718482578022553553e-02 7.718482578022553553e-02 7.718482578022553553e-02 --1.406250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.393433807414624082e-01 1.393433807414624082e-01 1.393433807414624082e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 7.740063784715073281e-02 7.740063784715073281e-02 7.740063784715073281e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 6.874889339966717972e-02 6.874889339966717972e-02 6.874889339966717972e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 6.461231155653786307e-02 6.461231155653786307e-02 6.461231155653786307e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 6.382360529642366886e-02 6.382360529642366886e-02 6.382360529642366886e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 3.915934916094574586e-02 3.915934916094574586e-02 3.915934916094574586e-02 --1.718750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 7.268479126554074077e-02 7.268479126554074077e-02 7.268479126554074077e-02 --1.718750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 9.084020846887305711e-02 9.084020846887305711e-02 9.084020846887305711e-02 --1.406250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.194573470486946370e-01 1.194573470486946370e-01 1.194573470486946370e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.132440121084643397e-01 1.132440121084643397e-01 1.132440121084643397e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 7.229743170468967695e-02 7.229743170468967695e-02 7.229743170468967695e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.068952138262273394e-01 1.068952138262273394e-01 1.068952138262273394e-01 --2.343750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 9.862463445329464062e-02 9.862463445329464062e-02 9.862463445329464062e-02 --2.031250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.347291535999524670e-01 1.347291535999524670e-01 1.347291535999524670e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 9.048901964288870448e-02 9.048901964288870448e-02 9.048901964288870448e-02 --2.031250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.087110437849759109e-01 1.087110437849759109e-01 1.087110437849759109e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 9.363278816486407530e-02 9.363278816486407530e-02 9.363278816486407530e-02 --2.343750000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.081405883458130407e-01 1.081405883458130407e-01 1.081405883458130407e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.112499231575081182e-01 1.112499231575081182e-01 1.112499231575081182e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.117858092911855478e-01 1.117858092911855478e-01 1.117858092911855478e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.253111324609929300e-01 1.253111324609929300e-01 1.253111324609929300e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.096591157085009399e-01 1.096591157085009399e-01 1.096591157085009399e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.174746592465067546e-01 1.174746592465067546e-01 1.174746592465067546e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 6.033916912595579940e-02 6.033916912595579940e-02 6.033916912595579940e-02 --2.343750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 5.506515821429117802e-02 5.506515821429117802e-02 5.506515821429117802e-02 --2.343750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 5.949559179675215775e-02 5.949559179675215775e-02 5.949559179675215775e-02 --2.343750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 4.909329023879169251e-02 4.909329023879169251e-02 4.909329023879169251e-02 --2.031250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 7.695679579040197449e-02 7.695679579040197449e-02 7.695679579040197449e-02 --2.031250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 4.355720788256575021e-02 4.355720788256575021e-02 4.355720788256575021e-02 --2.031250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 7.461786363346285811e-02 7.461786363346285811e-02 7.461786363346285811e-02 --2.343750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 7.573593618420119966e-02 7.573593618420119966e-02 7.573593618420119966e-02 --2.343750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.104922849469519297e-01 1.104922849469519297e-01 1.104922849469519297e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.108771306984304428e-01 1.108771306984304428e-01 1.108771306984304428e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 9.550597220000497933e-02 9.550597220000497933e-02 9.550597220000497933e-02 --2.031250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.215829783210879145e-01 1.215829783210879145e-01 1.215829783210879145e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 5.968476034037885347e-02 5.968476034037885347e-02 5.968476034037885347e-02 --2.031250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 8.931489667139050348e-02 8.931489667139050348e-02 8.931489667139050348e-02 --1.718750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.282519225141801056e-01 1.282519225141801056e-01 1.282519225141801056e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.004052953995953068e-01 1.004052953995953068e-01 1.004052953995953068e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 9.262505979223056851e-02 9.262505979223056851e-02 9.262505979223056851e-02 --1.406250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 9.608214230257779154e-02 9.608214230257779154e-02 9.608214230257779154e-02 --1.406250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 7.927998683943518476e-02 7.927998683943518476e-02 7.927998683943518476e-02 --1.406250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.068180803188014255e-01 1.068180803188014255e-01 1.068180803188014255e-01 --1.718750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 3.271237797864098851e-02 3.271237797864098851e-02 3.271237797864098851e-02 --1.718750000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 6.429477199838058710e-02 6.429477199838058710e-02 6.429477199838058710e-02 --1.718750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 5.904280748388365807e-02 5.904280748388365807e-02 5.904280748388365807e-02 --1.718750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.402188091135808667e-01 1.402188091135808667e-01 1.402188091135808667e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 5.379371612089439703e-02 5.379371612089439703e-02 5.379371612089439703e-02 --1.406250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.029878265807056409e-01 1.029878265807056409e-01 1.029878265807056409e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 8.778312663925644244e-02 8.778312663925644244e-02 8.778312663925644244e-02 --1.406250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 6.637652243907232741e-02 6.637652243907232741e-02 6.637652243907232741e-02 --1.718750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 5.888740347377105500e-02 5.888740347377105500e-02 5.888740347377105500e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.193665686502198148e-01 1.193665686502198148e-01 1.193665686502198148e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 3.785203124289703014e-02 3.785203124289703014e-02 3.785203124289703014e-02 --1.406250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 9.597285512461974089e-02 9.597285512461974089e-02 9.597285512461974089e-02 --1.406250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 9.284926839273631438e-02 9.284926839273631438e-02 9.284926839273631438e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 4.546098776220845045e-02 4.546098776220845045e-02 4.546098776220845045e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 7.012218704446052109e-02 7.012218704446052109e-02 7.012218704446052109e-02 --1.093750000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 6.788940736609073989e-02 6.788940736609073989e-02 6.788940736609073989e-02 --1.093750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 6.979237041576188960e-02 6.979237041576188960e-02 6.979237041576188960e-02 --1.093750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 8.922890615679608672e-02 8.922890615679608672e-02 8.922890615679608672e-02 --7.812500000000000000e-02 -2.031250000000000000e-01 -2.343750000000000000e-01 8.445267185175014957e-02 8.445267185175014957e-02 8.445267185175014957e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 7.193048738331037084e-02 7.193048738331037084e-02 7.193048738331037084e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 6.915990325671668437e-02 6.915990325671668437e-02 6.915990325671668437e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 6.633118368447242508e-02 6.633118368447242508e-02 6.633118368447242508e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 5.283702591197809995e-02 5.283702591197809995e-02 5.283702591197809995e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 4.913654817687576615e-02 4.913654817687576615e-02 4.913654817687576615e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 8.241768326261676714e-02 8.241768326261676714e-02 8.241768326261676714e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 7.933351653723304253e-02 7.933351653723304253e-02 7.933351653723304253e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.030247881551868139e-01 1.030247881551868139e-01 1.030247881551868139e-01 --1.093750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 1.011445473921990523e-01 1.011445473921990523e-01 1.011445473921990523e-01 --7.812500000000000000e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 8.918229443759839725e-02 8.918229443759839725e-02 8.918229443759839725e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 5.949711929633722668e-02 5.949711929633722668e-02 5.949711929633722668e-02 --4.687500000000000000e-02 -2.031250000000000000e-01 -2.343750000000000000e-01 6.490131165997449492e-02 6.490131165997449492e-02 6.490131165997449492e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 2.175991530720240014e-02 2.175991530720240014e-02 2.175991530720240014e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 7.906417981366448133e-02 7.906417981366448133e-02 7.906417981366448133e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 1.052930714147581742e-01 1.052930714147581742e-01 1.052930714147581742e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 1.069225319257037649e-01 1.069225319257037649e-01 1.069225319257037649e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 1.442151391066229527e-01 1.442151391066229527e-01 1.442151391066229527e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 1.232771770864540400e-01 1.232771770864540400e-01 1.232771770864540400e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 7.928826545869634146e-02 7.928826545869634146e-02 7.928826545869634146e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 8.931087842508134145e-02 8.931087842508134145e-02 8.931087842508134145e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 1.014281933644791966e-01 1.014281933644791966e-01 1.014281933644791966e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 8.296179860214479562e-02 8.296179860214479562e-02 8.296179860214479562e-02 --1.093750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.254002975745994730e-01 1.254002975745994730e-01 1.254002975745994730e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 1.826455869908873431e-01 1.826455869908873431e-01 1.826455869908873431e-01 --1.093750000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 3.956198625607378061e-02 3.956198625607378061e-02 3.956198625607378061e-02 --7.812500000000000000e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 1.945169030723775394e-01 1.945169030723775394e-01 1.945169030723775394e-01 --7.812500000000000000e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 6.874937571248851409e-02 6.874937571248851409e-02 6.874937571248851409e-02 --7.812500000000000000e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 5.751657113541209371e-02 5.751657113541209371e-02 5.751657113541209371e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.672375545211921832e-01 1.672375545211921832e-01 1.672375545211921832e-01 --1.093750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.016483598037458830e-01 1.016483598037458830e-01 1.016483598037458830e-01 --1.093750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 8.275845903145467863e-02 8.275845903145467863e-02 8.275845903145467863e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 1.382117349046816934e-01 1.382117349046816934e-01 1.382117349046816934e-01 --7.812500000000000000e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 8.383542956649948918e-02 8.383542956649948918e-02 8.383542956649948918e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 6.976045779184224249e-02 6.976045779184224249e-02 6.976045779184224249e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 7.991189220180382191e-02 7.991189220180382191e-02 7.991189220180382191e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 6.601188236988121683e-02 6.601188236988121683e-02 6.601188236988121683e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.129957579583793503e-01 1.129957579583793503e-01 1.129957579583793503e-01 --7.812500000000000000e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 1.068903929841730355e-01 1.068903929841730355e-01 1.068903929841730355e-01 --7.812500000000000000e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 8.453384528954427379e-02 8.453384528954427379e-02 8.453384528954427379e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 5.813699002522543929e-02 5.813699002522543929e-02 5.813699002522543929e-02 --4.687500000000000000e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 1.601430713300768804e-01 1.601430713300768804e-01 1.601430713300768804e-01 --4.687500000000000000e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 2.151715465104367953e-01 2.151715465104367953e-01 2.151715465104367953e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 1.202020473889352653e-01 1.202020473889352653e-01 1.202020473889352653e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 1.532816388946176001e-01 1.532816388946176001e-01 1.532816388946176001e-01 --1.562500000000000000e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 1.447781109612737982e-01 1.447781109612737982e-01 1.447781109612737982e-01 --1.562500000000000000e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 1.269891872633502894e-01 1.269891872633502894e-01 1.269891872633502894e-01 --1.562500000000000000e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 1.958451935738765304e-01 1.958451935738765304e-01 1.958451935738765304e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 1.190203244377772418e-01 1.190203244377772418e-01 1.190203244377772418e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 5.635000665859785096e-02 5.635000665859785096e-02 5.635000665859785096e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 1.422025427444491841e-01 1.422025427444491841e-01 1.422025427444491841e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 1.028030184535373148e-01 1.028030184535373148e-01 1.028030184535373148e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 1.023064449481949495e-01 1.023064449481949495e-01 1.023064449481949495e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 1.502783234354453656e-01 1.502783234354453656e-01 1.502783234354453656e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 1.260011554031906233e-01 1.260011554031906233e-01 1.260011554031906233e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 1.942680969748925845e-01 1.942680969748925845e-01 1.942680969748925845e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 1.665085441194459059e-01 1.665085441194459059e-01 1.665085441194459059e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.121288709540860240e-01 1.121288709540860240e-01 1.121288709540860240e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 1.085768666018300938e-01 1.085768666018300938e-01 1.085768666018300938e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.129355019811906224e-01 1.129355019811906224e-01 1.129355019811906224e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.216151113939257372e-01 1.216151113939257372e-01 1.216151113939257372e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 7.351207379431823341e-02 7.351207379431823341e-02 7.351207379431823341e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 7.715564890889196892e-02 7.715564890889196892e-02 7.715564890889196892e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 1.060258506392814659e-01 1.060258506392814659e-01 1.060258506392814659e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 9.220958915685895096e-02 9.220958915685895096e-02 9.220958915685895096e-02 --1.093750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 9.999629328068707079e-02 9.999629328068707079e-02 9.999629328068707079e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 9.815053486842717501e-02 9.815053486842717501e-02 9.815053486842717501e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.002269096623312067e-01 1.002269096623312067e-01 1.002269096623312067e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 8.646108760842093066e-02 8.646108760842093066e-02 8.646108760842093066e-02 --7.812500000000000000e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 9.805250036841289818e-02 9.805250036841289818e-02 9.805250036841289818e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 9.405789467378132540e-02 9.405789467378132540e-02 9.405789467378132540e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 9.788053792408532572e-02 9.788053792408532572e-02 9.788053792408532572e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.343797626992576100e-01 1.343797626992576100e-01 1.343797626992576100e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.416949685933246994e-01 1.416949685933246994e-01 1.416949685933246994e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 7.747225356712897359e-02 7.747225356712897359e-02 7.747225356712897359e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 -2.031250000000000000e-01 1.335042707893638048e-01 1.335042707893638048e-01 1.335042707893638048e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 1.281916779619811930e-01 1.281916779619811930e-01 1.281916779619811930e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 9.241531569708698324e-02 9.241531569708698324e-02 9.241531569708698324e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.061680668864690008e-01 1.061680668864690008e-01 1.061680668864690008e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 9.352831930279255357e-02 9.352831930279255357e-02 9.352831930279255357e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.359058267380028051e-01 1.359058267380028051e-01 1.359058267380028051e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 1.198116228274387490e-01 1.198116228274387490e-01 1.198116228274387490e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 8.915416666293173031e-02 8.915416666293173031e-02 8.915416666293173031e-02 --7.812500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 1.591152989350712033e-01 1.591152989350712033e-01 1.591152989350712033e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 9.383047502498104153e-02 9.383047502498104153e-02 9.383047502498104153e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 1.455667467922605318e-01 1.455667467922605318e-01 1.455667467922605318e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 9.021658606526583579e-02 9.021658606526583579e-02 9.021658606526583579e-02 --4.687500000000000000e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 1.026029430894732780e-01 1.026029430894732780e-01 1.026029430894732780e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 8.706062897338096018e-02 8.706062897338096018e-02 8.706062897338096018e-02 --4.687500000000000000e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 8.172166034434760751e-02 8.172166034434760751e-02 8.172166034434760751e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 1.213291265944936442e-01 1.213291265944936442e-01 1.213291265944936442e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 9.856356415505143631e-02 9.856356415505143631e-02 9.856356415505143631e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 1.160181398719614398e-01 1.160181398719614398e-01 1.160181398719614398e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 -2.343750000000000000e-01 1.276173442992487306e-01 1.276173442992487306e-01 1.276173442992487306e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 1.019858400374229340e-01 1.019858400374229340e-01 1.019858400374229340e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 1.199168609101662619e-01 1.199168609101662619e-01 1.199168609101662619e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 8.342071724641166031e-02 8.342071724641166031e-02 8.342071724641166031e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 8.158261578340583742e-02 8.158261578340583742e-02 8.158261578340583742e-02 --1.562500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 7.080882507654127911e-02 7.080882507654127911e-02 7.080882507654127911e-02 --1.562500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 1.164037625706513118e-01 1.164037625706513118e-01 1.164037625706513118e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 6.000593583332024250e-02 6.000593583332024250e-02 6.000593583332024250e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 4.531223145356312598e-02 4.531223145356312598e-02 4.531223145356312598e-02 --7.812500000000000000e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 9.755027257263736151e-02 9.755027257263736151e-02 9.755027257263736151e-02 --7.812500000000000000e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 7.867869960391561668e-02 7.867869960391561668e-02 7.867869960391561668e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 6.719157062179725859e-02 6.719157062179725859e-02 6.719157062179725859e-02 --1.093750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.129756726376581061e-01 1.129756726376581061e-01 1.129756726376581061e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 7.025707144725787390e-02 7.025707144725787390e-02 7.025707144725787390e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.955996019372804595e-01 1.955996019372804595e-01 1.955996019372804595e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.970378272667113739e-01 1.970378272667113739e-01 1.970378272667113739e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 4.002412784776433058e-02 4.002412784776433058e-02 4.002412784776433058e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 5.338495938002821989e-02 5.338495938002821989e-02 5.338495938002821989e-02 --7.812500000000000000e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 5.995769929543171006e-02 5.995769929543171006e-02 5.995769929543171006e-02 --7.812500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 6.550053137614765542e-02 6.550053137614765542e-02 6.550053137614765542e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.067264841826647964e-01 1.067264841826647964e-01 1.067264841826647964e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 8.466886627195918669e-02 8.466886627195918669e-02 8.466886627195918669e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.078023304638697777e-01 1.078023304638697777e-01 1.078023304638697777e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 4.084419207704598209e-01 4.084419207704598209e-01 4.084419207704598209e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 9.652571814779960235e-02 9.652571814779960235e-02 9.652571814779960235e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 5.688183673817316655e-02 5.688183673817316655e-02 5.688183673817316655e-02 --7.812500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 6.548891305709614308e-01 6.548891305709614308e-01 6.548891305709614308e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 5.033997903916577199e-01 5.033997903916577199e-01 5.033997903916577199e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 1.216681309360475166e-01 1.216681309360475166e-01 1.216681309360475166e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 1.337243494686447820e-01 1.337243494686447820e-01 1.337243494686447820e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 9.589169322730171918e-02 9.589169322730171918e-02 9.589169322730171918e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 1.576836222240207974e-01 1.576836222240207974e-01 1.576836222240207974e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 1.662154929225323208e-01 1.662154929225323208e-01 1.662154929225323208e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.736658878339858714e-01 1.736658878339858714e-01 1.736658878339858714e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 9.594955122188361663e-02 9.594955122188361663e-02 9.594955122188361663e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.042155845777947565e-01 1.042155845777947565e-01 1.042155845777947565e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 1.968548402036187361e-01 1.968548402036187361e-01 1.968548402036187361e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 1.044341363929526811e-01 1.044341363929526811e-01 1.044341363929526811e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 1.643688443861410498e-01 1.643688443861410498e-01 1.643688443861410498e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 1.060137984033898556e-01 1.060137984033898556e-01 1.060137984033898556e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 1.011726709751941400e-01 1.011726709751941400e-01 1.011726709751941400e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 1.302520160372568347e-01 1.302520160372568347e-01 1.302520160372568347e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 9.808062503226731843e-02 9.808062503226731843e-02 9.808062503226731843e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 7.667041107022519453e-02 7.667041107022519453e-02 7.667041107022519453e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 8.450009000852137797e-02 8.450009000852137797e-02 8.450009000852137797e-02 --1.562500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 1.030794269733380786e-01 1.030794269733380786e-01 1.030794269733380786e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 2.066994346090798296e-01 2.066994346090798296e-01 2.066994346090798296e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 4.819467770014394109e-02 4.819467770014394109e-02 4.819467770014394109e-02 --4.218750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 8.820906771813567804e-02 8.820906771813567804e-02 8.820906771813567804e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 7.684595545970407393e-02 7.684595545970407393e-02 7.684595545970407393e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.041207714733472650e-01 1.041207714733472650e-01 1.041207714733472650e-01 --3.906250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 7.596742589946503532e-02 7.596742589946503532e-02 7.596742589946503532e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 9.063367426489229994e-02 9.063367426489229994e-02 9.063367426489229994e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 8.966689426828006182e-02 8.966689426828006182e-02 8.966689426828006182e-02 --3.281250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.084282269460539877e-01 1.084282269460539877e-01 1.084282269460539877e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.074423775216503535e-01 1.074423775216503535e-01 1.074423775216503535e-01 --2.968750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.262051889928277604e-01 1.262051889928277604e-01 1.262051889928277604e-01 --2.968750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 8.489148965889485587e-02 8.489148965889485587e-02 8.489148965889485587e-02 --2.656250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.102062606072120726e-01 1.102062606072120726e-01 1.102062606072120726e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.248002385534497383e-01 1.248002385534497383e-01 1.248002385534497383e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 1.284013288089936866e-01 1.284013288089936866e-01 1.284013288089936866e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 8.017254568984560903e-02 8.017254568984560903e-02 8.017254568984560903e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 9.902560802323476241e-02 9.902560802323476241e-02 9.902560802323476241e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 5.109639783214761644e-02 5.109639783214761644e-02 5.109639783214761644e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.072278512299181114e-01 1.072278512299181114e-01 1.072278512299181114e-01 --3.281250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 5.807765770125177668e-02 5.807765770125177668e-02 5.807765770125177668e-02 --3.593750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 2.973142004495848978e-02 2.973142004495848978e-02 2.973142004495848978e-02 --3.593750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 2.911753777410009542e-02 2.911753777410009542e-02 2.911753777410009542e-02 --3.593750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 4.223789963145824222e-02 4.223789963145824222e-02 4.223789963145824222e-02 --3.593750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 4.343924538153426385e-02 4.343924538153426385e-02 4.343924538153426385e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 6.549578844179862469e-02 6.549578844179862469e-02 6.549578844179862469e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 6.534570256128512111e-02 6.534570256128512111e-02 6.534570256128512111e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 7.518260876322542530e-02 7.518260876322542530e-02 7.518260876322542530e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 7.557702775453965793e-02 7.557702775453965793e-02 7.557702775453965793e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 3.890555889609243617e-02 3.890555889609243617e-02 3.890555889609243617e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.068855721418476984e-01 1.068855721418476984e-01 1.068855721418476984e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 8.710161622257339697e-02 8.710161622257339697e-02 8.710161622257339697e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 7.452430171764140576e-02 7.452430171764140576e-02 7.452430171764140576e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.014956897091710414e-01 1.014956897091710414e-01 1.014956897091710414e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 5.099460743162023690e-02 5.099460743162023690e-02 5.099460743162023690e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 6.493290465422221769e-02 6.493290465422221769e-02 6.493290465422221769e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 7.018424354392772957e-02 7.018424354392772957e-02 7.018424354392772957e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 7.578038547633532407e-02 7.578038547633532407e-02 7.578038547633532407e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 8.919515284558911239e-02 8.919515284558911239e-02 8.919515284558911239e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 4.119076824177712176e-02 4.119076824177712176e-02 4.119076824177712176e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 8.507151678485044832e-02 8.507151678485044832e-02 8.507151678485044832e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 6.282338183420464739e-02 6.282338183420464739e-02 6.282338183420464739e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 7.156780166905715723e-02 7.156780166905715723e-02 7.156780166905715723e-02 --2.656250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 7.670216019834713572e-02 7.670216019834713572e-02 7.670216019834713572e-02 --2.656250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 8.185105997996976190e-02 8.185105997996976190e-02 8.185105997996976190e-02 --2.968750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.087881754776089394e-01 1.087881754776089394e-01 1.087881754776089394e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.017946014121316467e-01 1.017946014121316467e-01 1.017946014121316467e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.101990296416147375e-01 1.101990296416147375e-01 1.101990296416147375e-01 --2.656250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 9.494024468153812457e-02 9.494024468153812457e-02 9.494024468153812457e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.119995200070872388e-01 1.119995200070872388e-01 1.119995200070872388e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 8.425898044655945329e-02 8.425898044655945329e-02 8.425898044655945329e-02 --2.968750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 8.730574848602286331e-02 8.730574848602286331e-02 8.730574848602286331e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 5.866076873779828282e-02 5.866076873779828282e-02 5.866076873779828282e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 7.011012942891091393e-02 7.011012942891091393e-02 7.011012942891091393e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 6.044842432481877664e-02 6.044842432481877664e-02 6.044842432481877664e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 7.782864330643912698e-02 7.782864330643912698e-02 7.782864330643912698e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 8.374300355624660075e-02 8.374300355624660075e-02 8.374300355624660075e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 5.724137278366139142e-02 5.724137278366139142e-02 5.724137278366139142e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 7.103116528585816380e-02 7.103116528585816380e-02 7.103116528585816380e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 7.811872120490512272e-02 7.811872120490512272e-02 7.811872120490512272e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.149319593355663249e-01 1.149319593355663249e-01 1.149319593355663249e-01 --3.593750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 8.896289753445872639e-02 8.896289753445872639e-02 8.896289753445872639e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 5.416990877641067459e-02 5.416990877641067459e-02 5.416990877641067459e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 9.749241572917269338e-02 9.749241572917269338e-02 9.749241572917269338e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 9.707054165450600125e-02 9.707054165450600125e-02 9.707054165450600125e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.053147656324182890e-01 1.053147656324182890e-01 1.053147656324182890e-01 --3.281250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.405930719145914443e-01 1.405930719145914443e-01 1.405930719145914443e-01 --2.968750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 5.974368950684389584e-02 5.974368950684389584e-02 5.974368950684389584e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.126968878682736014e-01 1.126968878682736014e-01 1.126968878682736014e-01 --2.656250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 6.853289735248693781e-02 6.853289735248693781e-02 6.853289735248693781e-02 --2.656250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 9.839562059586945408e-02 9.839562059586945408e-02 9.839562059586945408e-02 --2.656250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.150050681011908771e-01 1.150050681011908771e-01 1.150050681011908771e-01 --2.656250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.214560525579198719e-01 1.214560525579198719e-01 1.214560525579198719e-01 --2.656250000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.463409194575113204e-01 1.463409194575113204e-01 1.463409194575113204e-01 --2.656250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.851725020248938813e-01 1.851725020248938813e-01 1.851725020248938813e-01 --2.968750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 7.082867977676128579e-02 7.082867977676128579e-02 7.082867977676128579e-02 --2.968750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 7.707012766028374651e-02 7.707012766028374651e-02 7.707012766028374651e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 7.743929909111035848e-02 7.743929909111035848e-02 7.743929909111035848e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.244837397568710896e-01 1.244837397568710896e-01 1.244837397568710896e-01 --2.968750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.661986324102319168e-01 1.661986324102319168e-01 1.661986324102319168e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.429365921026033437e-01 1.429365921026033437e-01 1.429365921026033437e-01 --2.656250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.786383213922761448e-01 1.786383213922761448e-01 1.786383213922761448e-01 --2.656250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.222852488078618238e-01 2.222852488078618238e-01 2.222852488078618238e-01 --2.656250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.987312404276936340e-01 1.987312404276936340e-01 1.987312404276936340e-01 --2.656250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.432616325294640336e-01 2.432616325294640336e-01 2.432616325294640336e-01 --3.906250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 9.265720443282148000e-02 9.265720443282148000e-02 9.265720443282148000e-02 --3.906250000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 4.698761363754212078e-02 4.698761363754212078e-02 4.698761363754212078e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.257087599081035401e-01 1.257087599081035401e-01 1.257087599081035401e-01 --3.906250000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 9.384976152190149801e-02 9.384976152190149801e-02 9.384976152190149801e-02 --3.593750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 1.072583830966234719e-01 1.072583830966234719e-01 1.072583830966234719e-01 --3.593750000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 7.016197716296738995e-02 7.016197716296738995e-02 7.016197716296738995e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.043120045694293924e-01 1.043120045694293924e-01 1.043120045694293924e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 1.039038258140132093e-01 1.039038258140132093e-01 1.039038258140132093e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 6.819310634202695176e-02 6.819310634202695176e-02 6.819310634202695176e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.493933679238849677e-01 1.493933679238849677e-01 1.493933679238849677e-01 --3.281250000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.040717578755346456e-01 1.040717578755346456e-01 1.040717578755346456e-01 --2.656250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.842831140437032333e-01 1.842831140437032333e-01 1.842831140437032333e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.239559712279641457e-01 1.239559712279641457e-01 1.239559712279641457e-01 --2.656250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.257086844071360676e-01 2.257086844071360676e-01 2.257086844071360676e-01 --2.656250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 2.098683560505516799e-01 2.098683560505516799e-01 2.098683560505516799e-01 --1.718750000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 1.232386181940908348e-01 1.232386181940908348e-01 1.232386181940908348e-01 --1.718750000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 1.207908940183945318e-01 1.207908940183945318e-01 1.207908940183945318e-01 --1.718750000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 1.149681120301609544e-01 1.149681120301609544e-01 1.149681120301609544e-01 --1.718750000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 1.596484575038385478e-01 1.596484575038385478e-01 1.596484575038385478e-01 --1.406250000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 2.299197837475080164e-01 2.299197837475080164e-01 2.299197837475080164e-01 --1.406250000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 1.859647554214578502e-01 1.859647554214578502e-01 1.859647554214578502e-01 --1.406250000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 2.553814483994333306e-01 2.553814483994333306e-01 2.553814483994333306e-01 --1.718750000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 1.162720083564660195e-01 1.162720083564660195e-01 1.162720083564660195e-01 --1.406250000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 1.866887734861001069e-01 1.866887734861001069e-01 1.866887734861001069e-01 --1.093750000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 1.840142087021309492e-01 1.840142087021309492e-01 1.840142087021309492e-01 --1.093750000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 1.819704987337768809e-01 1.819704987337768809e-01 1.819704987337768809e-01 --1.093750000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 2.349665548987436292e-01 2.349665548987436292e-01 2.349665548987436292e-01 --1.093750000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 2.822581307858592070e-01 2.822581307858592070e-01 2.822581307858592070e-01 --7.812500000000000000e-02 -2.656250000000000000e-01 1.562500000000000000e-02 2.593728642064948575e-01 2.593728642064948575e-01 2.593728642064948575e-01 --7.812500000000000000e-02 -2.656250000000000000e-01 4.687500000000000000e-02 2.427891866144631094e-01 2.427891866144631094e-01 2.427891866144631094e-01 --1.093750000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 1.877627483706535150e-01 1.877627483706535150e-01 1.877627483706535150e-01 --4.687500000000000000e-02 -2.968750000000000000e-01 1.562500000000000000e-02 1.761834515315428007e-01 1.761834515315428007e-01 1.761834515315428007e-01 --4.687500000000000000e-02 -2.656250000000000000e-01 1.562500000000000000e-02 2.864606595797801192e-01 2.864606595797801192e-01 2.864606595797801192e-01 --4.687500000000000000e-02 -2.656250000000000000e-01 4.687500000000000000e-02 2.221328074628598492e-01 2.221328074628598492e-01 2.221328074628598492e-01 --1.562500000000000000e-02 -2.968750000000000000e-01 1.562500000000000000e-02 2.058391740746848275e-01 2.058391740746848275e-01 2.058391740746848275e-01 --1.562500000000000000e-02 -2.656250000000000000e-01 1.562500000000000000e-02 3.001923068477755918e-01 3.001923068477755918e-01 3.001923068477755918e-01 --1.562500000000000000e-02 -2.656250000000000000e-01 4.687500000000000000e-02 2.398100664666348858e-01 2.398100664666348858e-01 2.398100664666348858e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.378527211536361430e-01 1.378527211536361430e-01 1.378527211536361430e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 1.363090240865979241e-01 1.363090240865979241e-01 1.363090240865979241e-01 --2.031250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.467087291715024611e-01 1.467087291715024611e-01 1.467087291715024611e-01 --2.031250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 1.181044972959335443e-01 1.181044972959335443e-01 1.181044972959335443e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 1.130399456463086622e-01 1.130399456463086622e-01 1.130399456463086622e-01 --1.718750000000000000e-01 -2.343750000000000000e-01 1.562500000000000000e-02 1.565249330753153700e-01 1.565249330753153700e-01 1.565249330753153700e-01 --1.718750000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.423149796231597264e-01 1.423149796231597264e-01 1.423149796231597264e-01 --1.718750000000000000e-01 -2.031250000000000000e-01 1.562500000000000000e-02 1.030890023662981748e-02 1.030890023662981748e-02 1.030890023662981748e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 8.772445910641929467e-02 8.772445910641929467e-02 8.772445910641929467e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.844043218291688269e-01 1.844043218291688269e-01 1.844043218291688269e-01 --1.406250000000000000e-01 -2.031250000000000000e-01 1.562500000000000000e-02 5.949647613862167617e-02 5.949647613862167617e-02 5.949647613862167617e-02 --1.406250000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 7.133806771789709400e-02 7.133806771789709400e-02 7.133806771789709400e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 7.812500000000000000e-02 1.843088004770691291e-01 1.843088004770691291e-01 1.843088004770691291e-01 --1.406250000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 1.350954100186362583e-01 1.350954100186362583e-01 1.350954100186362583e-01 --1.406250000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.282896757439069557e-01 1.282896757439069557e-01 1.282896757439069557e-01 --1.718750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 6.588591395484454105e-02 6.588591395484454105e-02 6.588591395484454105e-02 --1.718750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 7.858064137430724461e-02 7.858064137430724461e-02 7.858064137430724461e-02 --1.718750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 9.869052603887050468e-02 9.869052603887050468e-02 9.869052603887050468e-02 --1.718750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 9.802357213246379319e-02 9.802357213246379319e-02 9.802357213246379319e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 7.120527508586187160e-02 7.120527508586187160e-02 7.120527508586187160e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 7.592442352008685336e-02 7.592442352008685336e-02 7.592442352008685336e-02 --1.406250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 9.043115772125615015e-02 9.043115772125615015e-02 9.043115772125615015e-02 --1.718750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 8.333793526766572479e-02 8.333793526766572479e-02 8.333793526766572479e-02 --1.718750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 1.014812262115027397e-01 1.014812262115027397e-01 1.014812262115027397e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 7.772825312236548989e-02 7.772825312236548989e-02 7.772825312236548989e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.223759961049294617e-02 1.223759961049294617e-02 1.223759961049294617e-02 --1.406250000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 4.158294153116763592e-02 4.158294153116763592e-02 4.158294153116763592e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 9.766839683217350132e-02 9.766839683217350132e-02 9.766839683217350132e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 1.445877771230932307e-01 1.445877771230932307e-01 1.445877771230932307e-01 --1.406250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 6.290176340169868763e-02 6.290176340169868763e-02 6.290176340169868763e-02 --1.406250000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 1.792604560427202842e-01 1.792604560427202842e-01 1.792604560427202842e-01 --1.406250000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.008825958327186079e-01 1.008825958327186079e-01 1.008825958327186079e-01 --1.718750000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 1.077822438465717014e-01 1.077822438465717014e-01 1.077822438465717014e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 1.508982683224366905e-01 1.508982683224366905e-01 1.508982683224366905e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.459345600455019820e-01 1.459345600455019820e-01 1.459345600455019820e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.208382907629564906e-01 1.208382907629564906e-01 1.208382907629564906e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 1.311162980938964662e-01 1.311162980938964662e-01 1.311162980938964662e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.077251978261154902e-01 1.077251978261154902e-01 1.077251978261154902e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 9.582097784407171692e-02 9.582097784407171692e-02 9.582097784407171692e-02 --2.031250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.387908118743207964e-01 1.387908118743207964e-01 1.387908118743207964e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 1.193480916185031548e-01 1.193480916185031548e-01 1.193480916185031548e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.277490799352938300e-01 1.277490799352938300e-01 1.277490799352938300e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 1.621391605167232242e-01 1.621391605167232242e-01 1.621391605167232242e-01 --2.343750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 9.218387330233762667e-02 9.218387330233762667e-02 9.218387330233762667e-02 --2.343750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 7.097730853087409753e-02 7.097730853087409753e-02 7.097730853087409753e-02 --2.343750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 7.356432123937117762e-02 7.356432123937117762e-02 7.356432123937117762e-02 --2.343750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 7.667338503971624086e-02 7.667338503971624086e-02 7.667338503971624086e-02 --2.031250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 1.244909694387183186e-01 1.244909694387183186e-01 1.244909694387183186e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 1.545825054455957359e-01 1.545825054455957359e-01 1.545825054455957359e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.146563949295568291e-01 1.146563949295568291e-01 1.146563949295568291e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.066541713699708516e-01 1.066541713699708516e-01 1.066541713699708516e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.261304838409108842e-01 1.261304838409108842e-01 1.261304838409108842e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 9.903766130601990292e-02 9.903766130601990292e-02 9.903766130601990292e-02 --2.031250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.587178365586964790e-01 1.587178365586964790e-01 1.587178365586964790e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.874505105138936090e-01 1.874505105138936090e-01 1.874505105138936090e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.284792448849302327e-01 1.284792448849302327e-01 1.284792448849302327e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.298536077992342164e-01 1.298536077992342164e-01 1.298536077992342164e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.000212030959075488e-01 1.000212030959075488e-01 1.000212030959075488e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 8.742308411955072855e-02 8.742308411955072855e-02 8.742308411955072855e-02 --2.343750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.282928887839148435e-01 1.282928887839148435e-01 1.282928887839148435e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.390622778675994486e-01 1.390622778675994486e-01 1.390622778675994486e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.532495184667747035e-01 1.532495184667747035e-01 1.532495184667747035e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.701856437528347921e-01 1.701856437528347921e-01 1.701856437528347921e-01 --1.718750000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 8.304377725603624694e-02 8.304377725603624694e-02 8.304377725603624694e-02 --1.718750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 7.405841963050169285e-02 7.405841963050169285e-02 7.405841963050169285e-02 --1.718750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 9.053000514553102840e-02 9.053000514553102840e-02 9.053000514553102840e-02 --1.718750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 6.426526889226126527e-02 6.426526889226126527e-02 6.426526889226126527e-02 --1.406250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.361146543022696553e-01 1.361146543022696553e-01 1.361146543022696553e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 4.733336392081867461e-02 4.733336392081867461e-02 4.733336392081867461e-02 --1.406250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.166945851333208856e-01 1.166945851333208856e-01 1.166945851333208856e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 6.621397806211881676e-02 6.621397806211881676e-02 6.621397806211881676e-02 --1.718750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 8.857553597374502596e-02 8.857553597374502596e-02 8.857553597374502596e-02 --1.406250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.983050815145534218e-01 1.983050815145534218e-01 1.983050815145534218e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.496535554910580212e-01 1.496535554910580212e-01 1.496535554910580212e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 9.849767246547644350e-02 9.849767246547644350e-02 9.849767246547644350e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.807393422912629069e-02 1.807393422912629069e-02 1.807393422912629069e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 7.075930887975635797e-02 7.075930887975635797e-02 7.075930887975635797e-02 --1.718750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.170665472656140793e-01 1.170665472656140793e-01 1.170665472656140793e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.303692890540614213e-01 1.303692890540614213e-01 1.303692890540614213e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.203169250370163951e-01 1.203169250370163951e-01 1.203169250370163951e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 3.685349527609525083e-02 3.685349527609525083e-02 3.685349527609525083e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 3.024830641059371786e-02 3.024830641059371786e-02 3.024830641059371786e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 8.096776267659526460e-02 8.096776267659526460e-02 8.096776267659526460e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 4.726566130790749859e-02 4.726566130790749859e-02 4.726566130790749859e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 1.315877937775941919e-01 1.315877937775941919e-01 1.315877937775941919e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.332175250376247677e-01 1.332175250376247677e-01 1.332175250376247677e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.589370433242632830e-01 1.589370433242632830e-01 1.589370433242632830e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 5.242770149803673702e-02 5.242770149803673702e-02 5.242770149803673702e-02 --1.406250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 6.375575577780613623e-02 6.375575577780613623e-02 6.375575577780613623e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 6.012130143583760411e-02 6.012130143583760411e-02 6.012130143583760411e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.640933857520574510e-02 2.640933857520574510e-02 2.640933857520574510e-02 --2.343750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 8.040554974275532230e-02 8.040554974275532230e-02 8.040554974275532230e-02 --2.343750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.315371904549842430e-01 1.315371904549842430e-01 1.315371904549842430e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.258059574296020999e-01 1.258059574296020999e-01 1.258059574296020999e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.159964485402407569e-01 1.159964485402407569e-01 1.159964485402407569e-01 --2.343750000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 9.358296457063712548e-02 9.358296457063712548e-02 9.358296457063712548e-02 --2.343750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.403810434170563171e-01 1.403810434170563171e-01 1.403810434170563171e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.473752796085687489e-01 1.473752796085687489e-01 1.473752796085687489e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.197827024141777663e-01 1.197827024141777663e-01 1.197827024141777663e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.535916003643379157e-01 1.535916003643379157e-01 1.535916003643379157e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 2.081109802395116892e-01 2.081109802395116892e-01 2.081109802395116892e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.438135875878990000e-01 1.438135875878990000e-01 1.438135875878990000e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.552538085983747873e-01 1.552538085983747873e-01 1.552538085983747873e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 1.877796043644411050e-01 1.877796043644411050e-01 1.877796043644411050e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.694895768706636552e-01 1.694895768706636552e-01 1.694895768706636552e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.799773097456465742e-01 1.799773097456465742e-01 1.799773097456465742e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.617473335612093499e-01 1.617473335612093499e-01 1.617473335612093499e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 2.258619212633081741e-01 2.258619212633081741e-01 2.258619212633081741e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.917486912453030823e-01 1.917486912453030823e-01 1.917486912453030823e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.984984985515079181e-01 1.984984985515079181e-01 1.984984985515079181e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.175305474994292387e-01 2.175305474994292387e-01 2.175305474994292387e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.902140543793321148e-01 1.902140543793321148e-01 1.902140543793321148e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.360471051899272477e-01 2.360471051899272477e-01 2.360471051899272477e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 2.275996549278587466e-01 2.275996549278587466e-01 2.275996549278587466e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.349320604781925670e-01 2.349320604781925670e-01 2.349320604781925670e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.506846609085648603e-01 1.506846609085648603e-01 1.506846609085648603e-01 --1.718750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.379274154217350057e-01 1.379274154217350057e-01 1.379274154217350057e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 2.053095314841486552e-01 2.053095314841486552e-01 2.053095314841486552e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.407143455388583375e-01 1.407143455388583375e-01 1.407143455388583375e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.757989180412741215e-01 1.757989180412741215e-01 1.757989180412741215e-01 --1.718750000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.644619807185899452e-01 1.644619807185899452e-01 1.644619807185899452e-01 --1.718750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.900639601854856031e-01 1.900639601854856031e-01 1.900639601854856031e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.888110239312424388e-01 1.888110239312424388e-01 1.888110239312424388e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.815587001425995883e-01 1.815587001425995883e-01 1.815587001425995883e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 2.126231058152432685e-01 2.126231058152432685e-01 2.126231058152432685e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.198638042459631070e-01 2.198638042459631070e-01 2.198638042459631070e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 1.562500000000000000e-02 1.038973977855574132e-01 1.038973977855574132e-01 1.038973977855574132e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.926717066431499481e-01 1.926717066431499481e-01 1.926717066431499481e-01 --1.093750000000000000e-01 -2.031250000000000000e-01 1.562500000000000000e-02 5.758201401710853762e-02 5.758201401710853762e-02 5.758201401710853762e-02 --1.093750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 6.691897775562397066e-02 6.691897775562397066e-02 6.691897775562397066e-02 --7.812500000000000000e-02 -2.343750000000000000e-01 1.562500000000000000e-02 1.753260758020481758e-01 1.753260758020481758e-01 1.753260758020481758e-01 --7.812500000000000000e-02 -2.343750000000000000e-01 4.687500000000000000e-02 2.147936184951978189e-01 2.147936184951978189e-01 2.147936184951978189e-01 --7.812500000000000000e-02 -2.031250000000000000e-01 1.562500000000000000e-02 8.064305404183733095e-02 8.064305404183733095e-02 8.064305404183733095e-02 --7.812500000000000000e-02 -2.031250000000000000e-01 4.687500000000000000e-02 1.095217263168734995e-01 1.095217263168734995e-01 1.095217263168734995e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 7.812500000000000000e-02 2.004286306467830403e-01 2.004286306467830403e-01 2.004286306467830403e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 1.586519941168774983e-01 1.586519941168774983e-01 1.586519941168774983e-01 --1.093750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.012152580964229692e-01 1.012152580964229692e-01 1.012152580964229692e-01 --1.093750000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.474700417524685836e-01 1.474700417524685836e-01 1.474700417524685836e-01 --7.812500000000000000e-02 -2.343750000000000000e-01 1.093750000000000000e-01 1.588744128807497435e-01 1.588744128807497435e-01 1.588744128807497435e-01 --7.812500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 1.895534773021680663e-01 1.895534773021680663e-01 1.895534773021680663e-01 --1.093750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 5.882702656322091883e-02 5.882702656322091883e-02 5.882702656322091883e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 5.904980186319765123e-02 5.904980186319765123e-02 5.904980186319765123e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 3.633584716597451636e-02 3.633584716597451636e-02 3.633584716597451636e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 7.812500000000000000e-02 3.718400988201266133e-02 3.718400988201266133e-02 3.718400988201266133e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 7.863955670199809789e-02 7.863955670199809789e-02 7.863955670199809789e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 1.137059716755971228e-01 1.137059716755971228e-01 1.137059716755971228e-01 --7.812500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 7.576366675813377138e-02 7.576366675813377138e-02 7.576366675813377138e-02 --4.687500000000000000e-02 -2.343750000000000000e-01 1.562500000000000000e-02 2.309017268313101612e-01 2.309017268313101612e-01 2.309017268313101612e-01 --4.687500000000000000e-02 -2.343750000000000000e-01 4.687500000000000000e-02 1.980562871318240492e-01 1.980562871318240492e-01 1.980562871318240492e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 1.562500000000000000e-02 1.014000698708044379e-01 1.014000698708044379e-01 1.014000698708044379e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 4.687500000000000000e-02 1.005298437654635613e-01 1.005298437654635613e-01 1.005298437654635613e-01 --1.562500000000000000e-02 -2.343750000000000000e-01 1.562500000000000000e-02 2.508564815709274365e-01 2.508564815709274365e-01 2.508564815709274365e-01 --1.562500000000000000e-02 -2.343750000000000000e-01 4.687500000000000000e-02 2.219587030470918376e-01 2.219587030470918376e-01 2.219587030470918376e-01 --1.562500000000000000e-02 -2.031250000000000000e-01 1.562500000000000000e-02 1.720233277257930404e-01 1.720233277257930404e-01 1.720233277257930404e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 1.953933364868050415e-01 1.953933364868050415e-01 1.953933364868050415e-01 --1.562500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 1.884096949320406555e-01 1.884096949320406555e-01 1.884096949320406555e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 1.562500000000000000e-02 9.913971236125393438e-02 9.913971236125393438e-02 9.913971236125393438e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 4.687500000000000000e-02 1.452133874979951167e-01 1.452133874979951167e-01 1.452133874979951167e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 1.240154156492992016e-01 1.240154156492992016e-01 1.240154156492992016e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 4.687500000000000000e-02 1.325114996290324698e-01 1.325114996290324698e-01 1.325114996290324698e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 1.562500000000000000e-02 1.055566155886081686e-01 1.055566155886081686e-01 1.055566155886081686e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 4.687500000000000000e-02 1.271723332995030042e-01 1.271723332995030042e-01 1.271723332995030042e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 1.320994478072708422e-01 1.320994478072708422e-01 1.320994478072708422e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 4.687500000000000000e-02 1.438416962594527004e-01 1.438416962594527004e-01 1.438416962594527004e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 7.812500000000000000e-02 7.424715203642572037e-02 7.424715203642572037e-02 7.424715203642572037e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 1.283507234821505139e-01 1.283507234821505139e-01 1.283507234821505139e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 9.447657015532522073e-02 9.447657015532522073e-02 9.447657015532522073e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 1.060081740260201827e-01 1.060081740260201827e-01 1.060081740260201827e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 7.812500000000000000e-02 1.163635936257879366e-01 1.163635936257879366e-01 1.163635936257879366e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 1.664443138114601040e-01 1.664443138114601040e-01 1.664443138114601040e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 1.622547812209498563e-01 1.622547812209498563e-01 1.622547812209498563e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 1.619231741727724661e-01 1.619231741727724661e-01 1.619231741727724661e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 8.065912875755083811e-02 8.065912875755083811e-02 8.065912875755083811e-02 --1.093750000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.453169861791557826e-01 1.453169861791557826e-01 1.453169861791557826e-01 --7.812500000000000000e-02 -2.343750000000000000e-01 1.406250000000000000e-01 1.646370124999317064e-01 1.646370124999317064e-01 1.646370124999317064e-01 --7.812500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 2.204503172214851148e-01 2.204503172214851148e-01 2.204503172214851148e-01 --7.812500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 1.705372877081719474e-01 1.705372877081719474e-01 1.705372877081719474e-01 --1.093750000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.710414685972379834e-01 1.710414685972379834e-01 1.710414685972379834e-01 --1.093750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.048037447293061891e-01 1.048037447293061891e-01 1.048037447293061891e-01 --1.093750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 1.693940378089887899e-01 1.693940378089887899e-01 1.693940378089887899e-01 --7.812500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 2.137649391938799270e-01 2.137649391938799270e-01 2.137649391938799270e-01 --7.812500000000000000e-02 -1.406250000000000000e-01 1.406250000000000000e-01 1.339026609497993570e-01 1.339026609497993570e-01 1.339026609497993570e-01 --7.812500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 1.899058392612802404e-01 1.899058392612802404e-01 1.899058392612802404e-01 --1.093750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 6.159209787653286555e-02 6.159209787653286555e-02 6.159209787653286555e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 2.031250000000000000e-01 1.223043627162193059e-01 1.223043627162193059e-01 1.223043627162193059e-01 --7.812500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 1.030368408388656620e-01 1.030368408388656620e-01 1.030368408388656620e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 2.166479361800545400e-01 2.166479361800545400e-01 2.166479361800545400e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 1.891176379376188765e-01 1.891176379376188765e-01 1.891176379376188765e-01 --1.562500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 2.133773756403534450e-01 2.133773756403534450e-01 2.133773756403534450e-01 --1.562500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 1.860819472574730404e-01 1.860819472574730404e-01 1.860819472574730404e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 2.364738664148741953e-01 2.364738664148741953e-01 2.364738664148741953e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 2.363062104893185744e-01 2.363062104893185744e-01 2.363062104893185744e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 1.463722395641600393e-01 1.463722395641600393e-01 1.463722395641600393e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 1.406250000000000000e-01 1.734691998523418544e-01 1.734691998523418544e-01 1.734691998523418544e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 2.107101174425083656e-01 2.107101174425083656e-01 2.107101174425083656e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 2.031250000000000000e-01 1.412998295373860402e-01 1.412998295373860402e-01 1.412998295373860402e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 2.031250000000000000e-01 1.456599048931296603e-01 1.456599048931296603e-01 1.456599048931296603e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 9.394539033422853735e-02 9.394539033422853735e-02 9.394539033422853735e-02 --1.562500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 6.998778472092141711e-02 6.998778472092141711e-02 6.998778472092141711e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 2.623207870027364219e-01 2.623207870027364219e-01 2.623207870027364219e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 4.687500000000000000e-02 2.267147472301210553e-01 2.267147472301210553e-01 2.267147472301210553e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.256131688426684323e-01 1.256131688426684323e-01 1.256131688426684323e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 1.082321828720061579e-01 1.082321828720061579e-01 1.082321828720061579e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 7.812500000000000000e-02 2.141765729733243750e-01 2.141765729733243750e-01 2.141765729733243750e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 1.093750000000000000e-01 1.033253011957958600e-01 1.033253011957958600e-01 1.033253011957958600e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 1.423711980036078129e-01 1.423711980036078129e-01 1.423711980036078129e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 1.093750000000000000e-01 1.536927792384056857e-01 1.536927792384056857e-01 1.536927792384056857e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 4.203327920021653896e-01 4.203327920021653896e-01 4.203327920021653896e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 2.505637374476152313e-01 2.505637374476152313e-01 2.505637374476152313e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 7.135824381895190804e-02 7.135824381895190804e-02 7.135824381895190804e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 7.534200024524038974e-02 7.534200024524038974e-02 7.534200024524038974e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 7.812500000000000000e-02 2.436201762194107612e-01 2.436201762194107612e-01 2.436201762194107612e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 1.093750000000000000e-01 1.382269949615096971e-01 1.382269949615096971e-01 1.382269949615096971e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 1.093750000000000000e-01 1.789690567989513370e-01 1.789690567989513370e-01 1.789690567989513370e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 1.562500000000000000e-02 2.214636667740378373e-01 2.214636667740378373e-01 2.214636667740378373e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 4.687500000000000000e-02 2.068647448148500101e-01 2.068647448148500101e-01 2.068647448148500101e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 1.562500000000000000e-02 4.324283654619223705e-01 4.324283654619223705e-01 4.324283654619223705e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 4.687500000000000000e-02 4.940112363767009129e-01 4.940112363767009129e-01 4.940112363767009129e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 1.562500000000000000e-02 1.537353385680636508e-01 1.537353385680636508e-01 1.537353385680636508e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 4.687500000000000000e-02 6.482277126171351322e-02 6.482277126171351322e-02 6.482277126171351322e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 1.562500000000000000e-02 2.512915934773458926e-02 2.512915934773458926e-02 2.512915934773458926e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 7.812500000000000000e-02 3.391796536155749497e-01 3.391796536155749497e-01 3.391796536155749497e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 1.093750000000000000e-01 9.288623462527945129e-02 9.288623462527945129e-02 9.288623462527945129e-02 --4.687500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 4.289016780405558449e-01 4.289016780405558449e-01 4.289016780405558449e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 7.812500000000000000e-02 2.166375052611079488e-01 2.166375052611079488e-01 2.166375052611079488e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 1.093750000000000000e-01 1.345219288350521514e-01 1.345219288350521514e-01 1.345219288350521514e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 1.858090344985316722e-01 1.858090344985316722e-01 1.858090344985316722e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 1.093750000000000000e-01 1.326327854357606528e-01 1.326327854357606528e-01 1.326327854357606528e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 1.562500000000000000e-02 2.240992786438452400e-01 2.240992786438452400e-01 2.240992786438452400e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 4.687500000000000000e-02 4.638312325610007836e-01 4.638312325610007836e-01 4.638312325610007836e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 4.687500000000000000e-02 5.597081186823158472e-01 5.597081186823158472e-01 5.597081186823158472e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 7.812500000000000000e-02 5.162790848361614726e-01 5.162790848361614726e-01 5.162790848361614726e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 1.093750000000000000e-01 1.521437649189413821e-01 1.521437649189413821e-01 1.521437649189413821e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 7.812500000000000000e-02 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 1.093750000000000000e-01 6.895213116879813642e-01 6.895213116879813642e-01 6.895213116879813642e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 7.812500000000000000e-02 2.764293843016007446e-01 2.764293843016007446e-01 2.764293843016007446e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 1.093750000000000000e-01 1.277057035911436655e-01 1.277057035911436655e-01 1.277057035911436655e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 7.812500000000000000e-02 3.831103308559191123e-01 3.831103308559191123e-01 3.831103308559191123e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 1.093750000000000000e-01 1.624274090464769837e-01 1.624274090464769837e-01 1.624274090464769837e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.059294327015779386e-01 1.059294327015779386e-01 1.059294327015779386e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 9.007755618489356186e-02 9.007755618489356186e-02 9.007755618489356186e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 9.567713613410742945e-02 9.567713613410742945e-02 9.567713613410742945e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 1.231357943907698954e-01 1.231357943907698954e-01 1.231357943907698954e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 1.122678627336592405e-01 1.122678627336592405e-01 1.122678627336592405e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 8.436506874284195601e-02 8.436506874284195601e-02 8.436506874284195601e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.408982634679010471e-01 1.408982634679010471e-01 1.408982634679010471e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.163145874858752260e-01 1.163145874858752260e-01 1.163145874858752260e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 1.261939430604137047e-01 1.261939430604137047e-01 1.261939430604137047e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 3.476618592784893602e-01 3.476618592784893602e-01 3.476618592784893602e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 8.930364558124764818e-02 8.930364558124764818e-02 8.930364558124764818e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.828711502946069045e-01 1.828711502946069045e-01 1.828711502946069045e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 9.575026239868625333e-02 9.575026239868625333e-02 9.575026239868625333e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.968315655034762190e-01 1.968315655034762190e-01 1.968315655034762190e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 1.406250000000000000e-01 1.185736591691737424e-01 1.185736591691737424e-01 1.185736591691737424e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 1.515463144123043449e-01 1.515463144123043449e-01 1.515463144123043449e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 1.406250000000000000e-01 1.269417941422343599e-01 1.269417941422343599e-01 1.269417941422343599e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.894796335980620805e-01 1.894796335980620805e-01 1.894796335980620805e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.798544897997977343e-01 1.798544897997977343e-01 1.798544897997977343e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 2.295667947431552780e-01 2.295667947431552780e-01 2.295667947431552780e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.094912055727838895e-01 2.094912055727838895e-01 2.094912055727838895e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 1.387884024087556734e-01 1.387884024087556734e-01 1.387884024087556734e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 1.633202503064335731e-01 1.633202503064335731e-01 1.633202503064335731e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 1.406250000000000000e-01 1.512114510993957939e-01 1.512114510993957939e-01 1.512114510993957939e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 1.678613830672609775e-01 1.678613830672609775e-01 1.678613830672609775e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 1.101034201466358914e-01 1.101034201466358914e-01 1.101034201466358914e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 1.354544360739182440e-01 1.354544360739182440e-01 1.354544360739182440e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 1.406250000000000000e-01 1.614221478560510237e-01 1.614221478560510237e-01 1.614221478560510237e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 1.736859580091610067e-01 1.736859580091610067e-01 1.736859580091610067e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 1.683479178037144697e-01 1.683479178037144697e-01 1.683479178037144697e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 1.468589042699742775e-01 1.468589042699742775e-01 1.468589042699742775e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 1.268486143650675857e-01 1.268486143650675857e-01 1.268486143650675857e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 1.062926063315151326e-01 1.062926063315151326e-01 1.062926063315151326e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 2.343750000000000000e-01 8.682836750021225014e-02 8.682836750021225014e-02 8.682836750021225014e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 1.112828637874404558e-01 1.112828637874404558e-01 1.112828637874404558e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 2.343750000000000000e-01 8.737406034827806256e-02 8.737406034827806256e-02 8.737406034827806256e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 1.616991579841121907e-01 1.616991579841121907e-01 1.616991579841121907e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 2.343750000000000000e-01 1.513391329586483425e-01 1.513391329586483425e-01 1.513391329586483425e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 1.406250000000000000e-01 1.408364221150819606e-01 1.408364221150819606e-01 1.408364221150819606e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 1.380334329735286858e-01 1.380334329735286858e-01 1.380334329735286858e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 1.406250000000000000e-01 1.220673830325646886e-01 1.220673830325646886e-01 1.220673830325646886e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 1.459337569616327990e-01 1.459337569616327990e-01 1.459337569616327990e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 1.494351264790040879e-01 1.494351264790040879e-01 1.494351264790040879e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 1.406250000000000000e-01 1.823525945667257286e-01 1.823525945667257286e-01 1.823525945667257286e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 1.643624211868291995e-01 1.643624211868291995e-01 1.643624211868291995e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 1.450399196401430391e-01 1.450399196401430391e-01 1.450399196401430391e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 1.094919987568155478e-01 1.094919987568155478e-01 1.094919987568155478e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 2.031250000000000000e-01 1.564679216053765920e-01 1.564679216053765920e-01 1.564679216053765920e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 1.285202110388976304e-01 1.285202110388976304e-01 1.285202110388976304e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 1.651765576133034930e-01 1.651765576133034930e-01 1.651765576133034930e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 1.671877764880251027e-01 1.671877764880251027e-01 1.671877764880251027e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 2.031250000000000000e-01 1.248669119990394732e-01 1.248669119990394732e-01 1.248669119990394732e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.003275105304906378e-01 2.003275105304906378e-01 2.003275105304906378e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.799612548614079321e-01 1.799612548614079321e-01 1.799612548614079321e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.417400098732858105e-01 2.417400098732858105e-01 2.417400098732858105e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.916804679477839835e-01 1.916804679477839835e-01 1.916804679477839835e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.124810776208822527e-01 2.124810776208822527e-01 2.124810776208822527e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.790525431915353793e-01 1.790525431915353793e-01 1.790525431915353793e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.740961912926321520e-01 1.740961912926321520e-01 1.740961912926321520e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 2.015345233054438301e-01 2.015345233054438301e-01 2.015345233054438301e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 8.035266374923978605e-02 8.035266374923978605e-02 8.035266374923978605e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 4.427631705696229159e-02 4.427631705696229159e-02 4.427631705696229159e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 2.656250000000000000e-01 8.834970814519342575e-02 8.834970814519342575e-02 8.834970814519342575e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 2.968750000000000000e-01 1.172537327422059766e-01 1.172537327422059766e-01 1.172537327422059766e-01 --7.812500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 9.279381901205713268e-02 9.279381901205713268e-02 9.279381901205713268e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 2.656250000000000000e-01 1.201434034913577420e-01 1.201434034913577420e-01 1.201434034913577420e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 2.968750000000000000e-01 1.900230253567465333e-01 1.900230253567465333e-01 1.900230253567465333e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 2.656250000000000000e-01 3.280076114053809277e-02 3.280076114053809277e-02 3.280076114053809277e-02 --1.562500000000000000e-02 -1.718750000000000000e-01 2.968750000000000000e-01 8.194429188658360064e-02 8.194429188658360064e-02 8.194429188658360064e-02 --1.562500000000000000e-02 -1.406250000000000000e-01 2.656250000000000000e-01 8.197402962717016683e-02 8.197402962717016683e-02 8.197402962717016683e-02 --1.562500000000000000e-02 -1.406250000000000000e-01 2.968750000000000000e-01 1.240001528966498678e-01 1.240001528966498678e-01 1.240001528966498678e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.208631941260387421e-01 1.208631941260387421e-01 1.208631941260387421e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.585066587801461646e-01 1.585066587801461646e-01 1.585066587801461646e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 8.300680650089027612e-02 8.300680650089027612e-02 8.300680650089027612e-02 --1.093750000000000000e-01 -1.093750000000000000e-01 2.968750000000000000e-01 8.839230205460679723e-02 8.839230205460679723e-02 8.839230205460679723e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.018315635348158721e-01 1.018315635348158721e-01 1.018315635348158721e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 2.968750000000000000e-01 1.193633552537082254e-01 1.193633552537082254e-01 1.193633552537082254e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 2.968750000000000000e-01 1.020605676120092259e-01 1.020605676120092259e-01 1.020605676120092259e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 2.968750000000000000e-01 1.355331485072583109e-01 1.355331485072583109e-01 1.355331485072583109e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 3.281250000000000000e-01 8.577956599288549810e-02 8.577956599288549810e-02 8.577956599288549810e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 3.281250000000000000e-01 1.177237029421539655e-01 1.177237029421539655e-01 1.177237029421539655e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.404685855538386208e-01 1.404685855538386208e-01 1.404685855538386208e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 7.926471559780250142e-02 7.926471559780250142e-02 7.926471559780250142e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 3.281250000000000000e-01 1.521710676586801869e-01 1.521710676586801869e-01 1.521710676586801869e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 9.622196538729274606e-02 9.622196538729274606e-02 9.622196538729274606e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 9.975121242929572973e-02 9.975121242929572973e-02 9.975121242929572973e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.949808039993826403e-01 1.949808039993826403e-01 1.949808039993826403e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.282583485970830162e-01 1.282583485970830162e-01 1.282583485970830162e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 9.381922456630008289e-02 9.381922456630008289e-02 9.381922456630008289e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 1.067513919142232537e-01 1.067513919142232537e-01 1.067513919142232537e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 3.281250000000000000e-01 9.660929013469715665e-02 9.660929013469715665e-02 9.660929013469715665e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 1.406300162168338252e-01 1.406300162168338252e-01 1.406300162168338252e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 9.003817773579679551e-02 9.003817773579679551e-02 9.003817773579679551e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 2.968750000000000000e-01 5.069727580851342286e-02 5.069727580851342286e-02 5.069727580851342286e-02 --4.687500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.293901344430518074e-01 1.293901344430518074e-01 1.293901344430518074e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 9.608616021069581181e-02 9.608616021069581181e-02 9.608616021069581181e-02 --4.687500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 9.721839872485669998e-02 9.721839872485669998e-02 9.721839872485669998e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.136143833809293707e-01 1.136143833809293707e-01 1.136143833809293707e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 8.409663293444386012e-02 8.409663293444386012e-02 8.409663293444386012e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 3.281250000000000000e-01 9.072850326484507844e-02 9.072850326484507844e-02 9.072850326484507844e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 9.405468026626459532e-02 9.405468026626459532e-02 9.405468026626459532e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 1.545262955973261687e-01 1.545262955973261687e-01 1.545262955973261687e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 9.421218608364487213e-02 9.421218608364487213e-02 9.421218608364487213e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.246652849041254979e-01 1.246652849041254979e-01 1.246652849041254979e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 1.078296482553378899e-01 1.078296482553378899e-01 1.078296482553378899e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 1.406356381743865958e-01 1.406356381743865958e-01 1.406356381743865958e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 7.913933055686381279e-02 7.913933055686381279e-02 7.913933055686381279e-02 --1.562500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.353492183131808635e-01 1.353492183131808635e-01 1.353492183131808635e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 1.197658321683228583e-01 1.197658321683228583e-01 1.197658321683228583e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 1.035342133433617140e-01 1.035342133433617140e-01 1.035342133433617140e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 8.376550729026474573e-02 8.376550729026474573e-02 8.376550729026474573e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 3.281250000000000000e-01 1.047073253270119214e-01 1.047073253270119214e-01 1.047073253270119214e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 8.758060292018279847e-02 8.758060292018279847e-02 8.758060292018279847e-02 --1.562500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 6.632499381704283492e-02 6.632499381704283492e-02 6.632499381704283492e-02 --1.562500000000000000e-02 -1.562500000000000000e-02 3.281250000000000000e-01 1.065007072965700047e-01 1.065007072965700047e-01 1.065007072965700047e-01 --5.156250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 7.720033854773357407e-02 7.720033854773357407e-02 7.720033854773357407e-02 --5.156250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 9.052679059706050801e-02 9.052679059706050801e-02 9.052679059706050801e-02 --5.156250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.186194505068399047e-01 1.186194505068399047e-01 1.186194505068399047e-01 --5.156250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.375346673647305229e-01 1.375346673647305229e-01 1.375346673647305229e-01 --5.156250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.188933946316416967e-01 1.188933946316416967e-01 1.188933946316416967e-01 --5.156250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 9.659161145239932023e-02 9.659161145239932023e-02 9.659161145239932023e-02 --5.156250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.596492604508387703e-01 1.596492604508387703e-01 1.596492604508387703e-01 --5.156250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 9.547543587302367851e-02 9.547543587302367851e-02 9.547543587302367851e-02 --5.156250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.556328193876973520e-01 1.556328193876973520e-01 1.556328193876973520e-01 --5.156250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 8.614041954854706473e-02 8.614041954854706473e-02 8.614041954854706473e-02 --5.156250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.172601597036225934e-01 1.172601597036225934e-01 1.172601597036225934e-01 --5.156250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.677746735973950354e-01 1.677746735973950354e-01 1.677746735973950354e-01 --5.156250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 1.553413345536181212e-01 1.553413345536181212e-01 1.553413345536181212e-01 --3.281250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 6.791384480623616215e-02 6.791384480623616215e-02 6.791384480623616215e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 6.875411845503598407e-02 6.875411845503598407e-02 6.875411845503598407e-02 --3.281250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 3.512635343548344696e-02 3.512635343548344696e-02 3.512635343548344696e-02 --3.281250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 7.399146292523275936e-02 7.399146292523275936e-02 7.399146292523275936e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 4.259396301339305607e-02 4.259396301339305607e-02 4.259396301339305607e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 7.755680986824559087e-02 7.755680986824559087e-02 7.755680986824559087e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 8.993209691991588262e-02 8.993209691991588262e-02 8.993209691991588262e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 7.879853945828790840e-02 7.879853945828790840e-02 7.879853945828790840e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 7.143203525305566459e-02 7.143203525305566459e-02 7.143203525305566459e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 9.020131689939969721e-02 9.020131689939969721e-02 9.020131689939969721e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 8.195152539205455278e-02 8.195152539205455278e-02 8.195152539205455278e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 4.931874585408674988e-02 4.931874585408674988e-02 4.931874585408674988e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 4.411766811820783118e-02 4.411766811820783118e-02 4.411766811820783118e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 8.075075457583465177e-02 8.075075457583465177e-02 8.075075457583465177e-02 --2.656250000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 3.167831189769149125e-02 3.167831189769149125e-02 3.167831189769149125e-02 --2.656250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 8.681390136551360437e-02 8.681390136551360437e-02 8.681390136551360437e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 7.396871531641564801e-02 7.396871531641564801e-02 7.396871531641564801e-02 --2.968750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 6.124343432480247595e-02 6.124343432480247595e-02 6.124343432480247595e-02 --2.656250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 8.204877579145790356e-02 8.204877579145790356e-02 8.204877579145790356e-02 --3.281250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 7.980210080977045983e-02 7.980210080977045983e-02 7.980210080977045983e-02 --2.656250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 7.584991280086304799e-02 7.584991280086304799e-02 7.584991280086304799e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 9.704322020959564588e-02 9.704322020959564588e-02 9.704322020959564588e-02 --2.656250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 1.131877733713534395e-01 1.131877733713534395e-01 1.131877733713534395e-01 --2.656250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 7.505086740586026928e-02 7.505086740586026928e-02 7.505086740586026928e-02 --4.531250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 9.954871883474443461e-02 9.954871883474443461e-02 9.954871883474443461e-02 --4.843750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 8.839551668836198584e-02 8.839551668836198584e-02 8.839551668836198584e-02 --4.843750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.088452207443663944e-01 1.088452207443663944e-01 1.088452207443663944e-01 --4.531250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.176963885099534257e-01 1.176963885099534257e-01 1.176963885099534257e-01 --4.531250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.306134734172335055e-01 1.306134734172335055e-01 1.306134734172335055e-01 --4.531250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.274390188873200103e-01 1.274390188873200103e-01 1.274390188873200103e-01 --4.843750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 9.568918991855590583e-02 9.568918991855590583e-02 9.568918991855590583e-02 --4.843750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 9.331616673465295553e-02 9.331616673465295553e-02 9.331616673465295553e-02 --4.531250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 7.773066441728972154e-02 7.773066441728972154e-02 7.773066441728972154e-02 --4.531250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.077340359446097157e-01 1.077340359446097157e-01 1.077340359446097157e-01 --4.531250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 7.246020493679636298e-02 7.246020493679636298e-02 7.246020493679636298e-02 --4.531250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 1.167789395473625147e-01 1.167789395473625147e-01 1.167789395473625147e-01 --4.843750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.139566338436393544e-01 1.139566338436393544e-01 1.139566338436393544e-01 --4.843750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.028841733790560736e-01 1.028841733790560736e-01 1.028841733790560736e-01 --4.843750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.113760615941371546e-01 1.113760615941371546e-01 1.113760615941371546e-01 --4.218750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 9.596240854837631562e-02 9.596240854837631562e-02 9.596240854837631562e-02 --3.906250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 7.199945535937823937e-02 7.199945535937823937e-02 7.199945535937823937e-02 --3.906250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 1.066300670846294651e-01 1.066300670846294651e-01 1.066300670846294651e-01 --4.218750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 6.937605839027739807e-02 6.937605839027739807e-02 6.937605839027739807e-02 --4.218750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 9.938158088069636020e-02 9.938158088069636020e-02 9.938158088069636020e-02 --4.218750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.104255995878681978e-01 1.104255995878681978e-01 1.104255995878681978e-01 --4.218750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.329781678572325987e-01 1.329781678572325987e-01 1.329781678572325987e-01 --3.906250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 8.273916987552316915e-02 8.273916987552316915e-02 8.273916987552316915e-02 --3.906250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 7.700783534022179189e-02 7.700783534022179189e-02 7.700783534022179189e-02 --4.218750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 8.314906344389501325e-02 8.314906344389501325e-02 8.314906344389501325e-02 --4.218750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.234675613466296867e-01 1.234675613466296867e-01 1.234675613466296867e-01 --4.218750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 7.701362249972805440e-02 7.701362249972805440e-02 7.701362249972805440e-02 --4.218750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 1.277884399310327823e-01 1.277884399310327823e-01 1.277884399310327823e-01 --3.906250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 7.040296820761660079e-02 7.040296820761660079e-02 7.040296820761660079e-02 --3.906250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.182820400389055782e-01 1.182820400389055782e-01 1.182820400389055782e-01 --3.906250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 1.091159843462704421e-01 1.091159843462704421e-01 1.091159843462704421e-01 --4.218750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.522088096659711121e-01 1.522088096659711121e-01 1.522088096659711121e-01 --3.906250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.563852147532458214e-01 1.563852147532458214e-01 1.563852147532458214e-01 --4.843750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.127828533036462910e-01 1.127828533036462910e-01 1.127828533036462910e-01 --4.843750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.319347871323972576e-01 1.319347871323972576e-01 1.319347871323972576e-01 --4.843750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.356030258070228256e-01 1.356030258070228256e-01 1.356030258070228256e-01 --4.531250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.356945890734607973e-01 1.356945890734607973e-01 1.356945890734607973e-01 --4.531250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.303644696183764440e-01 1.303644696183764440e-01 1.303644696183764440e-01 --4.531250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.608881981065614641e-01 1.608881981065614641e-01 1.608881981065614641e-01 --4.843750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.014008733993264771e-01 1.014008733993264771e-01 1.014008733993264771e-01 --4.531250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.640549099196506877e-01 1.640549099196506877e-01 1.640549099196506877e-01 --4.843750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.252773942841353128e-01 1.252773942841353128e-01 1.252773942841353128e-01 --4.843750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.356624616234176628e-01 1.356624616234176628e-01 1.356624616234176628e-01 --4.843750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.356431851472444383e-01 1.356431851472444383e-01 1.356431851472444383e-01 --4.531250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.524986998126866278e-01 1.524986998126866278e-01 1.524986998126866278e-01 --4.843750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.076183368620172720e-01 1.076183368620172720e-01 1.076183368620172720e-01 --4.843750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 8.947321541580495474e-02 8.947321541580495474e-02 8.947321541580495474e-02 --4.531250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.528126793749783330e-01 1.528126793749783330e-01 1.528126793749783330e-01 --4.531250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.476860669005750359e-01 1.476860669005750359e-01 1.476860669005750359e-01 --4.218750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.293363167399501357e-01 1.293363167399501357e-01 1.293363167399501357e-01 --4.218750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.618541226542335454e-01 1.618541226542335454e-01 1.618541226542335454e-01 --3.906250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.110820060783212215e-01 1.110820060783212215e-01 1.110820060783212215e-01 --3.906250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.521309165676355823e-01 1.521309165676355823e-01 1.521309165676355823e-01 --3.906250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.811982743047880762e-01 1.811982743047880762e-01 1.811982743047880762e-01 --4.218750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.136151867874713867e-01 1.136151867874713867e-01 1.136151867874713867e-01 --4.218750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.783188232762893122e-01 1.783188232762893122e-01 1.783188232762893122e-01 --3.906250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.597030578807243084e-01 1.597030578807243084e-01 1.597030578807243084e-01 --4.218750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.515696022167635493e-01 1.515696022167635493e-01 1.515696022167635493e-01 --4.218750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.334376045012857226e-01 1.334376045012857226e-01 1.334376045012857226e-01 --3.906250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.422619736856293449e-01 1.422619736856293449e-01 1.422619736856293449e-01 --3.906250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.732660889013380445e-01 1.732660889013380445e-01 1.732660889013380445e-01 --3.906250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.174650188298917153e-01 1.174650188298917153e-01 1.174650188298917153e-01 --4.218750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.374302554932429477e-01 1.374302554932429477e-01 1.374302554932429477e-01 --3.906250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.448600266517669488e-01 1.448600266517669488e-01 1.448600266517669488e-01 --4.843750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 9.196448458429964945e-02 9.196448458429964945e-02 9.196448458429964945e-02 --4.531250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.198879405347346022e-01 1.198879405347346022e-01 1.198879405347346022e-01 --4.843750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.350110748068275024e-01 1.350110748068275024e-01 1.350110748068275024e-01 --4.843750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.653034144211240897e-01 1.653034144211240897e-01 1.653034144211240897e-01 --4.531250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.853611344936158811e-01 1.853611344936158811e-01 1.853611344936158811e-01 --4.531250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.694189261469015439e-01 1.694189261469015439e-01 1.694189261469015439e-01 --4.531250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 9.834821062813492443e-02 9.834821062813492443e-02 9.834821062813492443e-02 --4.218750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.301058261468057697e-01 1.301058261468057697e-01 1.301058261468057697e-01 --3.906250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.146081911463723846e-01 1.146081911463723846e-01 1.146081911463723846e-01 --4.218750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.713626012743695026e-01 1.713626012743695026e-01 1.713626012743695026e-01 --4.218750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.686907383675435579e-01 1.686907383675435579e-01 1.686907383675435579e-01 --4.218750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 8.913809364443404937e-02 8.913809364443404937e-02 8.913809364443404937e-02 --3.906250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.498623473747182633e-01 1.498623473747182633e-01 1.498623473747182633e-01 --3.906250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.470331712788520984e-01 1.470331712788520984e-01 1.470331712788520984e-01 --4.843750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 1.869753287252986784e-01 1.869753287252986784e-01 1.869753287252986784e-01 --4.843750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.152107363602435236e-01 1.152107363602435236e-01 1.152107363602435236e-01 --4.531250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 1.756190938159638837e-01 1.756190938159638837e-01 1.756190938159638837e-01 --4.531250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.297708735830670201e-01 1.297708735830670201e-01 1.297708735830670201e-01 --4.218750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 1.396212700456535283e-01 1.396212700456535283e-01 1.396212700456535283e-01 --3.593750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 8.354609561514161897e-02 8.354609561514161897e-02 8.354609561514161897e-02 --3.593750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 1.204575093481910775e-01 1.204575093481910775e-01 1.204575093481910775e-01 --3.281250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 6.782284745853525698e-02 6.782284745853525698e-02 6.782284745853525698e-02 --3.281250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 9.302927771296877479e-02 9.302927771296877479e-02 9.302927771296877479e-02 --3.281250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 7.578769991445824528e-02 7.578769991445824528e-02 7.578769991445824528e-02 --3.593750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 8.651011193602312077e-02 8.651011193602312077e-02 8.651011193602312077e-02 --3.593750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.213676864020203500e-01 1.213676864020203500e-01 1.213676864020203500e-01 --3.281250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 8.149179463989314476e-02 8.149179463989314476e-02 8.149179463989314476e-02 --3.281250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.055574190756181779e-01 1.055574190756181779e-01 1.055574190756181779e-01 --3.281250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 9.640357431846587055e-02 9.640357431846587055e-02 9.640357431846587055e-02 --3.593750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.193400581251474885e-01 1.193400581251474885e-01 1.193400581251474885e-01 --3.593750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 9.849445823533843625e-02 9.849445823533843625e-02 9.849445823533843625e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 8.341589499757019743e-02 8.341589499757019743e-02 8.341589499757019743e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 8.707589873532069202e-02 8.707589873532069202e-02 8.707589873532069202e-02 --3.281250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 7.758566508754335955e-02 7.758566508754335955e-02 7.758566508754335955e-02 --3.281250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 7.209350250419876982e-02 7.209350250419876982e-02 7.209350250419876982e-02 --3.593750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.414797304864338356e-01 1.414797304864338356e-01 1.414797304864338356e-01 --3.593750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.724231328340943559e-01 1.724231328340943559e-01 1.724231328340943559e-01 --3.593750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.397064035710575136e-01 1.397064035710575136e-01 1.397064035710575136e-01 --3.593750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.369563845272573910e-01 1.369563845272573910e-01 1.369563845272573910e-01 --3.281250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 9.772946780991419169e-02 9.772946780991419169e-02 9.772946780991419169e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.097740084114491171e-01 1.097740084114491171e-01 1.097740084114491171e-01 --3.281250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 5.688738415359604478e-02 5.688738415359604478e-02 5.688738415359604478e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 7.234228480596335831e-02 7.234228480596335831e-02 7.234228480596335831e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 9.161490791838163006e-02 9.161490791838163006e-02 9.161490791838163006e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 8.130774085761401093e-02 8.130774085761401093e-02 8.130774085761401093e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 7.693445090644404627e-02 7.693445090644404627e-02 7.693445090644404627e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 7.176835613909346434e-02 7.176835613909346434e-02 7.176835613909346434e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 9.063126335665355748e-02 9.063126335665355748e-02 9.063126335665355748e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 7.286484570765809632e-02 7.286484570765809632e-02 7.286484570765809632e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 8.431443570979685331e-02 8.431443570979685331e-02 8.431443570979685331e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 4.504857027182748025e-02 4.504857027182748025e-02 4.504857027182748025e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 6.787582207540673873e-02 6.787582207540673873e-02 6.787582207540673873e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 8.379042213128444494e-02 8.379042213128444494e-02 8.379042213128444494e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 8.319085639628918949e-02 8.319085639628918949e-02 8.319085639628918949e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 8.075236204540758855e-02 8.075236204540758855e-02 8.075236204540758855e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.161169558646223399e-01 1.161169558646223399e-01 1.161169558646223399e-01 --2.656250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 9.199261137646190523e-02 9.199261137646190523e-02 9.199261137646190523e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.013606969631618282e-01 1.013606969631618282e-01 1.013606969631618282e-01 --2.968750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 8.731941086310336664e-02 8.731941086310336664e-02 8.731941086310336664e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 8.423486945062540199e-02 8.423486945062540199e-02 8.423486945062540199e-02 --2.656250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 8.849034832640079173e-02 8.849034832640079173e-02 8.849034832640079173e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 8.942419289372122160e-02 8.942419289372122160e-02 8.942419289372122160e-02 --2.968750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 8.031649549656529052e-02 8.031649549656529052e-02 8.031649549656529052e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.096960742182612053e-01 1.096960742182612053e-01 1.096960742182612053e-01 --2.656250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.121899309561944086e-01 1.121899309561944086e-01 1.121899309561944086e-01 --2.656250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.020195879829225161e-01 1.020195879829225161e-01 1.020195879829225161e-01 --3.593750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 9.469675561881142623e-02 9.469675561881142623e-02 9.469675561881142623e-02 --3.593750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.074857647920117037e-01 1.074857647920117037e-01 1.074857647920117037e-01 --3.281250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 6.319470880969611792e-02 6.319470880969611792e-02 6.319470880969611792e-02 --3.281250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 8.823639216320082468e-02 8.823639216320082468e-02 8.823639216320082468e-02 --3.281250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 8.822915922276999834e-02 8.822915922276999834e-02 8.822915922276999834e-02 --3.593750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 4.426908016336333213e-02 4.426908016336333213e-02 4.426908016336333213e-02 --3.593750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 4.106966615897904987e-02 4.106966615897904987e-02 4.106966615897904987e-02 --3.593750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 5.331131219332672228e-02 5.331131219332672228e-02 5.331131219332672228e-02 --3.593750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 4.416607497403048088e-02 4.416607497403048088e-02 4.416607497403048088e-02 --3.281250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 5.411893513641123643e-02 5.411893513641123643e-02 5.411893513641123643e-02 --3.281250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 6.716359593197167299e-02 6.716359593197167299e-02 6.716359593197167299e-02 --3.593750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.205643532603994927e-01 1.205643532603994927e-01 1.205643532603994927e-01 --3.593750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.279466829849086884e-01 1.279466829849086884e-01 1.279466829849086884e-01 --3.593750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 6.569193667987241469e-02 6.569193667987241469e-02 6.569193667987241469e-02 --3.593750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 7.718916614035038759e-02 7.718916614035038759e-02 7.718916614035038759e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 8.260896795208014232e-02 8.260896795208014232e-02 8.260896795208014232e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 8.440123517550510157e-02 8.440123517550510157e-02 8.440123517550510157e-02 --3.593750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 1.179349877956249876e-01 1.179349877956249876e-01 1.179349877956249876e-01 --3.593750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 6.644059152215445185e-02 6.644059152215445185e-02 6.644059152215445185e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 3.543017611055167965e-02 3.543017611055167965e-02 3.543017611055167965e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 1.450929237475009903e-01 1.450929237475009903e-01 1.450929237475009903e-01 --3.281250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 8.980753214696447773e-02 8.980753214696447773e-02 8.980753214696447773e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 4.449511216579946776e-02 4.449511216579946776e-02 4.449511216579946776e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 5.415857237029876592e-02 5.415857237029876592e-02 5.415857237029876592e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 8.633491010328558923e-02 8.633491010328558923e-02 8.633491010328558923e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 5.205093788101571722e-02 5.205093788101571722e-02 5.205093788101571722e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 6.258469944198105650e-02 6.258469944198105650e-02 6.258469944198105650e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 6.310555511978674370e-02 6.310555511978674370e-02 6.310555511978674370e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 7.023408163059535747e-02 7.023408163059535747e-02 7.023408163059535747e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 5.984997092303936256e-02 5.984997092303936256e-02 5.984997092303936256e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 3.640034226516213750e-02 3.640034226516213750e-02 3.640034226516213750e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 5.880925918144062903e-02 5.880925918144062903e-02 5.880925918144062903e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 6.378767078363217768e-02 6.378767078363217768e-02 6.378767078363217768e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 4.436195358167280278e-02 4.436195358167280278e-02 4.436195358167280278e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 6.820090378608407999e-02 6.820090378608407999e-02 6.820090378608407999e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 9.381520654496898481e-02 9.381520654496898481e-02 9.381520654496898481e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 8.231319983681500974e-02 8.231319983681500974e-02 8.231319983681500974e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 3.656077561058626579e-02 3.656077561058626579e-02 3.656077561058626579e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 6.889921408770702249e-02 6.889921408770702249e-02 6.889921408770702249e-02 --2.656250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.299353615799132611e-02 7.299353615799132611e-02 7.299353615799132611e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 5.874277215690847098e-02 5.874277215690847098e-02 5.874277215690847098e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 9.834097859671317443e-02 9.834097859671317443e-02 9.834097859671317443e-02 --2.968750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 7.774979402109684357e-02 7.774979402109684357e-02 7.774979402109684357e-02 --2.968750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 8.052410104566558313e-02 8.052410104566558313e-02 8.052410104566558313e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 8.659369432729843719e-02 8.659369432729843719e-02 8.659369432729843719e-02 --2.656250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.085575836349541717e-01 1.085575836349541717e-01 1.085575836349541717e-01 --2.656250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.079831097938450668e-01 1.079831097938450668e-01 1.079831097938450668e-01 --3.281250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 8.275042188371041496e-02 8.275042188371041496e-02 8.275042188371041496e-02 --3.593750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.023803687062658091e-01 1.023803687062658091e-01 1.023803687062658091e-01 --3.593750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 6.221650493897432077e-02 6.221650493897432077e-02 6.221650493897432077e-02 --3.281250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 7.293783194710547202e-02 7.293783194710547202e-02 7.293783194710547202e-02 --3.281250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 3.597211635552993725e-02 3.597211635552993725e-02 3.597211635552993725e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 8.838105083544323115e-02 8.838105083544323115e-02 8.838105083544323115e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 9.238076010403825644e-02 9.238076010403825644e-02 9.238076010403825644e-02 --2.968750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 6.788820157114340559e-02 6.788820157114340559e-02 6.788820157114340559e-02 --2.656250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 8.523386232977389620e-02 8.523386232977389620e-02 8.523386232977389620e-02 --2.656250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.011196379247803340e-01 1.011196379247803340e-01 1.011196379247803340e-01 --2.656250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 8.175541679108778992e-02 8.175541679108778992e-02 8.175541679108778992e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 8.896852310355278515e-02 8.896852310355278515e-02 8.896852310355278515e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 8.892834045854199065e-02 8.892834045854199065e-02 8.892834045854199065e-02 --2.968750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 8.457483382600439192e-02 8.457483382600439192e-02 8.457483382600439192e-02 --2.968750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 9.021578242503404399e-02 9.021578242503404399e-02 9.021578242503404399e-02 --2.656250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.120806656565221798e-01 1.120806656565221798e-01 1.120806656565221798e-01 --2.656250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.103404350729895456e-01 1.103404350729895456e-01 1.103404350729895456e-01 --2.656250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.023594772163062966e-01 1.023594772163062966e-01 1.023594772163062966e-01 --2.968750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 4.920738501037884988e-02 4.920738501037884988e-02 4.920738501037884988e-02 --2.656250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 6.497856575376520505e-02 6.497856575376520505e-02 6.497856575376520505e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 7.349985592533887779e-02 7.349985592533887779e-02 7.349985592533887779e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 7.319456936019699822e-02 7.319456936019699822e-02 7.319456936019699822e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 4.011684533826013338e-02 4.011684533826013338e-02 4.011684533826013338e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 5.984370016259095426e-02 5.984370016259095426e-02 5.984370016259095426e-02 --2.656250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 9.344152968343399923e-02 9.344152968343399923e-02 9.344152968343399923e-02 --2.656250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 7.223184002769550416e-02 7.223184002769550416e-02 7.223184002769550416e-02 --2.656250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 8.988709289516931544e-02 8.988709289516931544e-02 8.988709289516931544e-02 --3.593750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 6.997243133117098113e-02 6.997243133117098113e-02 6.997243133117098113e-02 --3.593750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 6.133612736484088390e-02 6.133612736484088390e-02 6.133612736484088390e-02 --3.593750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 5.815258686193913035e-02 5.815258686193913035e-02 5.815258686193913035e-02 --3.593750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 4.888865897113593706e-02 4.888865897113593706e-02 4.888865897113593706e-02 --3.281250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 5.496843798717132579e-02 5.496843798717132579e-02 5.496843798717132579e-02 --3.281250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 6.387272381032133017e-02 6.387272381032133017e-02 6.387272381032133017e-02 --3.593750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 5.562200075150647294e-02 5.562200075150647294e-02 5.562200075150647294e-02 --3.281250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 8.540585180713033964e-02 8.540585180713033964e-02 8.540585180713033964e-02 --3.281250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 7.161265517710031780e-02 7.161265517710031780e-02 7.161265517710031780e-02 --2.968750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 7.740031633983783521e-02 7.740031633983783521e-02 7.740031633983783521e-02 --2.968750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 7.107055303905054910e-02 7.107055303905054910e-02 7.107055303905054910e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 8.048873660748583070e-02 8.048873660748583070e-02 8.048873660748583070e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 7.269387437874731683e-02 7.269387437874731683e-02 7.269387437874731683e-02 --2.968750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.080867564265071828e-01 1.080867564265071828e-01 1.080867564265071828e-01 --2.968750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 8.321577141528370414e-02 8.321577141528370414e-02 8.321577141528370414e-02 --2.656250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 1.047860678475335955e-01 1.047860678475335955e-01 1.047860678475335955e-01 --2.656250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.011164237993730786e-01 1.011164237993730786e-01 1.011164237993730786e-01 --2.656250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 7.156466674552530716e-02 7.156466674552530716e-02 7.156466674552530716e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 9.031945194928701903e-02 9.031945194928701903e-02 9.031945194928701903e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 9.920881772673001420e-02 9.920881772673001420e-02 9.920881772673001420e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 6.031127244727236408e-02 6.031127244727236408e-02 6.031127244727236408e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 8.408538111453085773e-02 8.408538111453085773e-02 8.408538111453085773e-02 --2.656250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 1.052946783940519743e-01 1.052946783940519743e-01 1.052946783940519743e-01 --2.656250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 9.359582227533788656e-02 9.359582227533788656e-02 9.359582227533788656e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 8.671746040105610120e-02 8.671746040105610120e-02 8.671746040105610120e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 6.127350128963877929e-02 6.127350128963877929e-02 6.127350128963877929e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 7.234831344670054898e-02 7.234831344670054898e-02 7.234831344670054898e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 5.765855157043765777e-02 5.765855157043765777e-02 5.765855157043765777e-02 --2.656250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 7.349591726982880602e-02 7.349591726982880602e-02 7.349591726982880602e-02 --2.656250000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 8.581814284224420497e-02 8.581814284224420497e-02 8.581814284224420497e-02 --2.656250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 8.400742203335287428e-02 8.400742203335287428e-02 8.400742203335287428e-02 --2.656250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 7.808134630577465152e-02 7.808134630577465152e-02 7.808134630577465152e-02 --2.656250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 7.034669951596068949e-02 7.034669951596068949e-02 7.034669951596068949e-02 --2.656250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 8.497266265394964879e-02 8.497266265394964879e-02 8.497266265394964879e-02 --1.406250000000000000e-01 1.562500000000000000e-02 -3.906250000000000000e-01 1.521742797450959805e-01 1.521742797450959805e-01 1.521742797450959805e-01 --1.406250000000000000e-01 1.093750000000000000e-01 -3.906250000000000000e-01 7.649349987628133174e-02 7.649349987628133174e-02 7.649349987628133174e-02 --2.343750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 5.739203656114436058e-02 5.739203656114436058e-02 5.739203656114436058e-02 --2.343750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 8.572250436927984774e-02 8.572250436927984774e-02 8.572250436927984774e-02 --2.031250000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 7.369381437613793662e-02 7.369381437613793662e-02 7.369381437613793662e-02 --2.031250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 1.049001640160657084e-01 1.049001640160657084e-01 1.049001640160657084e-01 --2.343750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 8.152555118307899806e-02 8.152555118307899806e-02 8.152555118307899806e-02 --2.343750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 1.084081404850199687e-01 1.084081404850199687e-01 1.084081404850199687e-01 --2.343750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 9.405789467378132540e-02 9.405789467378132540e-02 9.405789467378132540e-02 --2.031250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 1.386101017556054249e-01 1.386101017556054249e-01 1.386101017556054249e-01 --2.031250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 1.032618239358029100e-01 1.032618239358029100e-01 1.032618239358029100e-01 --2.031250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 1.157337419474434304e-01 1.157337419474434304e-01 1.157337419474434304e-01 --2.031250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 1.195135814034477412e-01 1.195135814034477412e-01 1.195135814034477412e-01 --2.343750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 5.491135450677581825e-02 5.491135450677581825e-02 5.491135450677581825e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 4.729235640674490232e-02 4.729235640674490232e-02 4.729235640674490232e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 9.522391252823909913e-02 9.522391252823909913e-02 9.522391252823909913e-02 --2.031250000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 7.613003095050729918e-02 7.613003095050729918e-02 7.613003095050729918e-02 --2.031250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 1.005177907062105302e-01 1.005177907062105302e-01 1.005177907062105302e-01 --2.031250000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 6.303923242796623250e-02 6.303923242796623250e-02 6.303923242796623250e-02 --2.031250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 1.065039212068658037e-01 1.065039212068658037e-01 1.065039212068658037e-01 --2.343750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 8.302288074435179577e-02 8.302288074435179577e-02 8.302288074435179577e-02 --2.031250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 8.592422908260928527e-02 8.592422908260928527e-02 8.592422908260928527e-02 --2.031250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 1.026495470339892219e-01 1.026495470339892219e-01 1.026495470339892219e-01 --2.031250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 1.019062912526975673e-01 1.019062912526975673e-01 1.019062912526975673e-01 --1.718750000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 2.147655346015572009e-01 2.147655346015572009e-01 2.147655346015572009e-01 --1.718750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 1.979920820049362873e-01 1.979920820049362873e-01 1.979920820049362873e-01 --1.406250000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 1.957047409323028064e-01 1.957047409323028064e-01 1.957047409323028064e-01 --1.406250000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 2.215166205565104185e-01 2.215166205565104185e-01 2.215166205565104185e-01 --1.406250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 2.065750504924362685e-01 2.065750504924362685e-01 2.065750504924362685e-01 --1.718750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 1.947616954173590209e-01 1.947616954173590209e-01 1.947616954173590209e-01 --1.718750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 1.741114445446350356e-01 1.741114445446350356e-01 1.741114445446350356e-01 --1.718750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 1.897605603717212597e-01 1.897605603717212597e-01 1.897605603717212597e-01 --1.718750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 1.234153462990095346e-01 1.234153462990095346e-01 1.234153462990095346e-01 --1.406250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 4.640007596933426459e-02 4.640007596933426459e-02 4.640007596933426459e-02 --1.406250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 2.010273233346207833e-01 2.010273233346207833e-01 2.010273233346207833e-01 --1.406250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 9.608535662909183095e-02 9.608535662909183095e-02 9.608535662909183095e-02 --1.718750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 8.087372590479942336e-02 8.087372590479942336e-02 8.087372590479942336e-02 --1.718750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 1.115190718117457375e-01 1.115190718117457375e-01 1.115190718117457375e-01 --1.718750000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 7.689201168528404795e-02 7.689201168528404795e-02 7.689201168528404795e-02 --1.718750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 9.395905158385869926e-02 9.395905158385869926e-02 9.395905158385869926e-02 --1.406250000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 8.581251705286292719e-02 8.581251705286292719e-02 8.581251705286292719e-02 --1.406250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 1.007636727573394675e-01 1.007636727573394675e-01 1.007636727573394675e-01 --1.406250000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 8.098383732745008390e-02 8.098383732745008390e-02 8.098383732745008390e-02 --1.718750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 1.107011784851532621e-01 1.107011784851532621e-01 1.107011784851532621e-01 --1.718750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.225035857745921525e-01 1.225035857745921525e-01 1.225035857745921525e-01 --1.718750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 9.874034647019301614e-02 9.874034647019301614e-02 9.874034647019301614e-02 --1.718750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 1.003273521306274063e-01 1.003273521306274063e-01 1.003273521306274063e-01 --1.406250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 1.064396429765208790e-01 1.064396429765208790e-01 1.064396429765208790e-01 --1.406250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.081365710396519630e-01 1.081365710396519630e-01 1.081365710396519630e-01 --1.406250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 8.443016830993708977e-02 8.443016830993708977e-02 8.443016830993708977e-02 --1.406250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 1.002469981660221721e-01 1.002469981660221721e-01 1.002469981660221721e-01 --1.718750000000000000e-01 1.406250000000000000e-01 -3.906250000000000000e-01 5.625754906761553514e-02 5.625754906761553514e-02 5.625754906761553514e-02 --1.406250000000000000e-01 1.406250000000000000e-01 -3.906250000000000000e-01 8.192419881239285107e-02 8.192419881239285107e-02 8.192419881239285107e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -3.906250000000000000e-01 5.082093630876042406e-02 5.082093630876042406e-02 5.082093630876042406e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.056026920499310962e-02 8.056026920499310962e-02 8.056026920499310962e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.032469363526061057e-02 8.032469363526061057e-02 8.032469363526061057e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 9.371073791974771083e-02 9.371073791974771083e-02 9.371073791974771083e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 6.513017971182454013e-02 6.513017971182454013e-02 6.513017971182454013e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 8.410547364898329770e-02 8.410547364898329770e-02 8.410547364898329770e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -3.593750000000000000e-01 6.107903053489444761e-02 6.107903053489444761e-02 6.107903053489444761e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.426782114325935547e-02 8.426782114325935547e-02 8.426782114325935547e-02 --1.718750000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 6.046032260094985622e-02 6.046032260094985622e-02 6.046032260094985622e-02 --1.718750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 8.891789296756329175e-02 8.891789296756329175e-02 8.891789296756329175e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 8.971430935198904111e-02 8.971430935198904111e-02 8.971430935198904111e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 9.801634007184235886e-02 9.801634007184235886e-02 9.801634007184235886e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 8.283641932285282228e-02 8.283641932285282228e-02 8.283641932285282228e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 7.071276684232825904e-02 7.071276684232825904e-02 7.071276684232825904e-02 --1.718750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 8.326560143010793003e-02 8.326560143010793003e-02 8.326560143010793003e-02 --1.718750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 8.075798818863323680e-02 8.075798818863323680e-02 8.075798818863323680e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 9.554133003782711020e-02 9.554133003782711020e-02 9.554133003782711020e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 9.493461952998712150e-02 9.493461952998712150e-02 9.493461952998712150e-02 --1.406250000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 1.057108849483232582e-01 1.057108849483232582e-01 1.057108849483232582e-01 --1.406250000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 1.238531483414467560e-01 1.238531483414467560e-01 1.238531483414467560e-01 --1.406250000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 1.137919360327515894e-01 1.137919360327515894e-01 1.137919360327515894e-01 --1.093750000000000000e-01 1.562500000000000000e-02 -3.906250000000000000e-01 1.791954331624502350e-01 1.791954331624502350e-01 1.791954331624502350e-01 --7.812500000000000000e-02 1.562500000000000000e-02 -4.218750000000000000e-01 1.431124738316695288e-01 1.431124738316695288e-01 1.431124738316695288e-01 --7.812500000000000000e-02 1.562500000000000000e-02 -3.906250000000000000e-01 2.001397156916326359e-01 2.001397156916326359e-01 2.001397156916326359e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -3.906250000000000000e-01 1.674559352059942496e-01 1.674559352059942496e-01 1.674559352059942496e-01 --1.093750000000000000e-01 1.093750000000000000e-01 -3.906250000000000000e-01 8.096535147868824667e-02 8.096535147868824667e-02 8.096535147868824667e-02 --4.687500000000000000e-02 1.562500000000000000e-02 -4.218750000000000000e-01 1.170504798224437509e-01 1.170504798224437509e-01 1.170504798224437509e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -4.218750000000000000e-01 5.717649240410729861e-02 5.717649240410729861e-02 5.717649240410729861e-02 --4.687500000000000000e-02 4.687500000000000000e-02 -3.906250000000000000e-01 1.068630748737838809e-01 1.068630748737838809e-01 1.068630748737838809e-01 --1.562500000000000000e-02 1.562500000000000000e-02 -4.218750000000000000e-01 6.675169161427962905e-02 6.675169161427962905e-02 6.675169161427962905e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -4.218750000000000000e-01 7.957407823793646862e-02 7.957407823793646862e-02 7.957407823793646862e-02 --4.687500000000000000e-02 7.812500000000000000e-02 -3.906250000000000000e-01 9.137944507810707995e-02 9.137944507810707995e-02 9.137944507810707995e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -4.218750000000000000e-01 7.402554413631470820e-02 7.402554413631470820e-02 7.402554413631470820e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -3.906250000000000000e-01 9.609178528173462075e-02 9.609178528173462075e-02 9.609178528173462075e-02 --1.093750000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 2.132971345057253776e-01 2.132971345057253776e-01 2.132971345057253776e-01 --1.093750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 2.028643029843708590e-01 2.028643029843708590e-01 2.028643029843708590e-01 --1.093750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 1.926701014081815821e-01 1.926701014081815821e-01 1.926701014081815821e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 2.091477563655868011e-01 2.091477563655868011e-01 2.091477563655868011e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -3.281250000000000000e-01 1.065103490270722375e-01 1.065103490270722375e-01 1.065103490270722375e-01 --1.093750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 1.065167768467651099e-01 1.065167768467651099e-01 1.065167768467651099e-01 --1.093750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 8.132863781477951692e-02 8.132863781477951692e-02 8.132863781477951692e-02 --7.812500000000000000e-02 4.687500000000000000e-02 -2.968750000000000000e-01 4.134845799801276089e-02 4.134845799801276089e-02 4.134845799801276089e-02 --7.812500000000000000e-02 4.687500000000000000e-02 -2.656250000000000000e-01 6.444059918146685662e-02 6.444059918146685662e-02 6.444059918146685662e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 7.925233785244777118e-02 7.925233785244777118e-02 7.925233785244777118e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 9.339893844710814297e-02 9.339893844710814297e-02 9.339893844710814297e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 9.775759258669247664e-02 9.775759258669247664e-02 9.775759258669247664e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 8.556578561739464073e-02 8.556578561739464073e-02 8.556578561739464073e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 1.477519183173441331e-01 1.477519183173441331e-01 1.477519183173441331e-01 --7.812500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 6.199446193730555332e-02 6.199446193730555332e-02 6.199446193730555332e-02 --7.812500000000000000e-02 1.093750000000000000e-01 -3.593750000000000000e-01 7.534216100300078489e-02 7.534216100300078489e-02 7.534216100300078489e-02 --7.812500000000000000e-02 1.093750000000000000e-01 -3.281250000000000000e-01 7.429256671027635595e-02 7.429256671027635595e-02 7.429256671027635595e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 9.111344356607391226e-02 9.111344356607391226e-02 9.111344356607391226e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 7.279587847342759710e-02 7.279587847342759710e-02 7.279587847342759710e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 8.732182187058785960e-02 8.732182187058785960e-02 8.732182187058785960e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 5.053992598951371346e-02 5.053992598951371346e-02 5.053992598951371346e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -2.656250000000000000e-01 4.046077563374586572e-02 4.046077563374586572e-02 4.046077563374586572e-02 --7.812500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 8.508276846683170136e-02 8.508276846683170136e-02 8.508276846683170136e-02 --7.812500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 5.719474252854599844e-02 5.719474252854599844e-02 5.719474252854599844e-02 --4.687500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 6.010811680392198764e-02 6.010811680392198764e-02 6.010811680392198764e-02 --1.562500000000000000e-02 1.562500000000000000e-02 -3.281250000000000000e-01 5.923077116741852499e-02 5.923077116741852499e-02 5.923077116741852499e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -3.281250000000000000e-01 4.279531342436471153e-02 4.279531342436471153e-02 4.279531342436471153e-02 --4.687500000000000000e-02 1.562500000000000000e-02 -2.656250000000000000e-01 7.410994329973132067e-02 7.410994329973132067e-02 7.410994329973132067e-02 --4.687500000000000000e-02 4.687500000000000000e-02 -2.656250000000000000e-01 4.669710184381004742e-02 4.669710184381004742e-02 4.669710184381004742e-02 --1.562500000000000000e-02 1.562500000000000000e-02 -2.968750000000000000e-01 4.677389097514179223e-02 4.677389097514179223e-02 4.677389097514179223e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -2.968750000000000000e-01 3.964794945712194624e-02 3.964794945712194624e-02 3.964794945712194624e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -2.656250000000000000e-01 3.193606565246299295e-02 3.193606565246299295e-02 3.193606565246299295e-02 --4.687500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 5.250778162973808449e-02 5.250778162973808449e-02 5.250778162973808449e-02 --4.687500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 6.059916249031220559e-02 6.059916249031220559e-02 6.059916249031220559e-02 --4.687500000000000000e-02 1.093750000000000000e-01 -3.593750000000000000e-01 6.768643163052474876e-02 6.768643163052474876e-02 6.768643163052474876e-02 --4.687500000000000000e-02 1.093750000000000000e-01 -3.281250000000000000e-01 8.496864419078165032e-02 8.496864419078165032e-02 8.496864419078165032e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 4.839263705087820666e-02 4.839263705087820666e-02 4.839263705087820666e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 5.002630573650940216e-02 5.002630573650940216e-02 5.002630573650940216e-02 --1.562500000000000000e-02 1.093750000000000000e-01 -3.593750000000000000e-01 3.964754738436783443e-02 3.964754738436783443e-02 3.964754738436783443e-02 --1.562500000000000000e-02 1.093750000000000000e-01 -3.281250000000000000e-01 5.542807912711653767e-02 5.542807912711653767e-02 5.542807912711653767e-02 --4.687500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 5.147372873837512131e-02 5.147372873837512131e-02 5.147372873837512131e-02 --4.687500000000000000e-02 7.812500000000000000e-02 -2.656250000000000000e-01 4.913558331604863522e-02 4.913558331604863522e-02 4.913558331604863522e-02 --4.687500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 7.415825173342241450e-02 7.415825173342241450e-02 7.415825173342241450e-02 --4.687500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 6.230718706030581588e-02 6.230718706030581588e-02 6.230718706030581588e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 5.256317838102438078e-02 5.256317838102438078e-02 5.256317838102438078e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -2.656250000000000000e-01 7.579895289489282928e-02 7.579895289489282928e-02 7.579895289489282928e-02 --1.562500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 7.079692833073983338e-02 7.079692833073983338e-02 7.079692833073983338e-02 --1.562500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 1.040034601894578165e-01 1.040034601894578165e-01 1.040034601894578165e-01 --1.093750000000000000e-01 1.406250000000000000e-01 -3.906250000000000000e-01 8.534396778519119653e-02 8.534396778519119653e-02 8.534396778519119653e-02 --1.093750000000000000e-01 1.718750000000000000e-01 -3.906250000000000000e-01 7.005587013657518791e-02 7.005587013657518791e-02 7.005587013657518791e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -3.906250000000000000e-01 5.929701660392751317e-02 5.929701660392751317e-02 5.929701660392751317e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -3.906250000000000000e-01 9.155785043332445583e-02 9.155785043332445583e-02 9.155785043332445583e-02 --1.093750000000000000e-01 1.406250000000000000e-01 -3.593750000000000000e-01 8.870813920758159610e-02 8.870813920758159610e-02 8.870813920758159610e-02 --1.093750000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 1.028062325115483844e-01 1.028062325115483844e-01 1.028062325115483844e-01 --1.093750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 7.962961710507025781e-02 7.962961710507025781e-02 7.962961710507025781e-02 --7.812500000000000000e-02 1.406250000000000000e-01 -3.593750000000000000e-01 7.198562961599740129e-02 7.198562961599740129e-02 7.198562961599740129e-02 --7.812500000000000000e-02 1.718750000000000000e-01 -3.593750000000000000e-01 7.898581399066254005e-02 7.898581399066254005e-02 7.898581399066254005e-02 --7.812500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 8.617015573818793961e-02 8.617015573818793961e-02 8.617015573818793961e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 1.289130031035534696e-01 1.289130031035534696e-01 1.289130031035534696e-01 --7.812500000000000000e-02 2.031250000000000000e-01 -3.593750000000000000e-01 6.396155508910982002e-02 6.396155508910982002e-02 6.396155508910982002e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -3.281250000000000000e-01 8.953670355573244144e-02 8.953670355573244144e-02 8.953670355573244144e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 1.347556590546372390e-01 1.347556590546372390e-01 1.347556590546372390e-01 --1.093750000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 1.221011225555556218e-01 1.221011225555556218e-01 1.221011225555556218e-01 --7.812500000000000000e-02 2.031250000000000000e-01 -2.968750000000000000e-01 9.727143434691490342e-02 9.727143434691490342e-02 9.727143434691490342e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 9.162053330204320001e-02 9.162053330204320001e-02 9.162053330204320001e-02 --4.687500000000000000e-02 1.406250000000000000e-01 -3.593750000000000000e-01 6.789398938667225158e-02 6.789398938667225158e-02 6.789398938667225158e-02 --4.687500000000000000e-02 1.718750000000000000e-01 -3.593750000000000000e-01 7.055674230280239989e-02 7.055674230280239989e-02 7.055674230280239989e-02 --1.562500000000000000e-02 1.406250000000000000e-01 -3.593750000000000000e-01 3.817144433579901242e-02 3.817144433579901242e-02 3.817144433579901242e-02 --1.562500000000000000e-02 1.406250000000000000e-01 -3.281250000000000000e-01 7.026784289756238255e-02 7.026784289756238255e-02 7.026784289756238255e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -3.593750000000000000e-01 3.779461395124789069e-02 3.779461395124789069e-02 3.779461395124789069e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -3.281250000000000000e-01 6.517680536788664214e-02 6.517680536788664214e-02 6.517680536788664214e-02 --4.687500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 5.266247434920219572e-02 5.266247434920219572e-02 5.266247434920219572e-02 --4.687500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 6.630417335042594618e-02 6.630417335042594618e-02 6.630417335042594618e-02 --1.562500000000000000e-02 1.406250000000000000e-01 -2.968750000000000000e-01 7.376888975539874771e-02 7.376888975539874771e-02 7.376888975539874771e-02 --1.562500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 9.359180424283181088e-02 9.359180424283181088e-02 9.359180424283181088e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -2.968750000000000000e-01 7.861898054879244702e-02 7.861898054879244702e-02 7.861898054879244702e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 8.224649111707937887e-02 8.224649111707937887e-02 8.224649111707937887e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -3.593750000000000000e-01 7.046542640926439782e-02 7.046542640926439782e-02 7.046542640926439782e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -3.281250000000000000e-01 9.388351288041409115e-02 9.388351288041409115e-02 9.388351288041409115e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -3.593750000000000000e-01 6.294766682781426093e-02 6.294766682781426093e-02 6.294766682781426093e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -3.281250000000000000e-01 6.796231773301963930e-02 6.796231773301963930e-02 6.796231773301963930e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -3.593750000000000000e-01 8.729208610660442458e-02 8.729208610660442458e-02 8.729208610660442458e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -3.281250000000000000e-01 8.621275080149341796e-02 8.621275080149341796e-02 8.621275080149341796e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -3.593750000000000000e-01 8.958331506961900170e-02 8.958331506961900170e-02 8.958331506961900170e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -3.281250000000000000e-01 8.153358845318532666e-02 8.153358845318532666e-02 8.153358845318532666e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -2.968750000000000000e-01 8.329132013534742973e-02 8.329132013534742973e-02 8.329132013534742973e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 6.810894212974688555e-02 6.810894212974688555e-02 6.810894212974688555e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -2.968750000000000000e-01 6.813241487019675025e-02 6.813241487019675025e-02 6.813241487019675025e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 1.321267573500292114e-01 1.321267573500292114e-01 1.321267573500292114e-01 --1.562500000000000000e-02 2.031250000000000000e-01 -2.968750000000000000e-01 7.186328776000386331e-02 7.186328776000386331e-02 7.186328776000386331e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 9.206413374649868864e-02 9.206413374649868864e-02 9.206413374649868864e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -2.968750000000000000e-01 9.082413578720681391e-02 9.082413578720681391e-02 9.082413578720681391e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 1.322231438974554585e-01 1.322231438974554585e-01 1.322231438974554585e-01 --2.343750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.142458584517454662e-01 1.142458584517454662e-01 1.142458584517454662e-01 --2.031250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.035759957077745513e-01 1.035759957077745513e-01 1.035759957077745513e-01 --2.343750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 5.203702830697561066e-02 5.203702830697561066e-02 5.203702830697561066e-02 --2.343750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 7.270970953824311411e-02 7.270970953824311411e-02 7.270970953824311411e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 9.066421242961551774e-02 9.066421242961551774e-02 9.066421242961551774e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 4.478603395784330754e-02 4.478603395784330754e-02 4.478603395784330754e-02 --2.031250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 1.118356216140506537e-01 1.118356216140506537e-01 1.118356216140506537e-01 --2.031250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 9.415593404141150979e-02 9.415593404141150979e-02 9.415593404141150979e-02 --2.343750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.044968092304020546e-01 1.044968092304020546e-01 1.044968092304020546e-01 --2.343750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.144611694293157650e-01 1.144611694293157650e-01 1.144611694293157650e-01 --2.343750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.185865128806325164e-01 1.185865128806325164e-01 1.185865128806325164e-01 --2.031250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.432257125496619876e-01 1.432257125496619876e-01 1.432257125496619876e-01 --2.031250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 8.057634393726484379e-02 8.057634393726484379e-02 8.057634393726484379e-02 --2.031250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 7.011889129640212770e-02 7.011889129640212770e-02 7.011889129640212770e-02 --1.718750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 6.930403353859117266e-02 6.930403353859117266e-02 6.930403353859117266e-02 --1.718750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 4.746708043424969353e-02 4.746708043424969353e-02 4.746708043424969353e-02 --1.718750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 8.653502592711553865e-02 8.653502592711553865e-02 8.653502592711553865e-02 --1.718750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 4.517875258575007602e-02 4.517875258575007602e-02 4.517875258575007602e-02 --1.406250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 7.153637204547896866e-02 7.153637204547896866e-02 7.153637204547896866e-02 --1.406250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 5.527387411872508594e-02 5.527387411872508594e-02 5.527387411872508594e-02 --1.718750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 4.407778470680202149e-02 4.407778470680202149e-02 4.407778470680202149e-02 --1.406250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 6.415400912495865249e-02 6.415400912495865249e-02 6.415400912495865249e-02 --1.406250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 6.377102996354053199e-02 6.377102996354053199e-02 6.377102996354053199e-02 --1.406250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 6.961801640427464632e-02 6.961801640427464632e-02 6.961801640427464632e-02 --1.406250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 6.061974325258275703e-02 6.061974325258275703e-02 6.061974325258275703e-02 --1.718750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 1.010151787838353549e-01 1.010151787838353549e-01 1.010151787838353549e-01 --1.718750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 6.063228465201872530e-02 6.063228465201872530e-02 6.063228465201872530e-02 --1.718750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 1.081116637369261141e-01 1.081116637369261141e-01 1.081116637369261141e-01 --1.718750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 2.375712420273704550e-01 2.375712420273704550e-01 2.375712420273704550e-01 --1.406250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 9.550999013691503781e-02 9.550999013691503781e-02 9.550999013691503781e-02 --1.406250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 7.923087773100966069e-02 7.923087773100966069e-02 7.923087773100966069e-02 --1.406250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 9.362475210337928289e-02 9.362475210337928289e-02 9.362475210337928289e-02 --1.406250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 8.162601700163636675e-02 8.162601700163636675e-02 8.162601700163636675e-02 --1.718750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 6.462107402278964574e-02 6.462107402278964574e-02 6.462107402278964574e-02 --1.718750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 7.289442604175695728e-02 7.289442604175695728e-02 7.289442604175695728e-02 --1.718750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 7.918651072019207426e-02 7.918651072019207426e-02 7.918651072019207426e-02 --1.718750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 8.326560143010793003e-02 8.326560143010793003e-02 8.326560143010793003e-02 --1.406250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 8.418825483798776654e-02 8.418825483798776654e-02 8.418825483798776654e-02 --1.406250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.107831288789391383e-01 1.107831288789391383e-01 1.107831288789391383e-01 --2.343750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 5.662705720373439194e-02 5.662705720373439194e-02 5.662705720373439194e-02 --2.031250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 6.623013604900744589e-02 6.623013604900744589e-02 6.623013604900744589e-02 --2.031250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 5.876246904415240169e-02 5.876246904415240169e-02 5.876246904415240169e-02 --2.343750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 2.531342212249038104e-02 2.531342212249038104e-02 2.531342212249038104e-02 --2.343750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 8.581010600014797596e-02 8.581010600014797596e-02 8.581010600014797596e-02 --2.343750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 7.569373746642113487e-02 7.569373746642113487e-02 7.569373746642113487e-02 --2.343750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 7.461746173541636273e-02 7.461746173541636273e-02 7.461746173541636273e-02 --2.031250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 7.765052901069649516e-02 7.765052901069649516e-02 7.765052901069649516e-02 --2.031250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 3.191089348128860886e-02 3.191089348128860886e-02 3.191089348128860886e-02 --2.031250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 9.623482267025121328e-02 9.623482267025121328e-02 9.623482267025121328e-02 --2.343750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 8.710563457920679487e-02 8.710563457920679487e-02 8.710563457920679487e-02 --2.343750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 7.216303301494803035e-02 7.216303301494803035e-02 7.216303301494803035e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 6.581404675541366323e-02 6.581404675541366323e-02 6.581404675541366323e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 8.462707408732920988e-02 8.462707408732920988e-02 8.462707408732920988e-02 --2.031250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.659425127651426302e-01 1.659425127651426302e-01 1.659425127651426302e-01 --2.031250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.133131053602346727e-01 1.133131053602346727e-01 1.133131053602346727e-01 --2.031250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 5.230444547692100071e-02 5.230444547692100071e-02 5.230444547692100071e-02 --2.343750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.073258745503074679e-01 1.073258745503074679e-01 1.073258745503074679e-01 --2.343750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 1.060443307308062966e-01 1.060443307308062966e-01 1.060443307308062966e-01 --2.343750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.285732260307534958e-01 1.285732260307534958e-01 1.285732260307534958e-01 --2.343750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.019914646959743931e-01 1.019914646959743931e-01 1.019914646959743931e-01 --2.031250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.255344467035036105e-01 1.255344467035036105e-01 1.255344467035036105e-01 --2.031250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 1.448953628062292776e-01 1.448953628062292776e-01 1.448953628062292776e-01 --2.031250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 8.147572009052726771e-02 8.147572009052726771e-02 8.147572009052726771e-02 --2.031250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 8.602067099792248817e-02 8.602067099792248817e-02 8.602067099792248817e-02 --1.718750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 2.801828031174942793e-02 2.801828031174942793e-02 2.801828031174942793e-02 --1.406250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 2.482891709138864214e-02 2.482891709138864214e-02 2.482891709138864214e-02 --1.406250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 7.476640500825353086e-02 7.476640500825353086e-02 7.476640500825353086e-02 --1.406250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 2.855058501994595099e-01 2.855058501994595099e-01 2.855058501994595099e-01 --1.718750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 8.315870797329338870e-02 8.315870797329338870e-02 8.315870797329338870e-02 --1.718750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 4.944602668739982859e-02 4.944602668739982859e-02 4.944602668739982859e-02 --1.406250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.249737500556666603e-01 1.249737500556666603e-01 1.249737500556666603e-01 --1.406250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.064500881924361902e-01 1.064500881924361902e-01 1.064500881924361902e-01 --1.406250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.210592074243249106e-01 1.210592074243249106e-01 1.210592074243249106e-01 --1.406250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 8.193866582631530171e-02 8.193866582631530171e-02 8.193866582631530171e-02 --1.406250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 2.010369537435881815e-01 2.010369537435881815e-01 2.010369537435881815e-01 --1.406250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.602859948889137631e-01 1.602859948889137631e-01 1.602859948889137631e-01 --2.343750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 7.413662949297231131e-02 7.413662949297231131e-02 7.413662949297231131e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.002204813400950217e-01 1.002204813400950217e-01 1.002204813400950217e-01 --2.343750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 9.354037340918472387e-02 9.354037340918472387e-02 9.354037340918472387e-02 --2.343750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.034361854032157801e-01 1.034361854032157801e-01 1.034361854032157801e-01 --2.031250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 7.230973013817283690e-02 7.230973013817283690e-02 7.230973013817283690e-02 --2.031250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 6.897855435899775955e-02 6.897855435899775955e-02 6.897855435899775955e-02 --2.343750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 6.500445108390111304e-02 6.500445108390111304e-02 6.500445108390111304e-02 --2.343750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 9.650964660189438604e-02 9.650964660189438604e-02 9.650964660189438604e-02 --2.343750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 5.830654516514748725e-02 5.830654516514748725e-02 5.830654516514748725e-02 --2.343750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 7.538612823965452903e-02 7.538612823965452903e-02 7.538612823965452903e-02 --2.031250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 6.546435644608381010e-02 6.546435644608381010e-02 6.546435644608381010e-02 --2.031250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 8.932454046168160355e-02 8.932454046168160355e-02 8.932454046168160355e-02 --2.031250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 7.279547656629736796e-02 7.279547656629736796e-02 7.279547656629736796e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 6.392160112336829625e-02 6.392160112336829625e-02 6.392160112336829625e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.456727542779006623e-01 1.456727542779006623e-01 1.456727542779006623e-01 --1.718750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 6.829881389555859939e-02 6.829881389555859939e-02 6.829881389555859939e-02 --1.406250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.074094353192747847e-01 1.074094353192747847e-01 1.074094353192747847e-01 --1.406250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 8.659369432729843719e-02 8.659369432729843719e-02 8.659369432729843719e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 1.636542603174414023e-01 1.636542603174414023e-01 1.636542603174414023e-01 --1.718750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.063239420324791629e-01 1.063239420324791629e-01 1.063239420324791629e-01 --1.718750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.362238869661399621e-01 1.362238869661399621e-01 1.362238869661399621e-01 --1.718750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 1.651091146720085057e-01 1.651091146720085057e-01 1.651091146720085057e-01 --1.406250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.962898248910145138e-01 1.962898248910145138e-01 1.962898248910145138e-01 --1.406250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.463714364846597227e-01 1.463714364846597227e-01 1.463714364846597227e-01 --1.406250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.368222544419299969e-01 1.368222544419299969e-01 1.368222544419299969e-01 --1.406250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 9.189537299610711640e-02 9.189537299610711640e-02 9.189537299610711640e-02 --1.718750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 4.273701513435625154e-02 4.273701513435625154e-02 4.273701513435625154e-02 --1.406250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 7.784520084279450414e-02 7.784520084279450414e-02 7.784520084279450414e-02 --1.406250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 7.375225099965435072e-02 7.375225099965435072e-02 7.375225099965435072e-02 --1.718750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 5.712166160883978827e-02 5.712166160883978827e-02 5.712166160883978827e-02 --1.718750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 1.696702176436405973e-01 1.696702176436405973e-01 1.696702176436405973e-01 --1.718750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 5.445926799143386426e-02 5.445926799143386426e-02 5.445926799143386426e-02 --1.406250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 1.137501589734590535e-01 1.137501589734590535e-01 1.137501589734590535e-01 --1.406250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 7.331875795261277862e-02 7.331875795261277862e-02 7.331875795261277862e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 6.369530213009776121e-02 6.369530213009776121e-02 6.369530213009776121e-02 --2.343750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 5.090881715990245443e-02 5.090881715990245443e-02 5.090881715990245443e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 5.312084224610414546e-02 5.312084224610414546e-02 5.312084224610414546e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 4.530394933747891595e-02 4.530394933747891595e-02 4.530394933747891595e-02 --2.031250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 5.699037305716578988e-02 5.699037305716578988e-02 5.699037305716578988e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.006953722629651132e-01 1.006953722629651132e-01 1.006953722629651132e-01 --2.343750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 1.084643825632671116e-01 1.084643825632671116e-01 1.084643825632671116e-01 --2.343750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 8.586073809191711870e-02 8.586073809191711870e-02 8.586073809191711870e-02 --2.343750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 8.329051642593761351e-02 8.329051642593761351e-02 8.329051642593761351e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 6.948031746427536792e-02 6.948031746427536792e-02 6.948031746427536792e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 9.420816808192104819e-02 9.420816808192104819e-02 9.420816808192104819e-02 --2.031250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 7.554133962701561900e-02 7.554133962701561900e-02 7.554133962701561900e-02 --2.031250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 6.550398809083664287e-02 6.550398809083664287e-02 6.550398809083664287e-02 --2.343750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 1.162093446910862637e-01 1.162093446910862637e-01 1.162093446910862637e-01 --2.031250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 5.360943816198530248e-02 5.360943816198530248e-02 5.360943816198530248e-02 --2.031250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 9.281310575748659419e-02 9.281310575748659419e-02 9.281310575748659419e-02 --2.031250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 5.315726392980602011e-02 5.315726392980602011e-02 5.315726392980602011e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 1.203233517537570102e-01 1.203233517537570102e-01 1.203233517537570102e-01 --1.718750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 5.397992326320264628e-02 5.397992326320264628e-02 5.397992326320264628e-02 --1.406250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 1.491990297475913607e-01 1.491990297475913607e-01 1.491990297475913607e-01 --1.406250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.036306341515858681e-01 1.036306341515858681e-01 1.036306341515858681e-01 --1.718750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 5.867130055414278983e-02 5.867130055414278983e-02 5.867130055414278983e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 7.022845475138717042e-02 7.022845475138717042e-02 7.022845475138717042e-02 --1.718750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 6.468635034676024909e-02 6.468635034676024909e-02 6.468635034676024909e-02 --1.718750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 6.403318277278512161e-02 6.403318277278512161e-02 6.403318277278512161e-02 --1.406250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.143149508431637595e-01 1.143149508431637595e-01 1.143149508431637595e-01 --1.406250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 7.284362502650901239e-02 7.284362502650901239e-02 7.284362502650901239e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 5.547278083654823277e-02 5.547278083654823277e-02 5.547278083654823277e-02 --1.718750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 6.420947824782748115e-02 6.420947824782748115e-02 6.420947824782748115e-02 --1.406250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 7.573022931129017032e-02 7.573022931129017032e-02 7.573022931129017032e-02 --1.718750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 6.972002439878095814e-02 6.972002439878095814e-02 6.972002439878095814e-02 --1.718750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 4.991293576490990480e-02 4.991293576490990480e-02 4.991293576490990480e-02 --1.718750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 7.852076149500680780e-02 7.852076149500680780e-02 7.852076149500680780e-02 --1.718750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 6.321593203602357547e-02 6.321593203602357547e-02 6.321593203602357547e-02 --1.406250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 9.861981311563895736e-02 9.861981311563895736e-02 9.861981311563895736e-02 --1.406250000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 9.008961080830980850e-02 9.008961080830980850e-02 9.008961080830980850e-02 --1.406250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 1.133572928738683233e-01 1.133572928738683233e-01 1.133572928738683233e-01 --1.406250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 9.371957757790369548e-02 9.371957757790369548e-02 9.371957757790369548e-02 --1.093750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 7.243110673379868358e-02 7.243110673379868358e-02 7.243110673379868358e-02 --1.093750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 5.808384820321755432e-02 5.808384820321755432e-02 5.808384820321755432e-02 --7.812500000000000000e-02 1.562500000000000000e-02 -2.343750000000000000e-01 8.773731774740733957e-02 8.773731774740733957e-02 8.773731774740733957e-02 --7.812500000000000000e-02 1.562500000000000000e-02 -2.031250000000000000e-01 9.025596442702260580e-02 9.025596442702260580e-02 9.025596442702260580e-02 --7.812500000000000000e-02 4.687500000000000000e-02 -2.343750000000000000e-01 8.312575582639576688e-02 8.312575582639576688e-02 8.312575582639576688e-02 --7.812500000000000000e-02 4.687500000000000000e-02 -2.031250000000000000e-01 9.488077877381799474e-02 9.488077877381799474e-02 9.488077877381799474e-02 --1.093750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 9.622035822678960681e-02 9.622035822678960681e-02 9.622035822678960681e-02 --1.093750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.006182328113592317e-01 1.006182328113592317e-01 1.006182328113592317e-01 --1.093750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 9.038695761420070807e-02 9.038695761420070807e-02 9.038695761420070807e-02 --1.093750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.042163880781976082e-01 1.042163880781976082e-01 1.042163880781976082e-01 --7.812500000000000000e-02 1.562500000000000000e-02 -1.718750000000000000e-01 1.664419051739099986e-01 1.664419051739099986e-01 1.664419051739099986e-01 --7.812500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 9.994406299790545289e-02 9.994406299790545289e-02 9.994406299790545289e-02 --7.812500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 1.298897537892972354e-01 1.298897537892972354e-01 1.298897537892972354e-01 --1.093750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 6.394169869412985596e-02 6.394169869412985596e-02 6.394169869412985596e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 5.765702403596308090e-02 5.765702403596308090e-02 5.765702403596308090e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 7.488134755053306446e-02 7.488134755053306446e-02 7.488134755053306446e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -2.343750000000000000e-01 5.657471836073342530e-02 5.657471836073342530e-02 5.657471836073342530e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 6.067979724368297023e-02 6.067979724368297023e-02 6.067979724368297023e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 9.042231770178768557e-02 9.042231770178768557e-02 9.042231770178768557e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 8.233168537588621272e-02 8.233168537588621272e-02 8.233168537588621272e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 9.237192029878256438e-02 9.237192029878256438e-02 9.237192029878256438e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -1.406250000000000000e-01 1.015905059072556432e-01 1.015905059072556432e-01 1.015905059072556432e-01 --7.812500000000000000e-02 1.093750000000000000e-01 -1.718750000000000000e-01 1.787442853113632435e-01 1.787442853113632435e-01 1.787442853113632435e-01 --7.812500000000000000e-02 1.093750000000000000e-01 -1.406250000000000000e-01 1.259722372147607794e-01 1.259722372147607794e-01 1.259722372147607794e-01 --4.687500000000000000e-02 1.562500000000000000e-02 -2.343750000000000000e-01 7.820962653223190175e-02 7.820962653223190175e-02 7.820962653223190175e-02 --4.687500000000000000e-02 4.687500000000000000e-02 -2.343750000000000000e-01 1.014289968927203495e-01 1.014289968927203495e-01 1.014289968927203495e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -2.031250000000000000e-01 1.193328279804201364e-01 1.193328279804201364e-01 1.193328279804201364e-01 --4.687500000000000000e-02 1.562500000000000000e-02 -1.718750000000000000e-01 6.880170663598110525e-02 6.880170663598110525e-02 6.880170663598110525e-02 --4.687500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 7.816566083855899794e-02 7.816566083855899794e-02 7.816566083855899794e-02 --4.687500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 1.248709284698939909e-01 1.248709284698939909e-01 1.248709284698939909e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 9.517971505416057687e-02 9.517971505416057687e-02 9.517971505416057687e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 4.727064653788053128e-02 4.727064653788053128e-02 4.727064653788053128e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 7.981423734729971298e-02 7.981423734729971298e-02 7.981423734729971298e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 1.340633015854069965e-01 1.340633015854069965e-01 1.340633015854069965e-01 --4.687500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 8.560355888295499704e-02 8.560355888295499704e-02 8.560355888295499704e-02 --4.687500000000000000e-02 7.812500000000000000e-02 -1.406250000000000000e-01 1.322207342351739978e-01 1.322207342351739978e-01 1.322207342351739978e-01 --4.687500000000000000e-02 1.093750000000000000e-01 -1.718750000000000000e-01 1.005876984246534683e-01 1.005876984246534683e-01 1.005876984246534683e-01 --4.687500000000000000e-02 1.093750000000000000e-01 -1.406250000000000000e-01 8.675041107690897868e-02 8.675041107690897868e-02 8.675041107690897868e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 1.334769617141876308e-01 1.334769617141876308e-01 1.334769617141876308e-01 --1.562500000000000000e-02 7.812500000000000000e-02 -1.406250000000000000e-01 1.135870675535669838e-01 1.135870675535669838e-01 1.135870675535669838e-01 --1.562500000000000000e-02 1.093750000000000000e-01 -1.718750000000000000e-01 1.172706035148429887e-01 1.172706035148429887e-01 1.172706035148429887e-01 --1.562500000000000000e-02 1.093750000000000000e-01 -1.406250000000000000e-01 9.704482735367914170e-02 9.704482735367914170e-02 9.704482735367914170e-02 --1.093750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 9.324785991750607350e-02 9.324785991750607350e-02 9.324785991750607350e-02 --1.093750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 8.146125299335915670e-02 8.146125299335915670e-02 8.146125299335915670e-02 --7.812500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 8.526199147504251452e-02 8.526199147504251452e-02 8.526199147504251452e-02 --7.812500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 1.382960667615024952e-01 1.382960667615024952e-01 1.382960667615024952e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -1.093750000000000000e-01 1.136184004135770420e-01 1.136184004135770420e-01 1.136184004135770420e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 1.311058560798580852e-01 1.311058560798580852e-01 1.311058560798580852e-01 --1.093750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 9.480443734138356560e-02 9.480443734138356560e-02 9.480443734138356560e-02 --1.093750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.314488353709268587e-01 1.314488353709268587e-01 1.314488353709268587e-01 --1.093750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 3.089358922636845084e-01 3.089358922636845084e-01 3.089358922636845084e-01 --7.812500000000000000e-02 1.562500000000000000e-02 -4.687500000000000000e-02 2.223863413299899117e-01 2.223863413299899117e-01 2.223863413299899117e-01 --7.812500000000000000e-02 1.562500000000000000e-02 -1.562500000000000000e-02 7.723970469871176414e-01 7.723970469871176414e-01 7.723970469871176414e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 1.262959596754549274e-01 1.262959596754549274e-01 1.262959596754549274e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -1.562500000000000000e-02 4.062582149119013386e-01 4.062582149119013386e-01 4.062582149119013386e-01 --1.093750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 9.940568733781850186e-02 9.940568733781850186e-02 9.940568733781850186e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 6.438513021794413371e-02 6.438513021794413371e-02 6.438513021794413371e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.026262450651057312e-01 1.026262450651057312e-01 1.026262450651057312e-01 --1.093750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 8.784340145721367121e-02 8.784340145721367121e-02 8.784340145721367121e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 1.189199053038948461e-01 1.189199053038948461e-01 1.189199053038948461e-01 --7.812500000000000000e-02 1.093750000000000000e-01 -1.093750000000000000e-01 1.087624649216141909e-01 1.087624649216141909e-01 1.087624649216141909e-01 --1.093750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 7.411838321120520212e-02 7.411838321120520212e-02 7.411838321120520212e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 2.610368981046822801e-01 2.610368981046822801e-01 2.610368981046822801e-01 --1.093750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 5.781741499915498544e-02 5.781741499915498544e-02 5.781741499915498544e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.064091107991070595e-01 1.064091107991070595e-01 1.064091107991070595e-01 --7.812500000000000000e-02 7.812500000000000000e-02 -1.562500000000000000e-02 1.905800582984351899e-01 1.905800582984351899e-01 1.905800582984351899e-01 --7.812500000000000000e-02 1.093750000000000000e-01 -1.562500000000000000e-02 1.838536677712332978e-01 1.838536677712332978e-01 1.838536677712332978e-01 --4.687500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 1.049515875884298316e-01 1.049515875884298316e-01 1.049515875884298316e-01 --4.687500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 1.412829638028030299e-01 1.412829638028030299e-01 1.412829638028030299e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -1.093750000000000000e-01 1.118966818387183981e-01 1.118966818387183981e-01 1.118966818387183981e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 1.523870801845698120e-01 1.523870801845698120e-01 1.523870801845698120e-01 --1.562500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 4.672677220796528363e-02 4.672677220796528363e-02 4.672677220796528363e-02 --1.562500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 9.411816479098135402e-02 9.411816479098135402e-02 9.411816479098135402e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -1.093750000000000000e-01 2.425963603749418246e-02 2.425963603749418246e-02 2.425963603749418246e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 8.747532253149195580e-02 8.747532253149195580e-02 8.747532253149195580e-02 --4.687500000000000000e-02 1.562500000000000000e-02 -4.687500000000000000e-02 6.519978536702459859e-01 6.519978536702459859e-01 6.519978536702459859e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 2.160445454148297861e-01 2.160445454148297861e-01 2.160445454148297861e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -1.562500000000000000e-02 3.854283815626161624e-01 3.854283815626161624e-01 3.854283815626161624e-01 --1.562500000000000000e-02 1.562500000000000000e-02 -4.687500000000000000e-02 2.304027343762567182e-01 2.304027343762567182e-01 2.304027343762567182e-01 --1.562500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 1.021770782081255907e-01 1.021770782081255907e-01 1.021770782081255907e-01 --4.687500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 1.114162330292560871e-01 1.114162330292560871e-01 1.114162330292560871e-01 --4.687500000000000000e-02 1.093750000000000000e-01 -1.093750000000000000e-01 9.907783890227396528e-02 9.907783890227396528e-02 9.907783890227396528e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 1.210656340817719834e-01 1.210656340817719834e-01 1.210656340817719834e-01 --1.562500000000000000e-02 7.812500000000000000e-02 -7.812500000000000000e-02 5.779530598814910242e-02 5.779530598814910242e-02 5.779530598814910242e-02 --1.562500000000000000e-02 1.093750000000000000e-01 -7.812500000000000000e-02 1.564149249914654205e-01 1.564149249914654205e-01 1.564149249914654205e-01 --4.687500000000000000e-02 7.812500000000000000e-02 -1.562500000000000000e-02 3.348741194257311982e-01 3.348741194257311982e-01 3.348741194257311982e-01 --4.687500000000000000e-02 1.093750000000000000e-01 -1.562500000000000000e-02 1.453788240880731220e-01 1.453788240880731220e-01 1.453788240880731220e-01 --1.562500000000000000e-02 7.812500000000000000e-02 -4.687500000000000000e-02 9.021497878477635624e-02 9.021497878477635624e-02 9.021497878477635624e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -1.562500000000000000e-02 4.078831922893133011e-01 4.078831922893133011e-01 4.078831922893133011e-01 --1.562500000000000000e-02 1.093750000000000000e-01 -4.687500000000000000e-02 1.892878001804217392e-01 1.892878001804217392e-01 1.892878001804217392e-01 --1.562500000000000000e-02 1.093750000000000000e-01 -1.562500000000000000e-02 6.486332118430507832e-01 6.486332118430507832e-01 6.486332118430507832e-01 --1.093750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 9.582579934943688538e-02 9.582579934943688538e-02 9.582579934943688538e-02 --1.093750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 1.016893396219193807e-01 1.016893396219193807e-01 1.016893396219193807e-01 --7.812500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 1.136400923864549772e-01 1.136400923864549772e-01 1.136400923864549772e-01 --7.812500000000000000e-02 1.406250000000000000e-01 -1.406250000000000000e-01 1.140377775191829673e-01 1.140377775191829673e-01 1.140377775191829673e-01 --1.093750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 1.074921925337750384e-01 1.074921925337750384e-01 1.074921925337750384e-01 --1.093750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 6.878972920794813872e-02 6.878972920794813872e-02 6.878972920794813872e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 4.703232003688401913e-02 4.703232003688401913e-02 4.703232003688401913e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 7.423549693900477475e-02 7.423549693900477475e-02 7.423549693900477475e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -2.343750000000000000e-01 9.305901135656961809e-02 9.305901135656961809e-02 9.305901135656961809e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -2.031250000000000000e-01 5.856606272427336557e-02 5.856606272427336557e-02 5.856606272427336557e-02 --7.812500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 6.374731477920603240e-02 6.374731477920603240e-02 6.374731477920603240e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 7.531081323275345962e-02 7.531081323275345962e-02 7.531081323275345962e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 6.531676256283505677e-02 6.531676256283505677e-02 6.531676256283505677e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 6.184613815707572931e-02 6.184613815707572931e-02 6.184613815707572931e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 6.634083023014218650e-02 6.634083023014218650e-02 6.634083023014218650e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 3.887902184498132074e-02 3.887902184498132074e-02 3.887902184498132074e-02 --7.812500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 5.039913904851443111e-02 5.039913904851443111e-02 5.039913904851443111e-02 --4.687500000000000000e-02 1.406250000000000000e-01 -2.031250000000000000e-01 7.153195099768948351e-02 7.153195099768948351e-02 7.153195099768948351e-02 --4.687500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 9.708902380317117886e-02 9.708902380317117886e-02 9.708902380317117886e-02 --4.687500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 9.380074166649050860e-02 9.380074166649050860e-02 9.380074166649050860e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 9.297382845635271398e-02 9.297382845635271398e-02 9.297382845635271398e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 8.254708177878630759e-02 8.254708177878630759e-02 8.254708177878630759e-02 --4.687500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 5.718678322368183492e-02 5.718678322368183492e-02 5.718678322368183492e-02 --4.687500000000000000e-02 1.718750000000000000e-01 -1.718750000000000000e-01 5.890308056030701261e-02 5.890308056030701261e-02 5.890308056030701261e-02 --4.687500000000000000e-02 1.718750000000000000e-01 -1.406250000000000000e-01 5.435008505895311259e-02 5.435008505895311259e-02 5.435008505895311259e-02 --1.562500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 7.551465389970492270e-02 7.551465389970492270e-02 7.551465389970492270e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -1.718750000000000000e-01 8.145241198825453610e-02 8.145241198825453610e-02 8.145241198825453610e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -1.406250000000000000e-01 9.552606188249522512e-02 9.552606188249522512e-02 9.552606188249522512e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -2.343750000000000000e-01 7.568706604806041405e-02 7.568706604806041405e-02 7.568706604806041405e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -2.031250000000000000e-01 9.762259356844131541e-02 9.762259356844131541e-02 9.762259356844131541e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 9.178125838331718800e-02 9.178125838331718800e-02 9.178125838331718800e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -2.343750000000000000e-01 9.067465969384379265e-02 9.067465969384379265e-02 9.067465969384379265e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -2.031250000000000000e-01 1.122871448112896103e-01 1.122871448112896103e-01 1.122871448112896103e-01 --1.562500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 1.238941168510430957e-01 1.238941168510430957e-01 1.238941168510430957e-01 --1.562500000000000000e-02 2.343750000000000000e-01 -2.031250000000000000e-01 1.259923192911630574e-01 1.259923192911630574e-01 1.259923192911630574e-01 --4.687500000000000000e-02 2.031250000000000000e-01 -1.718750000000000000e-01 6.982814147790297743e-02 6.982814147790297743e-02 6.982814147790297743e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 4.813823266200139422e-02 4.813823266200139422e-02 4.813823266200139422e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 7.780854920437496602e-02 7.780854920437496602e-02 7.780854920437496602e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 5.794468238805064453e-02 5.794468238805064453e-02 5.794468238805064453e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -1.718750000000000000e-01 8.638313082923930464e-02 8.638313082923930464e-02 8.638313082923930464e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 8.553846026530319280e-02 8.553846026530319280e-02 8.553846026530319280e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 1.046390281804495392e-01 1.046390281804495392e-01 1.046390281804495392e-01 --1.562500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 9.352590848129382906e-02 9.352590848129382906e-02 9.352590848129382906e-02 --1.093750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 8.209298047959893985e-02 8.209298047959893985e-02 8.209298047959893985e-02 --7.812500000000000000e-02 1.406250000000000000e-01 -1.093750000000000000e-01 9.911480227310927316e-02 9.911480227310927316e-02 9.911480227310927316e-02 --1.093750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.109799701700175389e-01 1.109799701700175389e-01 1.109799701700175389e-01 --1.093750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 7.741719547157235870e-02 7.741719547157235870e-02 7.741719547157235870e-02 --1.093750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 1.052312026878524376e-01 1.052312026878524376e-01 1.052312026878524376e-01 --7.812500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 1.115327300776628866e-01 1.115327300776628866e-01 1.115327300776628866e-01 --7.812500000000000000e-02 1.406250000000000000e-01 -1.562500000000000000e-02 1.723524846863841442e-01 1.723524846863841442e-01 1.723524846863841442e-01 --7.812500000000000000e-02 1.718750000000000000e-01 -1.562500000000000000e-02 1.429237422808486702e-01 1.429237422808486702e-01 1.429237422808486702e-01 --1.093750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 7.715926587698469785e-02 7.715926587698469785e-02 7.715926587698469785e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 7.129851932981315366e-02 7.129851932981315366e-02 7.129851932981315366e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 6.866408668436868590e-02 6.866408668436868590e-02 6.866408668436868590e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 7.696362785801344475e-02 7.696362785801344475e-02 7.696362785801344475e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 1.038893627492565308e-01 1.038893627492565308e-01 1.038893627492565308e-01 --7.812500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 7.382234273968794891e-02 7.382234273968794891e-02 7.382234273968794891e-02 --7.812500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 8.612273856571148190e-02 8.612273856571148190e-02 8.612273856571148190e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 8.738852638225719227e-02 8.738852638225719227e-02 8.738852638225719227e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 1.023691194431114310e-01 1.023691194431114310e-01 1.023691194431114310e-01 --1.093750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 9.068269605001796907e-02 9.068269605001796907e-02 9.068269605001796907e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 7.873938312055052402e-02 7.873938312055052402e-02 7.873938312055052402e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -4.687500000000000000e-02 9.398637407614204853e-02 9.398637407614204853e-02 9.398637407614204853e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 9.387226242914978314e-02 9.387226242914978314e-02 9.387226242914978314e-02 --7.812500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 1.082128998225353467e-01 1.082128998225353467e-01 1.082128998225353467e-01 --7.812500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 9.550999013691503781e-02 9.550999013691503781e-02 9.550999013691503781e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -7.812500000000000000e-02 9.892837814271983332e-02 9.892837814271983332e-02 9.892837814271983332e-02 --4.687500000000000000e-02 1.406250000000000000e-01 -1.562500000000000000e-02 2.545401542592296562e-01 2.545401542592296562e-01 2.545401542592296562e-01 --4.687500000000000000e-02 1.718750000000000000e-01 -4.687500000000000000e-02 1.601238007184425383e-01 1.601238007184425383e-01 1.601238007184425383e-01 --4.687500000000000000e-02 1.718750000000000000e-01 -1.562500000000000000e-02 2.793646559119347672e-01 2.793646559119347672e-01 2.793646559119347672e-01 --1.562500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 2.278058378256059557e-01 2.278058378256059557e-01 2.278058378256059557e-01 --1.562500000000000000e-02 1.406250000000000000e-01 -1.562500000000000000e-02 6.071094836895195579e-01 6.071094836895195579e-01 6.071094836895195579e-01 --1.562500000000000000e-02 1.718750000000000000e-01 -4.687500000000000000e-02 2.357711531175500086e-01 2.357711531175500086e-01 2.357711531175500086e-01 --1.562500000000000000e-02 1.718750000000000000e-01 -1.562500000000000000e-02 4.130188655963226152e-01 4.130188655963226152e-01 4.130188655963226152e-01 --4.687500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 6.466544906652357816e-02 6.466544906652357816e-02 6.466544906652357816e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -7.812500000000000000e-02 7.882008007046149844e-02 7.882008007046149844e-02 7.882008007046149844e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 7.674082177795274462e-02 7.674082177795274462e-02 7.674082177795274462e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 6.547617359169137508e-02 6.547617359169137508e-02 6.547617359169137508e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 8.823960680320340477e-02 8.823960680320340477e-02 8.823960680320340477e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 9.691304143287547690e-02 9.691304143287547690e-02 9.691304143287547690e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -4.687500000000000000e-02 1.432730960793893171e-01 1.432730960793893171e-01 1.432730960793893171e-01 --4.687500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 1.455836116288515558e-01 1.455836116288515558e-01 1.455836116288515558e-01 --4.687500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 1.252589186098435059e-01 1.252589186098435059e-01 1.252589186098435059e-01 --4.687500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 1.084113543191202594e-01 1.084113543191202594e-01 1.084113543191202594e-01 --1.562500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 3.855420804316609384e-01 3.855420804316609384e-01 3.855420804316609384e-01 --1.562500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 9.460193129599120399e-02 9.460193129599120399e-02 9.460193129599120399e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 1.228787343075248562e-01 1.228787343075248562e-01 1.228787343075248562e-01 --4.687500000000000000e-02 2.656250000000000000e-01 -3.906250000000000000e-01 6.303296191609031318e-02 6.303296191609031318e-02 6.303296191609031318e-02 --4.687500000000000000e-02 2.968750000000000000e-01 -3.906250000000000000e-01 6.262103645004001018e-02 6.262103645004001018e-02 6.262103645004001018e-02 --1.562500000000000000e-02 2.656250000000000000e-01 -3.906250000000000000e-01 9.553891927666563477e-02 9.553891927666563477e-02 9.553891927666563477e-02 --1.562500000000000000e-02 2.968750000000000000e-01 -3.906250000000000000e-01 1.020051245794367234e-01 1.020051245794367234e-01 1.020051245794367234e-01 --1.562500000000000000e-02 3.281250000000000000e-01 -3.906250000000000000e-01 1.077669780140769057e-01 1.077669780140769057e-01 1.077669780140769057e-01 --1.562500000000000000e-02 3.593750000000000000e-01 -3.906250000000000000e-01 6.658352086115566781e-02 6.658352086115566781e-02 6.658352086115566781e-02 --7.812500000000000000e-02 2.656250000000000000e-01 -2.656250000000000000e-01 1.659674021708003044e-01 1.659674021708003044e-01 1.659674021708003044e-01 --7.812500000000000000e-02 2.968750000000000000e-01 -2.656250000000000000e-01 1.131676880985686279e-01 1.131676880985686279e-01 1.131676880985686279e-01 --7.812500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 6.595794186659112435e-02 6.595794186659112435e-02 6.595794186659112435e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -3.593750000000000000e-01 5.857080606716107141e-02 5.857080606716107141e-02 5.857080606716107141e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -3.281250000000000000e-01 5.258665565743295828e-02 5.258665565743295828e-02 5.258665565743295828e-02 --4.687500000000000000e-02 2.968750000000000000e-01 -3.593750000000000000e-01 6.924342328977757532e-02 6.924342328977757532e-02 6.924342328977757532e-02 --4.687500000000000000e-02 2.968750000000000000e-01 -3.281250000000000000e-01 6.484254704986319728e-02 6.484254704986319728e-02 6.484254704986319728e-02 --1.562500000000000000e-02 2.968750000000000000e-01 -3.593750000000000000e-01 8.474923579678869667e-02 8.474923579678869667e-02 8.474923579678869667e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -2.968750000000000000e-01 7.672972968424278395e-02 7.672972968424278395e-02 7.672972968424278395e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -2.656250000000000000e-01 1.036997356597185865e-01 1.036997356597185865e-01 1.036997356597185865e-01 --4.687500000000000000e-02 2.968750000000000000e-01 -2.968750000000000000e-01 9.388110206955878334e-02 9.388110206955878334e-02 9.388110206955878334e-02 --4.687500000000000000e-02 2.968750000000000000e-01 -2.656250000000000000e-01 6.872823433129009174e-02 6.872823433129009174e-02 6.872823433129009174e-02 --1.562500000000000000e-02 2.656250000000000000e-01 -2.968750000000000000e-01 5.111955392424600425e-02 5.111955392424600425e-02 5.111955392424600425e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -3.593750000000000000e-01 7.803054856557019303e-02 7.803054856557019303e-02 7.803054856557019303e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -3.281250000000000000e-01 1.055975934161372809e-01 1.055975934161372809e-01 1.055975934161372809e-01 --1.562500000000000000e-02 3.281250000000000000e-01 -3.593750000000000000e-01 9.862543800953656181e-02 9.862543800953656181e-02 9.862543800953656181e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -3.593750000000000000e-01 7.935899537487631217e-02 7.935899537487631217e-02 7.935899537487631217e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -3.281250000000000000e-01 8.825728732083244765e-02 8.825728732083244765e-02 8.825728732083244765e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 1.270285476308474770e-01 1.270285476308474770e-01 1.270285476308474770e-01 --4.687500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 5.344485797014276313e-02 5.344485797014276313e-02 5.344485797014276313e-02 --4.687500000000000000e-02 3.593750000000000000e-01 -2.656250000000000000e-01 3.674042841065321141e-02 3.674042841065321141e-02 3.674042841065321141e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 1.271458253463901567e-01 1.271458253463901567e-01 1.271458253463901567e-01 --1.562500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 3.595329848862549582e-02 3.595329848862549582e-02 3.595329848862549582e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -2.968750000000000000e-01 9.171214663771197484e-02 9.171214663771197484e-02 9.171214663771197484e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -2.656250000000000000e-01 3.745541684603683613e-02 3.745541684603683613e-02 3.745541684603683613e-02 --1.562500000000000000e-02 3.906250000000000000e-01 -3.593750000000000000e-01 5.123670113522045544e-02 5.123670113522045544e-02 5.123670113522045544e-02 --1.562500000000000000e-02 3.906250000000000000e-01 -3.281250000000000000e-01 8.839873132198873551e-02 8.839873132198873551e-02 8.839873132198873551e-02 --2.031250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 5.474356099965671518e-02 5.474356099965671518e-02 5.474356099965671518e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 5.195718891345710994e-02 5.195718891345710994e-02 5.195718891345710994e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 4.467756158291937008e-02 4.467756158291937008e-02 4.467756158291937008e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 8.271505842411877585e-02 8.271505842411877585e-02 8.271505842411877585e-02 --1.406250000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 3.670013925448881859e-02 3.670013925448881859e-02 3.670013925448881859e-02 --1.406250000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 7.760752753093755341e-02 7.760752753093755341e-02 7.760752753093755341e-02 --1.406250000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 7.447719919996113880e-02 7.447719919996113880e-02 7.447719919996113880e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 5.120060019407895319e-02 5.120060019407895319e-02 5.120060019407895319e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 5.858037314773446164e-02 5.858037314773446164e-02 5.858037314773446164e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 8.373175168687709002e-02 8.373175168687709002e-02 8.373175168687709002e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 7.533018454862305813e-02 7.533018454862305813e-02 7.533018454862305813e-02 --1.406250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 4.510340929571118873e-02 4.510340929571118873e-02 4.510340929571118873e-02 --1.406250000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 6.004452504282985909e-02 6.004452504282985909e-02 6.004452504282985909e-02 --1.718750000000000000e-01 3.281250000000000000e-01 -2.031250000000000000e-01 8.517760400971451096e-02 8.517760400971451096e-02 8.517760400971451096e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 5.086338928451966668e-02 5.086338928451966668e-02 5.086338928451966668e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -2.031250000000000000e-01 1.184153976786899709e-01 1.184153976786899709e-01 1.184153976786899709e-01 --1.406250000000000000e-01 3.593750000000000000e-01 -2.031250000000000000e-01 8.771963711551002130e-02 8.771963711551002130e-02 8.771963711551002130e-02 --1.718750000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 8.639840071978281688e-02 8.639840071978281688e-02 8.639840071978281688e-02 --1.718750000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 8.217013769526539113e-02 8.217013769526539113e-02 8.217013769526539113e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 8.282195247037847652e-02 8.282195247037847652e-02 8.282195247037847652e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 6.711431865294226196e-02 6.711431865294226196e-02 6.711431865294226196e-02 --1.406250000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 9.587642513845970327e-02 9.587642513845970327e-02 9.587642513845970327e-02 --1.406250000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 7.214864462515754862e-02 7.214864462515754862e-02 7.214864462515754862e-02 --2.343750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 9.937354539340169379e-02 9.937354539340169379e-02 9.937354539340169379e-02 --2.343750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 1.096221571817807411e-01 1.096221571817807411e-01 1.096221571817807411e-01 --2.031250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 5.315517350249525375e-02 5.315517350249525375e-02 5.315517350249525375e-02 --2.031250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 1.143776159840541734e-01 1.143776159840541734e-01 1.143776159840541734e-01 --2.343750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 7.909014098743717691e-02 7.909014098743717691e-02 7.909014098743717691e-02 --2.343750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 7.730675765975454639e-02 7.730675765975454639e-02 7.730675765975454639e-02 --2.031250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 6.177081047400766189e-02 6.177081047400766189e-02 6.177081047400766189e-02 --2.031250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 5.723687055331434098e-02 5.723687055331434098e-02 5.723687055331434098e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 6.465274751665130160e-02 6.465274751665130160e-02 6.465274751665130160e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 5.317929381437761643e-02 5.317929381437761643e-02 5.317929381437761643e-02 --1.406250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 5.422088238409672467e-02 5.422088238409672467e-02 5.422088238409672467e-02 --1.406250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 5.938151161430986480e-02 5.938151161430986480e-02 5.938151161430986480e-02 --1.406250000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 7.526282700696512729e-02 7.526282700696512729e-02 7.526282700696512729e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 6.509617512147511387e-02 6.509617512147511387e-02 6.509617512147511387e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 6.208498352465621067e-02 6.208498352465621067e-02 6.208498352465621067e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 6.412458635731750622e-02 6.412458635731750622e-02 6.412458635731750622e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 6.856899051720129201e-02 6.856899051720129201e-02 6.856899051720129201e-02 --1.406250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 8.772687010176556666e-02 8.772687010176556666e-02 8.772687010176556666e-02 --1.406250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 9.220798191618437278e-02 9.220798191618437278e-02 9.220798191618437278e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 6.750515979819134149e-02 6.750515979819134149e-02 6.750515979819134149e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -7.812500000000000000e-02 8.408297001005650417e-02 8.408297001005650417e-02 8.408297001005650417e-02 --1.406250000000000000e-01 3.593750000000000000e-01 -1.093750000000000000e-01 5.215923951115678664e-02 5.215923951115678664e-02 5.215923951115678664e-02 --1.406250000000000000e-01 3.593750000000000000e-01 -7.812500000000000000e-02 4.929840341543866022e-02 4.929840341543866022e-02 4.929840341543866022e-02 --1.718750000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 4.510083620451870584e-02 4.510083620451870584e-02 4.510083620451870584e-02 --1.718750000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 6.073350010538162980e-02 6.073350010538162980e-02 6.073350010538162980e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 8.804512085282603651e-02 8.804512085282603651e-02 8.804512085282603651e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 7.791118982513778324e-02 7.791118982513778324e-02 7.791118982513778324e-02 --1.406250000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 4.944482061600344314e-02 4.944482061600344314e-02 4.944482061600344314e-02 --1.406250000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 9.917828280511102601e-02 9.917828280511102601e-02 9.917828280511102601e-02 --1.406250000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 9.364644946757466615e-02 9.364644946757466615e-02 9.364644946757466615e-02 --1.406250000000000000e-01 3.906250000000000000e-01 -7.812500000000000000e-02 5.921670204464701132e-02 5.921670204464701132e-02 5.921670204464701132e-02 --1.406250000000000000e-01 4.218750000000000000e-01 -1.093750000000000000e-01 7.480337955026754304e-02 7.480337955026754304e-02 7.480337955026754304e-02 --1.406250000000000000e-01 4.218750000000000000e-01 -7.812500000000000000e-02 8.267567637128618585e-02 8.267567637128618585e-02 8.267567637128618585e-02 --1.406250000000000000e-01 3.906250000000000000e-01 -4.687500000000000000e-02 6.788988968404675861e-02 6.788988968404675861e-02 6.788988968404675861e-02 --1.406250000000000000e-01 3.906250000000000000e-01 -1.562500000000000000e-02 6.071991360633324092e-02 6.071991360633324092e-02 6.071991360633324092e-02 --1.406250000000000000e-01 4.218750000000000000e-01 -4.687500000000000000e-02 6.494833939500710418e-02 6.494833939500710418e-02 6.494833939500710418e-02 --1.406250000000000000e-01 4.218750000000000000e-01 -1.562500000000000000e-02 4.853865387151651972e-02 4.853865387151651972e-02 4.853865387151651972e-02 --1.406250000000000000e-01 4.531250000000000000e-01 -7.812500000000000000e-02 8.477495402777869560e-02 8.477495402777869560e-02 8.477495402777869560e-02 --1.406250000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 6.891472845288668103e-02 6.891472845288668103e-02 6.891472845288668103e-02 --1.093750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 8.416173271874428929e-02 8.416173271874428929e-02 8.416173271874428929e-02 --1.093750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 5.647462324356801455e-02 5.647462324356801455e-02 5.647462324356801455e-02 --1.093750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 5.377192760587111431e-02 5.377192760587111431e-02 5.377192760587111431e-02 --7.812500000000000000e-02 2.656250000000000000e-01 -2.343750000000000000e-01 1.448776947309381169e-01 1.448776947309381169e-01 1.448776947309381169e-01 --7.812500000000000000e-02 2.968750000000000000e-01 -2.343750000000000000e-01 1.399184338465396527e-01 1.399184338465396527e-01 1.399184338465396527e-01 --1.093750000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 5.072477380353490606e-02 5.072477380353490606e-02 5.072477380353490606e-02 --1.093750000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 5.052633776894192158e-02 5.052633776894192158e-02 5.052633776894192158e-02 --1.093750000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 6.127189343085015505e-02 6.127189343085015505e-02 6.127189343085015505e-02 --7.812500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 5.935377539327672813e-02 5.935377539327672813e-02 5.935377539327672813e-02 --7.812500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 7.601412565365502083e-02 7.601412565365502083e-02 7.601412565365502083e-02 --1.093750000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 1.131982177112084847e-01 1.131982177112084847e-01 1.131982177112084847e-01 --1.093750000000000000e-01 3.593750000000000000e-01 -2.031250000000000000e-01 9.992076024541858559e-02 9.992076024541858559e-02 9.992076024541858559e-02 --7.812500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 1.048198146184661783e-01 1.048198146184661783e-01 1.048198146184661783e-01 --7.812500000000000000e-02 3.593750000000000000e-01 -2.343750000000000000e-01 7.490915879832661661e-02 7.490915879832661661e-02 7.490915879832661661e-02 --7.812500000000000000e-02 3.593750000000000000e-01 -2.031250000000000000e-01 1.149640950649030713e-01 1.149640950649030713e-01 1.149640950649030713e-01 --1.093750000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 1.042380825861838750e-01 1.042380825861838750e-01 1.042380825861838750e-01 --7.812500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 1.001055749934189193e-01 1.001055749934189193e-01 1.001055749934189193e-01 --1.562500000000000000e-02 2.656250000000000000e-01 -2.031250000000000000e-01 1.531965197328007122e-01 1.531965197328007122e-01 1.531965197328007122e-01 --1.562500000000000000e-02 2.968750000000000000e-01 -2.031250000000000000e-01 8.723422188571981761e-02 8.723422188571981761e-02 8.723422188571981761e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 1.283683951872058859e-01 1.283683951872058859e-01 1.283683951872058859e-01 --4.687500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 7.394315439139377555e-02 7.394315439139377555e-02 7.394315439139377555e-02 --1.562500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 1.270325639938071349e-01 1.270325639938071349e-01 1.270325639938071349e-01 --1.562500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 6.751352001584665086e-02 6.751352001584665086e-02 6.751352001584665086e-02 --1.562500000000000000e-02 2.968750000000000000e-01 -1.718750000000000000e-01 1.242531928953754944e-01 1.242531928953754944e-01 1.242531928953754944e-01 --1.562500000000000000e-02 2.968750000000000000e-01 -1.406250000000000000e-01 8.985253621621529241e-02 8.985253621621529241e-02 8.985253621621529241e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 5.392316068258241890e-02 5.392316068258241890e-02 5.392316068258241890e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 8.128764762444684600e-02 8.128764762444684600e-02 8.128764762444684600e-02 --4.687500000000000000e-02 3.593750000000000000e-01 -2.343750000000000000e-01 3.378093113469996661e-02 3.378093113469996661e-02 3.378093113469996661e-02 --4.687500000000000000e-02 3.593750000000000000e-01 -2.031250000000000000e-01 8.155287789814322230e-02 8.155287789814322230e-02 8.155287789814322230e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 7.188788475781926479e-02 7.188788475781926479e-02 7.188788475781926479e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -2.343750000000000000e-01 3.173653777908134327e-02 3.173653777908134327e-02 3.173653777908134327e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -2.031250000000000000e-01 3.534485175362211268e-02 3.534485175362211268e-02 3.534485175362211268e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -1.718750000000000000e-01 1.163716274163543452e-01 1.163716274163543452e-01 1.163716274163543452e-01 --4.687500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 1.098278392018264410e-01 1.098278392018264410e-01 1.098278392018264410e-01 --4.687500000000000000e-02 3.593750000000000000e-01 -1.406250000000000000e-01 9.933095729726285072e-02 9.933095729726285072e-02 9.933095729726285072e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -1.718750000000000000e-01 9.216619364758951716e-02 9.216619364758951716e-02 9.216619364758951716e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -1.406250000000000000e-01 9.666714761324522731e-02 9.666714761324522731e-02 9.666714761324522731e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 8.064385777769482455e-02 8.064385777769482455e-02 8.064385777769482455e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -1.406250000000000000e-01 6.766362148819620170e-01 6.766362148819620170e-01 6.766362148819620170e-01 --1.093750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 5.178826361123128885e-02 5.178826361123128885e-02 5.178826361123128885e-02 --1.093750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 8.678898746077952364e-02 8.678898746077952364e-02 8.678898746077952364e-02 --1.093750000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 7.570708030148294576e-02 7.570708030148294576e-02 7.570708030148294576e-02 --1.093750000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 9.860454554451360265e-02 9.860454554451360265e-02 9.860454554451360265e-02 --7.812500000000000000e-02 2.656250000000000000e-01 -1.093750000000000000e-01 8.968457447225290646e-02 8.968457447225290646e-02 8.968457447225290646e-02 --7.812500000000000000e-02 2.968750000000000000e-01 -1.093750000000000000e-01 8.646349864162733434e-02 8.646349864162733434e-02 8.646349864162733434e-02 --7.812500000000000000e-02 2.968750000000000000e-01 -7.812500000000000000e-02 1.087423785440269769e-01 1.087423785440269769e-01 1.087423785440269769e-01 --1.093750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 8.516554865029923871e-02 8.516554865029923871e-02 8.516554865029923871e-02 --1.093750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 8.907781979642927228e-02 8.907781979642927228e-02 8.907781979642927228e-02 --7.812500000000000000e-02 2.656250000000000000e-01 -4.687500000000000000e-02 9.222967966248392380e-02 9.222967966248392380e-02 9.222967966248392380e-02 --7.812500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 9.673946940291999752e-02 9.673946940291999752e-02 9.673946940291999752e-02 --7.812500000000000000e-02 2.968750000000000000e-01 -1.562500000000000000e-02 6.411276901318656296e-02 6.411276901318656296e-02 6.411276901318656296e-02 --1.093750000000000000e-01 3.281250000000000000e-01 -7.812500000000000000e-02 9.663179027019166978e-02 9.663179027019166978e-02 9.663179027019166978e-02 --1.093750000000000000e-01 3.593750000000000000e-01 -7.812500000000000000e-02 5.328212666291202299e-02 5.328212666291202299e-02 5.328212666291202299e-02 --7.812500000000000000e-02 3.281250000000000000e-01 -7.812500000000000000e-02 8.851526170428737628e-02 8.851526170428737628e-02 8.851526170428737628e-02 --1.093750000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 9.341742143922499020e-02 9.341742143922499020e-02 9.341742143922499020e-02 --1.093750000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 8.965805416483664525e-02 8.965805416483664525e-02 8.965805416483664525e-02 --1.093750000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 7.153733663768031825e-02 7.153733663768031825e-02 7.153733663768031825e-02 --1.093750000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 6.358814149663148674e-02 6.358814149663148674e-02 6.358814149663148674e-02 --7.812500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 9.660125437049300878e-02 9.660125437049300878e-02 9.660125437049300878e-02 --7.812500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 7.814886223993540437e-02 7.814886223993540437e-02 7.814886223993540437e-02 --7.812500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 7.245473897680863862e-02 7.245473897680863862e-02 7.245473897680863862e-02 --7.812500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 8.416816232420898380e-02 8.416816232420898380e-02 8.416816232420898380e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -1.093750000000000000e-01 1.060379028733676177e-01 1.060379028733676177e-01 1.060379028733676177e-01 --4.687500000000000000e-02 2.656250000000000000e-01 -7.812500000000000000e-02 1.030898726255308068e-01 1.030898726255308068e-01 1.030898726255308068e-01 --4.687500000000000000e-02 2.968750000000000000e-01 -1.093750000000000000e-01 8.640241911153909160e-02 8.640241911153909160e-02 8.640241911153909160e-02 --4.687500000000000000e-02 2.968750000000000000e-01 -7.812500000000000000e-02 1.101476094231460395e-01 1.101476094231460395e-01 1.101476094231460395e-01 --1.562500000000000000e-02 2.656250000000000000e-01 -1.093750000000000000e-01 7.523099693184297221e-02 7.523099693184297221e-02 7.523099693184297221e-02 --1.562500000000000000e-02 2.656250000000000000e-01 -7.812500000000000000e-02 9.846954794741046013e-02 9.846954794741046013e-02 9.846954794741046013e-02 --1.562500000000000000e-02 2.968750000000000000e-01 -1.093750000000000000e-01 6.503684792945198245e-02 6.503684792945198245e-02 6.503684792945198245e-02 --1.562500000000000000e-02 2.968750000000000000e-01 -7.812500000000000000e-02 9.917667570366249519e-02 9.917667570366249519e-02 9.917667570366249519e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -4.687500000000000000e-02 1.146941545395396972e-01 1.146941545395396972e-01 1.146941545395396972e-01 --4.687500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 1.023474244311703418e-01 1.023474244311703418e-01 1.023474244311703418e-01 --1.562500000000000000e-02 2.656250000000000000e-01 -4.687500000000000000e-02 1.070751917226447220e-01 1.070751917226447220e-01 1.070751917226447220e-01 --1.562500000000000000e-02 2.656250000000000000e-01 -1.562500000000000000e-02 1.062299348929369863e-01 1.062299348929369863e-01 1.062299348929369863e-01 --1.562500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 1.023578701783841582e-01 1.023578701783841582e-01 1.023578701783841582e-01 --1.562500000000000000e-02 2.968750000000000000e-01 -1.562500000000000000e-02 1.047812468791147339e-01 1.047812468791147339e-01 1.047812468791147339e-01 --4.687500000000000000e-02 3.281250000000000000e-01 -1.093750000000000000e-01 6.462002895804368208e-02 6.462002895804368208e-02 6.462002895804368208e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -7.812500000000000000e-02 8.717716129382850621e-02 8.717716129382850621e-02 8.717716129382850621e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -1.093750000000000000e-01 9.490167220587440722e-02 9.490167220587440722e-02 9.490167220587440722e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -7.812500000000000000e-02 7.902318846960822152e-02 7.902318846960822152e-02 7.902318846960822152e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -1.093750000000000000e-01 1.072310651111667568e-01 1.072310651111667568e-01 1.072310651111667568e-01 --1.562500000000000000e-02 3.593750000000000000e-01 -7.812500000000000000e-02 9.533159354527302731e-02 9.533159354527302731e-02 9.533159354527302731e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 9.760732580807515713e-02 9.760732580807515713e-02 9.760732580807515713e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 7.462742880599874951e-02 7.462742880599874951e-02 7.462742880599874951e-02 --4.687500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 6.233580657382505746e-02 6.233580657382505746e-02 6.233580657382505746e-02 --4.687500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 3.903559032002499457e-02 3.903559032002499457e-02 3.903559032002499457e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 6.819366904419352227e-02 6.819366904419352227e-02 6.819366904419352227e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 5.391455785171576226e-02 5.391455785171576226e-02 5.391455785171576226e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 6.347109265964429037e-02 6.347109265964429037e-02 6.347109265964429037e-02 --1.093750000000000000e-01 3.906250000000000000e-01 -1.718750000000000000e-01 6.021375458672232478e-02 6.021375458672232478e-02 6.021375458672232478e-02 --1.093750000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 1.282181855705100126e-01 1.282181855705100126e-01 1.282181855705100126e-01 --7.812500000000000000e-02 3.906250000000000000e-01 -1.718750000000000000e-01 8.373416280187701011e-02 8.373416280187701011e-02 8.373416280187701011e-02 --7.812500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 1.270984323175449182e-01 1.270984323175449182e-01 1.270984323175449182e-01 --7.812500000000000000e-02 4.218750000000000000e-01 -1.406250000000000000e-01 8.487782686950919031e-02 8.487782686950919031e-02 8.487782686950919031e-02 --4.687500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 1.285531445985581001e-01 1.285531445985581001e-01 1.285531445985581001e-01 --4.687500000000000000e-02 4.218750000000000000e-01 -1.406250000000000000e-01 8.005206488866541126e-02 8.005206488866541126e-02 8.005206488866541126e-02 --1.562500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 1.103002631007121564e-01 1.103002631007121564e-01 1.103002631007121564e-01 --1.093750000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 8.444865336259212152e-02 8.444865336259212152e-02 8.444865336259212152e-02 --1.093750000000000000e-01 4.218750000000000000e-01 -1.093750000000000000e-01 9.365850355626791079e-02 9.365850355626791079e-02 9.365850355626791079e-02 --7.812500000000000000e-02 4.218750000000000000e-01 -1.093750000000000000e-01 8.801618901838323406e-02 8.801618901838323406e-02 8.801618901838323406e-02 --1.093750000000000000e-01 3.906250000000000000e-01 -1.562500000000000000e-02 7.243392009642746210e-02 7.243392009642746210e-02 7.243392009642746210e-02 --1.093750000000000000e-01 4.218750000000000000e-01 -1.562500000000000000e-02 3.863608679751375646e-02 3.863608679751375646e-02 3.863608679751375646e-02 --7.812500000000000000e-02 3.906250000000000000e-01 -1.562500000000000000e-02 4.346071505205312269e-02 4.346071505205312269e-02 4.346071505205312269e-02 --1.093750000000000000e-01 4.531250000000000000e-01 -1.093750000000000000e-01 5.948554245665274576e-02 5.948554245665274576e-02 5.948554245665274576e-02 --1.093750000000000000e-01 4.531250000000000000e-01 -7.812500000000000000e-02 8.996022442260991070e-02 8.996022442260991070e-02 8.996022442260991070e-02 --7.812500000000000000e-02 4.531250000000000000e-01 -1.093750000000000000e-01 6.587683007300058902e-02 6.587683007300058902e-02 6.587683007300058902e-02 --7.812500000000000000e-02 4.531250000000000000e-01 -7.812500000000000000e-02 5.572274011733529403e-02 5.572274011733529403e-02 5.572274011733529403e-02 --7.812500000000000000e-02 4.843750000000000000e-01 -7.812500000000000000e-02 2.555374325654558715e-02 2.555374325654558715e-02 2.555374325654558715e-02 --1.093750000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 5.686792799931309622e-02 5.686792799931309622e-02 5.686792799931309622e-02 --1.093750000000000000e-01 4.531250000000000000e-01 -1.562500000000000000e-02 3.821173275520069190e-02 3.821173275520069190e-02 3.821173275520069190e-02 --1.093750000000000000e-01 4.843750000000000000e-01 -4.687500000000000000e-02 3.274108844315039291e-02 3.274108844315039291e-02 3.274108844315039291e-02 --1.093750000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 3.095917053473980565e-02 3.095917053473980565e-02 3.095917053473980565e-02 --7.812500000000000000e-02 4.531250000000000000e-01 -4.687500000000000000e-02 5.627724656330397590e-02 5.627724656330397590e-02 5.627724656330397590e-02 --7.812500000000000000e-02 4.843750000000000000e-01 -4.687500000000000000e-02 3.104835985409798091e-02 3.104835985409798091e-02 3.104835985409798091e-02 --7.812500000000000000e-02 4.843750000000000000e-01 -1.562500000000000000e-02 3.414603899241121926e-02 3.414603899241121926e-02 3.414603899241121926e-02 --4.687500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 9.733893417897231115e-02 9.733893417897231115e-02 9.733893417897231115e-02 --4.687500000000000000e-02 4.218750000000000000e-01 -1.093750000000000000e-01 9.333786418206964364e-02 9.333786418206964364e-02 9.333786418206964364e-02 --4.687500000000000000e-02 4.218750000000000000e-01 -7.812500000000000000e-02 3.849125823913126382e-02 3.849125823913126382e-02 3.849125823913126382e-02 --1.562500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 1.183551457603747165e-01 1.183551457603747165e-01 1.183551457603747165e-01 --1.562500000000000000e-02 3.906250000000000000e-01 -7.812500000000000000e-02 9.827267604559357383e-02 9.827267604559357383e-02 9.827267604559357383e-02 --1.562500000000000000e-02 4.218750000000000000e-01 -1.093750000000000000e-01 7.525977260636136645e-02 7.525977260636136645e-02 7.525977260636136645e-02 --1.562500000000000000e-02 4.218750000000000000e-01 -7.812500000000000000e-02 5.528416518166458932e-02 5.528416518166458932e-02 5.528416518166458932e-02 --4.687500000000000000e-02 3.906250000000000000e-01 -4.687500000000000000e-02 3.635635371808154659e-02 3.635635371808154659e-02 3.635635371808154659e-02 --4.687500000000000000e-02 3.906250000000000000e-01 -1.562500000000000000e-02 4.782247742333404356e-02 4.782247742333404356e-02 4.782247742333404356e-02 --1.562500000000000000e-02 3.906250000000000000e-01 -4.687500000000000000e-02 7.711610338041917367e-02 7.711610338041917367e-02 7.711610338041917367e-02 --1.562500000000000000e-02 4.218750000000000000e-01 -4.687500000000000000e-02 5.494496140576081433e-02 5.494496140576081433e-02 5.494496140576081433e-02 --1.562500000000000000e-02 4.218750000000000000e-01 -1.562500000000000000e-02 5.674741229419776045e-02 5.674741229419776045e-02 5.674741229419776045e-02 --4.687500000000000000e-02 4.531250000000000000e-01 -7.812500000000000000e-02 4.983277264600547568e-02 4.983277264600547568e-02 4.983277264600547568e-02 --4.687500000000000000e-02 4.843750000000000000e-01 -7.812500000000000000e-02 3.014142291448627942e-02 3.014142291448627942e-02 3.014142291448627942e-02 --1.562500000000000000e-02 4.531250000000000000e-01 -7.812500000000000000e-02 4.657456071174521928e-02 4.657456071174521928e-02 4.657456071174521928e-02 --1.562500000000000000e-02 4.843750000000000000e-01 -7.812500000000000000e-02 1.976798146230267575e-02 1.976798146230267575e-02 1.976798146230267575e-02 --4.687500000000000000e-02 4.531250000000000000e-01 -1.562500000000000000e-02 3.970158594484221593e-02 3.970158594484221593e-02 3.970158594484221593e-02 --4.687500000000000000e-02 4.843750000000000000e-01 -4.687500000000000000e-02 3.222059910366188024e-02 3.222059910366188024e-02 3.222059910366188024e-02 --4.687500000000000000e-02 4.843750000000000000e-01 -1.562500000000000000e-02 2.890376763537210944e-02 2.890376763537210944e-02 2.890376763537210944e-02 --1.562500000000000000e-02 4.531250000000000000e-01 -4.687500000000000000e-02 5.159417194079700397e-02 5.159417194079700397e-02 5.159417194079700397e-02 --1.562500000000000000e-02 4.531250000000000000e-01 -1.562500000000000000e-02 5.622249555315792652e-02 5.622249555315792652e-02 5.622249555315792652e-02 --1.562500000000000000e-02 4.843750000000000000e-01 -4.687500000000000000e-02 2.377214873479691765e-02 2.377214873479691765e-02 2.377214873479691765e-02 --1.562500000000000000e-02 4.843750000000000000e-01 -1.562500000000000000e-02 2.507285898319983400e-02 2.507285898319983400e-02 2.507285898319983400e-02 --4.218750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.968489265967844626e-02 1.968489265967844626e-02 1.968489265967844626e-02 --3.906250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 7.701691796537868395e-02 7.701691796537868395e-02 7.701691796537868395e-02 --3.906250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 5.592783639329358680e-02 5.592783639329358680e-02 5.592783639329358680e-02 --4.218750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 3.726635686206786896e-02 3.726635686206786896e-02 3.726635686206786896e-02 --3.906250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 4.979490217791390783e-02 4.979490217791390783e-02 4.979490217791390783e-02 --4.218750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 5.738407727579838274e-02 5.738407727579838274e-02 5.738407727579838274e-02 --4.218750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 8.749139588219681518e-02 8.749139588219681518e-02 8.749139588219681518e-02 --4.218750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 3.156073409159455140e-02 3.156073409159455140e-02 3.156073409159455140e-02 --4.218750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 2.691619287520911549e-02 2.691619287520911549e-02 2.691619287520911549e-02 --3.906250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 8.745040883157653711e-02 8.745040883157653711e-02 8.745040883157653711e-02 --4.218750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 7.707912990125466435e-02 7.707912990125466435e-02 7.707912990125466435e-02 --4.218750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 9.208984963929280065e-02 9.208984963929280065e-02 9.208984963929280065e-02 --4.218750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 5.712343034475771825e-02 5.712343034475771825e-02 5.712343034475771825e-02 --4.218750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 7.456706370641223713e-02 7.456706370641223713e-02 7.456706370641223713e-02 --3.906250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 4.974907165127018249e-02 4.974907165127018249e-02 4.974907165127018249e-02 --4.218750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 4.500603381846923073e-02 4.500603381846923073e-02 4.500603381846923073e-02 --4.218750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 3.576616501716449459e-02 3.576616501716449459e-02 3.576616501716449459e-02 --4.218750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.976741842132367574e-02 1.976741842132367574e-02 1.976741842132367574e-02 --4.218750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 3.253006226883949081e-02 3.253006226883949081e-02 3.253006226883949081e-02 --3.906250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 6.146588136293081039e-02 6.146588136293081039e-02 6.146588136293081039e-02 --3.906250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 5.525280959516155194e-02 5.525280959516155194e-02 5.525280959516155194e-02 --3.906250000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 5.108425696175045161e-02 5.108425696175045161e-02 5.108425696175045161e-02 --3.906250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 4.642098199528989916e-02 4.642098199528989916e-02 4.642098199528989916e-02 --4.218750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 6.923514363685216721e-02 6.923514363685216721e-02 6.923514363685216721e-02 --3.906250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 3.708131728976180735e-02 3.708131728976180735e-02 3.708131728976180735e-02 --3.906250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 6.526298237140096270e-02 6.526298237140096270e-02 6.526298237140096270e-02 --3.906250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 3.151907515601032328e-02 3.151907515601032328e-02 3.151907515601032328e-02 --3.906250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 4.124593154707755643e-02 4.124593154707755643e-02 4.124593154707755643e-02 --3.593750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 3.174667100827777144e-02 3.174667100827777144e-02 3.174667100827777144e-02 --3.593750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 5.713645467164597119e-02 5.713645467164597119e-02 5.713645467164597119e-02 --3.593750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 3.948977387960268121e-02 3.948977387960268121e-02 3.948977387960268121e-02 --3.593750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 6.644332470650823885e-02 6.644332470650823885e-02 6.644332470650823885e-02 --3.281250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 3.981995599807416908e-02 3.981995599807416908e-02 3.981995599807416908e-02 --3.281250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 7.817418070064516278e-02 7.817418070064516278e-02 7.817418070064516278e-02 --3.593750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 4.511989315920854338e-02 4.511989315920854338e-02 4.511989315920854338e-02 --3.593750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 6.828161130694213043e-02 6.828161130694213043e-02 6.828161130694213043e-02 --3.593750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 6.252319982234563756e-02 6.252319982234563756e-02 6.252319982234563756e-02 --3.593750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 8.937677763903387196e-02 8.937677763903387196e-02 8.937677763903387196e-02 --3.281250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 7.330758500619427576e-02 7.330758500619427576e-02 7.330758500619427576e-02 --3.281250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 8.504499495677707299e-02 8.504499495677707299e-02 8.504499495677707299e-02 --3.281250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 7.988143032988062608e-02 7.988143032988062608e-02 7.988143032988062608e-02 --3.593750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 4.719852148706928097e-02 4.719852148706928097e-02 4.719852148706928097e-02 --3.593750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 4.313135198555866773e-02 4.313135198555866773e-02 4.313135198555866773e-02 --3.281250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 8.520251841344372856e-02 8.520251841344372856e-02 8.520251841344372856e-02 --3.281250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 1.090308184450909101e-01 1.090308184450909101e-01 1.090308184450909101e-01 --3.281250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 4.391712511947322428e-02 4.391712511947322428e-02 4.391712511947322428e-02 --3.593750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 5.777086547435130587e-02 5.777086547435130587e-02 5.777086547435130587e-02 --3.593750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 4.299409017283437051e-02 4.299409017283437051e-02 4.299409017283437051e-02 --3.593750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.013711428384879154e-01 1.013711428384879154e-01 1.013711428384879154e-01 --3.281250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 6.214849328090011477e-02 6.214849328090011477e-02 6.214849328090011477e-02 --3.281250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 8.385873697840684482e-02 8.385873697840684482e-02 8.385873697840684482e-02 --3.281250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 8.197483334973135194e-02 8.197483334973135194e-02 8.197483334973135194e-02 --2.968750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.103814104640432753e-01 1.103814104640432753e-01 1.103814104640432753e-01 --2.656250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 9.551079372426583836e-02 9.551079372426583836e-02 9.551079372426583836e-02 --2.656250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.199056140987317109e-01 1.199056140987317109e-01 1.199056140987317109e-01 --2.656250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 9.949648826141764546e-02 9.949648826141764546e-02 9.949648826141764546e-02 --2.968750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 6.918546570145978070e-02 6.918546570145978070e-02 6.918546570145978070e-02 --2.968750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 6.771086913234065918e-02 6.771086913234065918e-02 6.771086913234065918e-02 --2.968750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 8.064948392850813941e-02 8.064948392850813941e-02 8.064948392850813941e-02 --2.968750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 9.274319128326700967e-02 9.274319128326700967e-02 9.274319128326700967e-02 --2.656250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 1.047932992996470081e-01 1.047932992996470081e-01 1.047932992996470081e-01 --2.656250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.054192191910524184e-01 1.054192191910524184e-01 1.054192191910524184e-01 --2.968750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 1.988909491187198786e-01 1.988909491187198786e-01 1.988909491187198786e-01 --2.968750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 5.456668198365614147e-02 5.456668198365614147e-02 5.456668198365614147e-02 --2.968750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 4.016525460131614017e-02 4.016525460131614017e-02 4.016525460131614017e-02 --2.656250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 6.605545276491182893e-02 6.605545276491182893e-02 6.605545276491182893e-02 --2.656250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 5.913992478836863076e-02 5.913992478836863076e-02 5.913992478836863076e-02 --2.968750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 5.069687379097493479e-02 5.069687379097493479e-02 5.069687379097493479e-02 --2.968750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 6.933859904466223301e-02 6.933859904466223301e-02 6.933859904466223301e-02 --2.656250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 1.000887006209914970e-01 1.000887006209914970e-01 1.000887006209914970e-01 --2.656250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.036908970980340156e-01 1.036908970980340156e-01 1.036908970980340156e-01 --2.656250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.040725613773739039e-01 1.040725613773739039e-01 1.040725613773739039e-01 --2.656250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.109205161165409126e-01 1.109205161165409126e-01 1.109205161165409126e-01 --3.593750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 9.672500505018596928e-02 9.672500505018596928e-02 9.672500505018596928e-02 --3.593750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 8.182935943447210148e-02 8.182935943447210148e-02 8.182935943447210148e-02 --3.281250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 9.407878831951863030e-02 9.407878831951863030e-02 9.407878831951863030e-02 --3.281250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.223790714209180980e-01 1.223790714209180980e-01 1.223790714209180980e-01 --3.281250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 9.216780088908105295e-02 9.216780088908105295e-02 9.216780088908105295e-02 --3.281250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.125980676749016030e-01 1.125980676749016030e-01 1.125980676749016030e-01 --3.281250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.172039237737926148e-01 1.172039237737926148e-01 1.172039237737926148e-01 --3.281250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.213178799804801034e-01 1.213178799804801034e-01 1.213178799804801034e-01 --3.593750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 4.843131223675808256e-02 4.843131223675808256e-02 4.843131223675808256e-02 --3.593750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 2.678573972517324028e-02 2.678573972517324028e-02 2.678573972517324028e-02 --3.593750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 9.218628416405094672e-02 9.218628416405094672e-02 9.218628416405094672e-02 --3.593750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 6.913032154952566954e-02 6.913032154952566954e-02 6.913032154952566954e-02 --3.281250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 7.030690948881163083e-02 7.030690948881163083e-02 7.030690948881163083e-02 --3.593750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 2.770043543678430559e-02 2.770043543678430559e-02 2.770043543678430559e-02 --3.593750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 5.856871578050470289e-02 5.856871578050470289e-02 5.856871578050470289e-02 --3.281250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 7.338515255185965036e-02 7.338515255185965036e-02 7.338515255185965036e-02 --2.968750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.182828433988382388e-01 1.182828433988382388e-01 1.182828433988382388e-01 --2.968750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 9.532596842108405355e-02 9.532596842108405355e-02 9.532596842108405355e-02 --2.968750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.190982495992801565e-01 1.190982495992801565e-01 1.190982495992801565e-01 --2.656250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.494776880609697822e-01 1.494776880609697822e-01 1.494776880609697822e-01 --2.656250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.740801352347549902e-01 1.740801352347549902e-01 1.740801352347549902e-01 --2.656250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.258380888158439903e-01 1.258380888158439903e-01 1.258380888158439903e-01 --2.656250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.588294474040713444e-01 1.588294474040713444e-01 1.588294474040713444e-01 --2.968750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 1.357106527936802753e-01 1.357106527936802753e-01 1.357106527936802753e-01 --2.968750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.163997456770728134e-01 1.163997456770728134e-01 1.163997456770728134e-01 --2.968750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.401328729886082425e-01 1.401328729886082425e-01 1.401328729886082425e-01 --2.968750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.480667194674835374e-01 1.480667194674835374e-01 1.480667194674835374e-01 --2.656250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 2.009334267867274038e-01 2.009334267867274038e-01 2.009334267867274038e-01 --2.656250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.990185553324574919e-01 1.990185553324574919e-01 1.990185553324574919e-01 --2.656250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.769011354260685009e-01 1.769011354260685009e-01 1.769011354260685009e-01 --2.656250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.613964541146729326e-01 1.613964541146729326e-01 1.613964541146729326e-01 --2.968750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 9.393976511311942501e-02 9.393976511311942501e-02 9.393976511311942501e-02 --2.656250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.237728178699253750e-01 1.237728178699253750e-01 1.237728178699253750e-01 --2.656250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.033196766304760456e-01 1.033196766304760456e-01 1.033196766304760456e-01 --2.968750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.361596324759480892e-01 1.361596324759480892e-01 1.361596324759480892e-01 --2.968750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.200453957863002880e-01 1.200453957863002880e-01 1.200453957863002880e-01 --2.968750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.038371349937673577e-01 1.038371349937673577e-01 1.038371349937673577e-01 --2.968750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 8.739897407183580547e-02 8.739897407183580547e-02 8.739897407183580547e-02 --2.656250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.235053168214902686e-01 1.235053168214902686e-01 1.235053168214902686e-01 --2.656250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.156718812488248121e-01 1.156718812488248121e-01 1.156718812488248121e-01 --2.656250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.236780278103653402e-01 1.236780278103653402e-01 1.236780278103653402e-01 --3.281250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 9.258246812367554313e-02 9.258246812367554313e-02 9.258246812367554313e-02 --2.656250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 8.516876341298540432e-02 8.516876341298540432e-02 8.516876341298540432e-02 --2.656250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 6.534819461621217684e-02 6.534819461621217684e-02 6.534819461621217684e-02 --2.968750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 9.263309595358680537e-02 9.263309595358680537e-02 9.263309595358680537e-02 --2.656250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 1.209716441656551178e-01 1.209716441656551178e-01 1.209716441656551178e-01 --2.656250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 8.815441880016496035e-02 8.815441880016496035e-02 8.815441880016496035e-02 --2.656250000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 5.813345259791537906e-02 5.813345259791537906e-02 5.813345259791537906e-02 --2.656250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 6.694212929416160085e-02 6.694212929416160085e-02 6.694212929416160085e-02 --2.656250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 6.836440877909778779e-02 6.836440877909778779e-02 6.836440877909778779e-02 --2.656250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 5.104711071117360582e-02 5.104711071117360582e-02 5.104711071117360582e-02 --3.593750000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 8.517358555676489418e-02 8.517358555676489418e-02 8.517358555676489418e-02 --3.593750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 8.499034388953298491e-02 8.499034388953298491e-02 8.499034388953298491e-02 --3.593750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 4.468359229700228502e-02 4.468359229700228502e-02 4.468359229700228502e-02 --3.593750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 4.189453981899349949e-02 4.189453981899349949e-02 4.189453981899349949e-02 --3.281250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 1.035615325840844730e-01 1.035615325840844730e-01 1.035615325840844730e-01 --3.281250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 6.202822666208658575e-02 6.202822666208658575e-02 6.202822666208658575e-02 --3.593750000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 5.618937157593648091e-02 5.618937157593648091e-02 5.618937157593648091e-02 --3.593750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 4.367428569484772122e-02 4.367428569484772122e-02 4.367428569484772122e-02 --3.593750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 5.609233110783802545e-02 5.609233110783802545e-02 5.609233110783802545e-02 --3.281250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 5.434839666191192131e-02 5.434839666191192131e-02 5.434839666191192131e-02 --3.281250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 6.678754441581059853e-02 6.678754441581059853e-02 6.678754441581059853e-02 --3.281250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 7.250007428072072213e-02 7.250007428072072213e-02 7.250007428072072213e-02 --3.281250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 4.528537487987365634e-02 4.528537487987365634e-02 4.528537487987365634e-02 --3.281250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 5.085325846279374618e-02 5.085325846279374618e-02 5.085325846279374618e-02 --3.281250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 9.424915168997458070e-02 9.424915168997458070e-02 9.424915168997458070e-02 --3.281250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 8.937115209848597863e-02 8.937115209848597863e-02 8.937115209848597863e-02 --2.968750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 7.583102388048210130e-02 7.583102388048210130e-02 7.583102388048210130e-02 --2.656250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 8.415530311276575581e-02 8.415530311276575581e-02 8.415530311276575581e-02 --2.656250000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 8.431684680733449178e-02 8.431684680733449178e-02 8.431684680733449178e-02 --2.656250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 1.038684716511329292e-01 1.038684716511329292e-01 1.038684716511329292e-01 --2.656250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 9.307910165008347059e-02 9.307910165008347059e-02 9.307910165008347059e-02 --2.968750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 7.233730112927691525e-02 7.233730112927691525e-02 7.233730112927691525e-02 --2.968750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 5.355323812456717208e-02 5.355323812456717208e-02 5.355323812456717208e-02 --2.656250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 1.132978405771608160e-01 1.132978405771608160e-01 1.132978405771608160e-01 --2.656250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 7.779745725786993416e-02 7.779745725786993416e-02 7.779745725786993416e-02 --2.656250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 8.490675983254863946e-02 8.490675983254863946e-02 8.490675983254863946e-02 --2.656250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 6.352519561164134132e-02 6.352519561164134132e-02 6.352519561164134132e-02 --2.968750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 6.460756856982623197e-02 6.460756856982623197e-02 6.460756856982623197e-02 --2.968750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 8.867840395597494096e-02 8.867840395597494096e-02 8.867840395597494096e-02 --2.656250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 7.495947623378292068e-02 7.495947623378292068e-02 7.495947623378292068e-02 --2.656250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 7.270335939852086427e-02 7.270335939852086427e-02 7.270335939852086427e-02 --2.968750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 8.138972119692114426e-02 8.138972119692114426e-02 8.138972119692114426e-02 --2.656250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 5.995786008393485383e-02 5.995786008393485383e-02 5.995786008393485383e-02 --4.531250000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 6.142214769674531061e-02 6.142214769674531061e-02 6.142214769674531061e-02 --4.218750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 6.960965640530053511e-02 6.960965640530053511e-02 6.960965640530053511e-02 --4.218750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 7.626450339151705227e-02 7.626450339151705227e-02 7.626450339151705227e-02 --4.218750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 8.061653075385717682e-02 8.061653075385717682e-02 8.061653075385717682e-02 --4.218750000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 6.596389059748358763e-02 6.596389059748358763e-02 6.596389059748358763e-02 --3.906250000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 9.187206791228059999e-02 9.187206791228059999e-02 9.187206791228059999e-02 --3.906250000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 8.110278964387790390e-02 8.110278964387790390e-02 8.110278964387790390e-02 --4.218750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 7.154529452297592185e-02 7.154529452297592185e-02 7.154529452297592185e-02 --4.218750000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 5.585161878690449166e-02 5.585161878690449166e-02 5.585161878690449166e-02 --4.218750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 4.318337793070398112e-02 4.318337793070398112e-02 4.318337793070398112e-02 --3.906250000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 6.571886683095778947e-02 6.571886683095778947e-02 6.571886683095778947e-02 --3.906250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 5.451611059349793786e-02 5.451611059349793786e-02 5.451611059349793786e-02 --3.906250000000000000e-01 1.093750000000000000e-01 2.968750000000000000e-01 4.767557483109242933e-02 4.767557483109242933e-02 4.767557483109242933e-02 --3.593750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 8.779839626407072439e-02 8.779839626407072439e-02 8.779839626407072439e-02 --3.593750000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 6.442259186997500997e-02 6.442259186997500997e-02 6.442259186997500997e-02 --3.281250000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 1.131202868349252127e-01 1.131202868349252127e-01 1.131202868349252127e-01 --3.281250000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 7.787132316262042331e-02 7.787132316262042331e-02 7.787132316262042331e-02 --3.281250000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 1.378382641905074868e-01 1.378382641905074868e-01 1.378382641905074868e-01 --3.593750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 4.975309187396085436e-02 4.975309187396085436e-02 4.975309187396085436e-02 --3.593750000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 5.751086296997900277e-02 5.751086296997900277e-02 5.751086296997900277e-02 --3.593750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 5.113072995241643021e-02 5.113072995241643021e-02 5.113072995241643021e-02 --3.281250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 6.591059316846513416e-02 6.591059316846513416e-02 6.591059316846513416e-02 --3.281250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 4.715582535629415234e-02 4.715582535629415234e-02 4.715582535629415234e-02 --2.968750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 1.034707362481974702e-01 1.034707362481974702e-01 1.034707362481974702e-01 --2.656250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 6.579668285866561994e-02 6.579668285866561994e-02 6.579668285866561994e-02 --2.343750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.162519238536413868e-01 1.162519238536413868e-01 1.162519238536413868e-01 --2.031250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 5.946528298321881317e-02 5.946528298321881317e-02 5.946528298321881317e-02 --2.343750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 1.022164507162472702e-01 1.022164507162472702e-01 1.022164507162472702e-01 --2.343750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.375161945050291934e-01 1.375161945050291934e-01 1.375161945050291934e-01 --2.343750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 8.352921776918953434e-02 8.352921776918953434e-02 8.352921776918953434e-02 --2.343750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 8.098785598965303756e-02 8.098785598965303756e-02 8.098785598965303756e-02 --2.031250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 7.658939045359332287e-02 7.658939045359332287e-02 7.658939045359332287e-02 --2.031250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.421680085287249651e-01 1.421680085287249651e-01 1.421680085287249651e-01 --2.343750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 5.204892782712317034e-02 5.204892782712317034e-02 5.204892782712317034e-02 --2.343750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 7.462879525913297674e-02 7.462879525913297674e-02 7.462879525913297674e-02 --2.343750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 5.873666210110591035e-02 5.873666210110591035e-02 5.873666210110591035e-02 --2.031250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 4.161398079537519806e-02 4.161398079537519806e-02 4.161398079537519806e-02 --2.343750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 8.068886697316730860e-02 8.068886697316730860e-02 8.068886697316730860e-02 --2.343750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 6.657909954119306528e-02 6.657909954119306528e-02 6.657909954119306528e-02 --2.343750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.256677923225411331e-01 1.256677923225411331e-01 1.256677923225411331e-01 --2.343750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 9.549552556313894991e-02 9.549552556313894991e-02 9.549552556313894991e-02 --1.718750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 5.345957130827974635e-02 5.345957130827974635e-02 5.345957130827974635e-02 --1.718750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.547880725562916227e-01 1.547880725562916227e-01 1.547880725562916227e-01 --1.406250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.762179711495423795e-01 1.762179711495423795e-01 1.762179711495423795e-01 --1.406250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 2.793919155124048870e-01 2.793919155124048870e-01 2.793919155124048870e-01 --1.406250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 3.626757663835322165e-01 3.626757663835322165e-01 3.626757663835322165e-01 --1.406250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 4.112843318018465366e-01 4.112843318018465366e-01 4.112843318018465366e-01 --1.718750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 3.591372094397969894e-01 3.591372094397969894e-01 3.591372094397969894e-01 --1.718750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.331886094429071965e-01 1.331886094429071965e-01 1.331886094429071965e-01 --1.718750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 1.172191878157731876e-01 1.172191878157731876e-01 1.172191878157731876e-01 --1.406250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 2.081575231074498655e-01 2.081575231074498655e-01 2.081575231074498655e-01 --1.406250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 3.045487420886330496e-03 3.045487420886330496e-03 3.045487420886330496e-03 --1.406250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 2.031877162038938922e-01 2.031877162038938922e-01 2.031877162038938922e-01 --1.406250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 4.092162545025353204e-02 4.092162545025353204e-02 4.092162545025353204e-02 --1.406250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 3.383520539343070621e-01 3.383520539343070621e-01 3.383520539343070621e-01 --1.406250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 2.617305695415525491e-01 2.617305695415525491e-01 2.617305695415525491e-01 --1.406250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 1.644194270628419052e-01 1.644194270628419052e-01 1.644194270628419052e-01 --1.406250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 1.990634983532435232e-01 1.990634983532435232e-01 1.990634983532435232e-01 --1.406250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 4.588187969690510903e-01 4.588187969690510903e-01 4.588187969690510903e-01 --1.406250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.673234616995514790e-01 1.673234616995514790e-01 1.673234616995514790e-01 --1.406250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.999174109781983733e-01 1.999174109781983733e-01 1.999174109781983733e-01 --2.343750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.739854044281173573e-01 1.739854044281173573e-01 1.739854044281173573e-01 --2.343750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.728446119717216845e-01 1.728446119717216845e-01 1.728446119717216845e-01 --2.343750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.267506148278302602e-01 1.267506148278302602e-01 1.267506148278302602e-01 --2.031250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.844075326289485728e-01 1.844075326289485728e-01 1.844075326289485728e-01 --2.031250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.916058235677747801e-01 1.916058235677747801e-01 1.916058235677747801e-01 --2.031250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.132030381753106330e-01 1.132030381753106330e-01 1.132030381753106330e-01 --2.031250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.732917788523079816e-01 1.732917788523079816e-01 1.732917788523079816e-01 --2.343750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.886665457221596010e-01 1.886665457221596010e-01 1.886665457221596010e-01 --2.343750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.640765882981539969e-01 1.640765882981539969e-01 1.640765882981539969e-01 --2.031250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 2.208811728664846485e-01 2.208811728664846485e-01 2.208811728664846485e-01 --2.031250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.952432519550338919e-01 1.952432519550338919e-01 1.952432519550338919e-01 --2.031250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 2.154772576825197405e-01 2.154772576825197405e-01 2.154772576825197405e-01 --2.031250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.664113957587480264e-01 1.664113957587480264e-01 1.664113957587480264e-01 --2.343750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 8.364816632232729976e-02 8.364816632232729976e-02 8.364816632232729976e-02 --2.343750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.080682768041156400e-01 1.080682768041156400e-01 1.080682768041156400e-01 --2.343750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 9.085065571024764086e-02 9.085065571024764086e-02 9.085065571024764086e-02 --2.343750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 9.100254237381295852e-02 9.100254237381295852e-02 9.100254237381295852e-02 --2.031250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 6.357648485497714719e-02 6.357648485497714719e-02 6.357648485497714719e-02 --2.031250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.024076883387938924e-01 1.024076883387938924e-01 1.024076883387938924e-01 --2.031250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 6.837333160837662238e-02 6.837333160837662238e-02 6.837333160837662238e-02 --2.343750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.133331905967162878e-01 1.133331905967162878e-01 1.133331905967162878e-01 --2.343750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 9.494667342568119395e-02 9.494667342568119395e-02 9.494667342568119395e-02 --2.343750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.032168273667506408e-01 1.032168273667506408e-01 1.032168273667506408e-01 --2.343750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 9.325428879688164863e-02 9.325428879688164863e-02 9.325428879688164863e-02 --2.031250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.066951486384845327e-01 1.066951486384845327e-01 1.066951486384845327e-01 --2.031250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.136513400737723528e-01 1.136513400737723528e-01 1.136513400737723528e-01 --1.718750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.242580126971394444e-01 1.242580126971394444e-01 1.242580126971394444e-01 --1.718750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.122397430288527703e-01 1.122397430288527703e-01 1.122397430288527703e-01 --1.718750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.550972252298990217e-01 1.550972252298990217e-01 1.550972252298990217e-01 --1.406250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 5.679122889899580751e-02 5.679122889899580751e-02 5.679122889899580751e-02 --1.718750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 1.783107956691084850e-01 1.783107956691084850e-01 1.783107956691084850e-01 --1.718750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.760566118777642519e-01 1.760566118777642519e-01 1.760566118777642519e-01 --1.718750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.938202440604278320e-01 1.938202440604278320e-01 1.938202440604278320e-01 --1.718750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.683045633426434040e-01 1.683045633426434040e-01 1.683045633426434040e-01 --1.406250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 1.597737171369727482e-01 1.597737171369727482e-01 1.597737171369727482e-01 --1.406250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.855136455279556562e-01 1.855136455279556562e-01 1.855136455279556562e-01 --1.406250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 2.104862370549646089e-01 2.104862370549646089e-01 2.104862370549646089e-01 --1.718750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 7.190187128263189620e-02 7.190187128263189620e-02 7.190187128263189620e-02 --1.718750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.431694947663316175e-01 1.431694947663316175e-01 1.431694947663316175e-01 --1.718750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.252332133168274630e-01 1.252332133168274630e-01 1.252332133168274630e-01 --1.718750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.283997222911621994e-01 1.283997222911621994e-01 1.283997222911621994e-01 --1.406250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 1.694325745870152444e-01 1.694325745870152444e-01 1.694325745870152444e-01 --1.406250000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 2.566870809886169780e-01 2.566870809886169780e-01 2.566870809886169780e-01 --1.406250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.491934083883972861e-01 1.491934083883972861e-01 1.491934083883972861e-01 --1.718750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.378005154412030031e-01 1.378005154412030031e-01 1.378005154412030031e-01 --1.718750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.256605627464434383e-01 1.256605627464434383e-01 1.256605627464434383e-01 --1.406250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.687798554177390720e-01 1.687798554177390720e-01 1.687798554177390720e-01 --1.406250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.246050376661533426e-01 1.246050376661533426e-01 1.246050376661533426e-01 --1.406250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.501410033906664387e-01 1.501410033906664387e-01 1.501410033906664387e-01 --1.406250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 1.861622155398141298e-01 1.861622155398141298e-01 1.861622155398141298e-01 --2.343750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 8.844775446889488468e-02 8.844775446889488468e-02 8.844775446889488468e-02 --2.343750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.240330883066273482e-01 1.240330883066273482e-01 1.240330883066273482e-01 --2.343750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.044381538839910667e-01 1.044381538839910667e-01 1.044381538839910667e-01 --2.031250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 5.685273290033539262e-02 5.685273290033539262e-02 5.685273290033539262e-02 --2.031250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 4.081041380983019273e-02 4.081041380983019273e-02 4.081041380983019273e-02 --2.031250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 7.907961184367202911e-02 7.907961184367202911e-02 7.907961184367202911e-02 --2.031250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 6.132832925543622166e-02 6.132832925543622166e-02 6.132832925543622166e-02 --2.343750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 8.553604920437528347e-02 8.553604920437528347e-02 8.553604920437528347e-02 --2.343750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 1.061793156184596548e-01 1.061793156184596548e-01 1.061793156184596548e-01 --2.343750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.019279863836113353e-01 1.019279863836113353e-01 1.019279863836113353e-01 --2.031250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 7.874091025481753936e-02 7.874091025481753936e-02 7.874091025481753936e-02 --2.031250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 4.588055947944495033e-02 4.588055947944495033e-02 4.588055947944495033e-02 --2.031250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 3.932596895019465494e-02 3.932596895019465494e-02 3.932596895019465494e-02 --2.343750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 9.891311063014991689e-02 9.891311063014991689e-02 9.891311063014991689e-02 --2.343750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 5.063094288707364193e-02 5.063094288707364193e-02 5.063094288707364193e-02 --2.343750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 8.997951184732994045e-02 8.997951184732994045e-02 8.997951184732994045e-02 --2.031250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 8.116226573613981310e-02 8.116226573613981310e-02 8.116226573613981310e-02 --2.031250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 6.732396794431465270e-02 6.732396794431465270e-02 6.732396794431465270e-02 --2.031250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 8.885038607000861344e-02 8.885038607000861344e-02 8.885038607000861344e-02 --2.343750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 6.248155691595196071e-02 6.248155691595196071e-02 6.248155691595196071e-02 --2.343750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 1.003699396993143061e-01 1.003699396993143061e-01 1.003699396993143061e-01 --2.343750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 9.933336794481871512e-02 9.933336794481871512e-02 9.933336794481871512e-02 --2.031250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 4.904633364028582881e-02 4.904633364028582881e-02 4.904633364028582881e-02 --2.031250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 3.096721285793226433e-02 3.096721285793226433e-02 3.096721285793226433e-02 --2.031250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 1.001987857487514344e-01 1.001987857487514344e-01 1.001987857487514344e-01 --1.718750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 4.688557681650333542e-02 4.688557681650333542e-02 4.688557681650333542e-02 --1.718750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 6.307621235984130215e-02 6.307621235984130215e-02 6.307621235984130215e-02 --1.718750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 4.726220380951984962e-02 4.726220380951984962e-02 4.726220380951984962e-02 --1.406250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 7.875160019387500432e-02 7.875160019387500432e-02 7.875160019387500432e-02 --1.406250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 1.443187390732081909e-01 1.443187390732081909e-01 1.443187390732081909e-01 --1.406250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.222015377188732932e-01 1.222015377188732932e-01 1.222015377188732932e-01 --1.406250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.733889189053097468e-01 1.733889189053097468e-01 1.733889189053097468e-01 --1.718750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 6.606405429767106541e-02 6.606405429767106541e-02 6.606405429767106541e-02 --1.718750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 5.754760425302768434e-02 5.754760425302768434e-02 5.754760425302768434e-02 --1.718750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 5.151473412125861379e-02 5.151473412125861379e-02 5.151473412125861379e-02 --1.718750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 5.512803031953623922e-02 5.512803031953623922e-02 5.512803031953623922e-02 --1.406250000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 9.421861488596418310e-02 9.421861488596418310e-02 9.421861488596418310e-02 --1.406250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 8.893235872393905062e-02 8.893235872393905062e-02 8.893235872393905062e-02 --1.406250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 7.728168005690695674e-02 7.728168005690695674e-02 7.728168005690695674e-02 --1.406250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 9.852499341649163800e-02 9.852499341649163800e-02 9.852499341649163800e-02 --1.718750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 1.274004619895315882e-01 1.274004619895315882e-01 1.274004619895315882e-01 --1.718750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 7.203715461267921893e-02 7.203715461267921893e-02 7.203715461267921893e-02 --1.718750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 1.538533803645528997e-01 1.538533803645528997e-01 1.538533803645528997e-01 --1.406250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 6.224198919793735157e-02 6.224198919793735157e-02 6.224198919793735157e-02 --1.406250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 1.043851229860451729e-01 1.043851229860451729e-01 1.043851229860451729e-01 --1.406250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 1.567489636714835266e-01 1.567489636714835266e-01 1.567489636714835266e-01 --1.406250000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 1.396903406486394994e-01 1.396903406486394994e-01 1.396903406486394994e-01 --2.343750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 1.451001515776267070e-01 1.451001515776267070e-01 1.451001515776267070e-01 --2.343750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 1.095699331476691629e-01 1.095699331476691629e-01 1.095699331476691629e-01 --2.343750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.073065912835959590e-01 1.073065912835959590e-01 1.073065912835959590e-01 --2.343750000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 1.475302718706722471e-01 1.475302718706722471e-01 1.475302718706722471e-01 --2.343750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 1.034361854032157801e-01 1.034361854032157801e-01 1.034361854032157801e-01 --2.343750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 1.264349269822961364e-01 1.264349269822961364e-01 1.264349269822961364e-01 --2.343750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 1.101411818935289361e-01 1.101411818935289361e-01 1.101411818935289361e-01 --2.343750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 9.168562699864087062e-02 9.168562699864087062e-02 9.168562699864087062e-02 --2.343750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 3.342571337548801147e-02 3.342571337548801147e-02 3.342571337548801147e-02 --2.343750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 9.150400741733917542e-02 9.150400741733917542e-02 9.150400741733917542e-02 --2.343750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 8.557542985709029604e-02 8.557542985709029604e-02 8.557542985709029604e-02 --2.031250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 5.272767997500507620e-02 5.272767997500507620e-02 5.272767997500507620e-02 --2.031250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.033437819076393205e-01 1.033437819076393205e-01 1.033437819076393205e-01 --2.031250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 8.505303187528535924e-02 8.505303187528535924e-02 8.505303187528535924e-02 --2.343750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.016668409007947665e-01 1.016668409007947665e-01 1.016668409007947665e-01 --2.343750000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 8.907299788663244899e-02 8.907299788663244899e-02 8.907299788663244899e-02 --2.343750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 6.618736962886793973e-02 6.618736962886793973e-02 6.618736962886793973e-02 --2.031250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 8.145080453268632725e-02 8.145080453268632725e-02 8.145080453268632725e-02 --2.031250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 8.886485183854003767e-02 8.886485183854003767e-02 8.886485183854003767e-02 --1.718750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 2.347307090304645294e-01 2.347307090304645294e-01 2.347307090304645294e-01 --1.406250000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 2.358786461885200303e-01 2.358786461885200303e-01 2.358786461885200303e-01 --1.406250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 1.811051573448019814e-01 1.811051573448019814e-01 1.811051573448019814e-01 --1.406250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 2.583150821155040799e-01 2.583150821155040799e-01 2.583150821155040799e-01 --1.406250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 1.407617305476789871e-01 1.407617305476789871e-01 1.407617305476789871e-01 --1.406250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 2.206396693347735249e-01 2.206396693347735249e-01 2.206396693347735249e-01 --1.406250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 2.011589388241351584e-01 2.011589388241351584e-01 2.011589388241351584e-01 --1.406250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 2.571241584177100803e-01 2.571241584177100803e-01 2.571241584177100803e-01 --1.718750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 1.155047767861983460e-01 1.155047767861983460e-01 1.155047767861983460e-01 --1.718750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.207908940183945318e-01 1.207908940183945318e-01 1.207908940183945318e-01 --1.718750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 1.756640499099677011e-01 1.756640499099677011e-01 1.756640499099677011e-01 --1.718750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.138738832783632443e-01 1.138738832783632443e-01 1.138738832783632443e-01 --1.406250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 1.280840409163949423e-01 1.280840409163949423e-01 1.280840409163949423e-01 --1.406250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.673611965993648532e-01 1.673611965993648532e-01 1.673611965993648532e-01 --1.406250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 1.917735726688115372e-01 1.917735726688115372e-01 1.917735726688115372e-01 --1.406250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.181414519262973251e-01 1.181414519262973251e-01 1.181414519262973251e-01 --1.718750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 7.467846983357288859e-02 7.467846983357288859e-02 7.467846983357288859e-02 --1.718750000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 1.233261789855090163e-01 1.233261789855090163e-01 1.233261789855090163e-01 --1.406250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.854373900469237502e-01 1.854373900469237502e-01 1.854373900469237502e-01 --1.406250000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 2.376506567869524078e-01 2.376506567869524078e-01 2.376506567869524078e-01 --1.406250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.166214779029459692e-01 1.166214779029459692e-01 1.166214779029459692e-01 --1.406250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 1.442424445371153774e-01 1.442424445371153774e-01 1.442424445371153774e-01 --1.093750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 4.768992139274427777e-01 4.768992139274427777e-01 4.768992139274427777e-01 --1.093750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 8.273939031658847920e-01 8.273939031658847920e-01 8.273939031658847920e-01 --1.093750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 7.377128379402727587e-01 7.377128379402727587e-01 7.377128379402727587e-01 --1.093750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 8.210390955818051006e-01 8.210390955818051006e-01 8.210390955818051006e-01 --7.812500000000000000e-02 1.562500000000000000e-02 1.562500000000000000e-02 5.116888241746158084e-01 5.116888241746158084e-01 5.116888241746158084e-01 --7.812500000000000000e-02 4.687500000000000000e-02 1.562500000000000000e-02 5.689140568571965373e-01 5.689140568571965373e-01 5.689140568571965373e-01 --1.093750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 7.568417329025247664e-01 7.568417329025247664e-01 7.568417329025247664e-01 --1.093750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.120870930312125452e-01 1.120870930312125452e-01 1.120870930312125452e-01 --1.093750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 3.182434923821846895e-01 3.182434923821846895e-01 3.182434923821846895e-01 --1.093750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 7.195058295354057887e-02 7.195058295354057887e-02 7.195058295354057887e-02 --7.812500000000000000e-02 1.562500000000000000e-02 1.093750000000000000e-01 1.716122810451049807e-01 1.716122810451049807e-01 1.716122810451049807e-01 --1.093750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 3.952667426006039042e-01 3.952667426006039042e-01 3.952667426006039042e-01 --1.093750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 6.954270890856940612e-01 6.954270890856940612e-01 6.954270890856940612e-01 --1.093750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 8.856910672049192468e-02 8.856910672049192468e-02 8.856910672049192468e-02 --7.812500000000000000e-02 7.812500000000000000e-02 1.562500000000000000e-02 6.314438895481661040e-01 6.314438895481661040e-01 6.314438895481661040e-01 --7.812500000000000000e-02 7.812500000000000000e-02 4.687500000000000000e-02 4.809612295925724257e-01 4.809612295925724257e-01 4.809612295925724257e-01 --7.812500000000000000e-02 1.093750000000000000e-01 1.562500000000000000e-02 2.201253687003355275e-01 2.201253687003355275e-01 2.201253687003355275e-01 --7.812500000000000000e-02 1.093750000000000000e-01 4.687500000000000000e-02 1.051693339133700361e-01 1.051693339133700361e-01 1.051693339133700361e-01 --1.093750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 1.422153926813914393e-01 1.422153926813914393e-01 1.422153926813914393e-01 --1.093750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 7.931792380611103754e-02 7.931792380611103754e-02 7.931792380611103754e-02 --1.093750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 5.685040137696249773e-02 5.685040137696249773e-02 5.685040137696249773e-02 --1.093750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 4.592108526342737751e-02 4.592108526342737751e-02 4.592108526342737751e-02 --7.812500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 7.440517891481682189e-02 7.440517891481682189e-02 7.440517891481682189e-02 --7.812500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 9.798982251070421923e-02 9.798982251070421923e-02 9.798982251070421923e-02 --7.812500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 6.017677333912457849e-02 6.017677333912457849e-02 6.017677333912457849e-02 --7.812500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 5.081715734959561109e-02 5.081715734959561109e-02 5.081715734959561109e-02 --1.562500000000000000e-02 1.562500000000000000e-02 4.687500000000000000e-02 5.555502013599029620e-01 5.555502013599029620e-01 5.555502013599029620e-01 --4.687500000000000000e-02 1.562500000000000000e-02 1.093750000000000000e-01 6.921472186966833862e-01 6.921472186966833862e-01 6.921472186966833862e-01 --4.687500000000000000e-02 4.687500000000000000e-02 1.093750000000000000e-01 1.995795387393046738e-01 1.995795387393046738e-01 1.995795387393046738e-01 --1.562500000000000000e-02 1.562500000000000000e-02 7.812500000000000000e-02 5.016016416963863245e-01 5.016016416963863245e-01 5.016016416963863245e-01 --1.562500000000000000e-02 1.562500000000000000e-02 1.093750000000000000e-01 2.142544060242833892e-01 2.142544060242833892e-01 2.142544060242833892e-01 --1.562500000000000000e-02 4.687500000000000000e-02 7.812500000000000000e-02 5.724441983994137395e-01 5.724441983994137395e-01 5.724441983994137395e-01 --1.562500000000000000e-02 4.687500000000000000e-02 1.093750000000000000e-01 3.024790838406293814e-01 3.024790838406293814e-01 3.024790838406293814e-01 --4.687500000000000000e-02 7.812500000000000000e-02 1.562500000000000000e-02 6.761886456466826845e-01 6.761886456466826845e-01 6.761886456466826845e-01 --4.687500000000000000e-02 1.093750000000000000e-01 1.562500000000000000e-02 2.358834593077297759e-01 2.358834593077297759e-01 2.358834593077297759e-01 --4.687500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 1.675627167221058200e-01 1.675627167221058200e-01 1.675627167221058200e-01 --4.687500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 1.506300544109830664e-01 1.506300544109830664e-01 1.506300544109830664e-01 --1.562500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 4.337431313104633812e-01 4.337431313104633812e-01 4.337431313104633812e-01 --1.562500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 1.925625505916826463e-01 1.925625505916826463e-01 1.925625505916826463e-01 --1.562500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 3.021119855694296974e-01 3.021119855694296974e-01 3.021119855694296974e-01 --1.562500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 2.516352559568322267e-01 2.516352559568322267e-01 2.516352559568322267e-01 --1.093750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.419816841323607026e-01 1.419816841323607026e-01 1.419816841323607026e-01 --1.093750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 8.185186370375939491e-02 8.185186370375939491e-02 8.185186370375939491e-02 --1.093750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 7.567894781532022441e-02 7.567894781532022441e-02 7.567894781532022441e-02 --7.812500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 9.289507437402567958e-02 9.289507437402567958e-02 9.289507437402567958e-02 --7.812500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 7.753237535689556925e-02 7.753237535689556925e-02 7.753237535689556925e-02 --7.812500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 5.570304248588726914e-02 5.570304248588726914e-02 5.570304248588726914e-02 --1.093750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 2.455235592531751221e-01 2.455235592531751221e-01 2.455235592531751221e-01 --1.093750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 2.071239441138650883e-01 2.071239441138650883e-01 2.071239441138650883e-01 --1.093750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 9.292882613304163930e-02 9.292882613304163930e-02 9.292882613304163930e-02 --1.093750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.831689571042097453e-01 1.831689571042097453e-01 1.831689571042097453e-01 --7.812500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 1.530897191476723873e-01 1.530897191476723873e-01 1.530897191476723873e-01 --7.812500000000000000e-02 1.562500000000000000e-02 2.343750000000000000e-01 1.677441646876344228e-01 1.677441646876344228e-01 1.677441646876344228e-01 --7.812500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 8.587359703079680551e-02 8.587359703079680551e-02 8.587359703079680551e-02 --7.812500000000000000e-02 4.687500000000000000e-02 2.343750000000000000e-01 1.219051117957096475e-01 1.219051117957096475e-01 1.219051117957096475e-01 --1.093750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 1.311958180025733223e-01 1.311958180025733223e-01 1.311958180025733223e-01 --1.093750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.649091941924164528e-01 1.649091941924164528e-01 1.649091941924164528e-01 --1.093750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.242877348017051437e-01 1.242877348017051437e-01 1.242877348017051437e-01 --1.093750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.445725182726917968e-01 1.445725182726917968e-01 1.445725182726917968e-01 --7.812500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 7.344053492989711940e-02 7.344053492989711940e-02 7.344053492989711940e-02 --7.812500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 9.215253209352582131e-02 9.215253209352582131e-02 9.215253209352582131e-02 --1.093750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.445548501265024322e-01 1.445548501265024322e-01 1.445548501265024322e-01 --1.093750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 9.285810814554412707e-02 9.285810814554412707e-02 9.285810814554412707e-02 --1.093750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 1.821888394319537696e-01 1.821888394319537696e-01 1.821888394319537696e-01 --7.812500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 1.087110437849759109e-01 1.087110437849759109e-01 1.087110437849759109e-01 --7.812500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 1.550883923128531516e-01 1.550883923128531516e-01 1.550883923128531516e-01 --4.687500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 1.247560573241314752e-01 1.247560573241314752e-01 1.247560573241314752e-01 --4.687500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 4.704598925473270354e-02 4.704598925473270354e-02 4.704598925473270354e-02 --4.687500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 3.753993479809990264e-02 3.753993479809990264e-02 3.753993479809990264e-02 --1.562500000000000000e-02 1.562500000000000000e-02 1.406250000000000000e-01 1.862818151319142190e-01 1.862818151319142190e-01 1.862818151319142190e-01 --1.562500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 1.639786340970400547e-01 1.639786340970400547e-01 1.639786340970400547e-01 --1.562500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 1.402300530857621408e-01 1.402300530857621408e-01 1.402300530857621408e-01 --1.562500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 1.564181369084521878e-01 1.564181369084521878e-01 1.564181369084521878e-01 --4.687500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 1.332978460795207487e-01 1.332978460795207487e-01 1.332978460795207487e-01 --4.687500000000000000e-02 1.562500000000000000e-02 2.343750000000000000e-01 1.119191776992696508e-01 1.119191776992696508e-01 1.119191776992696508e-01 --4.687500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 1.128029386724869187e-01 1.128029386724869187e-01 1.128029386724869187e-01 --4.687500000000000000e-02 4.687500000000000000e-02 2.343750000000000000e-01 1.535016634805542179e-01 1.535016634805542179e-01 1.535016634805542179e-01 --1.562500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 1.344183162524290598e-01 1.344183162524290598e-01 1.344183162524290598e-01 --1.562500000000000000e-02 1.562500000000000000e-02 2.343750000000000000e-01 1.359154649452029018e-01 1.359154649452029018e-01 1.359154649452029018e-01 --1.562500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 1.641954178246358975e-01 1.641954178246358975e-01 1.641954178246358975e-01 --1.562500000000000000e-02 4.687500000000000000e-02 2.343750000000000000e-01 1.855361208138258944e-01 1.855361208138258944e-01 1.855361208138258944e-01 --4.687500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 5.746752913756256881e-02 5.746752913756256881e-02 5.746752913756256881e-02 --4.687500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 1.531643992709749158e-01 1.531643992709749158e-01 1.531643992709749158e-01 --4.687500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 1.722938787895006707e-01 1.722938787895006707e-01 1.722938787895006707e-01 --4.687500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 1.514162237944203793e-01 1.514162237944203793e-01 1.514162237944203793e-01 --4.687500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 1.973805256030141397e-01 1.973805256030141397e-01 1.973805256030141397e-01 --4.687500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 2.224096086385321525e-01 2.224096086385321525e-01 2.224096086385321525e-01 --1.562500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 2.408255786187818992e-01 2.408255786187818992e-01 2.408255786187818992e-01 --1.562500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 1.939863833357020062e-01 1.939863833357020062e-01 1.939863833357020062e-01 --1.562500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 2.611387438809911754e-01 2.611387438809911754e-01 2.611387438809911754e-01 --1.562500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 3.006419726521785685e-01 3.006419726521785685e-01 3.006419726521785685e-01 --1.093750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 1.892500755633182152e-01 1.892500755633182152e-01 1.892500755633182152e-01 --1.093750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.254814297092346487e-01 1.254814297092346487e-01 1.254814297092346487e-01 --1.093750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 2.105929614751326229e-01 2.105929614751326229e-01 2.105929614751326229e-01 --7.812500000000000000e-02 1.406250000000000000e-01 4.687500000000000000e-02 1.177397702508760219e-01 1.177397702508760219e-01 1.177397702508760219e-01 --7.812500000000000000e-02 1.718750000000000000e-01 1.562500000000000000e-02 1.445982173875002552e-01 1.445982173875002552e-01 1.445982173875002552e-01 --7.812500000000000000e-02 1.718750000000000000e-01 4.687500000000000000e-02 1.871029538394462788e-01 1.871029538394462788e-01 1.871029538394462788e-01 --7.812500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 1.125305806438147843e-01 1.125305806438147843e-01 1.125305806438147843e-01 --7.812500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 1.079871271076867506e-01 1.079871271076867506e-01 1.079871271076867506e-01 --7.812500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 1.007612621526394192e-01 1.007612621526394192e-01 1.007612621526394192e-01 --1.093750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 1.705019628140659327e-01 1.705019628140659327e-01 1.705019628140659327e-01 --1.093750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 1.130801162506454988e-01 1.130801162506454988e-01 1.130801162506454988e-01 --7.812500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 1.105324568233501115e-01 1.105324568233501115e-01 1.105324568233501115e-01 --4.687500000000000000e-02 1.406250000000000000e-01 1.562500000000000000e-02 4.997099043131931206e-01 4.997099043131931206e-01 4.997099043131931206e-01 --4.687500000000000000e-02 1.406250000000000000e-01 4.687500000000000000e-02 2.308295255421767000e-01 2.308295255421767000e-01 2.308295255421767000e-01 --4.687500000000000000e-02 1.718750000000000000e-01 1.562500000000000000e-02 2.753694210624825778e-01 2.753694210624825778e-01 2.753694210624825778e-01 --4.687500000000000000e-02 1.718750000000000000e-01 4.687500000000000000e-02 1.002365521447402680e-01 1.002365521447402680e-01 1.002365521447402680e-01 --1.562500000000000000e-02 1.406250000000000000e-01 1.562500000000000000e-02 6.863058149007099651e-01 6.863058149007099651e-01 6.863058149007099651e-01 --1.562500000000000000e-02 1.718750000000000000e-01 1.562500000000000000e-02 3.834402267770045114e-01 3.834402267770045114e-01 3.834402267770045114e-01 --1.562500000000000000e-02 1.718750000000000000e-01 4.687500000000000000e-02 2.032378141051079112e-02 2.032378141051079112e-02 2.032378141051079112e-02 --4.687500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 1.066630096061211008e-01 1.066630096061211008e-01 1.066630096061211008e-01 --4.687500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 1.141518605681597770e-01 1.141518605681597770e-01 1.141518605681597770e-01 --4.687500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 3.526314615828671228e-02 3.526314615828671228e-02 3.526314615828671228e-02 --4.687500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 6.689478117524376433e-02 6.689478117524376433e-02 6.689478117524376433e-02 --1.562500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 2.302246366412890322e-01 2.302246366412890322e-01 2.302246366412890322e-01 --1.562500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 2.262542383764730713e-01 2.262542383764730713e-01 2.262542383764730713e-01 --1.562500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 8.704777022424026178e-02 8.704777022424026178e-02 8.704777022424026178e-02 --1.562500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 1.177494106345868957e-01 1.177494106345868957e-01 1.177494106345868957e-01 --4.687500000000000000e-02 2.031250000000000000e-01 1.562500000000000000e-02 1.425583246154685790e-01 1.425583246154685790e-01 1.425583246154685790e-01 --4.687500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 8.183820039817241154e-02 8.183820039817241154e-02 8.183820039817241154e-02 --4.687500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 1.133476519638775409e-01 1.133476519638775409e-01 1.133476519638775409e-01 --4.687500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 8.387882956944335555e-02 8.387882956944335555e-02 8.387882956944335555e-02 --1.562500000000000000e-02 2.031250000000000000e-01 1.562500000000000000e-02 3.212733992059281785e-01 3.212733992059281785e-01 3.212733992059281785e-01 --1.562500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 1.965899897699064369e-01 1.965899897699064369e-01 1.965899897699064369e-01 --1.562500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 1.318006486749903339e-01 1.318006486749903339e-01 1.318006486749903339e-01 --1.562500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 1.084804517212693969e-01 1.084804517212693969e-01 1.084804517212693969e-01 --1.562500000000000000e-02 2.031250000000000000e-01 7.812500000000000000e-02 9.641080652406092133e-02 9.641080652406092133e-02 9.641080652406092133e-02 --1.562500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 9.208583153159280443e-02 9.208583153159280443e-02 9.208583153159280443e-02 --1.562500000000000000e-02 2.343750000000000000e-01 7.812500000000000000e-02 2.187806295084193664e-01 2.187806295084193664e-01 2.187806295084193664e-01 --1.093750000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 2.625541462447607555e-01 2.625541462447607555e-01 2.625541462447607555e-01 --1.093750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 1.841057168893965590e-01 1.841057168893965590e-01 1.841057168893965590e-01 --1.093750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 2.541584011090032846e-01 2.541584011090032846e-01 2.541584011090032846e-01 --1.093750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 2.302013715927392346e-01 2.302013715927392346e-01 2.302013715927392346e-01 --7.812500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 1.946989093570618973e-02 1.946989093570618973e-02 1.946989093570618973e-02 --7.812500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 1.295298996531320523e-01 1.295298996531320523e-01 1.295298996531320523e-01 --7.812500000000000000e-02 1.718750000000000000e-01 1.718750000000000000e-01 1.528817386539609025e-01 1.528817386539609025e-01 1.528817386539609025e-01 --1.093750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 2.069827086860537568e-01 2.069827086860537568e-01 2.069827086860537568e-01 --1.093750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 2.294199829512453270e-01 2.294199829512453270e-01 2.294199829512453270e-01 --1.093750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 2.055566984603114100e-01 2.055566984603114100e-01 2.055566984603114100e-01 --7.812500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 1.961437549459371654e-01 1.961437549459371654e-01 1.961437549459371654e-01 --7.812500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 1.922960807851578358e-01 1.922960807851578358e-01 1.922960807851578358e-01 --1.093750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 1.947721291728988224e-01 1.947721291728988224e-01 1.947721291728988224e-01 --1.093750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.802751272671576643e-01 1.802751272671576643e-01 1.802751272671576643e-01 --1.093750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 1.308166920754831875e-01 1.308166920754831875e-01 1.308166920754831875e-01 --7.812500000000000000e-02 2.031250000000000000e-01 1.406250000000000000e-01 2.106306760859800731e-01 2.106306760859800731e-01 2.106306760859800731e-01 --7.812500000000000000e-02 2.031250000000000000e-01 1.718750000000000000e-01 1.862633534615192599e-01 1.862633534615192599e-01 1.862633534615192599e-01 --7.812500000000000000e-02 2.343750000000000000e-01 1.406250000000000000e-01 1.373274498258373055e-01 1.373274498258373055e-01 1.373274498258373055e-01 --7.812500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 1.193063174442298979e-01 1.193063174442298979e-01 1.193063174442298979e-01 --1.093750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.873469660727624386e-01 1.873469660727624386e-01 1.873469660727624386e-01 --1.093750000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 2.025753967757408791e-01 2.025753967757408791e-01 2.025753967757408791e-01 --7.812500000000000000e-02 2.031250000000000000e-01 2.031250000000000000e-01 1.970249860828860167e-01 1.970249860828860167e-01 1.970249860828860167e-01 --7.812500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 1.953861131734984380e-01 1.953861131734984380e-01 1.953861131734984380e-01 --4.687500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 1.044252979119477676e-01 1.044252979119477676e-01 1.044252979119477676e-01 --4.687500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 2.041731956157591954e-01 2.041731956157591954e-01 2.041731956157591954e-01 --1.562500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 1.564205458461125631e-01 1.564205458461125631e-01 1.564205458461125631e-01 --4.687500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 2.347788408964616991e-01 2.347788408964616991e-01 2.347788408964616991e-01 --4.687500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 2.102093948540386115e-01 2.102093948540386115e-01 2.102093948540386115e-01 --1.562500000000000000e-02 1.406250000000000000e-01 2.031250000000000000e-01 2.839329153270514494e-01 2.839329153270514494e-01 2.839329153270514494e-01 --1.562500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 3.237494879988546126e-01 3.237494879988546126e-01 3.237494879988546126e-01 --1.562500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 2.984769810566221815e-01 2.984769810566221815e-01 2.984769810566221815e-01 --4.687500000000000000e-02 2.031250000000000000e-01 1.406250000000000000e-01 1.908112178105149104e-01 1.908112178105149104e-01 1.908112178105149104e-01 --4.687500000000000000e-02 2.031250000000000000e-01 1.718750000000000000e-01 1.854582599752297722e-01 1.854582599752297722e-01 1.854582599752297722e-01 --4.687500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 1.544556317323536598e-01 1.544556317323536598e-01 1.544556317323536598e-01 --1.562500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 1.462935377345459809e-01 1.462935377345459809e-01 1.462935377345459809e-01 --4.687500000000000000e-02 2.031250000000000000e-01 2.031250000000000000e-01 1.514371025497291412e-01 1.514371025497291412e-01 1.514371025497291412e-01 --4.687500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 1.815249855447023941e-01 1.815249855447023941e-01 1.815249855447023941e-01 --4.687500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 1.061029849062417874e-01 1.061029849062417874e-01 1.061029849062417874e-01 --1.562500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 1.209403141692333428e-01 1.209403141692333428e-01 1.209403141692333428e-01 --1.562500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 1.212110370689759853e-01 1.212110370689759853e-01 1.212110370689759853e-01 --1.562500000000000000e-02 2.343750000000000000e-01 2.343750000000000000e-01 9.319803608490047353e-02 9.319803608490047353e-02 9.319803608490047353e-02 --2.343750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 9.030096824545019718e-02 9.030096824545019718e-02 9.030096824545019718e-02 --2.031250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 1.106585963848479987e-01 1.106585963848479987e-01 1.106585963848479987e-01 --2.031250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.325677248601831171e-01 1.325677248601831171e-01 1.325677248601831171e-01 --1.718750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 1.475326810744653772e-01 1.475326810744653772e-01 1.475326810744653772e-01 --1.718750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 7.757875269611759494e-02 7.757875269611759494e-02 7.757875269611759494e-02 --1.718750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 1.347002385485158993e-01 1.347002385485158993e-01 1.347002385485158993e-01 --1.406250000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 6.541451540467760339e-02 6.541451540467760339e-02 6.541451540467760339e-02 --1.406250000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 1.643046123699282157e-01 1.643046123699282157e-01 1.643046123699282157e-01 --1.406250000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 4.420804900153580547e-02 4.420804900153580547e-02 4.420804900153580547e-02 --1.406250000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 2.939524508576055878e-02 2.939524508576055878e-02 2.939524508576055878e-02 --1.406250000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 4.182924500029421011e-02 4.182924500029421011e-02 4.182924500029421011e-02 --1.718750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 1.394759003270593656e-01 1.394759003270593656e-01 1.394759003270593656e-01 --1.718750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.797260504401801684e-01 1.797260504401801684e-01 1.797260504401801684e-01 --1.718750000000000000e-01 1.093750000000000000e-01 2.968750000000000000e-01 1.244226890843318917e-01 1.244226890843318917e-01 1.244226890843318917e-01 --1.406250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 9.409646755398273776e-02 9.409646755398273776e-02 9.409646755398273776e-02 --1.406250000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 2.829221140046838875e-02 2.829221140046838875e-02 2.829221140046838875e-02 --1.406250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.681672740617995709e-01 1.681672740617995709e-01 1.681672740617995709e-01 --1.406250000000000000e-01 1.093750000000000000e-01 2.968750000000000000e-01 4.769028922432690110e-02 4.769028922432690110e-02 4.769028922432690110e-02 --1.406250000000000000e-01 7.812500000000000000e-02 3.281250000000000000e-01 3.526990134845366803e-02 3.526990134845366803e-02 3.526990134845366803e-02 --1.406250000000000000e-01 1.093750000000000000e-01 3.281250000000000000e-01 4.918358512775593272e-02 4.918358512775593272e-02 4.918358512775593272e-02 --2.343750000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 9.025676806687087106e-02 9.025676806687087106e-02 9.025676806687087106e-02 --2.343750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 1.087849616585611634e-01 1.087849616585611634e-01 1.087849616585611634e-01 --2.031250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 1.365234728492353278e-01 1.365234728492353278e-01 1.365234728492353278e-01 --2.031250000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 9.914533721880329498e-02 9.914533721880329498e-02 9.914533721880329498e-02 --2.031250000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 1.537168694277608882e-01 1.537168694277608882e-01 1.537168694277608882e-01 --2.031250000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 1.454784071141782542e-01 1.454784071141782542e-01 1.454784071141782542e-01 --2.343750000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 8.085443629699162749e-02 8.085443629699162749e-02 8.085443629699162749e-02 --2.031250000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 1.531330818083429801e-01 1.531330818083429801e-01 1.531330818083429801e-01 --2.031250000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 1.243873439369535261e-01 1.243873439369535261e-01 1.243873439369535261e-01 --2.031250000000000000e-01 2.343750000000000000e-01 2.656250000000000000e-01 1.089850216496462548e-01 1.089850216496462548e-01 1.089850216496462548e-01 --1.718750000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 1.144499218552138681e-01 1.144499218552138681e-01 1.144499218552138681e-01 --1.718750000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 1.351098674746418482e-01 1.351098674746418482e-01 1.351098674746418482e-01 --1.406250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 2.190871293209831761e-01 2.190871293209831761e-01 2.190871293209831761e-01 --1.406250000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 1.541384465739050191e-01 1.541384465739050191e-01 1.541384465739050191e-01 --1.406250000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 2.481904656306951895e-01 2.481904656306951895e-01 2.481904656306951895e-01 --1.406250000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 1.615578427915767001e-01 1.615578427915767001e-01 1.615578427915767001e-01 --1.718750000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 1.517896314847889117e-01 1.517896314847889117e-01 1.517896314847889117e-01 --1.718750000000000000e-01 2.343750000000000000e-01 2.656250000000000000e-01 1.351572557844393230e-01 1.351572557844393230e-01 1.351572557844393230e-01 --1.718750000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 1.030022898075303311e-01 1.030022898075303311e-01 1.030022898075303311e-01 --1.406250000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 2.490029521701788429e-01 2.490029521701788429e-01 2.490029521701788429e-01 --1.406250000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 1.801787982703044466e-01 1.801787982703044466e-01 1.801787982703044466e-01 --1.406250000000000000e-01 2.343750000000000000e-01 2.656250000000000000e-01 1.487653808849120629e-01 1.487653808849120629e-01 1.487653808849120629e-01 --1.093750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 1.789192860236874238e-01 1.789192860236874238e-01 1.789192860236874238e-01 --1.093750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 6.721544556492037303e-02 6.721544556492037303e-02 6.721544556492037303e-02 --1.093750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 8.327363852636951447e-02 8.327363852636951447e-02 8.327363852636951447e-02 --7.812500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 6.126385413637153166e-02 6.126385413637153166e-02 6.126385413637153166e-02 --7.812500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 7.813367115968154752e-02 7.813367115968154752e-02 7.813367115968154752e-02 --7.812500000000000000e-02 4.687500000000000000e-02 2.656250000000000000e-01 6.204422470530753658e-02 6.204422470530753658e-02 6.204422470530753658e-02 --1.093750000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 8.674317800288519620e-02 8.674317800288519620e-02 8.674317800288519620e-02 --1.093750000000000000e-01 1.562500000000000000e-02 3.593750000000000000e-01 6.346289280341706196e-02 6.346289280341706196e-02 6.346289280341706196e-02 --1.093750000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 9.143891357379692331e-02 9.143891357379692331e-02 9.143891357379692331e-02 --1.093750000000000000e-01 4.687500000000000000e-02 3.593750000000000000e-01 5.902970307039601128e-02 5.902970307039601128e-02 5.902970307039601128e-02 --7.812500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 9.214128140020418078e-02 9.214128140020418078e-02 9.214128140020418078e-02 --7.812500000000000000e-02 1.562500000000000000e-02 3.593750000000000000e-01 7.437857319048593596e-02 7.437857319048593596e-02 7.437857319048593596e-02 --7.812500000000000000e-02 4.687500000000000000e-02 3.593750000000000000e-01 8.123942384438548325e-02 8.123942384438548325e-02 8.123942384438548325e-02 --1.093750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 8.610264653504215437e-02 8.610264653504215437e-02 8.610264653504215437e-02 --1.093750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 5.252603281325172319e-02 5.252603281325172319e-02 5.252603281325172319e-02 --1.093750000000000000e-01 1.093750000000000000e-01 2.968750000000000000e-01 6.066468325817673396e-02 6.066468325817673396e-02 6.066468325817673396e-02 --7.812500000000000000e-02 7.812500000000000000e-02 2.656250000000000000e-01 1.033373538344376646e-01 1.033373538344376646e-01 1.033373538344376646e-01 --7.812500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 1.418796874050290147e-01 1.418796874050290147e-01 1.418796874050290147e-01 --7.812500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 8.669415381730039005e-02 8.669415381730039005e-02 8.669415381730039005e-02 --1.093750000000000000e-01 7.812500000000000000e-02 3.593750000000000000e-01 4.274344805118562157e-02 4.274344805118562157e-02 4.274344805118562157e-02 --1.093750000000000000e-01 1.093750000000000000e-01 3.281250000000000000e-01 5.787610434438027196e-02 5.787610434438027196e-02 5.787610434438027196e-02 --1.093750000000000000e-01 1.093750000000000000e-01 3.593750000000000000e-01 6.393800074148463242e-02 6.393800074148463242e-02 6.393800074148463242e-02 --7.812500000000000000e-02 7.812500000000000000e-02 3.593750000000000000e-01 5.627981929707659425e-02 5.627981929707659425e-02 5.627981929707659425e-02 --7.812500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 6.226996559910464440e-02 6.226996559910464440e-02 6.226996559910464440e-02 --7.812500000000000000e-02 1.093750000000000000e-01 3.593750000000000000e-01 4.405615438064765937e-02 4.405615438064765937e-02 4.405615438064765937e-02 --4.687500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 1.211548039006663940e-01 1.211548039006663940e-01 1.211548039006663940e-01 --4.687500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 1.303885667938786685e-01 1.303885667938786685e-01 1.303885667938786685e-01 --4.687500000000000000e-02 4.687500000000000000e-02 2.656250000000000000e-01 9.708902380317117886e-02 9.708902380317117886e-02 9.708902380317117886e-02 --1.562500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 9.942095475691412054e-02 9.942095475691412054e-02 9.942095475691412054e-02 --4.687500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 1.459249230384893348e-01 1.459249230384893348e-01 1.459249230384893348e-01 --4.687500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 8.117753661761516193e-02 8.117753661761516193e-02 8.117753661761516193e-02 --4.687500000000000000e-02 4.687500000000000000e-02 3.593750000000000000e-01 5.639792376830184140e-02 5.639792376830184140e-02 5.639792376830184140e-02 --1.562500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 1.570420493518207561e-01 1.570420493518207561e-01 1.570420493518207561e-01 --1.562500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 1.340584823710166684e-01 1.340584823710166684e-01 1.340584823710166684e-01 --1.562500000000000000e-02 4.687500000000000000e-02 3.593750000000000000e-01 3.992433379456340053e-02 3.992433379456340053e-02 3.992433379456340053e-02 --4.687500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 1.619344151120433728e-01 1.619344151120433728e-01 1.619344151120433728e-01 --4.687500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 1.325203350251013823e-01 1.325203350251013823e-01 1.325203350251013823e-01 --1.562500000000000000e-02 7.812500000000000000e-02 2.656250000000000000e-01 1.211772971727138604e-01 1.211772971727138604e-01 1.211772971727138604e-01 --1.562500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 1.662058583445152338e-01 1.662058583445152338e-01 1.662058583445152338e-01 --1.562500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 1.314825709599303505e-01 1.314825709599303505e-01 1.314825709599303505e-01 --4.687500000000000000e-02 7.812500000000000000e-02 3.281250000000000000e-01 7.551561844422834124e-02 7.551561844422834124e-02 7.551561844422834124e-02 --4.687500000000000000e-02 7.812500000000000000e-02 3.593750000000000000e-01 3.352768684789154269e-02 3.352768684789154269e-02 3.352768684789154269e-02 --4.687500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 9.163339132035387691e-02 9.163339132035387691e-02 9.163339132035387691e-02 --1.562500000000000000e-02 7.812500000000000000e-02 3.281250000000000000e-01 7.037571808899331649e-02 7.037571808899331649e-02 7.037571808899331649e-02 --1.562500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 9.546900717113158963e-02 9.546900717113158963e-02 9.546900717113158963e-02 --1.093750000000000000e-01 4.687500000000000000e-02 3.906250000000000000e-01 4.643826966649968607e-02 4.643826966649968607e-02 4.643826966649968607e-02 --7.812500000000000000e-02 4.687500000000000000e-02 3.906250000000000000e-01 5.887429903498896111e-02 5.887429903498896111e-02 5.887429903498896111e-02 --7.812500000000000000e-02 7.812500000000000000e-02 3.906250000000000000e-01 5.180989185866951424e-02 5.180989185866951424e-02 5.180989185866951424e-02 --1.093750000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 4.173578378121691190e-01 4.173578378121691190e-01 4.173578378121691190e-01 --1.093750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 1.561427145607564571e-01 1.561427145607564571e-01 1.561427145607564571e-01 --7.812500000000000000e-02 1.406250000000000000e-01 2.656250000000000000e-01 1.320825801438694769e-01 1.320825801438694769e-01 1.320825801438694769e-01 --7.812500000000000000e-02 1.406250000000000000e-01 2.968750000000000000e-01 9.484381345769557492e-02 9.484381345769557492e-02 9.484381345769557492e-02 --1.093750000000000000e-01 1.406250000000000000e-01 3.281250000000000000e-01 4.439484119932250727e-02 4.439484119932250727e-02 4.439484119932250727e-02 --1.093750000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 2.063222692758021060e-01 2.063222692758021060e-01 2.063222692758021060e-01 --4.687500000000000000e-02 1.406250000000000000e-01 2.656250000000000000e-01 1.002711043638232630e-01 1.002711043638232630e-01 1.002711043638232630e-01 --4.687500000000000000e-02 1.406250000000000000e-01 2.968750000000000000e-01 8.664914798129395856e-02 8.664914798129395856e-02 8.664914798129395856e-02 --2.343750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 7.298718604065322635e-02 7.298718604065322635e-02 7.298718604065322635e-02 --2.031250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 5.157760900109475272e-02 5.157760900109475272e-02 5.157760900109475272e-02 --2.343750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 1.208583741208778817e-01 1.208583741208778817e-01 1.208583741208778817e-01 --2.343750000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 1.307990209081863753e-01 1.307990209081863753e-01 1.307990209081863753e-01 --2.343750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 9.402735779717824594e-02 9.402735779717824594e-02 9.402735779717824594e-02 --2.031250000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 1.683519321044768258e-01 1.683519321044768258e-01 1.683519321044768258e-01 --2.031250000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 1.164527686562458614e-01 1.164527686562458614e-01 1.164527686562458614e-01 --2.031250000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 1.346287540712076125e-01 1.346287540712076125e-01 1.346287540712076125e-01 --1.718750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 7.275030219178124646e-02 7.275030219178124646e-02 7.275030219178124646e-02 --1.718750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 6.809463340103651119e-02 6.809463340103651119e-02 6.809463340103651119e-02 --1.406250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 7.546706968928210135e-02 7.546706968928210135e-02 7.546706968928210135e-02 --1.406250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 1.036161710377180439e-01 1.036161710377180439e-01 1.036161710377180439e-01 --1.406250000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 7.489509241696924724e-02 7.489509241696924724e-02 7.489509241696924724e-02 --1.406250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 5.687371660768664183e-02 5.687371660768664183e-02 5.687371660768664183e-02 --1.718750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 1.496567676780034273e-01 1.496567676780034273e-01 1.496567676780034273e-01 --1.718750000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 2.029012187029539671e-01 2.029012187029539671e-01 2.029012187029539671e-01 --1.718750000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 1.088620932803111424e-01 1.088620932803111424e-01 1.088620932803111424e-01 --1.718750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 1.344175130535979201e-01 1.344175130535979201e-01 1.344175130535979201e-01 --1.406250000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 1.383273900000795975e-01 1.383273900000795975e-01 1.383273900000795975e-01 --1.406250000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 1.925440903624600630e-01 1.925440903624600630e-01 1.925440903624600630e-01 --1.718750000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 6.357543977668020374e-02 6.357543977668020374e-02 6.357543977668020374e-02 --1.406250000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 8.215808188518120003e-02 8.215808188518120003e-02 8.215808188518120003e-02 --2.343750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 1.009235760409402799e-01 1.009235760409402799e-01 1.009235760409402799e-01 --2.343750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 7.564615336191625461e-02 7.564615336191625461e-02 7.564615336191625461e-02 --2.031250000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 7.388463752620956504e-02 7.388463752620956504e-02 7.388463752620956504e-02 --2.031250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.112603677489503728e-01 1.112603677489503728e-01 1.112603677489503728e-01 --1.718750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 1.963757010536281433e-01 1.963757010536281433e-01 1.963757010536281433e-01 --1.718750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 1.067602301396934350e-01 1.067602301396934350e-01 1.067602301396934350e-01 --1.718750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.146234556808499033e-01 1.146234556808499033e-01 1.146234556808499033e-01 --1.406250000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 1.952617115649616375e-01 1.952617115649616375e-01 1.952617115649616375e-01 --1.093750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 1.023634948109444082e-01 1.023634948109444082e-01 1.023634948109444082e-01 --7.812500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 9.945550732628681556e-02 9.945550732628681556e-02 9.945550732628681556e-02 --1.093750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 1.469119071789790343e-01 1.469119071789790343e-01 1.469119071789790343e-01 --1.093750000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 1.176128384244543579e-01 1.176128384244543579e-01 1.176128384244543579e-01 --1.093750000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 9.446371259137953391e-02 9.446371259137953391e-02 9.446371259137953391e-02 --1.093750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 9.057179426397797550e-02 9.057179426397797550e-02 9.057179426397797550e-02 --7.812500000000000000e-02 2.656250000000000000e-01 7.812500000000000000e-02 8.211468095399139522e-02 8.211468095399139522e-02 8.211468095399139522e-02 --7.812500000000000000e-02 2.656250000000000000e-01 1.093750000000000000e-01 8.416896602485149370e-02 8.416896602485149370e-02 8.416896602485149370e-02 --7.812500000000000000e-02 2.968750000000000000e-01 7.812500000000000000e-02 9.180858161519575567e-02 9.180858161519575567e-02 9.180858161519575567e-02 --7.812500000000000000e-02 2.968750000000000000e-01 1.093750000000000000e-01 1.117247489823716827e-01 1.117247489823716827e-01 1.117247489823716827e-01 --1.093750000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 7.613597892934746703e-02 7.613597892934746703e-02 7.613597892934746703e-02 --1.093750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 7.306427160828829481e-02 7.306427160828829481e-02 7.306427160828829481e-02 --7.812500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 7.923545910571820616e-02 7.923545910571820616e-02 7.923545910571820616e-02 --7.812500000000000000e-02 3.281250000000000000e-01 4.687500000000000000e-02 1.018669185927903453e-01 1.018669185927903453e-01 1.018669185927903453e-01 --7.812500000000000000e-02 3.281250000000000000e-01 1.093750000000000000e-01 5.363749796569351747e-02 5.363749796569351747e-02 5.363749796569351747e-02 --4.687500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 6.308650242483378190e-02 6.308650242483378190e-02 6.308650242483378190e-02 --4.687500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 6.457822635768092900e-02 6.457822635768092900e-02 6.457822635768092900e-02 --1.562500000000000000e-02 2.656250000000000000e-01 1.562500000000000000e-02 1.159803808833603928e-01 1.159803808833603928e-01 1.159803808833603928e-01 --1.562500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 1.029974687322050414e-01 1.029974687322050414e-01 1.029974687322050414e-01 --1.562500000000000000e-02 2.968750000000000000e-01 1.562500000000000000e-02 8.569116064333560934e-02 8.569116064333560934e-02 8.569116064333560934e-02 --1.562500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 9.141882287070589308e-02 9.141882287070589308e-02 9.141882287070589308e-02 --4.687500000000000000e-02 2.656250000000000000e-01 7.812500000000000000e-02 1.255352499910220021e-01 1.255352499910220021e-01 1.255352499910220021e-01 --4.687500000000000000e-02 2.968750000000000000e-01 7.812500000000000000e-02 5.641191298621924671e-02 5.641191298621924671e-02 5.641191298621924671e-02 --4.687500000000000000e-02 2.968750000000000000e-01 1.093750000000000000e-01 1.177204894800244900e-01 1.177204894800244900e-01 1.177204894800244900e-01 --1.562500000000000000e-02 2.656250000000000000e-01 7.812500000000000000e-02 2.709041124570504833e-01 2.709041124570504833e-01 2.709041124570504833e-01 --1.562500000000000000e-02 2.656250000000000000e-01 1.093750000000000000e-01 2.539177994534932425e-01 2.539177994534932425e-01 2.539177994534932425e-01 --1.562500000000000000e-02 2.968750000000000000e-01 1.093750000000000000e-01 1.112579574587365255e-01 1.112579574587365255e-01 1.112579574587365255e-01 --4.687500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 8.355493639017709528e-02 8.355493639017709528e-02 8.355493639017709528e-02 --4.687500000000000000e-02 3.281250000000000000e-01 4.687500000000000000e-02 7.368915230531521143e-02 7.368915230531521143e-02 7.368915230531521143e-02 --4.687500000000000000e-02 3.593750000000000000e-01 1.562500000000000000e-02 8.284526017587200142e-02 8.284526017587200142e-02 8.284526017587200142e-02 --4.687500000000000000e-02 3.593750000000000000e-01 4.687500000000000000e-02 1.064661577527595410e-01 1.064661577527595410e-01 1.064661577527595410e-01 --1.562500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 8.840837522209829547e-02 8.840837522209829547e-02 8.840837522209829547e-02 --1.562500000000000000e-02 3.281250000000000000e-01 4.687500000000000000e-02 9.468711247243155604e-02 9.468711247243155604e-02 9.468711247243155604e-02 --1.562500000000000000e-02 3.593750000000000000e-01 1.562500000000000000e-02 1.537618377619434096e-01 1.537618377619434096e-01 1.537618377619434096e-01 --1.562500000000000000e-02 3.593750000000000000e-01 4.687500000000000000e-02 1.643311080828358250e-01 1.643311080828358250e-01 1.643311080828358250e-01 --4.687500000000000000e-02 3.281250000000000000e-01 1.093750000000000000e-01 9.423066888893275039e-02 9.423066888893275039e-02 9.423066888893275039e-02 --4.687500000000000000e-02 3.593750000000000000e-01 7.812500000000000000e-02 5.744115900176892386e-02 5.744115900176892386e-02 5.744115900176892386e-02 --1.562500000000000000e-02 3.281250000000000000e-01 7.812500000000000000e-02 8.354850673570542174e-02 8.354850673570542174e-02 8.354850673570542174e-02 --1.562500000000000000e-02 3.593750000000000000e-01 7.812500000000000000e-02 8.597968319804051573e-02 8.597968319804051573e-02 8.597968319804051573e-02 --1.562500000000000000e-02 3.593750000000000000e-01 1.093750000000000000e-01 6.261629334593599161e-02 6.261629334593599161e-02 6.261629334593599161e-02 --1.093750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 1.159755605856616217e-01 1.159755605856616217e-01 1.159755605856616217e-01 --1.093750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 7.348177026063444639e-02 7.348177026063444639e-02 7.348177026063444639e-02 --1.093750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 8.199010407695749014e-02 8.199010407695749014e-02 8.199010407695749014e-02 --7.812500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 8.261620139779139727e-02 8.261620139779139727e-02 8.261620139779139727e-02 --7.812500000000000000e-02 2.968750000000000000e-01 1.406250000000000000e-01 9.817223101213490288e-02 9.817223101213490288e-02 9.817223101213490288e-02 --7.812500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 6.682950664305463417e-02 6.682950664305463417e-02 6.682950664305463417e-02 --7.812500000000000000e-02 3.281250000000000000e-01 1.406250000000000000e-01 9.107165472896690261e-02 9.107165472896690261e-02 9.107165472896690261e-02 --4.687500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 8.584627178323198105e-02 8.584627178323198105e-02 8.584627178323198105e-02 --4.687500000000000000e-02 2.968750000000000000e-01 1.406250000000000000e-01 9.708339880185529180e-02 9.708339880185529180e-02 9.708339880185529180e-02 --4.687500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 7.438299408183526862e-02 7.438299408183526862e-02 7.438299408183526862e-02 --1.562500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 9.055411425497499056e-02 9.055411425497499056e-02 9.055411425497499056e-02 --1.562500000000000000e-02 2.968750000000000000e-01 1.406250000000000000e-01 8.283481189493650809e-02 8.283481189493650809e-02 8.283481189493650809e-02 --1.562500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 6.249538429266751627e-02 6.249538429266751627e-02 6.249538429266751627e-02 --1.562500000000000000e-02 2.656250000000000000e-01 2.031250000000000000e-01 9.202234540318837697e-02 9.202234540318837697e-02 9.202234540318837697e-02 --1.562500000000000000e-02 2.968750000000000000e-01 2.031250000000000000e-01 1.776653734296610998e-01 1.776653734296610998e-01 1.776653734296610998e-01 --1.562500000000000000e-02 2.968750000000000000e-01 2.343750000000000000e-01 1.479510783717827016e-01 1.479510783717827016e-01 1.479510783717827016e-01 --4.687500000000000000e-02 3.281250000000000000e-01 1.406250000000000000e-01 9.046169596284908687e-02 9.046169596284908687e-02 9.046169596284908687e-02 --1.562500000000000000e-02 3.281250000000000000e-01 1.718750000000000000e-01 1.375876764168604827e-01 1.375876764168604827e-01 1.375876764168604827e-01 --1.562500000000000000e-02 3.281250000000000000e-01 2.031250000000000000e-01 1.858066264406528223e-01 1.858066264406528223e-01 1.858066264406528223e-01 --1.562500000000000000e-02 3.281250000000000000e-01 2.343750000000000000e-01 1.257457110458043148e-01 1.257457110458043148e-01 1.257457110458043148e-01 --1.562500000000000000e-02 3.593750000000000000e-01 2.031250000000000000e-01 1.168512432604354306e-01 1.168512432604354306e-01 1.168512432604354306e-01 --1.093750000000000000e-01 4.218750000000000000e-01 1.562500000000000000e-02 3.278322927446690460e-02 3.278322927446690460e-02 3.278322927446690460e-02 --7.812500000000000000e-02 3.906250000000000000e-01 1.562500000000000000e-02 3.917446718694662933e-02 3.917446718694662933e-02 3.917446718694662933e-02 --7.812500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 3.956737403657376029e-02 3.956737403657376029e-02 3.956737403657376029e-02 --1.093750000000000000e-01 4.531250000000000000e-01 1.562500000000000000e-02 3.076832596917737986e-02 3.076832596917737986e-02 3.076832596917737986e-02 --1.093750000000000000e-01 4.843750000000000000e-01 1.562500000000000000e-02 2.130876852943166394e-02 2.130876852943166394e-02 2.130876852943166394e-02 --7.812500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 4.273878418654007000e-02 4.273878418654007000e-02 4.273878418654007000e-02 --7.812500000000000000e-02 4.843750000000000000e-01 1.562500000000000000e-02 2.870945989836223150e-02 2.870945989836223150e-02 2.870945989836223150e-02 --4.687500000000000000e-02 3.906250000000000000e-01 1.562500000000000000e-02 6.363171320427130073e-02 6.363171320427130073e-02 6.363171320427130073e-02 --4.687500000000000000e-02 3.906250000000000000e-01 4.687500000000000000e-02 6.796794477070339235e-02 6.796794477070339235e-02 6.796794477070339235e-02 --4.687500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 5.022570785217275041e-02 5.022570785217275041e-02 5.022570785217275041e-02 --4.687500000000000000e-02 4.218750000000000000e-01 4.687500000000000000e-02 7.374276610353744377e-02 7.374276610353744377e-02 7.374276610353744377e-02 --1.562500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 4.780816508623301347e-02 4.780816508623301347e-02 4.780816508623301347e-02 --4.687500000000000000e-02 3.906250000000000000e-01 7.812500000000000000e-02 8.093400589937460587e-02 8.093400589937460587e-02 8.093400589937460587e-02 --4.687500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 7.190974874957030416e-02 7.190974874957030416e-02 7.190974874957030416e-02 --4.687500000000000000e-02 4.218750000000000000e-01 7.812500000000000000e-02 6.786392489591260013e-02 6.786392489591260013e-02 6.786392489591260013e-02 --4.687500000000000000e-02 4.218750000000000000e-01 1.093750000000000000e-01 5.617674908587022564e-02 5.617674908587022564e-02 5.617674908587022564e-02 --1.562500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 8.615488580434219057e-02 8.615488580434219057e-02 8.615488580434219057e-02 --1.562500000000000000e-02 4.218750000000000000e-01 1.093750000000000000e-01 6.167707283181964040e-02 6.167707283181964040e-02 6.167707283181964040e-02 --4.687500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 4.624376304923973752e-02 4.624376304923973752e-02 4.624376304923973752e-02 --4.687500000000000000e-02 4.531250000000000000e-01 4.687500000000000000e-02 2.729058098133161150e-02 2.729058098133161150e-02 2.729058098133161150e-02 --4.687500000000000000e-02 4.843750000000000000e-01 1.562500000000000000e-02 2.772078333710275774e-02 2.772078333710275774e-02 2.772078333710275774e-02 --1.562500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 6.341039762560707338e-02 6.341039762560707338e-02 6.341039762560707338e-02 --1.562500000000000000e-02 4.531250000000000000e-01 4.687500000000000000e-02 8.272711415072421526e-02 8.272711415072421526e-02 8.272711415072421526e-02 --4.687500000000000000e-02 4.531250000000000000e-01 7.812500000000000000e-02 6.027493439599693192e-02 6.027493439599693192e-02 6.027493439599693192e-02 --1.562500000000000000e-02 4.531250000000000000e-01 7.812500000000000000e-02 9.060876154296521046e-02 9.060876154296521046e-02 9.060876154296521046e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.266574348292445751e-01 1.266574348292445751e-01 1.266574348292445751e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 1.012658804942263152e-01 1.012658804942263152e-01 1.012658804942263152e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 1.641255653539704373e-01 1.641255653539704373e-01 1.641255653539704373e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 1.311620822933478314e-01 1.311620822933478314e-01 1.311620822933478314e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 1.817601847069037213e-01 1.817601847069037213e-01 1.817601847069037213e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 1.324480453923854995e-01 1.324480453923854995e-01 1.324480453923854995e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.308383794118543886e-01 1.308383794118543886e-01 1.308383794118543886e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 1.494873246424326396e-01 1.494873246424326396e-01 1.494873246424326396e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 8.159386795334536147e-02 8.159386795334536147e-02 8.159386795334536147e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -3.906250000000000000e-01 7.157648299515072254e-02 7.157648299515072254e-02 7.157648299515072254e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 -3.593750000000000000e-01 2.122417881421698790e-03 2.122417881421698790e-03 2.122417881421698790e-03 -4.687500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 8.897254136694292270e-02 8.897254136694292270e-02 8.897254136694292270e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 1.158928120969127951e-01 1.158928120969127951e-01 1.158928120969127951e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 1.050680939979450473e-01 1.050680939979450473e-01 1.050680939979450473e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 -3.593750000000000000e-01 5.105611586440241684e-02 5.105611586440241684e-02 5.105611586440241684e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 6.751159073492637996e-02 6.751159073492637996e-02 6.751159073492637996e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 -3.593750000000000000e-01 6.310016891533903882e-02 6.310016891533903882e-02 6.310016891533903882e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 5.516477269077692258e-02 5.516477269077692258e-02 5.516477269077692258e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -3.593750000000000000e-01 8.321416399492877203e-02 8.321416399492877203e-02 8.321416399492877203e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 9.104674214267841070e-02 9.104674214267841070e-02 9.104674214267841070e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 8.151108409487139994e-02 8.151108409487139994e-02 8.151108409487139994e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 7.551762791191855839e-02 7.551762791191855839e-02 7.551762791191855839e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 7.970123084096694677e-02 7.970123084096694677e-02 7.970123084096694677e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 4.902583032240746819e-02 4.902583032240746819e-02 4.902583032240746819e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 -3.906250000000000000e-01 7.507015840517539118e-02 7.507015840517539118e-02 7.507015840517539118e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 -4.218750000000000000e-01 5.521486127924194603e-02 5.521486127924194603e-02 5.521486127924194603e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 1.068494158151019474e-01 1.068494158151019474e-01 1.068494158151019474e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -3.906250000000000000e-01 8.208012093646946394e-02 8.208012093646946394e-02 8.208012093646946394e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 8.585350493790860904e-02 8.585350493790860904e-02 8.585350493790860904e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 -4.218750000000000000e-01 5.579027481709843833e-02 5.579027481709843833e-02 5.579027481709843833e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 9.005826878366000876e-02 9.005826878366000876e-02 9.005826878366000876e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 -4.218750000000000000e-01 6.830781711802944023e-02 6.830781711802944023e-02 6.830781711802944023e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 -3.906250000000000000e-01 1.126446658299966735e-01 1.126446658299966735e-01 1.126446658299966735e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 1.084997347066141843e-01 1.084997347066141843e-01 1.084997347066141843e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -3.906250000000000000e-01 1.050166705000656620e-01 1.050166705000656620e-01 1.050166705000656620e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -3.906250000000000000e-01 6.175360648954482390e-02 6.175360648954482390e-02 6.175360648954482390e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 7.536482784464486329e-02 7.536482784464486329e-02 7.536482784464486329e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 -3.906250000000000000e-01 6.057592873280422119e-02 6.057592873280422119e-02 6.057592873280422119e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 9.184072658200366501e-02 9.184072658200366501e-02 9.184072658200366501e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 8.157055988530081958e-02 8.157055988530081958e-02 8.157055988530081958e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 1.032626274457310867e-01 1.032626274457310867e-01 1.032626274457310867e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -3.281250000000000000e-01 7.745995592277710173e-02 7.745995592277710173e-02 7.745995592277710173e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 8.624570168405489012e-02 8.624570168405489012e-02 8.624570168405489012e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 9.171455751356094588e-02 9.171455751356094588e-02 9.171455751356094588e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 -2.968750000000000000e-01 1.214448059616491798e-01 1.214448059616491798e-01 1.214448059616491798e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 1.283475104444523340e-01 1.283475104444523340e-01 1.283475104444523340e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -2.968750000000000000e-01 1.127804430590434587e-01 1.127804430590434587e-01 1.127804430590434587e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 1.183021240349405034e-01 1.183021240349405034e-01 1.183021240349405034e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -2.968750000000000000e-01 1.111985036106867136e-01 1.111985036106867136e-01 1.111985036106867136e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 1.192219656800471012e-01 1.192219656800471012e-01 1.192219656800471012e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 1.080433694802469813e-01 1.080433694802469813e-01 1.080433694802469813e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -3.593750000000000000e-01 9.640518147532690929e-02 9.640518147532690929e-02 9.640518147532690929e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 -3.281250000000000000e-01 6.467517620146560897e-02 6.467517620146560897e-02 6.467517620146560897e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 9.623000118938034031e-02 9.623000118938034031e-02 9.623000118938034031e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 -2.656250000000000000e-01 1.116942188105956163e-01 1.116942188105956163e-01 1.116942188105956163e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 7.705308770139344954e-02 7.705308770139344954e-02 7.705308770139344954e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 7.632133058980983265e-02 7.632133058980983265e-02 7.632133058980983265e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 9.566990386256081502e-02 9.566990386256081502e-02 9.566990386256081502e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 -2.656250000000000000e-01 1.139036092193735777e-01 1.139036092193735777e-01 1.139036092193735777e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 7.772077810765713746e-02 7.772077810765713746e-02 7.772077810765713746e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 1.669083766335139607e-01 1.669083766335139607e-01 1.669083766335139607e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 2.303081813222456614e-02 2.303081813222456614e-02 2.303081813222456614e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 5.998503333711813212e-02 5.998503333711813212e-02 5.998503333711813212e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 4.113801729054704370e-02 4.113801729054704370e-02 4.113801729054704370e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 8.218781954676396273e-02 8.218781954676396273e-02 8.218781954676396273e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 1.051195174629742379e-01 1.051195174629742379e-01 1.051195174629742379e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 6.598567581094347267e-02 6.598567581094347267e-02 6.598567581094347267e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 7.119739754994641734e-02 7.119739754994641734e-02 7.119739754994641734e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 -3.593750000000000000e-01 9.624526921112307176e-02 9.624526921112307176e-02 9.624526921112307176e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 -3.281250000000000000e-01 8.433613558499868101e-02 8.433613558499868101e-02 8.433613558499868101e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 -3.593750000000000000e-01 7.313878490741039518e-02 7.313878490741039518e-02 7.313878490741039518e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 -3.281250000000000000e-01 5.032878568756096738e-02 5.032878568756096738e-02 5.032878568756096738e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -3.593750000000000000e-01 4.503707176207451951e-02 4.503707176207451951e-02 4.503707176207451951e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 6.222623237000497742e-02 6.222623237000497742e-02 6.222623237000497742e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 6.696841592879067273e-02 6.696841592879067273e-02 6.696841592879067273e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 9.565383214571486492e-02 9.565383214571486492e-02 9.565383214571486492e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 -2.656250000000000000e-01 1.043714635066640278e-01 1.043714635066640278e-01 1.043714635066640278e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 5.444037404831943150e-02 5.444037404831943150e-02 5.444037404831943150e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 6.900106222312082926e-02 6.900106222312082926e-02 6.900106222312082926e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 6.649975690363239822e-02 6.649975690363239822e-02 6.649975690363239822e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 9.174027351809171948e-02 9.174027351809171948e-02 9.174027351809171948e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 6.435876234940678120e-02 6.435876234940678120e-02 6.435876234940678120e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 5.537413152744747463e-02 5.537413152744747463e-02 5.537413152744747463e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -3.906250000000000000e-01 8.691918261972704507e-02 8.691918261972704507e-02 8.691918261972704507e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 -3.593750000000000000e-01 7.295945450973741198e-02 7.295945450973741198e-02 7.295945450973741198e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 7.267064411373565236e-02 7.267064411373565236e-02 7.267064411373565236e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -3.593750000000000000e-01 9.662375450823484924e-02 9.662375450823484924e-02 9.662375450823484924e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 1.086250739987733582e-01 1.086250739987733582e-01 1.086250739987733582e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 9.005344693262469502e-02 9.005344693262469502e-02 9.005344693262469502e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 5.927354128558294522e-02 5.927354128558294522e-02 5.927354128558294522e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 6.544779636154444968e-02 6.544779636154444968e-02 6.544779636154444968e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 5.808778761331952895e-02 5.808778761331952895e-02 5.808778761331952895e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 8.069529685617675419e-02 8.069529685617675419e-02 8.069529685617675419e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 9.271988644502592025e-02 9.271988644502592025e-02 9.271988644502592025e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 6.205467568658659672e-02 6.205467568658659672e-02 6.205467568658659672e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 5.626607125000426118e-02 5.626607125000426118e-02 5.626607125000426118e-02 -2.031250000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 6.347181617633640416e-02 6.347181617633640416e-02 6.347181617633640416e-02 -2.031250000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 5.536898600189615188e-02 5.536898600189615188e-02 5.536898600189615188e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 5.123436944909200152e-02 5.123436944909200152e-02 5.123436944909200152e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 5.520272103032211608e-02 5.520272103032211608e-02 5.520272103032211608e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 6.648038346150419997e-02 6.648038346150419997e-02 6.648038346150419997e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 7.512312825031146335e-02 7.512312825031146335e-02 7.512312825031146335e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 -3.906250000000000000e-01 6.429187796119385789e-02 6.429187796119385789e-02 6.429187796119385789e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 6.633464036347262727e-02 6.633464036347262727e-02 6.633464036347262727e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 5.378857049426507414e-02 5.378857049426507414e-02 5.378857049426507414e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 7.964754063866744116e-02 7.964754063866744116e-02 7.964754063866744116e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 5.627322666660616868e-02 5.627322666660616868e-02 5.627322666660616868e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 4.192196041055079592e-02 4.192196041055079592e-02 4.192196041055079592e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 5.557070643694678180e-02 5.557070643694678180e-02 5.557070643694678180e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 6.653729795871725361e-02 6.653729795871725361e-02 6.653729795871725361e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 6.138991018127312738e-02 6.138991018127312738e-02 6.138991018127312738e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 7.059251302509471360e-02 7.059251302509471360e-02 7.059251302509471360e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 4.836650515799101324e-02 4.836650515799101324e-02 4.836650515799101324e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 5.582492652794002891e-02 5.582492652794002891e-02 5.582492652794002891e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 5.187751024536185751e-02 5.187751024536185751e-02 5.187751024536185751e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 4.846958537539620276e-02 4.846958537539620276e-02 4.846958537539620276e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 -3.593750000000000000e-01 5.433424628544761270e-02 5.433424628544761270e-02 5.433424628544761270e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 8.177309873373203586e-02 8.177309873373203586e-02 8.177309873373203586e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 7.901892858364031880e-02 7.901892858364031880e-02 7.901892858364031880e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 -3.593750000000000000e-01 3.507231180189804981e-02 3.507231180189804981e-02 3.507231180189804981e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 5.841885816444966628e-02 5.841885816444966628e-02 5.841885816444966628e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 7.451152134442019792e-02 7.451152134442019792e-02 7.451152134442019792e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 9.004942872321973490e-02 9.004942872321973490e-02 9.004942872321973490e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 6.964896446986418299e-02 6.964896446986418299e-02 6.964896446986418299e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 4.934061598000166055e-02 4.934061598000166055e-02 4.934061598000166055e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 6.242166505331672721e-02 6.242166505331672721e-02 6.242166505331672721e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 7.324102958095862759e-02 7.324102958095862759e-02 7.324102958095862759e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 8.557703723026943710e-02 8.557703723026943710e-02 8.557703723026943710e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.151512854331204899e-01 1.151512854331204899e-01 1.151512854331204899e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 6.494062202497587200e-02 6.494062202497587200e-02 6.494062202497587200e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 5.874518402091425534e-02 5.874518402091425534e-02 5.874518402091425534e-02 -2.343750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 1.019585202616306169e-01 1.019585202616306169e-01 1.019585202616306169e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.285756358022651369e-01 1.285756358022651369e-01 1.285756358022651369e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.195184014891578633e-01 1.195184014891578633e-01 1.195184014891578633e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 8.653743695810615921e-02 8.653743695810615921e-02 8.653743695810615921e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.181237779747581762e-01 1.181237779747581762e-01 1.181237779747581762e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 5.216760132361903529e-02 5.216760132361903529e-02 5.216760132361903529e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 1.157192810091674517e-01 1.157192810091674517e-01 1.157192810091674517e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 1.199048107550027553e-01 1.199048107550027553e-01 1.199048107550027553e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 1.500149257162576577e-01 1.500149257162576577e-01 1.500149257162576577e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 7.452285488304272176e-02 7.452285488304272176e-02 7.452285488304272176e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 8.518965936732339483e-02 8.518965936732339483e-02 8.518965936732339483e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 7.375562697937014522e-02 7.375562697937014522e-02 7.375562697937014522e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 1.024703627548588375e-01 1.024703627548588375e-01 1.024703627548588375e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 8.580528389451916316e-02 8.580528389451916316e-02 8.580528389451916316e-02 -1.093750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.289475430093335317e-01 1.289475430093335317e-01 1.289475430093335317e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.159908248607110226e-01 1.159908248607110226e-01 1.159908248607110226e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.126157428403548738e-01 1.126157428403548738e-01 1.126157428403548738e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 5.160912682518106059e-02 5.160912682518106059e-02 5.160912682518106059e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 9.616892907341699492e-02 9.616892907341699492e-02 9.616892907341699492e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.132496359800150565e-01 1.132496359800150565e-01 1.132496359800150565e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 1.505634023122571774e-01 1.505634023122571774e-01 1.505634023122571774e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 1.293403329876871843e-01 1.293403329876871843e-01 1.293403329876871843e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 1.785989862655870952e-01 1.785989862655870952e-01 1.785989862655870952e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.040926489208720968e-01 1.040926489208720968e-01 1.040926489208720968e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 8.216451165079018126e-02 8.216451165079018126e-02 8.216451165079018126e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 1.732387933194176055e-01 1.732387933194176055e-01 1.732387933194176055e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.676381862796020306e-01 1.676381862796020306e-01 1.676381862796020306e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 1.290415236081244588e-01 1.290415236081244588e-01 1.290415236081244588e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 1.921853189794185679e-01 1.921853189794185679e-01 1.921853189794185679e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 9.615205387530154080e-02 9.615205387530154080e-02 9.615205387530154080e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 1.546860920631249192e-01 1.546860920631249192e-01 1.546860920631249192e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 1.458903904205257618e-01 1.458903904205257618e-01 1.458903904205257618e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 1.077404636665379167e-01 1.077404636665379167e-01 1.077404636665379167e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 1.808868137056671710e-01 1.808868137056671710e-01 1.808868137056671710e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 1.523702167740463853e-01 1.523702167740463853e-01 1.523702167740463853e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 7.930490306955755020e-02 7.930490306955755020e-02 7.930490306955755020e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 7.495682371799802790e-02 7.495682371799802790e-02 7.495682371799802790e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 8.642331474546849357e-02 8.642331474546849357e-02 8.642331474546849357e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 1.108353521255531771e-01 1.108353521255531771e-01 1.108353521255531771e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.504549921541930291e-01 1.504549921541930291e-01 1.504549921541930291e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 9.221119639748355523e-02 9.221119639748355523e-02 9.221119639748355523e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.398493634393734308e-01 1.398493634393734308e-01 1.398493634393734308e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.086588191594611008e-01 1.086588191594611008e-01 1.086588191594611008e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 1.613868189595473734e-01 1.613868189595473734e-01 1.613868189595473734e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 1.457313795698270131e-01 1.457313795698270131e-01 1.457313795698270131e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 1.455579128288189972e-01 1.455579128288189972e-01 1.455579128288189972e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.354729094070379614e-01 1.354729094070379614e-01 1.354729094070379614e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 8.505785402601924450e-02 8.505785402601924450e-02 8.505785402601924450e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 4.494966695243429039e-02 4.494966695243429039e-02 4.494966695243429039e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 7.742989500644205381e-02 7.742989500644205381e-02 7.742989500644205381e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 9.858284951738818802e-02 9.858284951738818802e-02 9.858284951738818802e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 7.794735915911765733e-02 7.794735915911765733e-02 7.794735915911765733e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 1.106553826405150820e-01 1.106553826405150820e-01 1.106553826405150820e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 9.057500881065039255e-02 9.057500881065039255e-02 9.057500881065039255e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 4.439500408144468890e-01 4.439500408144468890e-01 4.439500408144468890e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 6.584797065395774085e-02 6.584797065395774085e-02 6.584797065395774085e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 -2.343750000000000000e-01 1.162543339942479492e-01 1.162543339942479492e-01 1.162543339942479492e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 1.190163076748177173e-01 1.190163076748177173e-01 1.190163076748177173e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 1.092726572309032640e-01 1.092726572309032640e-01 1.092726572309032640e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 1.214094595060022097e-01 1.214094595060022097e-01 1.214094595060022097e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 9.378145515780114683e-02 9.378145515780114683e-02 9.378145515780114683e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 1.028335519994673514e-01 1.028335519994673514e-01 1.028335519994673514e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 1.270277443582386590e-01 1.270277443582386590e-01 1.270277443582386590e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 1.361805151908865585e-01 1.361805151908865585e-01 1.361805151908865585e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 1.375507307175588001e-01 1.375507307175588001e-01 1.375507307175588001e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -2.343750000000000000e-01 1.110193383704523584e-01 1.110193383704523584e-01 1.110193383704523584e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -2.031250000000000000e-01 1.212327269948143410e-01 1.212327269948143410e-01 1.212327269948143410e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -2.343750000000000000e-01 1.343869914918945641e-01 1.343869914918945641e-01 1.343869914918945641e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 1.874874333056398001e-01 1.874874333056398001e-01 1.874874333056398001e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 -2.343750000000000000e-01 1.170898450525248158e-01 1.170898450525248158e-01 1.170898450525248158e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 -2.031250000000000000e-01 1.351709100380215911e-01 1.351709100380215911e-01 1.351709100380215911e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -2.343750000000000000e-01 9.561445642584259774e-02 9.561445642584259774e-02 9.561445642584259774e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 1.362311155930667761e-01 1.362311155930667761e-01 1.362311155930667761e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 1.301564303697095304e-01 1.301564303697095304e-01 1.301564303697095304e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 1.703012528940480719e-01 1.703012528940480719e-01 1.703012528940480719e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 1.218022862880789869e-01 1.218022862880789869e-01 1.218022862880789869e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 1.163804645850650965e-01 1.163804645850650965e-01 1.163804645850650965e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 1.653612225203774933e-01 1.653612225203774933e-01 1.653612225203774933e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 1.334472430041770685e-01 1.334472430041770685e-01 1.334472430041770685e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 9.890427154259910647e-02 9.890427154259910647e-02 9.890427154259910647e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 9.153293799756787030e-02 9.153293799756787030e-02 9.153293799756787030e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 1.448752854476400009e-01 1.448752854476400009e-01 1.448752854476400009e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 9.250692812774054252e-02 9.250692812774054252e-02 9.250692812774054252e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.435092102013575399e-01 1.435092102013575399e-01 1.435092102013575399e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 1.501329729714315775e-01 1.501329729714315775e-01 1.501329729714315775e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 1.877563270387629935e-01 1.877563270387629935e-01 1.877563270387629935e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 1.819913695614185367e-01 1.819913695614185367e-01 1.819913695614185367e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 1.938940837806771567e-01 1.938940837806771567e-01 1.938940837806771567e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.691371254837306659e-01 1.691371254837306659e-01 1.691371254837306659e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.578899843757921584e-01 1.578899843757921584e-01 1.578899843757921584e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 1.922904624363618031e-01 1.922904624363618031e-01 1.922904624363618031e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.398180407933230784e-01 1.398180407933230784e-01 1.398180407933230784e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 -2.343750000000000000e-01 1.309090640231744263e-01 1.309090640231744263e-01 1.309090640231744263e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -2.343750000000000000e-01 1.049379282052224915e-01 1.049379282052224915e-01 1.049379282052224915e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 1.312399956956545877e-01 1.312399956956545877e-01 1.312399956956545877e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.349026436903222048e-01 1.349026436903222048e-01 1.349026436903222048e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.193633552537082254e-01 1.193633552537082254e-01 1.193633552537082254e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.582818301177228992e-01 1.582818301177228992e-01 1.582818301177228992e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 1.868380713011021377e-01 1.868380713011021377e-01 1.868380713011021377e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 1.700451463090014992e-01 1.700451463090014992e-01 1.700451463090014992e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 1.471937856993192628e-01 1.471937856993192628e-01 1.471937856993192628e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 9.877248866757762369e-02 9.877248866757762369e-02 9.877248866757762369e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 2.045062335674764364e-01 2.045062335674764364e-01 2.045062335674764364e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.880637477281171810e-01 1.880637477281171810e-01 1.880637477281171810e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.758944494975017148e-01 1.758944494975017148e-01 1.758944494975017148e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 6.619243407455276118e-02 6.619243407455276118e-02 6.619243407455276118e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 1.724263441120600648e-01 1.724263441120600648e-01 1.724263441120600648e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 1.558520345589007872e-01 1.558520345589007872e-01 1.558520345589007872e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 1.921106750677847308e-01 1.921106750677847308e-01 1.921106750677847308e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 1.670657398893194701e-01 1.670657398893194701e-01 1.670657398893194701e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 8.415369571118191949e-02 8.415369571118191949e-02 8.415369571118191949e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 9.294088032925361398e-02 9.294088032925361398e-02 9.294088032925361398e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 7.836547547954601789e-02 7.836547547954601789e-02 7.836547547954601789e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 8.206163533961534362e-02 8.206163533961534362e-02 8.206163533961534362e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 6.571701789548943518e-02 6.571701789548943518e-02 6.571701789548943518e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 1.592638449757019792e-01 1.592638449757019792e-01 1.592638449757019792e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 1.686674555183428348e-01 1.686674555183428348e-01 1.686674555183428348e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 1.031067463684897101e-01 1.031067463684897101e-01 1.031067463684897101e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 8.063260547488788899e-02 8.063260547488788899e-02 8.063260547488788899e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 6.438239696368645848e-02 6.438239696368645848e-02 6.438239696368645848e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 1.019191476272832131e-01 1.019191476272832131e-01 1.019191476272832131e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 1.740070801309969439e-01 1.740070801309969439e-01 1.740070801309969439e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 1.234314124711256150e-01 1.234314124711256150e-01 1.234314124711256150e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 1.780796002382014631e-01 1.780796002382014631e-01 1.780796002382014631e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 1.805157298537483912e-02 1.805157298537483912e-02 1.805157298537483912e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 1.267731065354453235e-01 1.267731065354453235e-01 1.267731065354453235e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 1.440553218422574722e-01 1.440553218422574722e-01 1.440553218422574722e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 2.003684401166783424e-01 2.003684401166783424e-01 2.003684401166783424e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 1.699881444189762225e-01 1.699881444189762225e-01 1.699881444189762225e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 1.961220852062280084e-01 1.961220852062280084e-01 1.961220852062280084e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 1.512748905390719767e-01 1.512748905390719767e-01 1.512748905390719767e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.417415498988763012e-01 1.417415498988763012e-01 1.417415498988763012e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 5.770421679868197734e-02 5.770421679868197734e-02 5.770421679868197734e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.414749117162500958e-01 1.414749117162500958e-01 1.414749117162500958e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.080586352602978112e-01 1.080586352602978112e-01 1.080586352602978112e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.106184245714330189e-01 1.106184245714330189e-01 1.106184245714330189e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 1.301797243663831427e-01 1.301797243663831427e-01 1.301797243663831427e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 1.680018843246564031e-01 1.680018843246564031e-01 1.680018843246564031e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 6.469856955422441380e-02 6.469856955422441380e-02 6.469856955422441380e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.522385214465171721e-01 1.522385214465171721e-01 1.522385214465171721e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.696421179944763158e-01 1.696421179944763158e-01 1.696421179944763158e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 7.994468491648662467e-02 7.994468491648662467e-02 7.994468491648662467e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 1.137822951748444222e-01 1.137822951748444222e-01 1.137822951748444222e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 8.236463784801797972e-02 8.236463784801797972e-02 8.236463784801797972e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 8.561802523528191933e-02 8.561802523528191933e-02 8.561802523528191933e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 9.574624447377552694e-02 9.574624447377552694e-02 9.574624447377552694e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 8.525234719777415038e-02 8.525234719777415038e-02 8.525234719777415038e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 1.071812499373588634e-01 1.071812499373588634e-01 1.071812499373588634e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 1.188660805965520706e-01 1.188660805965520706e-01 1.188660805965520706e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 1.186829156510357391e-01 1.186829156510357391e-01 1.186829156510357391e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 9.619223291260946274e-02 9.619223291260946274e-02 9.619223291260946274e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.545664454929621956e-01 1.545664454929621956e-01 1.545664454929621956e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.501795493918113567e-01 1.501795493918113567e-01 1.501795493918113567e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.962175925337505400e-01 1.962175925337505400e-01 1.962175925337505400e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 7.577990320566216353e-02 7.577990320566216353e-02 7.577990320566216353e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 5.832752849332530076e-02 5.832752849332530076e-02 5.832752849332530076e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 8.541228131318820416e-02 8.541228131318820416e-02 8.541228131318820416e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 7.173893615595122730e-02 7.173893615595122730e-02 7.173893615595122730e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 7.422327917990267920e-02 7.422327917990267920e-02 7.422327917990267920e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 9.595678346829193683e-02 9.595678346829193683e-02 9.595678346829193683e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 8.648278690464171470e-02 8.648278690464171470e-02 8.648278690464171470e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.016676444266524648e-01 1.016676444266524648e-01 1.016676444266524648e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 1.100905650798097157e-01 1.100905650798097157e-01 1.100905650798097157e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.165805056898417680e-01 1.165805056898417680e-01 1.165805056898417680e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 2.026876462593805994e-02 2.026876462593805994e-02 2.026876462593805994e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.077059146551136021e-01 1.077059146551136021e-01 1.077059146551136021e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 5.938022529702526031e-02 5.938022529702526031e-02 5.938022529702526031e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 1.078553591094323361e-01 1.078553591094323361e-01 1.078553591094323361e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 9.574142296364274163e-02 9.574142296364274163e-02 9.574142296364274163e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 1.213106500135085475e-01 1.213106500135085475e-01 1.213106500135085475e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 7.203482352930197508e-02 7.203482352930197508e-02 7.203482352930197508e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 8.354931044253802175e-02 8.354931044253802175e-02 8.354931044253802175e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 9.872990025328841346e-02 9.872990025328841346e-02 9.872990025328841346e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 7.970219533529988853e-02 7.970219533529988853e-02 7.970219533529988853e-02 -2.031250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 7.405150693601854350e-02 7.405150693601854350e-02 7.405150693601854350e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 7.495433196067886883e-02 7.495433196067886883e-02 7.495433196067886883e-02 -2.031250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 7.325967796653384823e-02 7.325967796653384823e-02 7.325967796653384823e-02 -2.031250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 9.822365888492481933e-02 9.822365888492481933e-02 9.822365888492481933e-02 -2.031250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 8.849034832640079173e-02 8.849034832640079173e-02 8.849034832640079173e-02 -2.343750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 7.171136495977373237e-02 7.171136495977373237e-02 7.171136495977373237e-02 -2.343750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 6.865805776755649903e-02 6.865805776755649903e-02 6.865805776755649903e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 8.684122628441946767e-02 8.684122628441946767e-02 8.684122628441946767e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.189930104457621735e-01 1.189930104457621735e-01 1.189930104457621735e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 6.809125718378633563e-02 6.809125718378633563e-02 6.809125718378633563e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 7.041454347644265921e-02 7.041454347644265921e-02 7.041454347644265921e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 7.251824054781680351e-02 7.251824054781680351e-02 7.251824054781680351e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 5.371363726913921943e-02 5.371363726913921943e-02 5.371363726913921943e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 7.160855566396244487e-02 7.160855566396244487e-02 7.160855566396244487e-02 -2.031250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 8.686855119406272641e-02 8.686855119406272641e-02 8.686855119406272641e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 6.358581016843929679e-02 6.358581016843929679e-02 6.358581016843929679e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 4.102455438034192242e-02 4.102455438034192242e-02 4.102455438034192242e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 9.091012459679842506e-02 9.091012459679842506e-02 9.091012459679842506e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.324817805623907940e-01 1.324817805623907940e-01 1.324817805623907940e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 6.192862068325744040e-02 6.192862068325744040e-02 6.192862068325744040e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 9.309678110422293928e-02 9.309678110422293928e-02 9.309678110422293928e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.160253703145568416e-01 1.160253703145568416e-01 1.160253703145568416e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.062652880181296916e-01 1.062652880181296916e-01 1.062652880181296916e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.053661889397661394e-01 1.053661889397661394e-01 1.053661889397661394e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.089336006552517333e-01 1.089336006552517333e-01 1.089336006552517333e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.027082036844029350e-01 1.027082036844029350e-01 1.027082036844029350e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.260373031241020514e-01 1.260373031241020514e-01 1.260373031241020514e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 4.949820935871140914e-02 4.949820935871140914e-02 4.949820935871140914e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 7.086493267828675169e-02 7.086493267828675169e-02 7.086493267828675169e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 4.329571204373789534e-02 4.329571204373789534e-02 4.329571204373789534e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 8.374219985134892519e-02 8.374219985134892519e-02 8.374219985134892519e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 7.496285216282423669e-02 7.496285216282423669e-02 7.496285216282423669e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 7.668150317211333555e-02 7.668150317211333555e-02 7.668150317211333555e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.142338074471684617e-01 1.142338074471684617e-01 1.142338074471684617e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.771363481059488043e-01 1.771363481059488043e-01 1.771363481059488043e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 5.470762243105540407e-02 5.470762243105540407e-02 5.470762243105540407e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.064902620872086453e-01 1.064902620872086453e-01 1.064902620872086453e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.048093691908755093e-01 1.048093691908755093e-01 1.048093691908755093e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.170536933113345140e-01 1.170536933113345140e-01 1.170536933113345140e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 9.393574709780831700e-02 9.393574709780831700e-02 9.393574709780831700e-02 -2.343750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 8.668611706271141248e-02 8.668611706271141248e-02 8.668611706271141248e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.265441727890974088e-01 1.265441727890974088e-01 1.265441727890974088e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.193103341926925326e-01 1.193103341926925326e-01 1.193103341926925326e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 7.636039424174445589e-02 7.636039424174445589e-02 7.636039424174445589e-02 -2.031250000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.283932962195511451e-01 1.283932962195511451e-01 1.283932962195511451e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.278575206933463548e-01 1.278575206933463548e-01 1.278575206933463548e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.274542809875872651e-01 1.274542809875872651e-01 1.274542809875872651e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.439557370546967752e-01 1.439557370546967752e-01 1.439557370546967752e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.858299043304328380e-01 1.858299043304328380e-01 1.858299043304328380e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 5.396247641195203726e-02 5.396247641195203726e-02 5.396247641195203726e-02 -2.031250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.140401877261189023e-01 1.140401877261189023e-01 1.140401877261189023e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.179293642515780310e-01 1.179293642515780310e-01 1.179293642515780310e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.252645416415965052e-01 1.252645416415965052e-01 1.252645416415965052e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.559042285592478205e-01 1.559042285592478205e-01 1.559042285592478205e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.528118763597627605e-01 1.528118763597627605e-01 1.528118763597627605e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.153344584190603012e-01 1.153344584190603012e-01 1.153344584190603012e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.160936577960001159e-01 1.160936577960001159e-01 1.160936577960001159e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 9.574865522874247137e-02 9.574865522874247137e-02 9.574865522874247137e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 1.435453500568508178e-01 1.435453500568508178e-01 1.435453500568508178e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.083020838876350839e-01 1.083020838876350839e-01 1.083020838876350839e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 8.973038225537162405e-02 8.973038225537162405e-02 8.973038225537162405e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 9.565061780196040808e-02 9.565061780196040808e-02 9.565061780196040808e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.194918910141160723e-01 1.194918910141160723e-01 1.194918910141160723e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.528680874058349626e-01 1.528680874058349626e-01 1.528680874058349626e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.143840431752291414e-01 1.143840431752291414e-01 1.143840431752291414e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.394582310615914145e-01 1.394582310615914145e-01 1.394582310615914145e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.205490898530619387e-01 1.205490898530619387e-01 1.205490898530619387e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.063046585256406940e-01 1.063046585256406940e-01 1.063046585256406940e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.711915982833374927e-01 1.711915982833374927e-01 1.711915982833374927e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 9.461398524154759904e-02 9.461398524154759904e-02 9.461398524154759904e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.493660642414962325e-01 1.493660642414962325e-01 1.493660642414962325e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 6.138669446829871784e-02 6.138669446829871784e-02 6.138669446829871784e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.129371088078251484e-01 1.129371088078251484e-01 1.129371088078251484e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 9.878052421492181101e-02 9.878052421492181101e-02 9.878052421492181101e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 4.538588596292632282e-02 4.538588596292632282e-02 4.538588596292632282e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 7.660884183924025759e-02 7.660884183924025759e-02 7.660884183924025759e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 6.206649333303793786e-02 6.206649333303793786e-02 6.206649333303793786e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 8.972073851372740216e-02 8.972073851372740216e-02 8.972073851372740216e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.519992208483775253e-01 1.519992208483775253e-01 1.519992208483775253e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 6.821424786384429340e-02 6.821424786384429340e-02 6.821424786384429340e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 8.027437955521066204e-02 8.027437955521066204e-02 8.027437955521066204e-02 -2.343750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 8.025862625849851384e-02 8.025862625849851384e-02 8.025862625849851384e-02 -2.343750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 8.651011193602312077e-02 8.651011193602312077e-02 8.651011193602312077e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 6.746070593392808346e-02 6.746070593392808346e-02 6.746070593392808346e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 6.717653824657965345e-02 6.717653824657965345e-02 6.717653824657965345e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 5.075484469963011114e-02 5.075484469963011114e-02 5.075484469963011114e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.143486936173950946e-01 1.143486936173950946e-01 1.143486936173950946e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.004310086264093571e-01 1.004310086264093571e-01 1.004310086264093571e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 6.118531018709646302e-02 6.118531018709646302e-02 6.118531018709646302e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.397610174833260055e-01 1.397610174833260055e-01 1.397610174833260055e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 7.031076791654547464e-02 7.031076791654547464e-02 7.031076791654547464e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.163033401708621906e-01 1.163033401708621906e-01 1.163033401708621906e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.082362001734109014e-01 1.082362001734109014e-01 1.082362001734109014e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.086483742302794125e-01 1.086483742302794125e-01 1.086483742302794125e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.100423585609672794e-01 1.100423585609672794e-01 1.100423585609672794e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 9.192671430507842745e-02 9.192671430507842745e-02 9.192671430507842745e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 8.825889464041450361e-02 8.825889464041450361e-02 8.825889464041450361e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 6.143034776096704258e-02 6.143034776096704258e-02 6.143034776096704258e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 6.317766591177947921e-02 6.317766591177947921e-02 6.317766591177947921e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 7.534891282882626162e-02 7.534891282882626162e-02 7.534891282882626162e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 6.559313912301190097e-02 6.559313912301190097e-02 6.559313912301190097e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.658124454231844902e-01 1.658124454231844902e-01 1.658124454231844902e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.473817041642215553e-01 1.473817041642215553e-01 1.473817041642215553e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 2.427980099082470145e-01 2.427980099082470145e-01 2.427980099082470145e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.588920778825709534e-01 1.588920778825709534e-01 1.588920778825709534e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 2.539137894198119083e-01 2.539137894198119083e-01 2.539137894198119083e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 5.735617957244765891e-02 5.735617957244765891e-02 5.735617957244765891e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 6.040396656129841391e-02 6.040396656129841391e-02 6.040396656129841391e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 8.579563968235877358e-02 8.579563968235877358e-02 8.579563968235877358e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.278671598647612151e-01 1.278671598647612151e-01 1.278671598647612151e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.262148283622095690e-01 1.262148283622095690e-01 1.262148283622095690e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.421198212262108629e-01 1.421198212262108629e-01 1.421198212262108629e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.140835714385653454e-01 1.140835714385653454e-01 1.140835714385653454e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 4.185907798437780297e-02 4.185907798437780297e-02 4.185907798437780297e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.063850064403447510e-01 1.063850064403447510e-01 1.063850064403447510e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.125627173323457270e-01 1.125627173323457270e-01 1.125627173323457270e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.229486225989538661e-01 1.229486225989538661e-01 1.229486225989538661e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.264815171239304370e-01 1.264815171239304370e-01 1.264815171239304370e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.878967935569279546e-01 1.878967935569279546e-01 1.878967935569279546e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.938282701202644620e-01 1.938282701202644620e-01 1.938282701202644620e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.384591081006844859e-01 1.384591081006844859e-01 1.384591081006844859e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.055148342527804928e-01 1.055148342527804928e-01 1.055148342527804928e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.573977656062585107e-01 1.573977656062585107e-01 1.573977656062585107e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.036434902506110506e-01 1.036434902506110506e-01 1.036434902506110506e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.687991239561628665e-01 1.687991239561628665e-01 1.687991239561628665e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.175308949870982334e-01 1.175308949870982334e-01 1.175308949870982334e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 9.038374306001470404e-02 9.038374306001470404e-02 9.038374306001470404e-02 -2.343750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.154485396293756794e-01 1.154485396293756794e-01 1.154485396293756794e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 7.292191645120213450e-02 7.292191645120213450e-02 7.292191645120213450e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 7.621499055234384756e-02 7.621499055234384756e-02 7.621499055234384756e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.412082726499389318e-01 1.412082726499389318e-01 1.412082726499389318e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.003876175513969543e-01 1.003876175513969543e-01 1.003876175513969543e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 3.339362548165750177e-02 3.339362548165750177e-02 3.339362548165750177e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 7.591276866564342085e-02 7.591276866564342085e-02 7.591276866564342085e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 8.022446731370026785e-02 8.022446731370026785e-02 8.022446731370026785e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.235013002824426609e-01 1.235013002824426609e-01 1.235013002824426609e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.162382663888702761e-01 1.162382663888702761e-01 1.162382663888702761e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.500823813118541961e-01 1.500823813118541961e-01 1.500823813118541961e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 6.043805352866656044e-02 6.043805352866656044e-02 6.043805352866656044e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.054409133746793681e-01 1.054409133746793681e-01 1.054409133746793681e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.151392345641640835e-01 1.151392345641640835e-01 1.151392345641640835e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.101106511208084643e-01 1.101106511208084643e-01 1.101106511208084643e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 -3.281250000000000000e-01 7.878399150425648145e-02 7.878399150425648145e-02 7.878399150425648145e-02 -2.656250000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 9.459871691021043416e-02 9.459871691021043416e-02 9.459871691021043416e-02 -2.656250000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.107734876604786339e-01 1.107734876604786339e-01 1.107734876604786339e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 5.796132441328403356e-02 5.796132441328403356e-02 5.796132441328403356e-02 -2.968750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 8.658726491567049488e-02 8.658726491567049488e-02 8.658726491567049488e-02 -2.656250000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 7.128421116837380112e-02 7.128421116837380112e-02 7.128421116837380112e-02 -2.656250000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 8.216451165079018126e-02 8.216451165079018126e-02 8.216451165079018126e-02 -2.968750000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 6.683786693091919862e-02 6.683786693091919862e-02 6.683786693091919862e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 6.508315208308261546e-02 6.508315208308261546e-02 6.508315208308261546e-02 -2.968750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 7.708081782132233939e-02 7.708081782132233939e-02 7.708081782132233939e-02 -2.968750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 7.403993219044528729e-02 7.403993219044528729e-02 7.403993219044528729e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 8.517037079427139390e-02 8.517037079427139390e-02 8.517037079427139390e-02 -3.281250000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 1.512524056800958749e-01 1.512524056800958749e-01 1.512524056800958749e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 1.870724522582542237e-01 1.870724522582542237e-01 1.870724522582542237e-01 -3.593750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 7.784391482067709589e-02 7.784391482067709589e-02 7.784391482067709589e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 1.136336651358303695e-01 1.136336651358303695e-01 1.136336651358303695e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 6.856087156619747325e-02 6.856087156619747325e-02 6.856087156619747325e-02 -2.968750000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 9.642125304208226666e-02 9.642125304208226666e-02 9.642125304208226666e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 9.937434894216370940e-02 9.937434894216370940e-02 9.937434894216370940e-02 -2.656250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 8.928435799448244947e-02 8.928435799448244947e-02 8.928435799448244947e-02 -2.968750000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 1.595946600374432700e-01 1.595946600374432700e-01 1.595946600374432700e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 1.087921927512336823e-01 1.087921927512336823e-01 1.087921927512336823e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.345227320328408749e-01 1.345227320328408749e-01 1.345227320328408749e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 6.245052570142269749e-02 6.245052570142269749e-02 6.245052570142269749e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 4.228880038760182009e-02 4.228880038760182009e-02 4.228880038760182009e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 3.986900875443005060e-02 3.986900875443005060e-02 3.986900875443005060e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 6.994807490054262555e-02 6.994807490054262555e-02 6.994807490054262555e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 7.314939520976775078e-02 7.314939520976775078e-02 7.314939520976775078e-02 -3.281250000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 1.609259360247842219e-01 1.609259360247842219e-01 1.609259360247842219e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 2.315386998413632436e-01 2.315386998413632436e-01 2.315386998413632436e-01 -3.281250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 1.553533794023885806e-01 1.553533794023885806e-01 1.553533794023885806e-01 -3.281250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 2.306754959088050116e-01 2.306754959088050116e-01 2.306754959088050116e-01 -3.593750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 2.075372168108410020e-01 2.075372168108410020e-01 2.075372168108410020e-01 -3.593750000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 1.102424154253968391e-01 1.102424154253968391e-01 1.102424154253968391e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 1.494399447724376884e-01 1.494399447724376884e-01 1.494399447724376884e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.807391103196583915e-01 1.807391103196583915e-01 1.807391103196583915e-01 -3.593750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 1.155529800321826450e-01 1.155529800321826450e-01 1.155529800321826450e-01 -3.593750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 5.197302815491573746e-02 5.197302815491573746e-02 5.197302815491573746e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 1.516659654738851670e-01 1.516659654738851670e-01 1.516659654738851670e-01 -3.593750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.625847810669865945e-01 1.625847810669865945e-01 1.625847810669865945e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 8.586957861260986757e-02 8.586957861260986757e-02 8.586957861260986757e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 1.204036856695122615e-01 1.204036856695122615e-01 1.204036856695122615e-01 -4.218750000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 9.701750590001859131e-02 9.701750590001859131e-02 9.701750590001859131e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 9.435603041277235148e-02 9.435603041277235148e-02 9.435603041277235148e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.018187071462523519e-01 1.018187071462523519e-01 1.018187071462523519e-01 -3.906250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 1.362801096029577497e-01 1.362801096029577497e-01 1.362801096029577497e-01 -4.218750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 7.698918782340759270e-02 7.698918782340759270e-02 7.698918782340759270e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 9.989183268121627768e-02 9.989183268121627768e-02 9.989183268121627768e-02 -4.218750000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 1.275522796677258930e-01 1.275522796677258930e-01 1.275522796677258930e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 9.374529294156724868e-02 9.374529294156724868e-02 9.374529294156724868e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 9.207538445060862997e-02 9.207538445060862997e-02 9.207538445060862997e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.181767998177278983e-01 1.181767998177278983e-01 1.181767998177278983e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.058804202056100735e-01 1.058804202056100735e-01 1.058804202056100735e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 9.767723605550451826e-02 9.767723605550451826e-02 9.767723605550451826e-02 -2.656250000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.138168415770203085e-01 1.138168415770203085e-01 1.138168415770203085e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.019986963992790541e-01 1.019986963992790541e-01 1.019986963992790541e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 1.450479505677497727e-01 1.450479505677497727e-01 1.450479505677497727e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.156517965961844918e-01 1.156517965961844918e-01 1.156517965961844918e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.347669037903535261e-01 1.347669037903535261e-01 1.347669037903535261e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 1.812351999659800872e-01 1.812351999659800872e-01 1.812351999659800872e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.546933190314547513e-01 1.546933190314547513e-01 1.546933190314547513e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.141494503645692632e-01 1.141494503645692632e-01 1.141494503645692632e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 8.561320311812267714e-02 8.561320311812267714e-02 8.561320311812267714e-02 -2.656250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 8.673514125319335688e-02 8.673514125319335688e-02 8.673514125319335688e-02 -2.968750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.825492608321807597e-01 1.825492608321807597e-01 1.825492608321807597e-01 -2.968750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 1.933033641211225895e-01 1.933033641211225895e-01 1.933033641211225895e-01 -2.968750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.120493321976359369e-01 1.120493321976359369e-01 1.120493321976359369e-01 -3.281250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 8.549023903307020888e-02 8.549023903307020888e-02 8.549023903307020888e-02 -3.281250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 1.116283378741061288e-01 1.116283378741061288e-01 1.116283378741061288e-01 -3.593750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.039174853727899278e-01 1.039174853727899278e-01 1.039174853727899278e-01 -3.593750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 1.432144689961349637e-01 1.432144689961349637e-01 1.432144689961349637e-01 -3.281250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 9.602508798554382219e-02 9.602508798554382219e-02 9.602508798554382219e-02 -3.593750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.283667886687167581e-01 1.283667886687167581e-01 1.283667886687167581e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.071555388678553100e-01 1.071555388678553100e-01 1.071555388678553100e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 9.746429085967717176e-02 9.746429085967717176e-02 9.746429085967717176e-02 -3.281250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 1.641841772012644918e-01 1.641841772012644918e-01 1.641841772012644918e-01 -3.593750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.450423289185110154e-01 1.450423289185110154e-01 1.450423289185110154e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.175911475226955466e-01 1.175911475226955466e-01 1.175911475226955466e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 2.308784619785546888e-01 2.308784619785546888e-01 2.308784619785546888e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 2.453567242770256229e-01 2.453567242770256229e-01 2.453567242770256229e-01 -3.593750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.304857586618229370e-01 1.304857586618229370e-01 1.304857586618229370e-01 -3.593750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 9.734777343850033182e-02 9.734777343850033182e-02 9.734777343850033182e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.433509977540431135e-01 1.433509977540431135e-01 1.433509977540431135e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.016451456994787034e-01 1.016451456994787034e-01 1.016451456994787034e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.256147754161252295e-01 1.256147754161252295e-01 1.256147754161252295e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.121361017462196297e-01 1.121361017462196297e-01 1.121361017462196297e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.089697560453716241e-01 1.089697560453716241e-01 1.089697560453716241e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.080980048902387552e-01 1.080980048902387552e-01 1.080980048902387552e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 8.025340195023057677e-02 8.025340195023057677e-02 8.025340195023057677e-02 -2.656250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 8.135998324035974283e-02 8.135998324035974283e-02 8.135998324035974283e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 9.740563038596350420e-02 9.740563038596350420e-02 9.740563038596350420e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 9.062001245059606025e-02 9.062001245059606025e-02 9.062001245059606025e-02 -2.656250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.151408413468042180e-01 1.151408413468042180e-01 1.151408413468042180e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 9.054607788595712969e-02 9.054607788595712969e-02 9.054607788595712969e-02 -2.656250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.407328176642559103e-01 1.407328176642559103e-01 1.407328176642559103e-01 -2.968750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 8.359512171901016531e-02 8.359512171901016531e-02 8.359512171901016531e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 5.037477669161166682e-02 5.037477669161166682e-02 5.037477669161166682e-02 -3.281250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.038861487345150575e-01 1.038861487345150575e-01 1.038861487345150575e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 8.752836457659947389e-02 8.752836457659947389e-02 8.752836457659947389e-02 -3.593750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 9.787973436040350861e-02 9.787973436040350861e-02 9.787973436040350861e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.314624902538968076e-01 1.314624902538968076e-01 1.314624902538968076e-01 -3.593750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.181302048666729443e-01 1.181302048666729443e-01 1.181302048666729443e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.229863783173423125e-01 1.229863783173423125e-01 1.229863783173423125e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 6.272152587805178425e-02 6.272152587805178425e-02 6.272152587805178425e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.770994205634965346e-01 1.770994205634965346e-01 1.770994205634965346e-01 -3.593750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 6.935314870671849263e-02 6.935314870671849263e-02 6.935314870671849263e-02 -2.968750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 7.673607950619491802e-02 7.673607950619491802e-02 7.673607950619491802e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.081847787004168587e-01 1.081847787004168587e-01 1.081847787004168587e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.441292072501759725e-01 1.441292072501759725e-01 1.441292072501759725e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.317564712897646984e-01 1.317564712897646984e-01 1.317564712897646984e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.717535785784624347e-01 1.717535785784624347e-01 1.717535785784624347e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 3.653938451634607815e-02 3.653938451634607815e-02 3.653938451634607815e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 5.661829386680887477e-02 5.661829386680887477e-02 5.661829386680887477e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 8.665879209112523074e-02 8.665879209112523074e-02 8.665879209112523074e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 7.493592510576871368e-02 7.493592510576871368e-02 7.493592510576871368e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 7.007299196165536759e-02 7.007299196165536759e-02 7.007299196165536759e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 5.298826074607145692e-02 5.298826074607145692e-02 5.298826074607145692e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 5.551515095907478409e-02 5.551515095907478409e-02 5.551515095907478409e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.423334513810763646e-01 1.423334513810763646e-01 1.423334513810763646e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 5.987947564834088243e-02 5.987947564834088243e-02 5.987947564834088243e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 8.562043629375316878e-02 8.562043629375316878e-02 8.562043629375316878e-02 -3.281250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 2.301588526935172130e-01 2.301588526935172130e-01 2.301588526935172130e-01 -3.281250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.172127608510835639e-01 1.172127608510835639e-01 1.172127608510835639e-01 -3.593750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.617666037839567139e-01 1.617666037839567139e-01 1.617666037839567139e-01 -3.593750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 9.345679823436207900e-02 9.345679823436207900e-02 9.345679823436207900e-02 -3.281250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.936661435563971079e-01 1.936661435563971079e-01 1.936661435563971079e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.790814423072509542e-01 1.790814423072509542e-01 1.790814423072509542e-01 -3.281250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 9.700304159727089759e-02 9.700304159727089759e-02 9.700304159727089759e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 8.978342281377889311e-02 8.978342281377889311e-02 8.978342281377889311e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.612174006266393067e-01 1.612174006266393067e-01 1.612174006266393067e-01 -3.281250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 6.493724567536669767e-02 6.493724567536669767e-02 6.493724567536669767e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.205619432489033749e-01 1.205619432489033749e-01 1.205619432489033749e-01 -3.593750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 4.436002374550111066e-02 4.436002374550111066e-02 4.436002374550111066e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 4.904376067519312932e-02 4.904376067519312932e-02 4.904376067519312932e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 8.610264653504215437e-02 8.610264653504215437e-02 8.610264653504215437e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 7.438862067048697402e-02 7.438862067048697402e-02 7.438862067048697402e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 7.892649704002592526e-02 7.892649704002592526e-02 7.892649704002592526e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 6.168438855224801787e-02 6.168438855224801787e-02 6.168438855224801787e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 5.473825463482403370e-02 5.473825463482403370e-02 5.473825463482403370e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 9.077189954958496398e-02 9.077189954958496398e-02 9.077189954958496398e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 5.851131327171796292e-02 5.851131327171796292e-02 5.851131327171796292e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 8.619667719535324679e-02 8.619667719535324679e-02 8.619667719535324679e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 8.172648269473886673e-02 8.172648269473886673e-02 8.172648269473886673e-02 -2.656250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 6.196343053490294822e-02 6.196343053490294822e-02 6.196343053490294822e-02 -2.968750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 9.082654668966591571e-02 9.082654668966591571e-02 9.082654668966591571e-02 -2.968750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 6.681326838912957089e-02 6.681326838912957089e-02 6.681326838912957089e-02 -2.968750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 7.250554023762842415e-02 7.250554023762842415e-02 7.250554023762842415e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 7.377451638699819569e-02 7.377451638699819569e-02 7.377451638699819569e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.062861784938944620e-01 1.062861784938944620e-01 1.062861784938944620e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 7.062016498828799227e-02 7.062016498828799227e-02 7.062016498828799227e-02 -2.656250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.816181020187846162e-01 1.816181020187846162e-01 1.816181020187846162e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 8.665155900886462037e-02 8.665155900886462037e-02 8.665155900886462037e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 7.490755121202044564e-02 7.490755121202044564e-02 7.490755121202044564e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 7.468964258961359459e-02 7.468964258961359459e-02 7.468964258961359459e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 9.738714831004775807e-02 9.738714831004775807e-02 9.738714831004775807e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 1.020244091168459322e-01 1.020244091168459322e-01 1.020244091168459322e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.200590526048270629e-01 1.200590526048270629e-01 1.200590526048270629e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.230883989996821581e-01 1.230883989996821581e-01 1.230883989996821581e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.095835917444848567e-01 1.095835917444848567e-01 1.095835917444848567e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 8.483924956927714478e-02 8.483924956927714478e-02 8.483924956927714478e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 2.466809673749230658e-01 2.466809673749230658e-01 2.466809673749230658e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.020758345273088813e-01 1.020758345273088813e-01 1.020758345273088813e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.942287694890511285e-01 1.942287694890511285e-01 1.942287694890511285e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 2.426576392105591062e-01 2.426576392105591062e-01 2.426576392105591062e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.199618481401645287e-01 1.199618481401645287e-01 1.199618481401645287e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.070229660352325501e-01 1.070229660352325501e-01 1.070229660352325501e-01 -3.281250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 8.640402646817826882e-02 8.640402646817826882e-02 8.640402646817826882e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.309243254652087685e-01 1.309243254652087685e-01 1.309243254652087685e-01 -3.593750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.312126858518902761e-01 1.312126858518902761e-01 1.312126858518902761e-01 -3.593750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.801627434262912941e-01 1.801627434262912941e-01 1.801627434262912941e-01 -3.593750000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 8.299314339144255037e-02 8.299314339144255037e-02 8.299314339144255037e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 5.660502826320577829e-02 5.660502826320577829e-02 5.660502826320577829e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 8.929641273674586432e-02 8.929641273674586432e-02 8.929641273674586432e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.157208877802232833e-01 1.157208877802232833e-01 1.157208877802232833e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 8.242411300746103897e-02 8.242411300746103897e-02 8.242411300746103897e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 9.503587219769556171e-02 9.503587219769556171e-02 9.503587219769556171e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 6.335291818031395239e-02 6.335291818031395239e-02 6.335291818031395239e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 6.096270158670458184e-02 6.096270158670458184e-02 6.096270158670458184e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.171179630622316420e-01 1.171179630622316420e-01 1.171179630622316420e-01 -3.281250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.257657931787496131e-01 1.257657931787496131e-01 1.257657931787496131e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.153392787551699439e-01 1.153392787551699439e-01 1.153392787551699439e-01 -3.593750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 8.559230727378927539e-02 8.559230727378927539e-02 8.559230727378927539e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.046559015985233793e-01 1.046559015985233793e-01 1.046559015985233793e-01 -3.593750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 9.626294796952492017e-02 9.626294796952492017e-02 9.626294796952492017e-02 -3.906250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.082249517290006791e-01 1.082249517290006791e-01 1.082249517290006791e-01 -3.906250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 1.470861740730505518e-01 1.470861740730505518e-01 1.470861740730505518e-01 -3.906250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.291877154324855004e-01 1.291877154324855004e-01 1.291877154324855004e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.393546248359730511e-01 1.393546248359730511e-01 1.393546248359730511e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 1.651580910992714313e-01 1.651580910992714313e-01 1.651580910992714313e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 1.117504585917338533e-01 1.117504585917338533e-01 1.117504585917338533e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.178787523374850432e-01 1.178787523374850432e-01 1.178787523374850432e-01 -4.218750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 9.769170023704397410e-02 9.769170023704397410e-02 9.769170023704397410e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.067730857386376131e-01 1.067730857386376131e-01 1.067730857386376131e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.452977120160263980e-01 1.452977120160263980e-01 1.452977120160263980e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.149865900677889408e-01 1.149865900677889408e-01 1.149865900677889408e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 1.052818225588562917e-01 1.052818225588562917e-01 1.052818225588562917e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.104681818114921499e-01 1.104681818114921499e-01 1.104681818114921499e-01 -4.218750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 9.682866618730226471e-02 9.682866618730226471e-02 9.682866618730226471e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 1.355668823836948533e-01 1.355668823836948533e-01 1.355668823836948533e-01 -4.218750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.203016615827377789e-01 1.203016615827377789e-01 1.203016615827377789e-01 -4.531250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.021513655393508913e-01 1.021513655393508913e-01 1.021513655393508913e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.177196861144765433e-01 1.177196861144765433e-01 1.177196861144765433e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 6.855894231039240394e-02 6.855894231039240394e-02 6.855894231039240394e-02 -3.906250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.095281538959794465e-01 1.095281538959794465e-01 1.095281538959794465e-01 -4.218750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.093843366906117609e-01 1.093843366906117609e-01 1.093843366906117609e-01 -4.218750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 5.419861158471936391e-02 5.419861158471936391e-02 5.419861158471936391e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 9.093101906001549439e-02 9.093101906001549439e-02 9.093101906001549439e-02 -4.531250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 8.221594975703848396e-02 8.221594975703848396e-02 8.221594975703848396e-02 -4.531250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.131652778654946290e-01 1.131652778654946290e-01 1.131652778654946290e-01 -4.531250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.019842329920375434e-01 1.019842329920375434e-01 1.019842329920375434e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.074263081563294336e-01 1.074263081563294336e-01 1.074263081563294336e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 8.849436661367332535e-02 8.849436661367332535e-02 8.849436661367332535e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 6.804680364336210263e-02 6.804680364336210263e-02 6.804680364336210263e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 9.628544820187905084e-02 9.628544820187905084e-02 9.628544820187905084e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 1.695867215145339668e-01 1.695867215145339668e-01 1.695867215145339668e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 7.260400777996608990e-02 7.260400777996608990e-02 7.260400777996608990e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 9.735259485236767707e-02 9.735259485236767707e-02 9.735259485236767707e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.761095955549283332e-01 1.761095955549283332e-01 1.761095955549283332e-01 -4.218750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.579662659710557859e-01 1.579662659710557859e-01 1.579662659710557859e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.824545399969804971e-01 1.824545399969804971e-01 1.824545399969804971e-01 -3.906250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 7.230201347423262370e-02 7.230201347423262370e-02 7.230201347423262370e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 7.591550152822799935e-02 7.591550152822799935e-02 7.591550152822799935e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 6.504609268447128501e-02 6.504609268447128501e-02 6.504609268447128501e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 7.363176058365779320e-02 7.363176058365779320e-02 7.363176058365779320e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 9.744179095701969995e-02 9.744179095701969995e-02 9.744179095701969995e-02 -4.218750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 9.382083177476920055e-02 9.382083177476920055e-02 9.382083177476920055e-02 -4.531250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 1.216359978843854911e-01 1.216359978843854911e-01 1.216359978843854911e-01 -4.531250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.088508449234078107e-01 1.088508449234078107e-01 1.088508449234078107e-01 -4.531250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.447042261492941517e-01 1.447042261492941517e-01 1.447042261492941517e-01 -4.531250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 9.716214878447164416e-02 9.716214878447164416e-02 9.716214878447164416e-02 -4.531250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 1.309580612741295669e-01 1.309580612741295669e-01 1.309580612741295669e-01 -4.531250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.677923366451302134e-01 1.677923366451302134e-01 1.677923366451302134e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 9.883596946969239183e-02 9.883596946969239183e-02 9.883596946969239183e-02 -4.531250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 8.975770618377953980e-02 8.975770618377953980e-02 8.975770618377953980e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.239141994461692153e-01 1.239141994461692153e-01 1.239141994461692153e-01 -4.531250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 7.593527458995240342e-02 7.593527458995240342e-02 7.593527458995240342e-02 -4.531250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.091674052240975551e-01 1.091674052240975551e-01 1.091674052240975551e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.018669185927903453e-01 1.018669185927903453e-01 1.018669185927903453e-01 -4.531250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 9.637544906835249225e-02 9.637544906835249225e-02 9.637544906835249225e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.060186192979524489e-01 1.060186192979524489e-01 1.060186192979524489e-01 -4.843750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 9.279622985547528180e-02 9.279622985547528180e-02 9.279622985547528180e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 8.347376196471625875e-02 8.347376196471625875e-02 8.347376196471625875e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 8.158583068927871551e-02 8.158583068927871551e-02 8.158583068927871551e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.880982622491425837e-01 1.880982622491425837e-01 1.880982622491425837e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.299556197738970242e-01 1.299556197738970242e-01 1.299556197738970242e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.153392787551699439e-01 1.153392787551699439e-01 1.153392787551699439e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 6.249602742640998632e-02 6.249602742640998632e-02 6.249602742640998632e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.267345493185234317e-01 1.267345493185234317e-01 1.267345493185234317e-01 -3.906250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 9.561204566687230011e-02 9.561204566687230011e-02 9.561204566687230011e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 9.942979378769978283e-02 9.942979378769978283e-02 9.942979378769978283e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.488456864061905027e-01 1.488456864061905027e-01 1.488456864061905027e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.028624785059844698e-01 1.028624785059844698e-01 1.028624785059844698e-01 -3.906250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 8.411994027068125934e-02 8.411994027068125934e-02 8.411994027068125934e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 8.156011143882350989e-02 8.156011143882350989e-02 8.156011143882350989e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 7.444086754630827030e-02 7.444086754630827030e-02 7.444086754630827030e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.020951190477692033e-01 1.020951190477692033e-01 1.020951190477692033e-01 -4.218750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 1.380462835763855145e-01 1.380462835763855145e-01 1.380462835763855145e-01 -4.218750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.282069399194702697e-01 1.282069399194702697e-01 1.282069399194702697e-01 -4.218750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.600410976244695804e-01 1.600410976244695804e-01 1.600410976244695804e-01 -3.906250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.304648744686991435e-01 1.304648744686991435e-01 1.304648744686991435e-01 -3.906250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 9.376136503967193170e-02 9.376136503967193170e-02 9.376136503967193170e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.178442076794183474e-01 1.178442076794183474e-01 1.178442076794183474e-01 -3.906250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 9.846151236900672898e-02 9.846151236900672898e-02 9.846151236900672898e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.431325516301735490e-01 1.431325516301735490e-01 1.431325516301735490e-01 -4.218750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.027789130143526714e-01 1.027789130143526714e-01 1.027789130143526714e-01 -4.218750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.832877584349583699e-01 1.832877584349583699e-01 1.832877584349583699e-01 -4.218750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.271795627397550033e-01 1.271795627397550033e-01 1.271795627397550033e-01 -4.531250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 8.421316954809249244e-02 8.421316954809249244e-02 8.421316954809249244e-02 -4.531250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 8.100151943967018320e-02 8.100151943967018320e-02 8.100151943967018320e-02 -4.531250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.716058584240593987e-01 1.716058584240593987e-01 1.716058584240593987e-01 -4.843750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.362383442193619565e-01 1.362383442193619565e-01 1.362383442193619565e-01 -4.531250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.143229848383009450e-01 1.143229848383009450e-01 1.143229848383009450e-01 -4.531250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.115712945806575929e-01 1.115712945806575929e-01 1.115712945806575929e-01 -4.843750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.100134346357901638e-01 1.100134346357901638e-01 1.100134346357901638e-01 -4.843750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.123474012740657002e-01 1.123474012740657002e-01 1.123474012740657002e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.318681195437938214e-01 1.318681195437938214e-01 1.318681195437938214e-01 -4.531250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 8.849275929879553415e-02 8.849275929879553415e-02 8.849275929879553415e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.353813458882925647e-01 1.353813458882925647e-01 1.353813458882925647e-01 -4.843750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 9.421379328426393585e-02 9.421379328426393585e-02 9.421379328426393585e-02 -4.843750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 9.432227925248516665e-02 9.432227925248516665e-02 9.432227925248516665e-02 -4.843750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 7.331256862277754638e-02 7.331256862277754638e-02 7.331256862277754638e-02 -4.531250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.388438200988184323e-01 1.388438200988184323e-01 1.388438200988184323e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 9.307186914498785657e-02 9.307186914498785657e-02 9.307186914498785657e-02 -5.156250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 9.716777378026383860e-02 9.716777378026383860e-02 9.716777378026383860e-02 -5.156250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 9.194037589748725592e-02 9.194037589748725592e-02 9.194037589748725592e-02 -5.156250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 9.332018478090704783e-02 9.332018478090704783e-02 9.332018478090704783e-02 -5.156250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 9.036686664841762917e-02 9.036686664841762917e-02 9.036686664841762917e-02 -5.468750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 5.689453951493998740e-02 5.689453951493998740e-02 5.689453951493998740e-02 -5.468750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 9.322857327629706370e-02 9.322857327629706370e-02 9.322857327629706370e-02 -5.156250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 7.637936341567599929e-02 7.637936341567599929e-02 7.637936341567599929e-02 -5.156250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 9.959773518811997073e-02 9.959773518811997073e-02 9.959773518811997073e-02 -5.156250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 6.854688446055805240e-02 6.854688446055805240e-02 6.854688446055805240e-02 -5.468750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 5.992505922171116606e-02 5.992505922171116606e-02 5.992505922171116606e-02 -5.468750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 4.218313906636216720e-02 4.218313906636216720e-02 4.218313906636216720e-02 -5.468750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 5.531334998582974893e-02 5.531334998582974893e-02 5.531334998582974893e-02 -5.468750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 6.703200221741083265e-02 6.703200221741083265e-02 6.703200221741083265e-02 -5.468750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 7.070585386037769871e-02 7.070585386037769871e-02 7.070585386037769871e-02 -5.781250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 5.914249743060123049e-02 5.914249743060123049e-02 5.914249743060123049e-02 -5.781250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 8.570401960930092156e-02 8.570401960930092156e-02 8.570401960930092156e-02 -5.781250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 7.382161931608897942e-02 7.382161931608897942e-02 7.382161931608897942e-02 -5.781250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.242178476735339154e-01 1.242178476735339154e-01 1.242178476735339154e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 1.562500000000000000e-02 1.962224080262416903e-01 1.962224080262416903e-01 1.962224080262416903e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.562500000000000000e-02 2.649109564585936938e-01 2.649109564585936938e-01 2.649109564585936938e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 4.687500000000000000e-02 1.816245238406071771e-01 1.816245238406071771e-01 1.816245238406071771e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 7.095327393755346268e-02 7.095327393755346268e-02 7.095327393755346268e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 5.651417891919825742e-02 5.651417891919825742e-02 5.651417891919825742e-02 -1.718750000000000000e-01 -3.281250000000000000e-01 1.562500000000000000e-02 6.886722072415150941e-02 6.886722072415150941e-02 6.886722072415150941e-02 -1.718750000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 -1.718750000000000000e-01 -3.281250000000000000e-01 7.812500000000000000e-02 9.185197731735489368e-02 9.185197731735489368e-02 9.185197731735489368e-02 -1.718750000000000000e-01 -3.281250000000000000e-01 1.093750000000000000e-01 7.415447387027773729e-02 7.415447387027773729e-02 7.415447387027773729e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 8.189124615986528855e-02 8.189124615986528855e-02 8.189124615986528855e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 7.783860997921211722e-02 7.783860997921211722e-02 7.783860997921211722e-02 -1.718750000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 7.319706117201858764e-02 7.319706117201858764e-02 7.319706117201858764e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 7.054058518482285434e-02 7.054058518482285434e-02 7.054058518482285434e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 7.879170754651088071e-02 7.879170754651088071e-02 7.879170754651088071e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 7.812500000000000000e-02 7.612014444418493953e-02 7.612014444418493953e-02 7.612014444418493953e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 6.112083495341769090e-02 6.112083495341769090e-02 6.112083495341769090e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 9.857722462053086776e-02 9.857722462053086776e-02 9.857722462053086776e-02 -1.718750000000000000e-01 -2.968750000000000000e-01 7.812500000000000000e-02 1.088211171154602891e-01 1.088211171154602891e-01 1.088211171154602891e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 9.331214868818035746e-02 9.331214868818035746e-02 9.331214868818035746e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 6.133114300633930871e-02 6.133114300633930871e-02 6.133114300633930871e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 1.562500000000000000e-02 5.867620468190840738e-02 5.867620468190840738e-02 5.867620468190840738e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 8.443981268576292165e-02 8.443981268576292165e-02 8.443981268576292165e-02 -2.343750000000000000e-01 -3.281250000000000000e-01 1.562500000000000000e-02 6.234320262623178205e-02 6.234320262623178205e-02 6.234320262623178205e-02 -2.343750000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 9.713322022838448422e-02 9.713322022838448422e-02 9.713322022838448422e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 7.812500000000000000e-02 7.988464530371483519e-02 7.988464530371483519e-02 7.988464530371483519e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 1.093750000000000000e-01 1.055959864428938355e-01 1.055959864428938355e-01 1.055959864428938355e-01 -2.343750000000000000e-01 -3.281250000000000000e-01 7.812500000000000000e-02 1.104031033096745801e-01 1.104031033096745801e-01 1.104031033096745801e-01 -2.343750000000000000e-01 -3.281250000000000000e-01 1.093750000000000000e-01 1.153360651977837076e-01 1.153360651977837076e-01 1.153360651977837076e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 6.139151803770320770e-02 6.139151803770320770e-02 6.139151803770320770e-02 -2.031250000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 7.163524268691212615e-02 7.163524268691212615e-02 7.163524268691212615e-02 -2.343750000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 6.178881837905059876e-02 6.178881837905059876e-02 6.178881837905059876e-02 -2.343750000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 7.030096107903052727e-02 7.030096107903052727e-02 7.030096107903052727e-02 -2.343750000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 8.002851525136120414e-02 8.002851525136120414e-02 8.002851525136120414e-02 -2.031250000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 1.185350980225116924e-01 1.185350980225116924e-01 1.185350980225116924e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 1.239382985536963550e-01 1.239382985536963550e-01 1.239382985536963550e-01 -2.343750000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 1.153328516402869625e-01 1.153328516402869625e-01 1.153328516402869625e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 1.294592138300912909e-01 1.294592138300912909e-01 1.294592138300912909e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 1.406250000000000000e-01 9.425397328955580079e-02 9.425397328955580079e-02 9.425397328955580079e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 1.406250000000000000e-01 1.161539114079427476e-01 1.161539114079427476e-01 1.161539114079427476e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 1.718750000000000000e-01 1.009766092205924837e-01 1.009766092205924837e-01 1.009766092205924837e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 1.406250000000000000e-01 1.103878379744684113e-01 1.103878379744684113e-01 1.103878379744684113e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 1.406250000000000000e-01 1.462084111791120966e-01 1.462084111791120966e-01 1.462084111791120966e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 1.718750000000000000e-01 1.253737890376318276e-01 1.253737890376318276e-01 1.253737890376318276e-01 -2.031250000000000000e-01 -3.281250000000000000e-01 1.406250000000000000e-01 7.675794218043695272e-02 7.675794218043695272e-02 7.675794218043695272e-02 -2.343750000000000000e-01 -3.281250000000000000e-01 1.406250000000000000e-01 7.606034311172815698e-02 7.606034311172815698e-02 7.606034311172815698e-02 -2.031250000000000000e-01 -2.968750000000000000e-01 1.406250000000000000e-01 1.167050290179591360e-01 1.167050290179591360e-01 1.167050290179591360e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.406250000000000000e-01 1.600435064536546992e-01 1.600435064536546992e-01 1.600435064536546992e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.718750000000000000e-01 1.149183016467055229e-01 1.149183016467055229e-01 1.149183016467055229e-01 -2.343750000000000000e-01 -2.968750000000000000e-01 1.406250000000000000e-01 8.965725051900791387e-02 8.965725051900791387e-02 8.965725051900791387e-02 -2.343750000000000000e-01 -2.656250000000000000e-01 1.406250000000000000e-01 1.204277858285953545e-01 1.204277858285953545e-01 1.204277858285953545e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.562500000000000000e-02 2.324412033431178803e-01 2.324412033431178803e-01 2.324412033431178803e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 4.687500000000000000e-02 1.858315097019015150e-01 1.858315097019015150e-01 1.858315097019015150e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.562500000000000000e-02 1.585090676552733668e-01 1.585090676552733668e-01 1.585090676552733668e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 1.446118700388894507e-01 1.446118700388894507e-01 1.446118700388894507e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 1.163635936257879366e-01 1.163635936257879366e-01 1.163635936257879366e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 1.026559751621450023e-01 1.026559751621450023e-01 1.026559751621450023e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 4.687500000000000000e-02 1.526841968377539160e-01 1.526841968377539160e-01 1.526841968377539160e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 1.174481480980224118e-01 1.174481480980224118e-01 1.174481480980224118e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 4.687500000000000000e-02 1.720201164317411435e-01 1.720201164317411435e-01 1.720201164317411435e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 1.097804359703999783e-01 1.097804359703999783e-01 1.097804359703999783e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 2.071295614268916785e-01 2.071295614268916785e-01 2.071295614268916785e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 1.177759216837998557e-01 1.177759216837998557e-01 1.177759216837998557e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 1.003514583043523534e-01 1.003514583043523534e-01 1.003514583043523534e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 1.901803434083136346e-01 1.901803434083136346e-01 1.901803434083136346e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 1.291459463669223928e-01 1.291459463669223928e-01 1.291459463669223928e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 1.107927700962621359e-01 1.107927700962621359e-01 1.107927700962621359e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 5.508726797557893240e-02 5.508726797557893240e-02 5.508726797557893240e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.148259113376893237e-01 1.148259113376893237e-01 1.148259113376893237e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 9.594231897484302440e-02 9.594231897484302440e-02 9.594231897484302440e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 1.562500000000000000e-02 7.607561496162194847e-02 7.607561496162194847e-02 7.607561496162194847e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 4.687500000000000000e-02 8.554328238692437969e-02 8.554328238692437969e-02 8.554328238692437969e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 1.052850365178433362e-01 1.052850365178433362e-01 1.052850365178433362e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.150267597001823627e-01 1.150267597001823627e-01 1.150267597001823627e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 1.265674678316555668e-01 1.265674678316555668e-01 1.265674678316555668e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.010987461074271815e-01 1.010987461074271815e-01 1.010987461074271815e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 7.812500000000000000e-02 9.339893844710814297e-02 9.339893844710814297e-02 9.339893844710814297e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 1.801507022911744416e-01 1.801507022911744416e-01 1.801507022911744416e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 1.192926604979283600e-01 1.192926604979283600e-01 1.192926604979283600e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 1.907140987908594876e-01 1.907140987908594876e-01 1.907140987908594876e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 9.650402156007087395e-02 9.650402156007087395e-02 9.650402156007087395e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.039520360110792463e-01 1.039520360110792463e-01 1.039520360110792463e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 8.962671197206757701e-02 8.962671197206757701e-02 8.962671197206757701e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.517342227112047914e-01 1.517342227112047914e-01 1.517342227112047914e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 1.668120316311124118e-01 1.668120316311124118e-01 1.668120316311124118e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 1.325323832909028055e-01 1.325323832909028055e-01 1.325323832909028055e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 1.258364822468286404e-01 1.258364822468286404e-01 1.258364822468286404e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 1.130552104783136835e-01 1.130552104783136835e-01 1.130552104783136835e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.406250000000000000e-01 1.349219203439445958e-01 1.349219203439445958e-01 1.349219203439445958e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 1.562808273427618300e-01 1.562808273427618300e-01 1.562808273427618300e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.406250000000000000e-01 1.303178817252638455e-01 1.303178817252638455e-01 1.303178817252638455e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 1.366608161385039211e-01 1.366608161385039211e-01 1.366608161385039211e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 1.268421881695645514e-01 1.268421881695645514e-01 1.268421881695645514e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 2.031250000000000000e-01 1.097145534667657713e-01 1.097145534667657713e-01 1.097145534667657713e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 2.343750000000000000e-01 1.167516247944101054e-01 1.167516247944101054e-01 1.167516247944101054e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 2.031250000000000000e-01 1.205683699460540353e-01 1.205683699460540353e-01 1.205683699460540353e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 1.002703008240176941e-01 1.002703008240176941e-01 1.002703008240176941e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 2.031250000000000000e-01 1.171999069201462990e-01 1.171999069201462990e-01 1.171999069201462990e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 2.343750000000000000e-01 5.240141011211932320e-02 5.240141011211932320e-02 5.240141011211932320e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 2.031250000000000000e-01 1.171059124878335717e-01 1.171059124878335717e-01 1.171059124878335717e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 4.950407890206114103e-02 4.950407890206114103e-02 4.950407890206114103e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 1.718750000000000000e-01 6.591959665819366321e-02 6.591959665819366321e-02 6.591959665819366321e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 9.064572880498447671e-02 9.064572880498447671e-02 9.064572880498447671e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 8.576027756126079760e-02 8.576027756126079760e-02 8.576027756126079760e-02 -1.093750000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 7.072281478014204315e-02 7.072281478014204315e-02 7.072281478014204315e-02 -1.093750000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 8.439159079505481609e-02 8.439159079505481609e-02 8.439159079505481609e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 5.300739623378734888e-02 5.300739623378734888e-02 5.300739623378734888e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 2.031250000000000000e-01 3.900310258753589970e-02 3.900310258753589970e-02 3.900310258753589970e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 2.343750000000000000e-01 3.862177282611326673e-02 3.862177282611326673e-02 3.862177282611326673e-02 -1.093750000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 7.187550587751692643e-02 7.187550587751692643e-02 7.187550587751692643e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 6.298705853864015880e-02 6.298705853864015880e-02 6.298705853864015880e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 4.972430707513905007e-02 4.972430707513905007e-02 4.972430707513905007e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 1.406250000000000000e-01 1.808563097677190756e-01 1.808563097677190756e-01 1.808563097677190756e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 9.610303542263240462e-02 9.610303542263240462e-02 9.610303542263240462e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 2.031250000000000000e-01 1.134520950939721107e-01 1.134520950939721107e-01 1.134520950939721107e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.562500000000000000e-02 7.175002893773756163e-02 7.175002893773756163e-02 7.175002893773756163e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 7.812500000000000000e-02 1.881921737778975978e-01 1.881921737778975978e-01 1.881921737778975978e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.093750000000000000e-01 1.616935374982381712e-01 1.616935374982381712e-01 1.616935374982381712e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 1.112724191989186429e-01 1.112724191989186429e-01 1.112724191989186429e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 4.687500000000000000e-02 1.257368749057218016e-01 1.257368749057218016e-01 1.257368749057218016e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.562500000000000000e-02 8.080651292532583518e-01 8.080651292532583518e-01 8.080651292532583518e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 4.687500000000000000e-02 3.765962107896211886e-01 3.765962107896211886e-01 3.765962107896211886e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.562500000000000000e-02 2.380214927610704162e-02 2.380214927610704162e-02 2.380214927610704162e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 4.687500000000000000e-02 1.437686136930043102e-01 1.437686136930043102e-01 1.437686136930043102e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.562500000000000000e-02 1.990033068018454421e-01 1.990033068018454421e-01 1.990033068018454421e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 4.687500000000000000e-02 1.357227005817311649e-01 1.357227005817311649e-01 1.357227005817311649e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 7.812500000000000000e-02 2.224360852228243479e-01 2.224360852228243479e-01 2.224360852228243479e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.093750000000000000e-01 1.934703070732783359e-01 1.934703070732783359e-01 1.934703070732783359e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.562500000000000000e-02 1.837846350724676170e-01 1.837846350724676170e-01 1.837846350724676170e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 4.687500000000000000e-02 2.905146652352935122e-01 2.905146652352935122e-01 2.905146652352935122e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.554304663918436857e-01 1.554304663918436857e-01 1.554304663918436857e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 9.922569228368623151e-02 9.922569228368623151e-02 9.922569228368623151e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 2.490406487798463298e-01 2.490406487798463298e-01 2.490406487798463298e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 5.893081693671558402e-02 5.893081693671558402e-02 5.893081693671558402e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 8.885279703159626452e-02 8.885279703159626452e-02 8.885279703159626452e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 6.291036527163232361e-02 6.291036527163232361e-02 6.291036527163232361e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 1.562500000000000000e-02 1.721060185035248047e-01 1.721060185035248047e-01 1.721060185035248047e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 4.687500000000000000e-02 2.322743412363207083e-01 2.322743412363207083e-01 2.322743412363207083e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.562500000000000000e-02 1.015109567316618000e-01 1.015109567316618000e-01 1.015109567316618000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 4.687500000000000000e-02 1.659778396612154594e-01 1.659778396612154594e-01 1.659778396612154594e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.717519729260601202e-01 1.717519729260601202e-01 1.717519729260601202e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.457370011709193391e-01 1.457370011709193391e-01 1.457370011709193391e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.925376694121739285e-01 1.925376694121739285e-01 1.925376694121739285e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 7.812500000000000000e-02 1.534446498682421334e-01 1.534446498682421334e-01 1.534446498682421334e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.093750000000000000e-01 5.182661555532443176e-02 5.182661555532443176e-02 5.182661555532443176e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 8.471387321576052953e-02 8.471387321576052953e-02 8.471387321576052953e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 4.918607768335212654e-02 4.918607768335212654e-02 4.918607768335212654e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.467336245280571605e-01 1.467336245280571605e-01 1.467336245280571605e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.370543716338775142e-01 1.370543716338775142e-01 1.370543716338775142e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.406250000000000000e-01 1.217163304894682690e-01 1.217163304894682690e-01 1.217163304894682690e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 9.683348763229632228e-02 9.683348763229632228e-02 9.683348763229632228e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 1.335131060764083166e-01 1.335131060764083166e-01 1.335131060764083166e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 1.422210145281627702e-01 1.422210145281627702e-01 1.422210145281627702e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 1.406250000000000000e-01 2.113689159726069577e-01 2.113689159726069577e-01 2.113689159726069577e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 1.930320810850380542e-01 1.930320810850380542e-01 1.930320810850380542e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 4.378436763080691824e-02 4.378436763080691824e-02 4.378436763080691824e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 7.918723409557076875e-02 7.918723409557076875e-02 7.918723409557076875e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 1.558062644076678160e-01 1.558062644076678160e-01 1.558062644076678160e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 2.343750000000000000e-01 1.287780563527993472e-01 1.287780563527993472e-01 1.287780563527993472e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 1.894483302682501702e-01 1.894483302682501702e-01 1.894483302682501702e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 2.343750000000000000e-01 1.611427279780167088e-01 1.611427279780167088e-01 1.611427279780167088e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 1.926893642257949402e-01 1.926893642257949402e-01 1.926893642257949402e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 2.343750000000000000e-01 1.171870529871732319e-01 1.171870529871732319e-01 1.171870529871732319e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 1.062114548440448447e-01 1.062114548440448447e-01 1.062114548440448447e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 2.343750000000000000e-01 1.206358502351772832e-01 1.206358502351772832e-01 1.206358502351772832e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 1.397401356977232834e-01 1.397401356977232834e-01 1.397401356977232834e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 6.774808807643878383e-02 6.774808807643878383e-02 6.774808807643878383e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 2.932020871292090672e-02 2.932020871292090672e-02 2.932020871292090672e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 1.667349555461286048e-01 1.667349555461286048e-01 1.667349555461286048e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 1.906129664639596988e-01 1.906129664639596988e-01 1.906129664639596988e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 2.031250000000000000e-01 1.103942654843800553e-01 1.103942654843800553e-01 1.103942654843800553e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 1.048760592052133261e-01 1.048760592052133261e-01 1.048760592052133261e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 6.282161322359219868e-02 6.282161322359219868e-02 6.282161322359219868e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 1.456831944014970459e-01 1.456831944014970459e-01 1.456831944014970459e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 2.031250000000000000e-01 3.745983976676659638e-02 3.745983976676659638e-02 3.745983976676659638e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 1.061994026359571602e-01 1.061994026359571602e-01 1.061994026359571602e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 2.815502051523234850e-01 2.815502051523234850e-01 2.815502051523234850e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 1.479109251746920928e-01 1.479109251746920928e-01 1.479109251746920928e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 8.673674860320310098e-02 8.673674860320310098e-02 8.673674860320310098e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 1.488288222533651894e-01 1.488288222533651894e-01 1.488288222533651894e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 8.253904460992603220e-02 8.253904460992603220e-02 8.253904460992603220e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 4.604700453342679828e-02 4.604700453342679828e-02 4.604700453342679828e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 6.889977678493505731e-02 6.889977678493505731e-02 6.889977678493505731e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 9.320928663044678042e-02 9.320928663044678042e-02 9.320928663044678042e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 1.406250000000000000e-01 9.039017216825827317e-02 9.039017216825827317e-02 9.039017216825827317e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 5.234352079172945732e-02 5.234352079172945732e-02 5.234352079172945732e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 1.406250000000000000e-01 7.047507245926454278e-02 7.047507245926454278e-02 7.047507245926454278e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 6.568003917741353781e-02 6.568003917741353781e-02 6.568003917741353781e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 6.038692307219857558e-02 6.038692307219857558e-02 6.038692307219857558e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 7.183724387177278792e-02 7.183724387177278792e-02 7.183724387177278792e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 1.661616998471522055e-01 1.661616998471522055e-01 1.661616998471522055e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 7.479485933121596264e-02 7.479485933121596264e-02 7.479485933121596264e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 7.060320404688355533e-02 7.060320404688355533e-02 7.060320404688355533e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 7.985595165768548387e-02 7.985595165768548387e-02 7.985595165768548387e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 6.251009597573359278e-02 6.251009597573359278e-02 6.251009597573359278e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 8.141302931735580617e-02 8.141302931735580617e-02 8.141302931735580617e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 9.413905842106674859e-02 9.413905842106674859e-02 9.413905842106674859e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 8.862214804449172756e-02 8.862214804449172756e-02 8.862214804449172756e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 6.420312743715805848e-02 6.420312743715805848e-02 6.420312743715805848e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 7.812500000000000000e-02 6.818506773911303664e-02 6.818506773911303664e-02 6.818506773911303664e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 8.252136283561793684e-02 8.252136283561793684e-02 8.252136283561793684e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 9.831928249852953106e-02 9.831928249852953106e-02 9.831928249852953106e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.104304202180785704e-01 1.104304202180785704e-01 1.104304202180785704e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 5.339307986263782529e-02 5.339307986263782529e-02 5.339307986263782529e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 7.410930025882134231e-02 7.410930025882134231e-02 7.410930025882134231e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 9.161972967583502381e-02 9.161972967583502381e-02 9.161972967583502381e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 8.204797206963539147e-02 8.204797206963539147e-02 8.204797206963539147e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 9.735741626596390585e-02 9.735741626596390585e-02 9.735741626596390585e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.094654849777476485e-01 1.094654849777476485e-01 1.094654849777476485e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 8.511089766494502051e-02 8.511089766494502051e-02 8.511089766494502051e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 9.859731353611593530e-02 9.859731353611593530e-02 9.859731353611593530e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.028528363383069549e-01 1.028528363383069549e-01 1.028528363383069549e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.119248016634290938e-01 1.119248016634290938e-01 1.119248016634290938e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 9.005907242546518088e-02 9.005907242546518088e-02 9.005907242546518088e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.378824382363485757e-01 1.378824382363485757e-01 1.378824382363485757e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.562500000000000000e-02 7.982211403955710716e-02 7.982211403955710716e-02 7.982211403955710716e-02 -2.031250000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.124422046841697942e-01 1.124422046841697942e-01 1.124422046841697942e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 1.129499634198352087e-01 1.129499634198352087e-01 1.129499634198352087e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 1.562500000000000000e-02 9.108612009811686838e-02 9.108612009811686838e-02 9.108612009811686838e-02 -2.343750000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.202912181649914702e-01 1.202912181649914702e-01 1.202912181649914702e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 1.034353818950031201e-01 1.034353818950031201e-01 1.034353818950031201e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.095442228414977015e-01 1.095442228414977015e-01 1.095442228414977015e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 9.853945744562074560e-02 9.853945744562074560e-02 9.853945744562074560e-02 -2.343750000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 1.305323464577246295e-01 1.305323464577246295e-01 1.305323464577246295e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.011574038884921617e-01 1.011574038884921617e-01 1.011574038884921617e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.191777813873263481e-01 1.191777813873263481e-01 1.191777813873263481e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.035430519222593077e-01 1.035430519222593077e-01 1.035430519222593077e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 1.063898273126820948e-01 1.063898273126820948e-01 1.063898273126820948e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.034699327403477143e-01 1.034699327403477143e-01 1.034699327403477143e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 1.090284080880999373e-01 1.090284080880999373e-01 1.090284080880999373e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 7.510890114813768836e-02 7.510890114813768836e-02 7.510890114813768836e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 8.115262096741286679e-02 8.115262096741286679e-02 8.115262096741286679e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 5.178142940542523193e-02 5.178142940542523193e-02 5.178142940542523193e-02 -2.031250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.147174530134538878e-01 1.147174530134538878e-01 1.147174530134538878e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.230691195105641789e-01 1.230691195105641789e-01 1.230691195105641789e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 9.121550467316603961e-02 9.121550467316603961e-02 9.121550467316603961e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.203225484141813573e-01 1.203225484141813573e-01 1.203225484141813573e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 9.689295209671575093e-02 9.689295209671575093e-02 9.689295209671575093e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.069827924064768315e-01 1.069827924064768315e-01 1.069827924064768315e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 7.916617583207585795e-02 7.916617583207585795e-02 7.916617583207585795e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.188371598434002918e-01 1.188371598434002918e-01 1.188371598434002918e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 8.353404001125652734e-02 8.353404001125652734e-02 8.353404001125652734e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 1.303692890540614213e-01 1.303692890540614213e-01 1.303692890540614213e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 1.617979178860993184e-01 1.617979178860993184e-01 1.617979178860993184e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.269008271845331326e-01 1.269008271845331326e-01 1.269008271845331326e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 9.721920229514387224e-02 9.721920229514387224e-02 9.721920229514387224e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 1.316167099476577007e-01 1.316167099476577007e-01 1.316167099476577007e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 4.547867768331501775e-02 4.547867768331501775e-02 4.547867768331501775e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 1.051130895316475244e-01 1.051130895316475244e-01 1.051130895316475244e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 1.615353608062357893e-01 1.615353608062357893e-01 1.615353608062357893e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.604947591814822327e-01 1.604947591814822327e-01 1.604947591814822327e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.012875757978327490e-01 1.012875757978327490e-01 1.012875757978327490e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.227743034141094841e-01 1.227743034141094841e-01 1.227743034141094841e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 1.583187662982575572e-01 1.583187662982575572e-01 1.583187662982575572e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 1.411199281860846255e-01 1.411199281860846255e-01 1.411199281860846255e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 9.127095514163670320e-02 9.127095514163670320e-02 9.127095514163670320e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 1.998949397094559599e-01 1.998949397094559599e-01 1.998949397094559599e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 1.420636026701275756e-01 1.420636026701275756e-01 1.420636026701275756e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 1.465368706934629117e-01 1.465368706934629117e-01 1.465368706934629117e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 1.593593960677125998e-01 1.593593960677125998e-01 1.593593960677125998e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 1.831537055693177041e-01 1.831537055693177041e-01 1.831537055693177041e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 1.373515449159183333e-01 1.373515449159183333e-01 1.373515449159183333e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 1.471239184658175991e-01 1.471239184658175991e-01 1.471239184658175991e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 1.167492146687006960e-01 1.167492146687006960e-01 1.167492146687006960e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.525243963957962079e-01 1.525243963957962079e-01 1.525243963957962079e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 1.260421228190036214e-01 1.260421228190036214e-01 1.260421228190036214e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 1.233358186998366468e-01 1.233358186998366468e-01 1.233358186998366468e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 6.552239710377555371e-02 6.552239710377555371e-02 6.552239710377555371e-02 -2.031250000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 1.070379827954178430e-02 1.070379827954178430e-02 1.070379827954178430e-02 -2.031250000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 1.320110933407025455e-01 1.320110933407025455e-01 1.320110933407025455e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 8.791974949512378068e-02 8.791974949512378068e-02 8.791974949512378068e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 1.122445635503650507e-01 1.122445635503650507e-01 1.122445635503650507e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 1.080465833289185051e-01 1.080465833289185051e-01 1.080465833289185051e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.699857358875190017e-01 1.699857358875190017e-01 1.699857358875190017e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.199618481401645287e-01 1.199618481401645287e-01 1.199618481401645287e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 1.791239882087240498e-01 1.791239882087240498e-01 1.791239882087240498e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 1.258509413667404930e-01 1.258509413667404930e-01 1.258509413667404930e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.601559184019235860e-01 1.601559184019235860e-01 1.601559184019235860e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.378936825350569051e-01 1.378936825350569051e-01 1.378936825350569051e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 1.508324194808747243e-01 1.508324194808747243e-01 1.508324194808747243e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 1.596195514069575772e-01 1.596195514069575772e-01 1.596195514069575772e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 1.751623063649762890e-01 1.751623063649762890e-01 1.751623063649762890e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 1.436738471892945734e-01 1.436738471892945734e-01 1.436738471892945734e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 1.684354295150688741e-01 1.684354295150688741e-01 1.684354295150688741e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 7.158998727830931386e-02 7.158998727830931386e-02 7.158998727830931386e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.769565268699247185e-01 1.769565268699247185e-01 1.769565268699247185e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 7.236334485563460095e-02 7.236334485563460095e-02 7.236334485563460095e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 6.533943222917042160e-02 6.533943222917042160e-02 6.533943222917042160e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 9.220235657359725223e-02 9.220235657359725223e-02 9.220235657359725223e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 8.406368117167828391e-02 8.406368117167828391e-02 8.406368117167828391e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 6.826191675006583470e-02 6.826191675006583470e-02 6.826191675006583470e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 8.101196795869113065e-02 8.101196795869113065e-02 8.101196795869113065e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 8.072744626353371700e-02 8.072744626353371700e-02 8.072744626353371700e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 7.937450772317773684e-02 7.937450772317773684e-02 7.937450772317773684e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.044968092304020546e-01 1.044968092304020546e-01 1.044968092304020546e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.914637582660776161e-01 1.914637582660776161e-01 1.914637582660776161e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.441099328024740833e-01 1.441099328024740833e-01 1.441099328024740833e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.565048586186782165e-01 1.565048586186782165e-01 1.565048586186782165e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.591602642519887867e-01 1.591602642519887867e-01 1.591602642519887867e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 2.015248929560355673e-01 2.015248929560355673e-01 2.015248929560355673e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.111888624420024757e-01 1.111888624420024757e-01 1.111888624420024757e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 9.581937067554058274e-02 9.581937067554058274e-02 9.581937067554058274e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 7.903918313379579286e-02 7.903918313379579286e-02 7.903918313379579286e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 2.304629024408808013e-01 2.304629024408808013e-01 2.304629024408808013e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.455011007188387939e-01 2.455011007188387939e-01 2.455011007188387939e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 9.951657694746958438e-02 9.951657694746958438e-02 9.951657694746958438e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 1.032513783059530316e-01 1.032513783059530316e-01 1.032513783059530316e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 8.627383047557490858e-02 8.627383047557490858e-02 8.627383047557490858e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 1.204767894631474379e-01 1.204767894631474379e-01 1.204767894631474379e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 9.792875173061058036e-02 9.792875173061058036e-02 9.792875173061058036e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 8.221193115617796143e-02 8.221193115617796143e-02 8.221193115617796143e-02 -2.343750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 9.384654710606915584e-02 9.384654710606915584e-02 9.384654710606915584e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 8.601584890489624713e-02 8.601584890489624713e-02 8.601584890489624713e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.023715299996366263e-01 1.023715299996366263e-01 1.023715299996366263e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 9.941372282190291676e-02 9.941372282190291676e-02 9.941372282190291676e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 2.275587391927091085e-01 2.275587391927091085e-01 2.275587391927091085e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 6.512784842829785759e-02 6.512784842829785759e-02 6.512784842829785759e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.059985322353186599e-01 1.059985322353186599e-01 1.059985322353186599e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 1.415897589936090661e-01 1.415897589936090661e-01 1.415897589936090661e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 2.730153226507008313e-01 2.730153226507008313e-01 2.730153226507008313e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 9.803964337593194800e-02 9.803964337593194800e-02 9.803964337593194800e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.090613496275891769e-01 1.090613496275891769e-01 1.090613496275891769e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.142683536554690849e-01 1.142683536554690849e-01 1.142683536554690849e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 2.523097599148679260e-01 2.523097599148679260e-01 2.523097599148679260e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.073917590099987135e-01 1.073917590099987135e-01 1.073917590099987135e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 1.407657462251034886e-01 1.407657462251034886e-01 1.407657462251034886e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 2.346328408141280242e-01 2.346328408141280242e-01 2.346328408141280242e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 8.198126312996743825e-02 8.198126312996743825e-02 8.198126312996743825e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.157988161375110986e-01 1.157988161375110986e-01 1.157988161375110986e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 9.076948864548829710e-02 9.076948864548829710e-02 9.076948864548829710e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 1.476692025046779100e-01 1.476692025046779100e-01 1.476692025046779100e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.252637383513752478e-01 1.252637383513752478e-01 1.252637383513752478e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.530134329286318429e-01 1.530134329286318429e-01 1.530134329286318429e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 1.701246277502385384e-01 1.701246277502385384e-01 1.701246277502385384e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 2.381175177280299149e-01 2.381175177280299149e-01 2.381175177280299149e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.278189639961204438e-01 1.278189639961204438e-01 1.278189639961204438e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.022943921551142665e-01 1.022943921551142665e-01 1.022943921551142665e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 1.280583365259961026e-01 1.280583365259961026e-01 1.280583365259961026e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.727105417045541325e-01 1.727105417045541325e-01 1.727105417045541325e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.520337508444036256e-01 1.520337508444036256e-01 1.520337508444036256e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.333500547137602688e-01 1.333500547137602688e-01 1.333500547137602688e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.061383380872188004e-01 1.061383380872188004e-01 1.061383380872188004e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.531459299996241197e-01 1.531459299996241197e-01 1.531459299996241197e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 1.754456915037586884e-01 1.754456915037586884e-01 1.754456915037586884e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 9.941613346697888987e-02 9.941613346697888987e-02 9.941613346697888987e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.105276361992356821e-01 1.105276361992356821e-01 1.105276361992356821e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.381049144258236216e-01 1.381049144258236216e-01 1.381049144258236216e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.151810109021822737e-01 1.151810109021822737e-01 1.151810109021822737e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 9.758643307866558814e-02 9.758643307866558814e-02 9.758643307866558814e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 1.672455832333394066e-01 1.672455832333394066e-01 1.672455832333394066e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.956750451995432072e-01 1.956750451995432072e-01 1.956750451995432072e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.745441540153176152e-01 1.745441540153176152e-01 1.745441540153176152e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 1.591723085290384088e-01 1.591723085290384088e-01 1.591723085290384088e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 1.596492604508387703e-01 1.596492604508387703e-01 1.596492604508387703e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 2.062099218134776923e-01 2.062099218134776923e-01 2.062099218134776923e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 8.364254038120753909e-02 8.364254038120753909e-02 8.364254038120753909e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.391088606974488218e-01 1.391088606974488218e-01 1.391088606974488218e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 8.247153235984068520e-02 8.247153235984068520e-02 8.247153235984068520e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 8.490997460557543619e-02 8.490997460557543619e-02 8.490997460557543619e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 7.968234282478932340e-02 7.968234282478932340e-02 7.968234282478932340e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 9.766678970054631925e-02 9.766678970054631925e-02 9.766678970054631925e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.182659728384785336e-01 1.182659728384785336e-01 1.182659728384785336e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.231566804864531323e-01 1.231566804864531323e-01 1.231566804864531323e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 2.656250000000000000e-01 8.859321641755082966e-02 8.859321641755082966e-02 8.859321641755082966e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 2.968750000000000000e-01 9.306624386280326622e-02 9.306624386280326622e-02 9.306624386280326622e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 2.656250000000000000e-01 5.842866645043968271e-02 5.842866645043968271e-02 5.842866645043968271e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 2.968750000000000000e-01 8.700758661990251608e-02 8.700758661990251608e-02 8.700758661990251608e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 3.281250000000000000e-01 8.684444098015015046e-02 8.684444098015015046e-02 8.684444098015015046e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.344632953744604731e-01 1.344632953744604731e-01 1.344632953744604731e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 3.281250000000000000e-01 7.951251122900357404e-02 7.951251122900357404e-02 7.951251122900357404e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.317588809659512028e-01 1.317588809659512028e-01 1.317588809659512028e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 2.656250000000000000e-01 3.273288545433601648e-02 3.273288545433601648e-02 3.273288545433601648e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 2.656250000000000000e-01 6.809961734053884830e-02 6.809961734053884830e-02 6.809961734053884830e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 2.656250000000000000e-01 6.243340225407564142e-02 6.243340225407564142e-02 6.243340225407564142e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 2.968750000000000000e-01 1.190966428956908851e-01 1.190966428956908851e-01 1.190966428956908851e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 8.137525408428887552e-02 8.137525408428887552e-02 8.137525408428887552e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 2.968750000000000000e-01 1.561860755759935382e-01 1.561860755759935382e-01 1.561860755759935382e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 1.049644434763763040e-01 1.049644434763763040e-01 1.049644434763763040e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 2.968750000000000000e-01 1.792195157168231801e-01 1.792195157168231801e-01 1.792195157168231801e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.427815909906706704e-01 1.427815909906706704e-01 1.427815909906706704e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 3.281250000000000000e-01 1.568437147753351524e-01 1.568437147753351524e-01 1.568437147753351524e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 2.968750000000000000e-01 6.046868355070356832e-02 6.046868355070356832e-02 6.046868355070356832e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 2.656250000000000000e-01 7.916786370835811326e-02 7.916786370835811326e-02 7.916786370835811326e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 2.968750000000000000e-01 6.034841442078733159e-02 6.034841442078733159e-02 6.034841442078733159e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.341267545481143464e-01 1.341267545481143464e-01 1.341267545481143464e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 3.281250000000000000e-01 8.398089985449690154e-02 8.398089985449690154e-02 8.398089985449690154e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.167162762768171325e-01 1.167162762768171325e-01 1.167162762768171325e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 9.600740917487525505e-02 9.600740917487525505e-02 9.600740917487525505e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 3.281250000000000000e-01 1.363291035829951037e-01 1.363291035829951037e-01 1.363291035829951037e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 1.107678636158386659e-01 1.107678636158386659e-01 1.107678636158386659e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 1.553316986733069838e-01 1.553316986733069838e-01 1.553316986733069838e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 1.029958617070443200e-01 1.029958617070443200e-01 1.029958617070443200e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.425037126020535505e-01 1.425037126020535505e-01 1.425037126020535505e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 1.289764601283492351e-01 1.289764601283492351e-01 1.289764601283492351e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 1.267899753120436679e-01 1.267899753120436679e-01 1.267899753120436679e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 9.484863502163901061e-02 9.484863502163901061e-02 9.484863502163901061e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.582962834077761283e-01 1.582962834077761283e-01 1.582962834077761283e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 1.220087404946344767e-01 1.220087404946344767e-01 1.220087404946344767e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 1.057590940625837972e-01 1.057590940625837972e-01 1.057590940625837972e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 1.042895065817116274e-01 1.042895065817116274e-01 1.042895065817116274e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 2.656250000000000000e-01 1.104834471314539296e-01 1.104834471314539296e-01 1.104834471314539296e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 3.760282060017400285e-02 3.760282060017400285e-02 3.760282060017400285e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.093730884067234260e-01 1.093730884067234260e-01 1.093730884067234260e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 1.197240582109344031e-01 1.197240582109344031e-01 1.197240582109344031e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 1.117665270934020544e-01 1.117665270934020544e-01 1.117665270934020544e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 3.281250000000000000e-01 1.414476053464655270e-01 1.414476053464655270e-01 1.414476053464655270e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 3.593750000000000000e-01 1.034032415604341643e-01 1.034032415604341643e-01 1.034032415604341643e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 3.593750000000000000e-01 1.175252714148061484e-01 1.175252714148061484e-01 1.175252714148061484e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 7.008577303998664298e-02 7.008577303998664298e-02 7.008577303998664298e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 7.827545446377286165e-02 7.827545446377286165e-02 7.827545446377286165e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 9.122595186580731430e-02 9.122595186580731430e-02 9.122595186580731430e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 3.638554538912785324e-02 3.638554538912785324e-02 3.638554538912785324e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 4.868105217870061924e-02 4.868105217870061924e-02 4.868105217870061924e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 8.277694446820345331e-02 8.277694446820345331e-02 8.277694446820345331e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 1.039263239095819247e-01 1.039263239095819247e-01 1.039263239095819247e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 5.510045343032434623e-02 5.510045343032434623e-02 5.510045343032434623e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 3.281250000000000000e-01 4.505114336469152880e-02 4.505114336469152880e-02 4.505114336469152880e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 3.281250000000000000e-01 5.100682871873336854e-02 5.100682871873336854e-02 5.100682871873336854e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 3.593750000000000000e-01 8.993932970725193599e-02 8.993932970725193599e-02 8.993932970725193599e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 3.281250000000000000e-01 4.539698237878690007e-02 4.539698237878690007e-02 4.539698237878690007e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 7.375860105660742017e-02 7.375860105660742017e-02 7.375860105660742017e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 2.341434979466302801e-01 2.341434979466302801e-01 2.341434979466302801e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 2.968750000000000000e-01 1.592228944729608964e-01 1.592228944729608964e-01 1.592228944729608964e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 1.936524992267049661e-01 1.936524992267049661e-01 1.936524992267049661e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 1.390550494950238691e-01 1.390550494950238691e-01 1.390550494950238691e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 1.955113171788509241e-01 1.955113171788509241e-01 1.955113171788509241e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 1.461698632753277161e-01 1.461698632753277161e-01 1.461698632753277161e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 2.197482663020811355e-01 2.197482663020811355e-01 2.197482663020811355e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 3.011365219806441118e-01 3.011365219806441118e-01 3.011365219806441118e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 2.968750000000000000e-01 1.372125964639235862e-01 1.372125964639235862e-01 1.372125964639235862e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.215918149173972479e-01 1.215918149173972479e-01 1.215918149173972479e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 2.968750000000000000e-01 9.768045031829158953e-02 9.768045031829158953e-02 9.768045031829158953e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 1.992601237740170284e-01 1.992601237740170284e-01 1.992601237740170284e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.704048192753007673e-01 1.704048192753007673e-01 1.704048192753007673e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 3.281250000000000000e-01 1.211507872442895428e-01 1.211507872442895428e-01 1.211507872442895428e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 3.281250000000000000e-01 1.381378440622456349e-01 1.381378440622456349e-01 1.381378440622456349e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 3.593750000000000000e-01 9.732929134927573167e-02 9.732929134927573167e-02 9.732929134927573167e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 7.143573286126522759e-02 7.143573286126522759e-02 7.143573286126522759e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 4.402672426211620693e-02 4.402672426211620693e-02 4.402672426211620693e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.245721024903309743e-01 1.245721024903309743e-01 1.245721024903309743e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.011477615164649291e-01 1.011477615164649291e-01 1.011477615164649291e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 1.256509233106537782e-01 1.256509233106537782e-01 1.256509233106537782e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 9.089164102866340023e-02 9.089164102866340023e-02 9.089164102866340023e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 8.136962798422833765e-02 8.136962798422833765e-02 8.136962798422833765e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 3.281250000000000000e-01 7.618959109705633614e-02 7.618959109705633614e-02 7.618959109705633614e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 3.281250000000000000e-01 9.978335422283259037e-02 9.978335422283259037e-02 9.978335422283259037e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 3.281250000000000000e-01 6.984108336388426819e-02 6.984108336388426819e-02 6.984108336388426819e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 1.748845397928440459e-01 1.748845397928440459e-01 1.748845397928440459e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.492913805923741233e-01 1.492913805923741233e-01 1.492913805923741233e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 1.934293739776412613e-01 1.934293739776412613e-01 1.934293739776412613e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.858876976828397198e-01 1.858876976828397198e-01 1.858876976828397198e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 1.126334180019250703e-01 1.126334180019250703e-01 1.126334180019250703e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 8.196599240106322570e-02 8.196599240106322570e-02 8.196599240106322570e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 1.597512346530731153e-01 1.597512346530731153e-01 1.597512346530731153e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 9.245951468981278287e-02 9.245951468981278287e-02 9.245951468981278287e-02 -2.656250000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 9.347206678241033739e-02 9.347206678241033739e-02 9.347206678241033739e-02 -2.656250000000000000e-01 -3.281250000000000000e-01 7.812500000000000000e-02 9.962666285806615063e-02 9.962666285806615063e-02 9.962666285806615063e-02 -2.656250000000000000e-01 -3.281250000000000000e-01 1.093750000000000000e-01 7.719688233554182488e-02 7.719688233554182488e-02 7.719688233554182488e-02 -2.656250000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 6.484230588174212662e-02 6.484230588174212662e-02 6.484230588174212662e-02 -2.656250000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 1.101733195364972967e-01 1.101733195364972967e-01 1.101733195364972967e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 4.807760646578777830e-02 4.807760646578777830e-02 4.807760646578777830e-02 -2.656250000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 8.618381830811114308e-02 8.618381830811114308e-02 8.618381830811114308e-02 -2.656250000000000000e-01 -2.968750000000000000e-01 7.812500000000000000e-02 7.865000552778751708e-02 7.865000552778751708e-02 7.865000552778751708e-02 -2.656250000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 8.937115209848597863e-02 8.937115209848597863e-02 8.937115209848597863e-02 -2.656250000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 1.085503525211953257e-01 1.085503525211953257e-01 1.085503525211953257e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 1.242331103848671597e-01 1.242331103848671597e-01 1.242331103848671597e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.008416156036232025e-01 1.008416156036232025e-01 1.008416156036232025e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 7.029830840965334282e-02 7.029830840965334282e-02 7.029830840965334282e-02 -2.968750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 1.462766730467693066e-01 1.462766730467693066e-01 1.462766730467693066e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 7.812500000000000000e-02 1.157024099112240051e-01 1.157024099112240051e-01 1.157024099112240051e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 1.223107892741866626e-01 1.223107892741866626e-01 1.223107892741866626e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.009227725076334292e-01 1.009227725076334292e-01 1.009227725076334292e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.250709484651415793e-01 1.250709484651415793e-01 1.250709484651415793e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.069402083380723706e-01 1.069402083380723706e-01 1.069402083380723706e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.236804377285028872e-01 1.236804377285028872e-01 1.236804377285028872e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 6.637025218729578069e-02 6.637025218729578069e-02 6.637025218729578069e-02 -2.656250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 7.390521489024073909e-02 7.390521489024073909e-02 7.390521489024073909e-02 -2.656250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.068478088668797371e-01 1.068478088668797371e-01 1.068478088668797371e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 6.605778402154205420e-02 6.605778402154205420e-02 6.605778402154205420e-02 -2.968750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 8.514384899878535418e-02 8.514384899878535418e-02 8.514384899878535418e-02 -2.968750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 1.075387936462281341e-01 1.075387936462281341e-01 1.075387936462281341e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 9.899105526923319964e-02 9.899105526923319964e-02 9.899105526923319964e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 7.480466562098739280e-02 7.480466562098739280e-02 7.480466562098739280e-02 -3.281250000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 9.860615265739068602e-02 9.860615265739068602e-02 9.860615265739068602e-02 -3.281250000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.272566767285816247e-01 1.272566767285816247e-01 1.272566767285816247e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.009701809582573134e-01 1.009701809582573134e-01 1.009701809582573134e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 1.245174782665642993e-01 1.245174782665642993e-01 1.245174782665642993e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 6.106962453772158544e-02 6.106962453772158544e-02 6.106962453772158544e-02 -3.593750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 8.550390171847384313e-02 8.550390171847384313e-02 8.550390171847384313e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 6.161774311848438462e-02 6.161774311848438462e-02 6.161774311848438462e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 5.072364815481397032e-02 5.072364815481397032e-02 5.072364815481397032e-02 -3.281250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.212455802814559197e-01 1.212455802814559197e-01 1.212455802814559197e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 8.442936461190388153e-02 8.442936461190388153e-02 8.442936461190388153e-02 -3.593750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.001192351970800337e-01 1.001192351970800337e-01 1.001192351970800337e-01 -3.593750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 9.091414276321696519e-02 9.091414276321696519e-02 9.091414276321696519e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.081646921786026255e-01 1.081646921786026255e-01 1.081646921786026255e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 4.308029094023117789e-02 4.308029094023117789e-02 4.308029094023117789e-02 -2.656250000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 1.042171915786102715e-01 1.042171915786102715e-01 1.042171915786102715e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 5.044529081988130548e-02 5.044529081988130548e-02 5.044529081988130548e-02 -2.968750000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 4.666952206461810054e-02 4.666952206461810054e-02 4.666952206461810054e-02 -2.968750000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 9.960737774591842120e-02 9.960737774591842120e-02 9.960737774591842120e-02 -2.656250000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 4.351692213990573238e-02 4.351692213990573238e-02 4.351692213990573238e-02 -2.656250000000000000e-01 -2.343750000000000000e-01 2.343750000000000000e-01 3.334304078091653717e-02 3.334304078091653717e-02 3.334304078091653717e-02 -2.656250000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 1.960498526983480705e-01 1.960498526983480705e-01 1.960498526983480705e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 5.822590803316204933e-02 5.822590803316204933e-02 5.822590803316204933e-02 -2.968750000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 4.720977846693028002e-02 4.720977846693028002e-02 4.720977846693028002e-02 -2.968750000000000000e-01 -2.343750000000000000e-01 2.343750000000000000e-01 3.865691442550911461e-02 3.865691442550911461e-02 3.865691442550911461e-02 -2.968750000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 3.901138535226731513e-02 3.901138535226731513e-02 3.901138535226731513e-02 -2.656250000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 7.775686715076282618e-02 7.775686715076282618e-02 7.775686715076282618e-02 -2.656250000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 7.334705202582404715e-02 7.334705202582404715e-02 7.334705202582404715e-02 -2.656250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.022927851158920987e-01 1.022927851158920987e-01 1.022927851158920987e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 7.610310428408981198e-02 7.610310428408981198e-02 7.610310428408981198e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.082908354524361738e-01 1.082908354524361738e-01 1.082908354524361738e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 1.124076576917303893e-01 1.124076576917303893e-01 1.124076576917303893e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 9.514757142139715351e-02 9.514757142139715351e-02 9.514757142139715351e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 2.088219597345408740e-01 2.088219597345408740e-01 2.088219597345408740e-01 -3.281250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 8.827416417493172407e-02 8.827416417493172407e-02 8.827416417493172407e-02 -3.281250000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 1.020581570461670112e-01 1.020581570461670112e-01 1.020581570461670112e-01 -3.281250000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.349958141400112444e-01 1.349958141400112444e-01 1.349958141400112444e-01 -3.281250000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 4.894011835657838955e-02 4.894011835657838955e-02 4.894011835657838955e-02 -3.281250000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 1.153786448225290195e-01 1.153786448225290195e-01 1.153786448225290195e-01 -3.281250000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 9.486470689933379496e-02 9.486470689933379496e-02 9.486470689933379496e-02 -3.281250000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 9.023748070860000692e-02 9.023748070860000692e-02 9.023748070860000692e-02 -3.281250000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.294278871386751739e-01 1.294278871386751739e-01 1.294278871386751739e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 8.274720702439147813e-02 8.274720702439147813e-02 8.274720702439147813e-02 -3.281250000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 5.859725622831771230e-02 5.859725622831771230e-02 5.859725622831771230e-02 -3.593750000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 6.257971516083137009e-02 6.257971516083137009e-02 6.257971516083137009e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 8.643858462836742640e-02 8.643858462836742640e-02 8.643858462836742640e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 6.736866304466176958e-02 6.736866304466176958e-02 6.736866304466176958e-02 -3.281250000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 1.067658544644887186e-01 1.067658544644887186e-01 1.067658544644887186e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 1.140658965955797938e-01 1.140658965955797938e-01 1.140658965955797938e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 9.590294339617896902e-02 9.590294339617896902e-02 9.590294339617896902e-02 -3.281250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 9.601865932757160105e-02 9.601865932757160105e-02 9.601865932757160105e-02 -3.593750000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 1.044164594299719084e-01 1.044164594299719084e-01 1.044164594299719084e-01 -3.593750000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 9.134408541118078928e-02 9.134408541118078928e-02 9.134408541118078928e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 8.950295037365690876e-02 8.950295037365690876e-02 8.950295037365690876e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.463698303256171784e-01 1.463698303256171784e-01 1.463698303256171784e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 9.270783221570308430e-02 9.270783221570308430e-02 9.270783221570308430e-02 -2.656250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 2.084223354643264803e-01 2.084223354643264803e-01 2.084223354643264803e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 1.989776250595348128e-01 1.989776250595348128e-01 1.989776250595348128e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.517518892808381592e-01 1.517518892808381592e-01 1.517518892808381592e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 6.433737864481479940e-02 6.433737864481479940e-02 6.433737864481479940e-02 -2.968750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 7.274306785899592454e-02 7.274306785899592454e-02 7.274306785899592454e-02 -2.968750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 6.400625205743272483e-02 6.400625205743272483e-02 6.400625205743272483e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 2.370570496164033092e-01 2.370570496164033092e-01 2.370570496164033092e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.856605374613901904e-01 1.856605374613901904e-01 1.856605374613901904e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.142426448507026238e-01 1.142426448507026238e-01 1.142426448507026238e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.607565167213571289e-01 1.607565167213571289e-01 1.607565167213571289e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 9.773107494027148678e-02 9.773107494027148678e-02 9.773107494027148678e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 6.953505945288340762e-02 6.953505945288340762e-02 6.953505945288340762e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.351821547157001646e-01 1.351821547157001646e-01 1.351821547157001646e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 6.995522910040108400e-02 6.995522910040108400e-02 6.995522910040108400e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 8.928837624211617696e-02 8.928837624211617696e-02 8.928837624211617696e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 9.705848807701226988e-02 9.705848807701226988e-02 9.705848807701226988e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 8.544523252359216559e-02 8.544523252359216559e-02 8.544523252359216559e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 5.607255316873403089e-02 5.607255316873403089e-02 5.607255316873403089e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 4.816404300486588214e-02 4.816404300486588214e-02 4.816404300486588214e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 3.891215294986935525e-02 3.891215294986935525e-02 3.891215294986935525e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 4.528079157150715489e-02 4.528079157150715489e-02 4.528079157150715489e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 4.683218634004503167e-02 4.683218634004503167e-02 4.683218634004503167e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 3.481513103029158090e-02 3.481513103029158090e-02 3.481513103029158090e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 6.506265285169450518e-02 6.506265285169450518e-02 6.506265285169450518e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 8.857232134718269478e-02 8.857232134718269478e-02 8.857232134718269478e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 7.383777577517221247e-02 7.383777577517221247e-02 7.383777577517221247e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 9.183429758967312506e-02 9.183429758967312506e-02 9.183429758967312506e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 8.869528072175476840e-02 8.869528072175476840e-02 8.869528072175476840e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.173493337403371389e-01 1.173493337403371389e-01 1.173493337403371389e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.023876003745956970e-01 1.023876003745956970e-01 1.023876003745956970e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 7.320903794393840425e-02 7.320903794393840425e-02 7.320903794393840425e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 8.356699199093098329e-02 8.356699199093098329e-02 8.356699199093098329e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 6.529891622525715866e-02 6.529891622525715866e-02 6.529891622525715866e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 9.016595671468140283e-02 9.016595671468140283e-02 9.016595671468140283e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 7.395175508092087513e-02 7.395175508092087513e-02 7.395175508092087513e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 6.999630544906458585e-02 6.999630544906458585e-02 6.999630544906458585e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 8.252940000624457706e-02 8.252940000624457706e-02 8.252940000624457706e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 7.079741063128361378e-02 7.079741063128361378e-02 7.079741063128361378e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 4.625863852024419270e-02 4.625863852024419270e-02 4.625863852024419270e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 5.623881634276030328e-02 5.623881634276030328e-02 5.623881634276030328e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 8.673996330310837499e-02 8.673996330310837499e-02 8.673996330310837499e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 4.803241821026988517e-02 4.803241821026988517e-02 4.803241821026988517e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 1.733616233650794591e-01 1.733616233650794591e-01 1.733616233650794591e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.796040328586351875e-01 1.796040328586351875e-01 1.796040328586351875e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.358094446024434299e-01 1.358094446024434299e-01 1.358094446024434299e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.653114433262859728e-01 1.653114433262859728e-01 1.653114433262859728e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.779158364060072772e-01 1.779158364060072772e-01 1.779158364060072772e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.878076976795726161e-01 1.878076976795726161e-01 1.878076976795726161e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.320641060322871874e-01 1.320641060322871874e-01 1.320641060322871874e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.746300533922123255e-01 1.746300533922123255e-01 1.746300533922123255e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.498005129118056833e-01 1.498005129118056833e-01 1.498005129118056833e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 7.382169969647926766e-02 7.382169969647926766e-02 7.382169969647926766e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.257119730511852274e-01 1.257119730511852274e-01 1.257119730511852274e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.493050324473993995e-01 1.493050324473993995e-01 1.493050324473993995e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.487581533840551251e-01 1.487581533840551251e-01 1.487581533840551251e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 4.108277349813165003e-02 4.108277349813165003e-02 4.108277349813165003e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.537128543967085648e-01 1.537128543967085648e-01 1.537128543967085648e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.345197306780729685e-01 2.345197306780729685e-01 2.345197306780729685e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.380157633912647008e-01 1.380157633912647008e-01 1.380157633912647008e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.464123935292051537e-01 1.464123935292051537e-01 1.464123935292051537e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.749495661572773586e-01 1.749495661572773586e-01 1.749495661572773586e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.796891240863524863e-01 1.796891240863524863e-01 1.796891240863524863e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.353371704691840871e-01 1.353371704691840871e-01 1.353371704691840871e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 6.832445699977686415e-02 6.832445699977686415e-02 6.832445699977686415e-02 -3.281250000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 5.093342056489340991e-02 5.093342056489340991e-02 5.093342056489340991e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 9.819312358942224039e-02 9.819312358942224039e-02 9.819312358942224039e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 6.921512777336795430e-02 6.921512777336795430e-02 6.921512777336795430e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 9.214851398895634871e-02 9.214851398895634871e-02 9.214851398895634871e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 4.309178972965056059e-02 4.309178972965056059e-02 4.309178972965056059e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 8.189928339342139596e-02 8.189928339342139596e-02 8.189928339342139596e-02 -3.281250000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 5.521301210236297108e-02 5.521301210236297108e-02 5.521301210236297108e-02 -3.281250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 6.592417879097889344e-02 6.592417879097889344e-02 6.592417879097889344e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 7.985056657451775064e-02 7.985056657451775064e-02 7.985056657451775064e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 7.988319856549196130e-02 7.988319856549196130e-02 7.988319856549196130e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 6.880138509430373805e-02 6.880138509430373805e-02 6.880138509430373805e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.126792127206472233e-01 1.126792127206472233e-01 1.126792127206472233e-01 -3.281250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 8.698588746522499526e-02 8.698588746522499526e-02 8.698588746522499526e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 1.104513096123666410e-01 1.104513096123666410e-01 1.104513096123666410e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.018387952524755780e-01 1.018387952524755780e-01 1.018387952524755780e-01 -3.593750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.013148958014403189e-01 1.013148958014403189e-01 1.013148958014403189e-01 -3.281250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 8.967010885110794638e-02 8.967010885110794638e-02 8.967010885110794638e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 9.619223291260946274e-02 9.619223291260946274e-02 9.619223291260946274e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 9.058947426909573497e-02 9.058947426909573497e-02 9.058947426909573497e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 9.747955864720488084e-02 9.747955864720488084e-02 9.747955864720488084e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 9.475140009304872102e-02 9.475140009304872102e-02 9.475140009304872102e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 8.947964459680934901e-02 8.947964459680934901e-02 8.947964459680934901e-02 -3.906250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 5.551426657344198795e-02 5.551426657344198795e-02 5.551426657344198795e-02 -3.906250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 8.737566768550539265e-02 8.737566768550539265e-02 8.737566768550539265e-02 -3.906250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 7.695084787226233458e-02 7.695084787226233458e-02 7.695084787226233458e-02 -3.906250000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 1.284728188196530285e-01 1.284728188196530285e-01 1.284728188196530285e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.134858382300900914e-01 1.134858382300900914e-01 1.134858382300900914e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 6.494817861645932333e-02 6.494817861645932333e-02 6.494817861645932333e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 5.708990475284760058e-02 5.708990475284760058e-02 5.708990475284760058e-02 -3.906250000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 7.808552586525550898e-02 7.808552586525550898e-02 7.808552586525550898e-02 -3.906250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 8.797841688555455009e-02 8.797841688555455009e-02 8.797841688555455009e-02 -3.906250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 9.317633859977392241e-02 9.317633859977392241e-02 9.317633859977392241e-02 -3.906250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 1.054409133746793681e-01 1.054409133746793681e-01 1.054409133746793681e-01 -4.218750000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 5.169258467727860101e-02 5.169258467727860101e-02 5.169258467727860101e-02 -4.218750000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 6.949952941459544564e-02 6.949952941459544564e-02 6.949952941459544564e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 9.336518688531093846e-02 9.336518688531093846e-02 9.336518688531093846e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 1.159458354101791377e-01 1.159458354101791377e-01 1.159458354101791377e-01 -4.531250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 4.687407856929230732e-02 4.687407856929230732e-02 4.687407856929230732e-02 -4.531250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 7.152246583981360095e-02 7.152246583981360095e-02 7.152246583981360095e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 7.708282724993752166e-02 7.708282724993752166e-02 7.708282724993752166e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 5.785005592795281620e-02 5.785005592795281620e-02 5.785005592795281620e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 6.833337983348658495e-02 6.833337983348658495e-02 6.833337983348658495e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 7.434441174906454564e-02 7.434441174906454564e-02 7.434441174906454564e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 9.761134364004357689e-02 9.761134364004357689e-02 9.761134364004357689e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 9.652491457056810997e-02 9.652491457056810997e-02 9.652491457056810997e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.074761231784038401e-01 1.074761231784038401e-01 1.074761231784038401e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.074865682597557492e-01 1.074865682597557492e-01 1.074865682597557492e-01 -3.906250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 7.103679210892593909e-02 7.103679210892593909e-02 7.103679210892593909e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 9.080163402746189993e-02 9.080163402746189993e-02 9.080163402746189993e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 7.476905753031640178e-02 7.476905753031640178e-02 7.476905753031640178e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 8.735236129242346381e-02 8.735236129242346381e-02 8.735236129242346381e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.662861464594391769e-01 1.662861464594391769e-01 1.662861464594391769e-01 -3.906250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 5.190404300939191473e-02 5.190404300939191473e-02 5.190404300939191473e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 8.686774752036954816e-02 8.686774752036954816e-02 8.686774752036954816e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 3.695602732466200802e-02 3.695602732466200802e-02 3.695602732466200802e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 5.450187984681883341e-02 5.450187984681883341e-02 5.450187984681883341e-02 -4.531250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.181454687329351882e-01 1.181454687329351882e-01 1.181454687329351882e-01 -4.531250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 8.037645441324235696e-02 8.037645441324235696e-02 8.037645441324235696e-02 -4.843750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.203715521128322641e-01 1.203715521128322641e-01 1.203715521128322641e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.239222324828196109e-01 1.239222324828196109e-01 1.239222324828196109e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.185423282389286709e-01 1.185423282389286709e-01 1.185423282389286709e-01 -4.843750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.177084389958914096e-01 1.177084389958914096e-01 1.177084389958914096e-01 -4.843750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.719735526535577375e-01 1.719735526535577375e-01 1.719735526535577375e-01 -4.843750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.188548336382264092e-01 1.188548336382264092e-01 1.188548336382264092e-01 -4.843750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.566566213866172341e-01 1.566566213866172341e-01 1.566566213866172341e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 7.728891398161573389e-02 7.728891398161573389e-02 7.728891398161573389e-02 -4.531250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 8.685810343558592050e-02 8.685810343558592050e-02 8.685810343558592050e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.309765356396866143e-01 1.309765356396866143e-01 1.309765356396866143e-01 -4.843750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 5.432234710330369198e-02 5.432234710330369198e-02 5.432234710330369198e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 1.058627435603961831e-01 1.058627435603961831e-01 1.058627435603961831e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 5.782778613313902666e-02 5.782778613313902666e-02 5.782778613313902666e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 8.459492623822187363e-02 8.459492623822187363e-02 8.459492623822187363e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 5.471542118220562578e-02 5.471542118220562578e-02 5.471542118220562578e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.101749264182989158e-01 1.101749264182989158e-01 1.101749264182989158e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 9.874516780062556065e-02 9.874516780062556065e-02 9.874516780062556065e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 7.899650389716186827e-02 7.899650389716186827e-02 7.899650389716186827e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 5.925633676710623937e-02 5.925633676710623937e-02 5.925633676710623937e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 8.274559959469274251e-02 8.274559959469274251e-02 8.274559959469274251e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 6.370719992606159454e-02 6.370719992606159454e-02 6.370719992606159454e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 7.234123984152558695e-02 7.234123984152558695e-02 7.234123984152558695e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 8.173693111962772317e-02 8.173693111962772317e-02 8.173693111962772317e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.110217486678149040e-01 1.110217486678149040e-01 1.110217486678149040e-01 -4.218750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.050496136821801180e-01 1.050496136821801180e-01 1.050496136821801180e-01 -4.218750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 8.109877098741584411e-02 8.109877098741584411e-02 8.109877098741584411e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 8.735155762358098874e-02 8.735155762358098874e-02 8.735155762358098874e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 7.708347026708163574e-02 7.708347026708163574e-02 7.708347026708163574e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 8.225693947441814480e-02 8.225693947441814480e-02 8.225693947441814480e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 7.233810494811300507e-02 7.233810494811300507e-02 7.233810494811300507e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 6.207171882239188171e-02 6.207171882239188171e-02 6.207171882239188171e-02 -4.218750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 7.208699155155763594e-02 7.208699155155763594e-02 7.208699155155763594e-02 -4.531250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.073186433258255662e-01 1.073186433258255662e-01 1.073186433258255662e-01 -4.531250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 4.527564540036813773e-02 4.527564540036813773e-02 4.527564540036813773e-02 -4.531250000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 4.008837874802217982e-02 4.008837874802217982e-02 4.008837874802217982e-02 -4.531250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 5.788904815311263913e-02 5.788904815311263913e-02 5.788904815311263913e-02 -4.531250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.140506319553343251e-01 1.140506319553343251e-01 1.140506319553343251e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 8.320130463100447460e-02 8.320130463100447460e-02 8.320130463100447460e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 9.342626112960827900e-02 9.342626112960827900e-02 9.342626112960827900e-02 -2.656250000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 1.393602468826480034e-01 1.393602468826480034e-01 1.393602468826480034e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 2.103907466643042123e-01 2.103907466643042123e-01 2.103907466643042123e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 7.267779807148229410e-02 7.267779807148229410e-02 7.267779807148229410e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 9.294811284610676738e-02 9.294811284610676738e-02 9.294811284610676738e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 2.043770310559001602e-01 2.043770310559001602e-01 2.043770310559001602e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.581121852498821645e-01 2.581121852498821645e-01 2.581121852498821645e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.842343568079040428e-01 2.842343568079040428e-01 2.842343568079040428e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 6.889149709664442456e-02 6.889149709664442456e-02 6.889149709664442456e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 4.630897387741451238e-02 4.630897387741451238e-02 4.630897387741451238e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 9.063849608115305545e-02 9.063849608115305545e-02 9.063849608115305545e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 2.968750000000000000e-01 6.886931074325872149e-02 6.886931074325872149e-02 6.886931074325872149e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 9.487515361812712267e-02 9.487515361812712267e-02 9.487515361812712267e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 2.968750000000000000e-01 6.813844382639863695e-02 6.813844382639863695e-02 6.813844382639863695e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 1.150163155977008828e-01 1.150163155977008828e-01 1.150163155977008828e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 1.078151858963001253e-01 1.078151858963001253e-01 1.078151858963001253e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 2.968750000000000000e-01 7.624770439593263338e-02 7.624770439593263338e-02 7.624770439593263338e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 8.963796301703143288e-02 8.963796301703143288e-02 8.963796301703143288e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 1.051355872890441800e-01 1.051355872890441800e-01 1.051355872890441800e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 2.968750000000000000e-01 7.951789633479859620e-02 7.951789633479859620e-02 7.951789633479859620e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 9.273113705743586677e-02 9.273113705743586677e-02 9.273113705743586677e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 2.968750000000000000e-01 6.360872149433179079e-02 6.360872149433179079e-02 6.360872149433179079e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 8.158824186857231708e-02 8.158824186857231708e-02 8.158824186857231708e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 8.929319813898675684e-02 8.929319813898675684e-02 8.929319813898675684e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 9.987576180773066747e-02 9.987576180773066747e-02 9.987576180773066747e-02 -5.156250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.164551787908357783e-01 1.164551787908357783e-01 1.164551787908357783e-01 -5.468750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.194452968246886571e-01 1.194452968246886571e-01 1.194452968246886571e-01 -5.156250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.469030733632364361e-01 1.469030733632364361e-01 1.469030733632364361e-01 -5.156250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 9.557829503348930222e-02 9.557829503348930222e-02 9.557829503348930222e-02 -5.156250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.140891952514298952e-01 1.140891952514298952e-01 1.140891952514298952e-01 -5.156250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.099226455808901687e-01 1.099226455808901687e-01 1.099226455808901687e-01 -5.468750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.557412225689883412e-01 1.557412225689883412e-01 1.557412225689883412e-01 -5.468750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 9.205609752831150905e-02 9.205609752831150905e-02 9.205609752831150905e-02 -5.468750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.506613728479542225e-01 1.506613728479542225e-01 1.506613728479542225e-01 -5.468750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.024767908973310965e-01 1.024767908973310965e-01 1.024767908973310965e-01 -5.781250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 8.941053087404306210e-02 8.941053087404306210e-02 8.941053087404306210e-02 -5.781250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.188106491438814527e-01 1.188106491438814527e-01 1.188106491438814527e-01 -1.562500000000000000e-02 1.562500000000000000e-02 -4.218750000000000000e-01 6.657411550749747775e-02 6.657411550749747775e-02 6.657411550749747775e-02 -1.562500000000000000e-02 1.562500000000000000e-02 -3.906250000000000000e-01 9.101298959409012679e-02 9.101298959409012679e-02 9.101298959409012679e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -4.218750000000000000e-01 6.985378409470235916e-02 6.985378409470235916e-02 6.985378409470235916e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -3.906250000000000000e-01 7.159625712329548142e-02 7.159625712329548142e-02 7.159625712329548142e-02 -4.687500000000000000e-02 4.687500000000000000e-02 -3.906250000000000000e-01 6.531386856241036543e-02 6.531386856241036543e-02 6.531386856241036543e-02 -1.562500000000000000e-02 7.812500000000000000e-02 -4.218750000000000000e-01 7.211399994424823323e-02 7.211399994424823323e-02 7.211399994424823323e-02 -1.562500000000000000e-02 7.812500000000000000e-02 -3.906250000000000000e-01 7.827215904967245452e-02 7.827215904967245452e-02 7.827215904967245452e-02 -4.687500000000000000e-02 7.812500000000000000e-02 -3.906250000000000000e-01 7.051180782236489419e-02 7.051180782236489419e-02 7.051180782236489419e-02 -1.562500000000000000e-02 1.562500000000000000e-02 -3.593750000000000000e-01 8.942338924557431679e-02 8.942338924557431679e-02 8.942338924557431679e-02 -1.562500000000000000e-02 1.562500000000000000e-02 -3.281250000000000000e-01 5.594238848082636051e-02 5.594238848082636051e-02 5.594238848082636051e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 6.492856363284350840e-02 6.492856363284350840e-02 6.492856363284350840e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -3.281250000000000000e-01 5.982593300534777558e-02 5.982593300534777558e-02 5.982593300534777558e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -3.593750000000000000e-01 7.042523452188072242e-02 7.042523452188072242e-02 7.042523452188072242e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -3.281250000000000000e-01 4.424157996179689523e-02 4.424157996179689523e-02 4.424157996179689523e-02 -4.687500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 4.949282224320925710e-02 4.949282224320925710e-02 4.949282224320925710e-02 -4.687500000000000000e-02 4.687500000000000000e-02 -3.281250000000000000e-01 4.813308667363247473e-02 4.813308667363247473e-02 4.813308667363247473e-02 -1.562500000000000000e-02 1.562500000000000000e-02 -2.968750000000000000e-01 2.926881720174854401e-02 2.926881720174854401e-02 2.926881720174854401e-02 -1.562500000000000000e-02 1.562500000000000000e-02 -2.656250000000000000e-01 6.183190870687384905e-02 6.183190870687384905e-02 6.183190870687384905e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -2.968750000000000000e-01 6.266549298847629013e-02 6.266549298847629013e-02 6.266549298847629013e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -2.968750000000000000e-01 8.399858130803899980e-02 8.399858130803899980e-02 8.399858130803899980e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -2.656250000000000000e-01 1.492970019447228680e-01 1.492970019447228680e-01 1.492970019447228680e-01 -4.687500000000000000e-02 4.687500000000000000e-02 -2.968750000000000000e-01 5.919370907295976036e-02 5.919370907295976036e-02 5.919370907295976036e-02 -1.562500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 6.216979717526353172e-02 6.216979717526353172e-02 6.216979717526353172e-02 -1.562500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 5.968829769948132830e-02 5.968829769948132830e-02 5.968829769948132830e-02 -1.562500000000000000e-02 1.093750000000000000e-01 -3.593750000000000000e-01 3.910249570796253682e-02 3.910249570796253682e-02 3.910249570796253682e-02 -4.687500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 5.320100208888541016e-02 5.320100208888541016e-02 5.320100208888541016e-02 -4.687500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 5.525280959516155194e-02 5.525280959516155194e-02 5.525280959516155194e-02 -1.562500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 8.857714328698694517e-02 8.857714328698694517e-02 8.857714328698694517e-02 -1.562500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 8.505062079982787793e-02 8.505062079982787793e-02 8.505062079982787793e-02 -1.562500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 7.844295777315918317e-02 7.844295777315918317e-02 7.844295777315918317e-02 -4.687500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 9.409325314800712214e-02 9.409325314800712214e-02 9.409325314800712214e-02 -4.687500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 9.613839299805948535e-02 9.613839299805948535e-02 9.613839299805948535e-02 -7.812500000000000000e-02 1.562500000000000000e-02 -3.593750000000000000e-01 4.225470572985830925e-02 4.225470572985830925e-02 4.225470572985830925e-02 -7.812500000000000000e-02 1.562500000000000000e-02 -3.281250000000000000e-01 5.603203249785197737e-02 5.603203249785197737e-02 5.603203249785197737e-02 -7.812500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 4.898168786736682712e-02 4.898168786736682712e-02 4.898168786736682712e-02 -1.093750000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 4.887032655711806561e-02 4.887032655711806561e-02 4.887032655711806561e-02 -1.093750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 7.586373788019766529e-02 7.586373788019766529e-02 7.586373788019766529e-02 -1.093750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 4.456539021856276150e-02 4.456539021856276150e-02 4.456539021856276150e-02 -1.093750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 6.496618581033222761e-02 6.496618581033222761e-02 6.496618581033222761e-02 -1.093750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 5.404496702094296195e-02 5.404496702094296195e-02 5.404496702094296195e-02 -7.812500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 4.735137505763899191e-02 4.735137505763899191e-02 4.735137505763899191e-02 -7.812500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 6.042808470007769023e-02 6.042808470007769023e-02 6.042808470007769023e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 3.750511437761375882e-02 3.750511437761375882e-02 3.750511437761375882e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 5.646513631034013464e-02 5.646513631034013464e-02 5.646513631034013464e-02 -7.812500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 8.115744335192977277e-02 8.115744335192977277e-02 8.115744335192977277e-02 -7.812500000000000000e-02 7.812500000000000000e-02 -2.656250000000000000e-01 1.259939258570665355e-01 1.259939258570665355e-01 1.259939258570665355e-01 -7.812500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 7.308155355544410092e-02 7.308155355544410092e-02 7.308155355544410092e-02 -7.812500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 8.822353360197741912e-02 8.822353360197741912e-02 8.822353360197741912e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 5.460414820768279276e-02 5.460414820768279276e-02 5.460414820768279276e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.069193180321302145e-01 1.069193180321302145e-01 1.069193180321302145e-01 -1.093750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 9.451273204286922414e-02 9.451273204286922414e-02 9.451273204286922414e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -3.906250000000000000e-01 8.974404422073556375e-02 8.974404422073556375e-02 8.974404422073556375e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -3.906250000000000000e-01 5.709577374237059105e-02 5.709577374237059105e-02 5.709577374237059105e-02 -1.562500000000000000e-02 1.406250000000000000e-01 -2.968750000000000000e-01 6.607860455192128557e-02 6.607860455192128557e-02 6.607860455192128557e-02 -1.562500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 1.158486259758300663e-01 1.158486259758300663e-01 1.158486259758300663e-01 -1.562500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 7.800137200093811007e-02 7.800137200093811007e-02 7.800137200093811007e-02 -4.687500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 1.092421261285930478e-01 1.092421261285930478e-01 1.092421261285930478e-01 -4.687500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 6.471939043637199573e-02 6.471939043637199573e-02 6.471939043637199573e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -3.593750000000000000e-01 7.280656920241206087e-02 7.280656920241206087e-02 7.280656920241206087e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -3.281250000000000000e-01 6.855725421152723820e-02 6.855725421152723820e-02 6.855725421152723820e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -3.593750000000000000e-01 9.697330941123911974e-02 9.697330941123911974e-02 9.697330941123911974e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -3.281250000000000000e-01 8.572491542462003233e-02 8.572491542462003233e-02 8.572491542462003233e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -3.593750000000000000e-01 6.086703356269862475e-02 6.086703356269862475e-02 6.086703356269862475e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -3.281250000000000000e-01 6.567489431094432339e-02 6.567489431094432339e-02 6.567489431094432339e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 6.626655179860506395e-02 6.626655179860506395e-02 6.626655179860506395e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -2.968750000000000000e-01 7.797026639556846328e-02 7.797026639556846328e-02 7.797026639556846328e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 1.146483609676954146e-01 1.146483609676954146e-01 1.146483609676954146e-01 -4.687500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 6.179758115280357955e-02 6.179758115280357955e-02 6.179758115280357955e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -2.968750000000000000e-01 8.558266303611676562e-02 8.558266303611676562e-02 8.558266303611676562e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 8.394232212419124040e-02 8.394232212419124040e-02 8.394232212419124040e-02 -7.812500000000000000e-02 1.406250000000000000e-01 -2.968750000000000000e-01 8.900066920510807389e-02 8.900066920510807389e-02 8.900066920510807389e-02 -7.812500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 1.304198931112521553e-01 1.304198931112521553e-01 1.304198931112521553e-01 -7.812500000000000000e-02 1.718750000000000000e-01 -2.968750000000000000e-01 8.373175168687709002e-02 8.373175168687709002e-02 8.373175168687709002e-02 -7.812500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 9.480524093579938139e-02 9.480524093579938139e-02 9.480524093579938139e-02 -1.093750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 9.975523015420122153e-02 9.975523015420122153e-02 9.975523015420122153e-02 -1.093750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 8.876921698722983756e-02 8.876921698722983756e-02 8.876921698722983756e-02 -7.812500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 8.730414114738081766e-02 8.730414114738081766e-02 8.730414114738081766e-02 -7.812500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 1.183471121678531940e-01 1.183471121678531940e-01 1.183471121678531940e-01 -1.093750000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 8.102161274427943649e-02 8.102161274427943649e-02 8.102161274427943649e-02 -1.093750000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 1.308078564923199627e-01 1.308078564923199627e-01 1.308078564923199627e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 1.397224664902863567e-01 1.397224664902863567e-01 1.397224664902863567e-01 -1.406250000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 7.459246367393811139e-02 7.459246367393811139e-02 7.459246367393811139e-02 -1.406250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 6.609612916406035210e-02 6.609612916406035210e-02 6.609612916406035210e-02 -1.406250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 6.478104915611518355e-02 6.478104915611518355e-02 6.478104915611518355e-02 -1.406250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 6.835138626970242715e-02 6.835138626970242715e-02 6.835138626970242715e-02 -1.406250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 5.137306445491334611e-02 5.137306445491334611e-02 5.137306445491334611e-02 -1.718750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 5.018446060023787347e-02 5.018446060023787347e-02 5.018446060023787347e-02 -1.718750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 7.650788748906096892e-02 7.650788748906096892e-02 7.650788748906096892e-02 -1.718750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 7.002942374229079170e-02 7.002942374229079170e-02 7.002942374229079170e-02 -1.718750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 1.016467527516194264e-01 1.016467527516194264e-01 1.016467527516194264e-01 -1.406250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 6.589628404877435897e-02 6.589628404877435897e-02 6.589628404877435897e-02 -1.406250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.122509909119440430e-01 1.122509909119440430e-01 1.122509909119440430e-01 -1.406250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 2.776336523670119849e-01 2.776336523670119849e-01 2.776336523670119849e-01 -1.718750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 9.762580783341141821e-02 9.762580783341141821e-02 9.762580783341141821e-02 -1.718750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.008102777672841704e-01 1.008102777672841704e-01 1.008102777672841704e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 1.127025117780692670e-01 1.127025117780692670e-01 1.127025117780692670e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 9.512989241790413553e-02 9.512989241790413553e-02 9.512989241790413553e-02 -2.031250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 1.088580760101767048e-01 1.088580760101767048e-01 1.088580760101767048e-01 -2.031250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 1.013108781544385661e-01 1.013108781544385661e-01 1.013108781544385661e-01 -2.343750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 8.794144839793253954e-02 8.794144839793253954e-02 8.794144839793253954e-02 -2.031250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 1.094968194429654512e-01 1.094968194429654512e-01 1.094968194429654512e-01 -2.343750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 1.125185293823084270e-01 1.125185293823084270e-01 1.125185293823084270e-01 -2.031250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 1.017062136586160820e-01 1.017062136586160820e-01 1.017062136586160820e-01 -2.031250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.012184722178639806e-01 1.012184722178639806e-01 1.012184722178639806e-01 -2.343750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 1.154107803734472082e-01 1.154107803734472082e-01 1.154107803734472082e-01 -2.343750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.319709321874524277e-01 1.319709321874524277e-01 1.319709321874524277e-01 -2.343750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 1.288599883356099096e-01 1.288599883356099096e-01 1.288599883356099096e-01 -2.343750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 1.123923927368625925e-01 1.123923927368625925e-01 1.123923927368625925e-01 -1.718750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.653261489605265644e-02 8.653261489605265644e-02 8.653261489605265644e-02 -1.718750000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 5.250504797194379542e-02 5.250504797194379542e-02 5.250504797194379542e-02 -1.718750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 8.701321232571875008e-02 8.701321232571875008e-02 8.701321232571875008e-02 -1.406250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 1.075998571320335301e-01 1.075998571320335301e-01 1.075998571320335301e-01 -1.406250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 1.440207884218303591e-01 1.440207884218303591e-01 1.440207884218303591e-01 -1.406250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 9.320848302010788233e-02 9.320848302010788233e-02 9.320848302010788233e-02 -1.406250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 1.082474486162484650e-01 1.082474486162484650e-01 1.082474486162484650e-01 -1.718750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 1.143703853933552284e-01 1.143703853933552284e-01 1.143703853933552284e-01 -1.718750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 8.638313082923930464e-02 8.638313082923930464e-02 8.638313082923930464e-02 -1.718750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 8.697945808492082986e-02 8.697945808492082986e-02 8.697945808492082986e-02 -1.718750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 1.626112773462865257e-01 1.626112773462865257e-01 1.626112773462865257e-01 -1.406250000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 7.752811539199140622e-02 7.752811539199140622e-02 7.752811539199140622e-02 -1.406250000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 1.346432116110705679e-01 1.346432116110705679e-01 1.346432116110705679e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -3.593750000000000000e-01 5.527427611339363195e-02 5.527427611339363195e-02 5.527427611339363195e-02 -1.718750000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 9.775437832698735674e-02 9.775437832698735674e-02 9.775437832698735674e-02 -1.718750000000000000e-01 2.343750000000000000e-01 -3.593750000000000000e-01 5.920842135979336590e-02 5.920842135979336590e-02 5.920842135979336590e-02 -1.718750000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 1.202695279853091270e-01 1.202695279853091270e-01 1.202695279853091270e-01 -1.406250000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 1.107686670508062077e-01 1.107686670508062077e-01 1.107686670508062077e-01 -1.406250000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 8.780562924324566976e-02 8.780562924324566976e-02 8.780562924324566976e-02 -1.406250000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 1.411962256833090568e-01 1.411962256833090568e-01 1.411962256833090568e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 1.480819776551932088e-01 1.480819776551932088e-01 1.480819776551932088e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 9.497158480438799844e-02 9.497158480438799844e-02 9.497158480438799844e-02 -1.718750000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 8.704375186469892611e-02 8.704375186469892611e-02 8.704375186469892611e-02 -1.718750000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 8.249725131893846652e-02 8.249725131893846652e-02 8.249725131893846652e-02 -1.718750000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 1.220713996431809778e-01 1.220713996431809778e-01 1.220713996431809778e-01 -2.031250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 9.141962649893871362e-02 9.141962649893871362e-02 9.141962649893871362e-02 -2.031250000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 5.180273604511535790e-02 5.180273604511535790e-02 5.180273604511535790e-02 -2.031250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 1.096245675210012760e-01 1.096245675210012760e-01 1.096245675210012760e-01 -2.343750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.158824186857231708e-02 8.158824186857231708e-02 8.158824186857231708e-02 -2.343750000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 5.325237831523722126e-02 5.325237831523722126e-02 5.325237831523722126e-02 -2.343750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 9.716938092185925524e-02 9.716938092185925524e-02 9.716938092185925524e-02 -2.031250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 8.848874101142488457e-02 8.848874101142488457e-02 8.848874101142488457e-02 -2.031250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 5.663397139550360726e-02 5.663397139550360726e-02 5.663397139550360726e-02 -2.343750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 1.568284582492041057e-01 1.568284582492041057e-01 1.568284582492041057e-01 -2.343750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 7.765294030795019675e-02 7.765294030795019675e-02 7.765294030795019675e-02 -2.031250000000000000e-01 2.031250000000000000e-01 -3.593750000000000000e-01 4.478000325143925708e-02 4.478000325143925708e-02 4.478000325143925708e-02 -2.031250000000000000e-01 2.343750000000000000e-01 -3.593750000000000000e-01 5.928608289486995975e-02 5.928608289486995975e-02 5.928608289486995975e-02 -2.343750000000000000e-01 2.031250000000000000e-01 -3.593750000000000000e-01 5.478874548592274629e-02 5.478874548592274629e-02 5.478874548592274629e-02 -2.343750000000000000e-01 2.343750000000000000e-01 -3.593750000000000000e-01 7.148532902448369308e-02 7.148532902448369308e-02 7.148532902448369308e-02 -2.343750000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 1.348881861970788743e-01 1.348881861970788743e-01 1.348881861970788743e-01 -2.031250000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 7.710251964766033639e-02 7.710251964766033639e-02 7.710251964766033639e-02 -2.343750000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 7.176248821981161263e-02 7.176248821981161263e-02 7.176248821981161263e-02 -1.562500000000000000e-02 1.562500000000000000e-02 -2.031250000000000000e-01 1.157080336109315710e-01 1.157080336109315710e-01 1.157080336109315710e-01 -4.687500000000000000e-02 1.562500000000000000e-02 -2.343750000000000000e-01 8.576027756126079760e-02 8.576027756126079760e-02 8.576027756126079760e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -2.031250000000000000e-01 1.276848186763642479e-01 1.276848186763642479e-01 1.276848186763642479e-01 -4.687500000000000000e-02 4.687500000000000000e-02 -2.031250000000000000e-01 1.440978862703222174e-01 1.440978862703222174e-01 1.440978862703222174e-01 -1.562500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 3.590295665212949600e-02 3.590295665212949600e-02 3.590295665212949600e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 8.456760055638699869e-02 8.456760055638699869e-02 8.456760055638699869e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 2.502491484266122237e-04 2.502491484266122237e-04 2.502491484266122237e-04 -4.687500000000000000e-02 1.562500000000000000e-02 -1.718750000000000000e-01 1.284495243287717137e-01 1.284495243287717137e-01 1.284495243287717137e-01 -4.687500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 1.122228712012406510e-01 1.122228712012406510e-01 1.122228712012406510e-01 -4.687500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 1.184828797736243999e-01 1.184828797736243999e-01 1.184828797736243999e-01 -4.687500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 8.828139711133438372e-02 8.828139711133438372e-02 8.828139711133438372e-02 -1.562500000000000000e-02 1.093750000000000000e-01 -2.031250000000000000e-01 1.818500900070359472e-01 1.818500900070359472e-01 1.818500900070359472e-01 -4.687500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 1.579397681619524596e-01 1.579397681619524596e-01 1.579397681619524596e-01 -4.687500000000000000e-02 1.093750000000000000e-01 -2.343750000000000000e-01 7.605222491667126827e-02 7.605222491667126827e-02 7.605222491667126827e-02 -4.687500000000000000e-02 1.093750000000000000e-01 -2.031250000000000000e-01 1.649661996809963782e-01 1.649661996809963782e-01 1.649661996809963782e-01 -1.562500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 1.249094865799558196e-01 1.249094865799558196e-01 1.249094865799558196e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -1.718750000000000000e-01 1.561226400087501742e-01 1.561226400087501742e-01 1.561226400087501742e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -1.406250000000000000e-01 9.469273764128767479e-02 9.469273764128767479e-02 9.469273764128767479e-02 -4.687500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 1.435019822283215285e-01 1.435019822283215285e-01 1.435019822283215285e-01 -7.812500000000000000e-02 1.562500000000000000e-02 -2.031250000000000000e-01 1.274092979469071962e-01 1.274092979469071962e-01 1.274092979469071962e-01 -7.812500000000000000e-02 4.687500000000000000e-02 -2.031250000000000000e-01 9.904248261863549119e-02 9.904248261863549119e-02 9.904248261863549119e-02 -1.093750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 9.802035788338490929e-02 9.802035788338490929e-02 9.802035788338490929e-02 -1.093750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 1.281338431494150609e-01 1.281338431494150609e-01 1.281338431494150609e-01 -1.093750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 8.939124331291971315e-02 8.939124331291971315e-02 8.939124331291971315e-02 -7.812500000000000000e-02 1.562500000000000000e-02 -1.718750000000000000e-01 1.165242692849445399e-01 1.165242692849445399e-01 1.165242692849445399e-01 -7.812500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 7.472492919742838857e-02 7.472492919742838857e-02 7.472492919742838857e-02 -7.812500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 7.216874014089728895e-02 7.216874014089728895e-02 7.216874014089728895e-02 -1.093750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 1.048157971464860061e-01 1.048157971464860061e-01 1.048157971464860061e-01 -1.093750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.065963210730047905e-01 1.065963210730047905e-01 1.065963210730047905e-01 -1.093750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 7.476150186119442931e-02 7.476150186119442931e-02 7.476150186119442931e-02 -7.812500000000000000e-02 7.812500000000000000e-02 -2.343750000000000000e-01 7.114048634926321835e-02 7.114048634926321835e-02 7.114048634926321835e-02 -7.812500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 7.661028863632640684e-02 7.661028863632640684e-02 7.661028863632640684e-02 -7.812500000000000000e-02 1.093750000000000000e-01 -2.343750000000000000e-01 7.795555753922729647e-02 7.795555753922729647e-02 7.795555753922729647e-02 -7.812500000000000000e-02 1.093750000000000000e-01 -2.031250000000000000e-01 8.510848659120384685e-02 8.510848659120384685e-02 8.510848659120384685e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 8.013605585983599178e-02 8.013605585983599178e-02 8.013605585983599178e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 6.383727166173809586e-02 6.383727166173809586e-02 6.383727166173809586e-02 -1.093750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 8.556739299074861416e-02 8.556739299074861416e-02 8.556739299074861416e-02 -1.093750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 9.491694047969997938e-02 9.491694047969997938e-02 9.491694047969997938e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.575567534010336168e-01 1.575567534010336168e-01 1.575567534010336168e-01 -1.093750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.023120695843503791e-01 1.023120695843503791e-01 1.023120695843503791e-01 -1.562500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 4.898024057333599801e-02 4.898024057333599801e-02 4.898024057333599801e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 5.951070600188348297e-02 5.951070600188348297e-02 5.951070600188348297e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 7.446289160379668259e-02 7.446289160379668259e-02 7.446289160379668259e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 5.499505013107451601e-02 5.499505013107451601e-02 5.499505013107451601e-02 -4.687500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 1.918490195188906622e-01 1.918490195188906622e-01 1.918490195188906622e-01 -1.562500000000000000e-02 1.562500000000000000e-02 -4.687500000000000000e-02 1.012449887148662853e-01 1.012449887148662853e-01 1.012449887148662853e-01 -1.562500000000000000e-02 1.562500000000000000e-02 -1.562500000000000000e-02 3.014667541993162891e-01 3.014667541993162891e-01 3.014667541993162891e-01 -1.562500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 9.911399872173713710e-02 9.911399872173713710e-02 9.911399872173713710e-02 -4.687500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 1.869287736018127866e-01 1.869287736018127866e-01 1.869287736018127866e-01 -1.562500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 1.029267595943387098e-01 1.029267595943387098e-01 1.029267595943387098e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -1.093750000000000000e-01 1.317877970745240379e-01 1.317877970745240379e-01 1.317877970745240379e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -7.812500000000000000e-02 1.641311856699468885e-01 1.641311856699468885e-01 1.641311856699468885e-01 -4.687500000000000000e-02 7.812500000000000000e-02 -7.812500000000000000e-02 7.369578874346803810e-01 7.369578874346803810e-01 7.369578874346803810e-01 -1.562500000000000000e-02 7.812500000000000000e-02 -4.687500000000000000e-02 2.283152757936874333e-01 2.283152757936874333e-01 2.283152757936874333e-01 -1.562500000000000000e-02 7.812500000000000000e-02 -1.562500000000000000e-02 2.083420893876253011e-01 2.083420893876253011e-01 2.083420893876253011e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -4.687500000000000000e-02 5.378031303616620518e-01 5.378031303616620518e-01 5.378031303616620518e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -1.562500000000000000e-02 6.028757589804837336e-01 6.028757589804837336e-01 6.028757589804837336e-01 -4.687500000000000000e-02 7.812500000000000000e-02 -4.687500000000000000e-02 9.460434208524695632e-02 9.460434208524695632e-02 9.460434208524695632e-02 -4.687500000000000000e-02 1.093750000000000000e-01 -4.687500000000000000e-02 5.418916405465322716e-01 5.418916405465322716e-01 5.418916405465322716e-01 -7.812500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 9.405307306246699084e-02 9.405307306246699084e-02 9.405307306246699084e-02 -7.812500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 8.659851638569113219e-02 8.659851638569113219e-02 8.659851638569113219e-02 -7.812500000000000000e-02 4.687500000000000000e-02 -1.093750000000000000e-01 5.495126890623830418e-01 5.495126890623830418e-01 5.495126890623830418e-01 -7.812500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 6.873236839004849275e-01 6.873236839004849275e-01 6.873236839004849275e-01 -1.093750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.021810958118720691e-01 1.021810958118720691e-01 1.021810958118720691e-01 -1.093750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 5.124458914687406441e-01 5.124458914687406441e-01 5.124458914687406441e-01 -1.093750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.630665302367190206e-01 1.630665302367190206e-01 1.630665302367190206e-01 -1.093750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 3.914558014885638482e-01 3.914558014885638482e-01 3.914558014885638482e-01 -7.812500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 6.621491851603438228e-01 6.621491851603438228e-01 6.621491851603438228e-01 -7.812500000000000000e-02 7.812500000000000000e-02 -7.812500000000000000e-02 7.101521550668429272e-01 7.101521550668429272e-01 7.101521550668429272e-01 -7.812500000000000000e-02 1.093750000000000000e-01 -7.812500000000000000e-02 5.163038660969172522e-01 5.163038660969172522e-01 5.163038660969172522e-01 -1.093750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 8.883204224898458845e-01 8.883204224898458845e-01 8.883204224898458845e-01 -1.093750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 7.494937717373659769e-01 7.494937717373659769e-01 7.494937717373659769e-01 -1.093750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.099934580577247356e-01 7.099934580577247356e-01 7.099934580577247356e-01 -1.093750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 5.335689537863390619e-01 5.335689537863390619e-01 5.335689537863390619e-01 -1.562500000000000000e-02 1.406250000000000000e-01 -2.031250000000000000e-01 7.822039691787695259e-02 7.822039691787695259e-02 7.822039691787695259e-02 -1.562500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 6.037494439136891627e-02 6.037494439136891627e-02 6.037494439136891627e-02 -4.687500000000000000e-02 1.406250000000000000e-01 -2.343750000000000000e-01 1.084201923622385849e-01 1.084201923622385849e-01 1.084201923622385849e-01 -4.687500000000000000e-02 1.406250000000000000e-01 -2.031250000000000000e-01 9.364323504361932171e-02 9.364323504361932171e-02 9.364323504361932171e-02 -4.687500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 6.925411449082161108e-02 6.925411449082161108e-02 6.925411449082161108e-02 -4.687500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 1.028568539083085653e-01 1.028568539083085653e-01 1.028568539083085653e-01 -1.562500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 7.439288080164517536e-02 7.439288080164517536e-02 7.439288080164517536e-02 -1.562500000000000000e-02 1.406250000000000000e-01 -1.406250000000000000e-01 8.021152709788570423e-02 8.021152709788570423e-02 8.021152709788570423e-02 -1.562500000000000000e-02 1.718750000000000000e-01 -1.718750000000000000e-01 9.391003179501908327e-02 9.391003179501908327e-02 9.391003179501908327e-02 -1.562500000000000000e-02 1.718750000000000000e-01 -1.406250000000000000e-01 1.000027216208359965e-01 1.000027216208359965e-01 1.000027216208359965e-01 -4.687500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 8.043086749329102225e-02 8.043086749329102225e-02 8.043086749329102225e-02 -4.687500000000000000e-02 1.406250000000000000e-01 -1.406250000000000000e-01 8.478540205675832997e-02 8.478540205675832997e-02 8.478540205675832997e-02 -4.687500000000000000e-02 1.718750000000000000e-01 -1.718750000000000000e-01 6.367833972874827053e-02 6.367833972874827053e-02 6.367833972874827053e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -2.343750000000000000e-01 6.049561545020676334e-02 6.049561545020676334e-02 6.049561545020676334e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -2.031250000000000000e-01 5.579188278543969343e-02 5.579188278543969343e-02 5.579188278543969343e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 2.040488075934248913e-01 2.040488075934248913e-01 2.040488075934248913e-01 -1.562500000000000000e-02 2.343750000000000000e-01 -2.031250000000000000e-01 1.765045636851602651e-01 1.765045636851602651e-01 1.765045636851602651e-01 -1.562500000000000000e-02 2.031250000000000000e-01 -1.718750000000000000e-01 6.175521433870653082e-02 6.175521433870653082e-02 6.175521433870653082e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 1.005547534154894174e-01 1.005547534154894174e-01 1.005547534154894174e-01 -1.562500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 1.159474421767104080e-01 1.159474421767104080e-01 1.159474421767104080e-01 -1.562500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 8.356699199093098329e-02 8.356699199093098329e-02 8.356699199093098329e-02 -4.687500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 8.468654757432511615e-02 8.468654757432511615e-02 8.468654757432511615e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 4.166938504809593324e-02 4.166938504809593324e-02 4.166938504809593324e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 7.692633279958814574e-02 7.692633279958814574e-02 7.692633279958814574e-02 -7.812500000000000000e-02 1.406250000000000000e-01 -2.343750000000000000e-01 9.838919212729302366e-02 9.838919212729302366e-02 9.838919212729302366e-02 -7.812500000000000000e-02 1.406250000000000000e-01 -2.031250000000000000e-01 1.405183801212502581e-01 1.405183801212502581e-01 1.405183801212502581e-01 -7.812500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 7.466440341188246288e-02 7.466440341188246288e-02 7.466440341188246288e-02 -7.812500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 1.606079734366697154e-01 1.606079734366697154e-01 1.606079734366697154e-01 -7.812500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 7.547261582336048380e-02 7.547261582336048380e-02 7.547261582336048380e-02 -7.812500000000000000e-02 1.406250000000000000e-01 -1.406250000000000000e-01 1.182507089950784462e-01 1.182507089950784462e-01 1.182507089950784462e-01 -1.093750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.152452821490634743e-01 1.152452821490634743e-01 1.152452821490634743e-01 -1.093750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.380832290481230906e-01 1.380832290481230906e-01 1.380832290481230906e-01 -1.093750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.005226119301284304e-01 1.005226119301284304e-01 1.005226119301284304e-01 -1.093750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 1.173429067860440461e-01 1.173429067860440461e-01 1.173429067860440461e-01 -7.812500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 1.382302076046826589e-01 1.382302076046826589e-01 1.382302076046826589e-01 -1.093750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 1.621247079170118344e-01 1.621247079170118344e-01 1.621247079170118344e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 1.800768499563602520e-01 1.800768499563602520e-01 1.800768499563602520e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 2.132955296822083568e-01 2.132955296822083568e-01 2.132955296822083568e-01 -7.812500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 9.873472158432913814e-02 9.873472158432913814e-02 9.873472158432913814e-02 -7.812500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 7.302898427209593424e-02 7.302898427209593424e-02 7.302898427209593424e-02 -1.093750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 4.623290797406198055e-02 4.623290797406198055e-02 4.623290797406198055e-02 -1.093750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 1.553003820543031877e-01 1.553003820543031877e-01 1.553003820543031877e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 7.295656078421330903e-02 7.295656078421330903e-02 7.295656078421330903e-02 -1.562500000000000000e-02 1.406250000000000000e-01 -1.093750000000000000e-01 1.084740240584607662e-01 1.084740240584607662e-01 1.084740240584607662e-01 -1.562500000000000000e-02 1.406250000000000000e-01 -7.812500000000000000e-02 1.439717991255381468e-01 1.439717991255381468e-01 1.439717991255381468e-01 -1.562500000000000000e-02 1.718750000000000000e-01 -1.093750000000000000e-01 1.045859974149086213e-01 1.045859974149086213e-01 1.045859974149086213e-01 -1.562500000000000000e-02 1.718750000000000000e-01 -7.812500000000000000e-02 1.284961133037896830e-01 1.284961133037896830e-01 1.284961133037896830e-01 -4.687500000000000000e-02 1.406250000000000000e-01 -1.093750000000000000e-01 1.170906484243619955e-01 1.170906484243619955e-01 1.170906484243619955e-01 -4.687500000000000000e-02 1.718750000000000000e-01 -1.093750000000000000e-01 1.107301021630820587e-01 1.107301021630820587e-01 1.107301021630820587e-01 -1.562500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 3.139063840763666735e-01 3.139063840763666735e-01 3.139063840763666735e-01 -1.562500000000000000e-02 1.406250000000000000e-01 -1.562500000000000000e-02 7.715412202931498653e-01 7.715412202931498653e-01 7.715412202931498653e-01 -1.562500000000000000e-02 1.718750000000000000e-01 -1.562500000000000000e-02 5.488534573326504518e-01 5.488534573326504518e-01 5.488534573326504518e-01 -4.687500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 6.266773846558802985e-01 6.266773846558802985e-01 6.266773846558802985e-01 -4.687500000000000000e-02 1.718750000000000000e-01 -4.687500000000000000e-02 7.107733830613049975e-01 7.107733830613049975e-01 7.107733830613049975e-01 -1.562500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 1.063367977011549087e-01 1.063367977011549087e-01 1.063367977011549087e-01 -1.562500000000000000e-02 2.031250000000000000e-01 -7.812500000000000000e-02 1.079035669386979590e-01 1.079035669386979590e-01 1.079035669386979590e-01 -1.562500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 8.984449977711822521e-02 8.984449977711822521e-02 8.984449977711822521e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 8.365218485145003990e-02 8.365218485145003990e-02 8.365218485145003990e-02 -4.687500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 9.415191603687839139e-02 9.415191603687839139e-02 9.415191603687839139e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 7.961852540962688352e-02 7.961852540962688352e-02 7.961852540962688352e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 7.787325219513166474e-02 7.787325219513166474e-02 7.787325219513166474e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 4.242400035109711309e-01 4.242400035109711309e-01 4.242400035109711309e-01 -1.562500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 8.039574413563305155e-02 8.039574413563305155e-02 8.039574413563305155e-02 -4.687500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 3.443653772756071763e-01 3.443653772756071763e-01 3.443653772756071763e-01 -4.687500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 8.111002322502518236e-02 8.111002322502518236e-02 8.111002322502518236e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 1.526432429858897155e-01 1.526432429858897155e-01 1.526432429858897155e-01 -7.812500000000000000e-02 1.406250000000000000e-01 -1.093750000000000000e-01 1.269233188501550369e-01 1.269233188501550369e-01 1.269233188501550369e-01 -7.812500000000000000e-02 1.718750000000000000e-01 -1.093750000000000000e-01 1.013462334412254390e-01 1.013462334412254390e-01 1.013462334412254390e-01 -1.093750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 3.645691267798553681e-01 3.645691267798553681e-01 3.645691267798553681e-01 -1.093750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 3.458201718894182153e-01 3.458201718894182153e-01 3.458201718894182153e-01 -1.093750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 8.992325684561219834e-02 8.992325684561219834e-02 8.992325684561219834e-02 -1.093750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 2.765592729362295055e-01 2.765592729362295055e-01 2.765592729362295055e-01 -7.812500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 5.104137052891141169e-01 5.104137052891141169e-01 5.104137052891141169e-01 -7.812500000000000000e-02 1.718750000000000000e-01 -4.687500000000000000e-02 2.271608125263924194e-01 2.271608125263924194e-01 2.271608125263924194e-01 -1.093750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 2.663319056423266162e-01 2.663319056423266162e-01 2.663319056423266162e-01 -1.093750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.986068439914101535e-01 1.986068439914101535e-01 1.986068439914101535e-01 -7.812500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 8.535361205149458175e-02 8.535361205149458175e-02 8.535361205149458175e-02 -7.812500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 9.030579008163301669e-02 9.030579008163301669e-02 9.030579008163301669e-02 -7.812500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 7.034838757727993053e-02 7.034838757727993053e-02 7.034838757727993053e-02 -1.093750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 3.856580356521363551e-02 3.856580356521363551e-02 3.856580356521363551e-02 -1.093750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.322713371278747829e-01 1.322713371278747829e-01 1.322713371278747829e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 8.493408539919078404e-02 8.493408539919078404e-02 8.493408539919078404e-02 -1.093750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 7.515873618427523772e-02 7.515873618427523772e-02 7.515873618427523772e-02 -7.812500000000000000e-02 2.031250000000000000e-01 -4.687500000000000000e-02 1.341026584922267728e-01 1.341026584922267728e-01 1.341026584922267728e-01 -7.812500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 1.650376572082269400e-01 1.650376572082269400e-01 1.650376572082269400e-01 -7.812500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 9.620187587857120803e-02 9.620187587857120803e-02 9.620187587857120803e-02 -7.812500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 1.041818375534327712e-01 1.041818375534327712e-01 1.041818375534327712e-01 -1.093750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 9.642286019859014345e-02 9.642286019859014345e-02 9.642286019859014345e-02 -1.093750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 1.168472263891807278e-01 1.168472263891807278e-01 1.168472263891807278e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 1.011212449874179659e-01 1.011212449874179659e-01 1.011212449874179659e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 8.376148876678439492e-02 8.376148876678439492e-02 8.376148876678439492e-02 -1.406250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.035446589365081188e-01 1.035446589365081188e-01 1.035446589365081188e-01 -1.406250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 1.129130064047949994e-01 1.129130064047949994e-01 1.129130064047949994e-01 -1.406250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 5.954841110762000567e-02 5.954841110762000567e-02 5.954841110762000567e-02 -1.406250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 8.694088179239541081e-02 8.694088179239541081e-02 8.694088179239541081e-02 -1.406250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 9.213726329507282431e-02 9.213726329507282431e-02 9.213726329507282431e-02 -1.406250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.428040782171440537e-01 1.428040782171440537e-01 1.428040782171440537e-01 -1.406250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.394244988167309129e-01 1.394244988167309129e-01 1.394244988167309129e-01 -1.406250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 2.473635335903115184e-01 2.473635335903115184e-01 2.473635335903115184e-01 -1.718750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 9.815214199039122567e-02 9.815214199039122567e-02 9.815214199039122567e-02 -1.718750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 7.807523771845462091e-02 7.807523771845462091e-02 7.807523771845462091e-02 -1.718750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.118163394282055412e-01 1.118163394282055412e-01 1.118163394282055412e-01 -1.718750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.399087961188552887e-01 1.399087961188552887e-01 1.399087961188552887e-01 -1.406250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 6.850331541475503105e-02 6.850331541475503105e-02 6.850331541475503105e-02 -1.406250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 6.499657294083688308e-02 6.499657294083688308e-02 6.499657294083688308e-02 -1.718750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 1.172987214613586265e-01 1.172987214613586265e-01 1.172987214613586265e-01 -1.406250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.245423804908187548e-01 1.245423804908187548e-01 1.245423804908187548e-01 -1.406250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 4.992293671495165452e-01 4.992293671495165452e-01 4.992293671495165452e-01 -1.406250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.311909986164173647e-01 1.311909986164173647e-01 1.311909986164173647e-01 -1.406250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.905929005109856522e-01 1.905929005109856522e-01 1.905929005109856522e-01 -1.718750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.077878680999213856e-01 1.077878680999213856e-01 1.077878680999213856e-01 -1.718750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.290800797194580629e-01 1.290800797194580629e-01 1.290800797194580629e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.685614783265106109e-01 1.685614783265106109e-01 1.685614783265106109e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.465111721979022452e-01 1.465111721979022452e-01 1.465111721979022452e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.127941011108083980e-01 1.127941011108083980e-01 1.127941011108083980e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 1.058675644640279939e-01 1.058675644640279939e-01 1.058675644640279939e-01 -2.343750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.028801558104008584e-01 1.028801558104008584e-01 1.028801558104008584e-01 -2.343750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 8.534075302950576425e-02 8.534075302950576425e-02 8.534075302950576425e-02 -2.343750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 1.013928381137092910e-01 1.013928381137092910e-01 1.013928381137092910e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 1.664154101561352295e-01 1.664154101561352295e-01 1.664154101561352295e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 9.760009371005491652e-02 9.760009371005491652e-02 9.760009371005491652e-02 -2.031250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.500269713624745593e-01 1.500269713624745593e-01 1.500269713624745593e-01 -2.031250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.172007102909023019e-01 1.172007102909023019e-01 1.172007102909023019e-01 -2.343750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 8.071217529664502510e-02 8.071217529664502510e-02 8.071217529664502510e-02 -2.343750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 7.312946070117011532e-02 7.312946070117011532e-02 7.312946070117011532e-02 -2.343750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 7.645749064422398267e-02 7.645749064422398267e-02 7.645749064422398267e-02 -2.343750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 6.450587565186542693e-02 6.450587565186542693e-02 6.450587565186542693e-02 -2.343750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 9.129988580566893164e-02 9.129988580566893164e-02 9.129988580566893164e-02 -2.343750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 1.049764958694648920e-01 1.049764958694648920e-01 1.049764958694648920e-01 -2.343750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 9.826303332780990385e-02 9.826303332780990385e-02 9.826303332780990385e-02 -2.031250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 8.748978854726369159e-02 8.748978854726369159e-02 8.748978854726369159e-02 -2.031250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 8.148616854798219900e-02 8.148616854798219900e-02 8.148616854798219900e-02 -2.031250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.890646628263037143e-01 1.890646628263037143e-01 1.890646628263037143e-01 -2.031250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.311050528479391353e-01 1.311050528479391353e-01 1.311050528479391353e-01 -2.343750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 7.022274748778163656e-02 7.022274748778163656e-02 7.022274748778163656e-02 -2.343750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 5.308393813917419018e-02 5.308393813917419018e-02 5.308393813917419018e-02 -2.343750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 9.452478600177197099e-02 9.452478600177197099e-02 9.452478600177197099e-02 -2.343750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 6.884077393913880238e-02 6.884077393913880238e-02 6.884077393913880238e-02 -1.406250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 7.151194524496897742e-01 7.151194524496897742e-01 7.151194524496897742e-01 -1.718750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.867810813076470899e-01 1.867810813076470899e-01 1.867810813076470899e-01 -1.718750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.787081612637220762e-01 1.787081612637220762e-01 1.787081612637220762e-01 -1.718750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 8.104466340477191055e-01 8.104466340477191055e-01 8.104466340477191055e-01 -1.406250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 2.568426647860071466e-01 2.568426647860071466e-01 2.568426647860071466e-01 -1.406250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 2.106964760030376471e-01 2.106964760030376471e-01 2.106964760030376471e-01 -1.406250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 5.692383985682427650e-01 5.692383985682427650e-01 5.692383985682427650e-01 -1.718750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.916210735005005883e-01 1.916210735005005883e-01 1.916210735005005883e-01 -1.718750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 4.249074598314681039e-01 4.249074598314681039e-01 4.249074598314681039e-01 -1.718750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 6.612442577743425642e-02 6.612442577743425642e-02 6.612442577743425642e-02 -1.406250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 8.603146000122260384e-01 8.603146000122260384e-01 8.603146000122260384e-01 -1.406250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.821419919825433054e-01 7.821419919825433054e-01 7.821419919825433054e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 5.302648945160904903e-01 5.302648945160904903e-01 5.302648945160904903e-01 -1.406250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 6.021027727415368958e-01 6.021027727415368958e-01 6.021027727415368958e-01 -1.718750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 8.712347673256273239e-01 8.712347673256273239e-01 8.712347673256273239e-01 -1.718750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 5.692368008290381587e-01 5.692368008290381587e-01 5.692368008290381587e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 4.772343239855363906e-01 4.772343239855363906e-01 4.772343239855363906e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.509962384503623634e-01 1.509962384503623634e-01 1.509962384503623634e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.770873789698824419e-01 1.770873789698824419e-01 1.770873789698824419e-01 -2.031250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.174393110465863227e-01 1.174393110465863227e-01 1.174393110465863227e-01 -2.031250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 2.357575159266331599e-01 2.357575159266331599e-01 2.357575159266331599e-01 -2.343750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.012739157925411360e-01 1.012739157925411360e-01 1.012739157925411360e-01 -2.343750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 9.708420237349082993e-02 9.708420237349082993e-02 9.708420237349082993e-02 -2.343750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.035526940072171304e-01 1.035526940072171304e-01 1.035526940072171304e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.235366458190799571e-01 1.235366458190799571e-01 1.235366458190799571e-01 -2.031250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 2.540693785803317395e-01 2.540693785803317395e-01 2.540693785803317395e-01 -2.031250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 1.361323243020656215e-01 1.361323243020656215e-01 1.361323243020656215e-01 -2.343750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.468500704484120012e-01 1.468500704484120012e-01 1.468500704484120012e-01 -2.343750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.182466921937127269e-01 1.182466921937127269e-01 1.182466921937127269e-01 -2.343750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.001296812335941699e-01 1.001296812335941699e-01 1.001296812335941699e-01 -2.343750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 1.198678569345674599e-01 1.198678569345674599e-01 1.198678569345674599e-01 -2.031250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 6.706520211804860299e-02 6.706520211804860299e-02 6.706520211804860299e-02 -2.031250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.588936837916432310e-01 1.588936837916432310e-01 1.588936837916432310e-01 -2.031250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.540332532452247105e-01 1.540332532452247105e-01 1.540332532452247105e-01 -2.343750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 4.072316523520676940e-02 4.072316523520676940e-02 4.072316523520676940e-02 -2.343750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 7.780099382069442793e-02 7.780099382069442793e-02 7.780099382069442793e-02 -2.343750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.281999289771055872e-02 7.281999289771055872e-02 7.281999289771055872e-02 -2.343750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.171115360894380009e-01 1.171115360894380009e-01 1.171115360894380009e-01 -2.031250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 3.893332852209080985e-01 3.893332852209080985e-01 3.893332852209080985e-01 -2.031250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 4.423721993144377196e-01 4.423721993144377196e-01 4.423721993144377196e-01 -2.031250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 5.742415633001781705e-01 5.742415633001781705e-01 5.742415633001781705e-01 -2.343750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.042943275796144459e-01 1.042943275796144459e-01 1.042943275796144459e-01 -1.406250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 7.638121210612687506e-02 7.638121210612687506e-02 7.638121210612687506e-02 -1.406250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 2.103722905252941311e-01 2.103722905252941311e-01 2.103722905252941311e-01 -1.718750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 1.432080441077048238e-01 1.432080441077048238e-01 1.432080441077048238e-01 -1.406250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 9.562651021968184006e-02 9.562651021968184006e-02 9.562651021968184006e-02 -1.406250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.792050661850608795e-01 1.792050661850608795e-01 1.792050661850608795e-01 -1.406250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 9.365127110327582660e-02 9.365127110327582660e-02 9.365127110327582660e-02 -1.718750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.916555864954817556e-01 1.916555864954817556e-01 1.916555864954817556e-01 -1.718750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 6.757308654152835437e-02 6.757308654152835437e-02 6.757308654152835437e-02 -1.406250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 2.316550230832696011e-01 2.316550230832696011e-01 2.316550230832696011e-01 -1.406250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 1.460823273418845603e-01 1.460823273418845603e-01 1.460823273418845603e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 1.391401836195824415e-01 1.391401836195824415e-01 1.391401836195824415e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 1.627381381990130882e-01 1.627381381990130882e-01 1.627381381990130882e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 1.014265863079549662e-01 1.014265863079549662e-01 1.014265863079549662e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 8.501766942778654634e-02 8.501766942778654634e-02 8.501766942778654634e-02 -1.718750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 1.213893762856449315e-01 1.213893762856449315e-01 1.213893762856449315e-01 -1.718750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 5.680674559919149380e-02 5.680674559919149380e-02 5.680674559919149380e-02 -1.406250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 5.714192167243838799e-02 5.714192167243838799e-02 5.714192167243838799e-02 -1.406250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 4.700932358276274647e-02 4.700932358276274647e-02 4.700932358276274647e-02 -1.406250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 5.932547639849083954e-02 5.932547639849083954e-02 5.932547639849083954e-02 -1.406250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 1.394477901301646450e-01 1.394477901301646450e-01 1.394477901301646450e-01 -1.718750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 6.190795986347488733e-02 6.190795986347488733e-02 6.190795986347488733e-02 -1.718750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 1.303243076431554459e-01 1.303243076431554459e-01 1.303243076431554459e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 5.577982302202552645e-02 5.577982302202552645e-02 5.577982302202552645e-02 -2.343750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.793808686451986434e-01 1.793808686451986434e-01 1.793808686451986434e-01 -2.343750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 1.012883793274783201e-01 1.012883793274783201e-01 1.012883793274783201e-01 -2.031250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.867345260717589994e-01 1.867345260717589994e-01 1.867345260717589994e-01 -2.031250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.938346909675501828e-01 1.938346909675501828e-01 1.938346909675501828e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.157690908967272669e-01 1.157690908967272669e-01 1.157690908967272669e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 8.609862812829546797e-02 8.609862812829546797e-02 8.609862812829546797e-02 -2.343750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.792379790036426057e-01 1.792379790036426057e-01 1.792379790036426057e-01 -2.343750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.614317830069456339e-01 1.614317830069456339e-01 1.614317830069456339e-01 -2.031250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 5.119698205877768610e-02 5.119698205877768610e-02 5.119698205877768610e-02 -2.031250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 5.678825419447487699e-02 5.678825419447487699e-02 5.678825419447487699e-02 -2.031250000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 5.503500853003216037e-02 5.503500853003216037e-02 5.503500853003216037e-02 -2.031250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 5.962880573035725384e-02 5.962880573035725384e-02 5.962880573035725384e-02 -2.343750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 6.055414205445514009e-02 6.055414205445514009e-02 6.055414205445514009e-02 -2.343750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 3.863005563010269566e-02 3.863005563010269566e-02 3.863005563010269566e-02 -2.343750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 7.526443458617240734e-02 7.526443458617240734e-02 7.526443458617240734e-02 -2.031250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 5.404713782530150279e-02 5.404713782530150279e-02 5.404713782530150279e-02 -2.031250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 1.253729857485013366e-01 1.253729857485013366e-01 1.253729857485013366e-01 -2.031250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 1.703293523129842391e-01 1.703293523129842391e-01 1.703293523129842391e-01 -2.343750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 1.024856295923963351e-01 1.024856295923963351e-01 1.024856295923963351e-01 -2.343750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 1.434256869176956661e-01 1.434256869176956661e-01 1.434256869176956661e-01 -2.343750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 1.857544518356625818e-01 1.857544518356625818e-01 1.857544518356625818e-01 -1.406250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 4.061997791535005287e-01 4.061997791535005287e-01 4.061997791535005287e-01 -1.406250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 1.168295521533274234e-01 1.168295521533274234e-01 1.168295521533274234e-01 -1.406250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.764106385128435261e-01 1.764106385128435261e-01 1.764106385128435261e-01 -1.718750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 3.791754970631889821e-01 3.791754970631889821e-01 3.791754970631889821e-01 -1.718750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 3.589297609144894707e-01 3.589297609144894707e-01 3.589297609144894707e-01 -1.718750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 1.354142766394987318e-01 1.354142766394987318e-01 1.354142766394987318e-01 -1.718750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.504541891154271560e-01 1.504541891154271560e-01 1.504541891154271560e-01 -1.406250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 3.612124662119823859e-01 3.612124662119823859e-01 3.612124662119823859e-01 -1.406250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.873285046467662307e-01 1.873285046467662307e-01 1.873285046467662307e-01 -1.406250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 1.942400059155389158e-01 1.942400059155389158e-01 1.942400059155389158e-01 -1.718750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 3.711851264000279316e-01 3.711851264000279316e-01 3.711851264000279316e-01 -1.718750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 2.982813995316141442e-01 2.982813995316141442e-01 2.982813995316141442e-01 -1.718750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 2.816768785998216007e-01 2.816768785998216007e-01 2.816768785998216007e-01 -1.406250000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.181414519262973251e-01 1.181414519262973251e-01 1.181414519262973251e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 1.187728914658463392e-01 1.187728914658463392e-01 1.187728914658463392e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 1.052400410803232544e-01 1.052400410803232544e-01 1.052400410803232544e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.438200124279719605e-01 1.438200124279719605e-01 1.438200124279719605e-01 -1.718750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 5.623656519955754635e-02 5.623656519955754635e-02 5.623656519955754635e-02 -1.406250000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 1.083727883014256876e-01 1.083727883014256876e-01 1.083727883014256876e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 1.273137089019339419e-01 1.273137089019339419e-01 1.273137089019339419e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 1.502140801688278127e-01 1.502140801688278127e-01 1.502140801688278127e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 1.827154233838163278e-01 1.827154233838163278e-01 1.827154233838163278e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 2.337616480022724763e-01 2.337616480022724763e-01 2.337616480022724763e-01 -1.718750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 1.141711421942665644e-01 1.141711421942665644e-01 1.141711421942665644e-01 -2.031250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 3.405095636354260047e-01 3.405095636354260047e-01 3.405095636354260047e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 1.249641105375877276e-01 1.249641105375877276e-01 1.249641105375877276e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.275506731329404397e-01 1.275506731329404397e-01 1.275506731329404397e-01 -2.343750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.812119207467715876e-01 1.812119207467715876e-01 1.812119207467715876e-01 -2.343750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 1.616630262823716413e-01 1.616630262823716413e-01 1.616630262823716413e-01 -2.343750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.435003760119932248e-01 1.435003760119932248e-01 1.435003760119932248e-01 -2.031250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.641761481836244152e-01 1.641761481836244152e-01 1.641761481836244152e-01 -2.031250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 2.985875966266778314e-01 2.985875966266778314e-01 2.985875966266778314e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 2.063615908505465613e-01 2.063615908505465613e-01 2.063615908505465613e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 2.116947022900025066e-01 2.116947022900025066e-01 2.116947022900025066e-01 -2.343750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.918329670035141543e-01 1.918329670035141543e-01 1.918329670035141543e-01 -2.343750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 2.074481426808694740e-01 2.074481426808694740e-01 2.074481426808694740e-01 -2.031250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 1.099676383996751050e-01 1.099676383996751050e-01 1.099676383996751050e-01 -2.031250000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.012787369711483781e-01 1.012787369711483781e-01 1.012787369711483781e-01 -2.031250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 9.931649341042865509e-02 9.931649341042865509e-02 9.931649341042865509e-02 -2.343750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 9.063769244511775403e-02 9.063769244511775403e-02 9.063769244511775403e-02 -2.343750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 6.648440284821553747e-02 6.648440284821553747e-02 6.648440284821553747e-02 -2.031250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 1.442247763184400233e-01 1.442247763184400233e-01 1.442247763184400233e-01 -1.562500000000000000e-02 2.656250000000000000e-01 -3.906250000000000000e-01 8.656074358726083273e-02 8.656074358726083273e-02 8.656074358726083273e-02 -1.562500000000000000e-02 2.968750000000000000e-01 -3.906250000000000000e-01 8.079897864882019942e-02 8.079897864882019942e-02 8.079897864882019942e-02 -4.687500000000000000e-02 2.656250000000000000e-01 -3.906250000000000000e-01 6.781078949838020842e-02 6.781078949838020842e-02 6.781078949838020842e-02 -4.687500000000000000e-02 2.968750000000000000e-01 -3.906250000000000000e-01 8.012182964409483854e-02 8.012182964409483854e-02 8.012182964409483854e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -3.906250000000000000e-01 7.567131185310567443e-02 7.567131185310567443e-02 7.567131185310567443e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -3.906250000000000000e-01 7.807925652596171828e-02 7.807925652596171828e-02 7.807925652596171828e-02 -4.687500000000000000e-02 3.281250000000000000e-01 -3.906250000000000000e-01 6.420047456672049735e-02 6.420047456672049735e-02 6.420047456672049735e-02 -4.687500000000000000e-02 3.593750000000000000e-01 -3.906250000000000000e-01 6.888651320619684770e-02 6.888651320619684770e-02 6.888651320619684770e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -3.906250000000000000e-01 6.076179860491301432e-02 6.076179860491301432e-02 6.076179860491301432e-02 -4.687500000000000000e-02 2.656250000000000000e-01 -3.593750000000000000e-01 8.560034413764219807e-02 8.560034413764219807e-02 8.560034413764219807e-02 -4.687500000000000000e-02 2.656250000000000000e-01 -3.281250000000000000e-01 6.814583934539547583e-02 6.814583934539547583e-02 6.814583934539547583e-02 -4.687500000000000000e-02 2.968750000000000000e-01 -3.593750000000000000e-01 1.040846139040711021e-01 1.040846139040711021e-01 1.040846139040711021e-01 -4.687500000000000000e-02 2.968750000000000000e-01 -3.281250000000000000e-01 8.699633520708997814e-02 8.699633520708997814e-02 8.699633520708997814e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -3.281250000000000000e-01 9.338286627658455574e-02 9.338286627658455574e-02 9.338286627658455574e-02 -4.687500000000000000e-02 3.593750000000000000e-01 -3.593750000000000000e-01 8.262263112678834565e-02 8.262263112678834565e-02 8.262263112678834565e-02 -4.687500000000000000e-02 3.593750000000000000e-01 -3.281250000000000000e-01 8.248519555788898228e-02 8.248519555788898228e-02 8.248519555788898228e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 9.437772757975319837e-02 9.437772757975319837e-02 9.437772757975319837e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 3.905673950515856779e-02 3.905673950515856779e-02 3.905673950515856779e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -2.968750000000000000e-01 1.084418857366969274e-01 1.084418857366969274e-01 1.084418857366969274e-01 -4.687500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 9.197975341554305573e-02 9.197975341554305573e-02 9.197975341554305573e-02 -4.687500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 6.999775236506800002e-02 6.999775236506800002e-02 6.999775236506800002e-02 -4.687500000000000000e-02 3.593750000000000000e-01 -2.968750000000000000e-01 7.837327193778174939e-02 7.837327193778174939e-02 7.837327193778174939e-02 -7.812500000000000000e-02 2.656250000000000000e-01 -3.281250000000000000e-01 6.923425940202232454e-02 6.923425940202232454e-02 6.923425940202232454e-02 -7.812500000000000000e-02 2.968750000000000000e-01 -3.593750000000000000e-01 9.256478855651768811e-02 9.256478855651768811e-02 9.256478855651768811e-02 -7.812500000000000000e-02 2.968750000000000000e-01 -3.281250000000000000e-01 1.147166496179010814e-01 1.147166496179010814e-01 1.147166496179010814e-01 -1.093750000000000000e-01 2.968750000000000000e-01 -3.281250000000000000e-01 1.215942248980436818e-01 1.215942248980436818e-01 1.215942248980436818e-01 -7.812500000000000000e-02 2.656250000000000000e-01 -2.968750000000000000e-01 7.880561249575405991e-02 7.880561249575405991e-02 7.880561249575405991e-02 -7.812500000000000000e-02 2.656250000000000000e-01 -2.656250000000000000e-01 1.005828772046537256e-01 1.005828772046537256e-01 1.005828772046537256e-01 -7.812500000000000000e-02 2.968750000000000000e-01 -2.968750000000000000e-01 1.047941027942801973e-01 1.047941027942801973e-01 1.047941027942801973e-01 -7.812500000000000000e-02 2.968750000000000000e-01 -2.656250000000000000e-01 8.458287079149709453e-02 8.458287079149709453e-02 8.458287079149709453e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 1.332882075587314419e-01 1.332882075587314419e-01 1.332882075587314419e-01 -1.093750000000000000e-01 2.656250000000000000e-01 -2.656250000000000000e-01 1.424531161447546157e-01 1.424531161447546157e-01 1.424531161447546157e-01 -1.093750000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 1.278213737902239022e-01 1.278213737902239022e-01 1.278213737902239022e-01 -1.093750000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 1.278527011071969310e-01 1.278527011071969310e-01 1.278527011071969310e-01 -7.812500000000000000e-02 3.281250000000000000e-01 -3.593750000000000000e-01 8.731941086310336664e-02 8.731941086310336664e-02 8.731941086310336664e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -3.281250000000000000e-01 9.603071306085259051e-02 9.603071306085259051e-02 9.603071306085259051e-02 -7.812500000000000000e-02 3.593750000000000000e-01 -3.593750000000000000e-01 5.851460949532459599e-02 5.851460949532459599e-02 5.851460949532459599e-02 -7.812500000000000000e-02 3.593750000000000000e-01 -3.281250000000000000e-01 6.903257322233236071e-02 6.903257322233236071e-02 6.903257322233236071e-02 -1.093750000000000000e-01 3.281250000000000000e-01 -3.281250000000000000e-01 5.962382126609912930e-02 5.962382126609912930e-02 5.962382126609912930e-02 -1.093750000000000000e-01 3.593750000000000000e-01 -3.281250000000000000e-01 1.042268335827757353e-01 1.042268335827757353e-01 1.042268335827757353e-01 -7.812500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 1.079790924798206403e-01 1.079790924798206403e-01 1.079790924798206403e-01 -7.812500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 9.724491654025595178e-02 9.724491654025595178e-02 9.724491654025595178e-02 -1.093750000000000000e-01 3.281250000000000000e-01 -2.968750000000000000e-01 1.452928934745136569e-01 1.452928934745136569e-01 1.452928934745136569e-01 -1.093750000000000000e-01 3.281250000000000000e-01 -2.656250000000000000e-01 1.442793871636339487e-01 1.442793871636339487e-01 1.442793871636339487e-01 -1.093750000000000000e-01 3.593750000000000000e-01 -2.968750000000000000e-01 1.224312871410883491e-01 1.224312871410883491e-01 1.224312871410883491e-01 -1.093750000000000000e-01 3.593750000000000000e-01 -2.656250000000000000e-01 1.106674341811060697e-01 1.106674341811060697e-01 1.106674341811060697e-01 -1.562500000000000000e-02 3.906250000000000000e-01 -3.906250000000000000e-01 5.738110259317943940e-02 5.738110259317943940e-02 5.738110259317943940e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -3.906250000000000000e-01 4.638487889320144775e-02 4.638487889320144775e-02 4.638487889320144775e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -3.593750000000000000e-01 7.898412611056097876e-02 7.898412611056097876e-02 7.898412611056097876e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -3.281250000000000000e-01 9.940729443469244198e-02 9.940729443469244198e-02 9.940729443469244198e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -3.593750000000000000e-01 6.941809965225073653e-02 6.941809965225073653e-02 6.941809965225073653e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -3.281250000000000000e-01 7.878543826224559954e-02 7.878543826224559954e-02 7.878543826224559954e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -2.968750000000000000e-01 8.963635572498242221e-02 8.963635572498242221e-02 8.963635572498242221e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -2.968750000000000000e-01 8.055625052143225440e-02 8.055625052143225440e-02 8.055625052143225440e-02 -1.718750000000000000e-01 2.656250000000000000e-01 -3.906250000000000000e-01 8.289348299343198001e-02 8.289348299343198001e-02 8.289348299343198001e-02 -1.718750000000000000e-01 2.968750000000000000e-01 -3.906250000000000000e-01 1.082828008549179682e-01 1.082828008549179682e-01 1.082828008549179682e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -3.906250000000000000e-01 8.519608889064046731e-02 8.519608889064046731e-02 8.519608889064046731e-02 -2.031250000000000000e-01 2.656250000000000000e-01 -3.906250000000000000e-01 8.880377413149410926e-02 8.880377413149410926e-02 8.880377413149410926e-02 -2.031250000000000000e-01 2.968750000000000000e-01 -3.906250000000000000e-01 1.034667187088506579e-01 1.034667187088506579e-01 1.034667187088506579e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -3.906250000000000000e-01 7.817554709352400599e-02 7.817554709352400599e-02 7.817554709352400599e-02 -2.343750000000000000e-01 2.968750000000000000e-01 -3.906250000000000000e-01 9.132158379685707816e-02 9.132158379685707816e-02 9.132158379685707816e-02 -2.031250000000000000e-01 3.281250000000000000e-01 -3.906250000000000000e-01 9.987094054505006591e-02 9.987094054505006591e-02 9.987094054505006591e-02 -2.031250000000000000e-01 3.593750000000000000e-01 -3.906250000000000000e-01 7.389002300871277962e-02 7.389002300871277962e-02 7.389002300871277962e-02 -2.343750000000000000e-01 3.281250000000000000e-01 -3.906250000000000000e-01 9.592624731241525260e-02 9.592624731241525260e-02 9.592624731241525260e-02 -1.406250000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 1.242821117016816163e-01 1.242821117016816163e-01 1.242821117016816163e-01 -1.406250000000000000e-01 2.968750000000000000e-01 -3.593750000000000000e-01 1.074937994691445575e-01 1.074937994691445575e-01 1.074937994691445575e-01 -1.406250000000000000e-01 2.968750000000000000e-01 -3.281250000000000000e-01 1.253681660135142206e-01 1.253681660135142206e-01 1.253681660135142206e-01 -1.718750000000000000e-01 2.656250000000000000e-01 -3.593750000000000000e-01 1.112700089090658401e-01 1.112700089090658401e-01 1.112700089090658401e-01 -1.718750000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 1.530110238889544616e-01 1.530110238889544616e-01 1.530110238889544616e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -3.593750000000000000e-01 1.102705358283196657e-01 1.102705358283196657e-01 1.102705358283196657e-01 -1.406250000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 1.202406077366482834e-01 1.202406077366482834e-01 1.202406077366482834e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -3.593750000000000000e-01 1.079967686600562110e-01 1.079967686600562110e-01 1.079967686600562110e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -3.281250000000000000e-01 1.282912822639180050e-01 1.282912822639180050e-01 1.282912822639180050e-01 -1.406250000000000000e-01 3.593750000000000000e-01 -3.593750000000000000e-01 9.809267845662636431e-02 9.809267845662636431e-02 9.809267845662636431e-02 -1.406250000000000000e-01 3.593750000000000000e-01 -3.281250000000000000e-01 1.394831286618060662e-01 1.394831286618060662e-01 1.394831286618060662e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -3.593750000000000000e-01 1.110064834499718961e-01 1.110064834499718961e-01 1.110064834499718961e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -3.281250000000000000e-01 1.046398316766412734e-01 1.046398316766412734e-01 1.046398316766412734e-01 -1.406250000000000000e-01 3.593750000000000000e-01 -2.968750000000000000e-01 1.512251026286181577e-01 1.512251026286181577e-01 1.512251026286181577e-01 -1.406250000000000000e-01 3.593750000000000000e-01 -2.656250000000000000e-01 1.384912344339735701e-01 1.384912344339735701e-01 1.384912344339735701e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -2.656250000000000000e-01 1.348809574494918562e-01 1.348809574494918562e-01 1.348809574494918562e-01 -2.031250000000000000e-01 2.656250000000000000e-01 -3.593750000000000000e-01 9.826544400736418605e-02 9.826544400736418605e-02 9.826544400736418605e-02 -2.343750000000000000e-01 2.656250000000000000e-01 -3.593750000000000000e-01 1.145680213050108698e-01 1.145680213050108698e-01 1.145680213050108698e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 1.416981810980198486e-01 1.416981810980198486e-01 1.416981810980198486e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -3.593750000000000000e-01 1.251062933122000786e-01 1.251062933122000786e-01 1.251062933122000786e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 1.479085159822254580e-01 1.479085159822254580e-01 1.479085159822254580e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 1.459787296462289330e-01 1.459787296462289330e-01 1.459787296462289330e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 1.355893716267767557e-01 1.355893716267767557e-01 1.355893716267767557e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -2.656250000000000000e-01 6.357624368307877860e-02 6.357624368307877860e-02 6.357624368307877860e-02 -2.343750000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 1.760301200260974419e-01 1.760301200260974419e-01 1.760301200260974419e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.593750000000000000e-01 -3.593750000000000000e-01 1.112820603575899459e-01 1.112820603575899459e-01 1.112820603575899459e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -3.593750000000000000e-01 1.167492146687006960e-01 1.167492146687006960e-01 1.167492146687006960e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -3.281250000000000000e-01 1.325741505983810686e-01 1.325741505983810686e-01 1.325741505983810686e-01 -2.343750000000000000e-01 3.593750000000000000e-01 -3.593750000000000000e-01 1.011702603827486502e-01 1.011702603827486502e-01 1.011702603827486502e-01 -2.343750000000000000e-01 3.593750000000000000e-01 -3.281250000000000000e-01 1.097241948121421978e-01 1.097241948121421978e-01 1.097241948121421978e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -2.968750000000000000e-01 1.343444219259527228e-01 1.343444219259527228e-01 1.343444219259527228e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -2.656250000000000000e-01 1.301990021516401252e-01 1.301990021516401252e-01 1.301990021516401252e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -2.968750000000000000e-01 1.479735641534129509e-01 1.479735641534129509e-01 1.479735641534129509e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -2.656250000000000000e-01 1.298744921510303907e-01 1.298744921510303907e-01 1.298744921510303907e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -2.968750000000000000e-01 1.342496443209055534e-01 1.342496443209055534e-01 1.342496443209055534e-01 -2.343750000000000000e-01 3.593750000000000000e-01 -2.968750000000000000e-01 1.139759155165341875e-01 1.139759155165341875e-01 1.139759155165341875e-01 -1.406250000000000000e-01 3.906250000000000000e-01 -3.281250000000000000e-01 1.055485807180132352e-01 1.055485807180132352e-01 1.055485807180132352e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -3.281250000000000000e-01 1.284776383686546120e-01 1.284776383686546120e-01 1.284776383686546120e-01 -1.406250000000000000e-01 3.906250000000000000e-01 -2.968750000000000000e-01 1.346480307904535101e-01 1.346480307904535101e-01 1.346480307904535101e-01 -1.406250000000000000e-01 3.906250000000000000e-01 -2.656250000000000000e-01 1.067168424780644553e-01 1.067168424780644553e-01 1.067168424780644553e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -2.968750000000000000e-01 1.451370938102911901e-01 1.451370938102911901e-01 1.451370938102911901e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -2.656250000000000000e-01 1.229285397628035320e-01 1.229285397628035320e-01 1.229285397628035320e-01 -2.031250000000000000e-01 3.906250000000000000e-01 -3.593750000000000000e-01 8.248278440545872559e-02 8.248278440545872559e-02 8.248278440545872559e-02 -2.031250000000000000e-01 3.906250000000000000e-01 -3.281250000000000000e-01 1.293242679955004248e-01 1.293242679955004248e-01 1.293242679955004248e-01 -2.031250000000000000e-01 3.906250000000000000e-01 -2.968750000000000000e-01 1.301925762237224615e-01 1.301925762237224615e-01 1.301925762237224615e-01 -1.562500000000000000e-02 2.968750000000000000e-01 -2.031250000000000000e-01 5.746656437664100087e-02 5.746656437664100087e-02 5.746656437664100087e-02 -4.687500000000000000e-02 2.968750000000000000e-01 -2.343750000000000000e-01 5.485861255088219507e-02 5.485861255088219507e-02 5.485861255088219507e-02 -1.562500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 1.246733178657832980e-01 1.246733178657832980e-01 1.246733178657832980e-01 -1.562500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 4.226620463727376320e-02 4.226620463727376320e-02 4.226620463727376320e-02 -1.562500000000000000e-02 2.968750000000000000e-01 -1.718750000000000000e-01 3.383963801656001552e-02 3.383963801656001552e-02 3.383963801656001552e-02 -1.562500000000000000e-02 2.968750000000000000e-01 -1.406250000000000000e-01 4.249545873499706305e-02 4.249545873499706305e-02 4.249545873499706305e-02 -4.687500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 4.545294688768751479e-02 4.545294688768751479e-02 4.545294688768751479e-02 -4.687500000000000000e-02 2.968750000000000000e-01 -1.406250000000000000e-01 2.121980971127015309e-02 2.121980971127015309e-02 2.121980971127015309e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 4.773797027248517788e-02 4.773797027248517788e-02 4.773797027248517788e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 7.015032147372736449e-02 7.015032147372736449e-02 7.015032147372736449e-02 -4.687500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 2.031861111787111318e-01 2.031861111787111318e-01 2.031861111787111318e-01 -4.687500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 4.503248843954484049e-02 4.503248843954484049e-02 4.503248843954484049e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -1.718750000000000000e-01 3.521087383430353268e-02 3.521087383430353268e-02 3.521087383430353268e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -1.406250000000000000e-01 7.751525511918973266e-02 7.751525511918973266e-02 7.751525511918973266e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 8.962590832594363732e-02 8.962590832594363732e-02 8.962590832594363732e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -1.406250000000000000e-01 1.047129497953218219e-01 1.047129497953218219e-01 1.047129497953218219e-01 -4.687500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 8.201100085688857455e-02 8.201100085688857455e-02 8.201100085688857455e-02 -7.812500000000000000e-02 2.656250000000000000e-01 -2.343750000000000000e-01 2.192580305418716513e-01 2.192580305418716513e-01 2.192580305418716513e-01 -7.812500000000000000e-02 2.656250000000000000e-01 -2.031250000000000000e-01 1.906555062677540158e-01 1.906555062677540158e-01 1.906555062677540158e-01 -7.812500000000000000e-02 2.968750000000000000e-01 -2.343750000000000000e-01 8.908023075121927759e-02 8.908023075121927759e-02 8.908023075121927759e-02 -7.812500000000000000e-02 2.968750000000000000e-01 -2.031250000000000000e-01 9.712357737403203017e-02 9.712357737403203017e-02 9.712357737403203017e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 1.323685267213854100e-01 1.323685267213854100e-01 1.323685267213854100e-01 -1.093750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 9.434156563152841513e-02 9.434156563152841513e-02 9.434156563152841513e-02 -1.093750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 1.128953313046481138e-01 1.128953313046481138e-01 1.128953313046481138e-01 -1.093750000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 1.020244091168459322e-01 1.020244091168459322e-01 1.020244091168459322e-01 -7.812500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 8.329292755416084493e-02 8.329292755416084493e-02 8.329292755416084493e-02 -7.812500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 9.297704290705328944e-02 9.297704290705328944e-02 9.297704290705328944e-02 -7.812500000000000000e-02 2.968750000000000000e-01 -1.718750000000000000e-01 8.488827488512945552e-02 8.488827488512945552e-02 8.488827488512945552e-02 -7.812500000000000000e-02 2.968750000000000000e-01 -1.406250000000000000e-01 6.915877786587748544e-02 6.915877786587748544e-02 6.915877786587748544e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 9.990549292116844560e-02 9.990549292116844560e-02 9.990549292116844560e-02 -1.093750000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 9.615044671340186588e-02 9.615044671340186588e-02 9.615044671340186588e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 6.898683403831132321e-02 6.898683403831132321e-02 6.898683403831132321e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 7.548202013679508604e-02 7.548202013679508604e-02 7.548202013679508604e-02 -1.093750000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 1.086572122473607044e-01 1.086572122473607044e-01 1.086572122473607044e-01 -7.812500000000000000e-02 3.281250000000000000e-01 -1.718750000000000000e-01 4.286776406796499045e-02 4.286776406796499045e-02 4.286776406796499045e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -1.406250000000000000e-01 8.306547747395913450e-02 8.306547747395913450e-02 8.306547747395913450e-02 -7.812500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 8.516715603164945469e-02 8.516715603164945469e-02 8.516715603164945469e-02 -7.812500000000000000e-02 3.593750000000000000e-01 -1.406250000000000000e-01 7.706257220725835910e-02 7.706257220725835910e-02 7.706257220725835910e-02 -1.093750000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 9.784277042213182507e-02 9.784277042213182507e-02 9.784277042213182507e-02 -1.093750000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 8.351716216277539628e-02 8.351716216277539628e-02 8.351716216277539628e-02 -1.562500000000000000e-02 2.656250000000000000e-01 -4.687500000000000000e-02 8.042604506524114738e-02 8.042604506524114738e-02 8.042604506524114738e-02 -1.562500000000000000e-02 2.656250000000000000e-01 -1.562500000000000000e-02 1.204060956857489900e-01 1.204060956857489900e-01 1.204060956857489900e-01 -1.562500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 5.893933883594070638e-02 5.893933883594070638e-02 5.893933883594070638e-02 -1.562500000000000000e-02 2.968750000000000000e-01 -1.562500000000000000e-02 1.279796167793232353e-01 1.279796167793232353e-01 1.279796167793232353e-01 -4.687500000000000000e-02 2.656250000000000000e-01 -1.562500000000000000e-02 1.016933572500219179e-01 1.016933572500219179e-01 1.016933572500219179e-01 -4.687500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 4.752400838334246841e-02 4.752400838334246841e-02 4.752400838334246841e-02 -4.687500000000000000e-02 2.968750000000000000e-01 -1.562500000000000000e-02 7.874002612445502036e-02 7.874002612445502036e-02 7.874002612445502036e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -1.093750000000000000e-01 5.831410237975664240e-02 5.831410237975664240e-02 5.831410237975664240e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -7.812500000000000000e-02 8.007320329444959917e-02 8.007320329444959917e-02 8.007320329444959917e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -1.093750000000000000e-01 8.315710055181620153e-02 8.315710055181620153e-02 8.315710055181620153e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -7.812500000000000000e-02 1.111278016801368895e-01 1.111278016801368895e-01 1.111278016801368895e-01 -1.562500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 1.064058968850238596e-01 1.064058968850238596e-01 1.064058968850238596e-01 -1.562500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 7.995778592377592031e-02 7.995778592377592031e-02 7.995778592377592031e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 6.997733477010073533e-02 6.997733477010073533e-02 6.997733477010073533e-02 -4.687500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 6.565696766425910269e-02 6.565696766425910269e-02 6.565696766425910269e-02 -4.687500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 2.605738582135677661e-02 2.605738582135677661e-02 2.605738582135677661e-02 -4.687500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 5.346817418779748615e-02 5.346817418779748615e-02 5.346817418779748615e-02 -4.687500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 5.426920276157683187e-02 5.426920276157683187e-02 5.426920276157683187e-02 -7.812500000000000000e-02 2.656250000000000000e-01 -1.093750000000000000e-01 8.361521437589976291e-02 8.361521437589976291e-02 8.361521437589976291e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 9.809830338737830779e-02 9.809830338737830779e-02 9.809830338737830779e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 5.400991254246022277e-02 5.400991254246022277e-02 5.400991254246022277e-02 -1.093750000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 9.606205275894223738e-02 9.606205275894223738e-02 9.606205275894223738e-02 -1.093750000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 5.606515653986975101e-02 5.606515653986975101e-02 5.606515653986975101e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 8.767704284999187914e-02 8.767704284999187914e-02 8.767704284999187914e-02 -1.093750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 6.917155908944304377e-02 6.917155908944304377e-02 6.917155908944304377e-02 -1.093750000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 8.560677362813934321e-02 8.560677362813934321e-02 8.560677362813934321e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 4.414163031958764916e-02 4.414163031958764916e-02 4.414163031958764916e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 3.246395563238455018e-02 3.246395563238455018e-02 3.246395563238455018e-02 -7.812500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 6.069756421238130945e-02 6.069756421238130945e-02 6.069756421238130945e-02 -1.093750000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 1.276655402886693880e-01 1.276655402886693880e-01 1.276655402886693880e-01 -1.093750000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 4.348877839552842128e-02 4.348877839552842128e-02 4.348877839552842128e-02 -1.093750000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 4.851380851710753589e-02 4.851380851710753589e-02 4.851380851710753589e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -1.718750000000000000e-01 6.479399185399872807e-02 6.479399185399872807e-02 6.479399185399872807e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 1.024060813018525945e-01 1.024060813018525945e-01 1.024060813018525945e-01 -4.687500000000000000e-02 3.906250000000000000e-01 -1.718750000000000000e-01 7.754957596762424021e-02 7.754957596762424021e-02 7.754957596762424021e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 9.722080943569412492e-02 9.722080943569412492e-02 9.722080943569412492e-02 -7.812500000000000000e-02 3.906250000000000000e-01 -1.718750000000000000e-01 6.952211751767491121e-02 6.952211751767491121e-02 6.952211751767491121e-02 -7.812500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 1.027837341027566798e-01 1.027837341027566798e-01 1.027837341027566798e-01 -1.093750000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 9.003174859942522645e-02 9.003174859942522645e-02 9.003174859942522645e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 8.340705420725604002e-02 8.340705420725604002e-02 8.340705420725604002e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -7.812500000000000000e-02 1.255521190271629006e-01 1.255521190271629006e-01 1.255521190271629006e-01 -4.687500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 1.623133944311480892e-01 1.623133944311480892e-01 1.623133944311480892e-01 -4.687500000000000000e-02 3.906250000000000000e-01 -7.812500000000000000e-02 1.059390745005426571e-01 1.059390745005426571e-01 1.059390745005426571e-01 -1.562500000000000000e-02 3.906250000000000000e-01 -4.687500000000000000e-02 7.047016905065245362e-02 7.047016905065245362e-02 7.047016905065245362e-02 -1.562500000000000000e-02 4.218750000000000000e-01 -4.687500000000000000e-02 6.300402108571732940e-02 6.300402108571732940e-02 6.300402108571732940e-02 -1.562500000000000000e-02 4.218750000000000000e-01 -1.562500000000000000e-02 6.167634929898740959e-02 6.167634929898740959e-02 6.167634929898740959e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -4.687500000000000000e-02 6.148131676886133684e-02 6.148131676886133684e-02 6.148131676886133684e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -1.562500000000000000e-02 5.700749766301767968e-02 5.700749766301767968e-02 5.700749766301767968e-02 -4.687500000000000000e-02 4.218750000000000000e-01 -4.687500000000000000e-02 6.366603997577777174e-02 6.366603997577777174e-02 6.366603997577777174e-02 -4.687500000000000000e-02 4.218750000000000000e-01 -1.562500000000000000e-02 5.213246562506428095e-02 5.213246562506428095e-02 5.213246562506428095e-02 -4.687500000000000000e-02 4.531250000000000000e-01 -1.562500000000000000e-02 7.434835036305441347e-02 7.434835036305441347e-02 7.434835036305441347e-02 -7.812500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 2.211780366796617381e-01 2.211780366796617381e-01 2.211780366796617381e-01 -7.812500000000000000e-02 3.906250000000000000e-01 -7.812500000000000000e-02 1.614173302801620857e-01 1.614173302801620857e-01 1.614173302801620857e-01 -7.812500000000000000e-02 4.218750000000000000e-01 -7.812500000000000000e-02 1.011566003575384981e-01 1.011566003575384981e-01 1.011566003575384981e-01 -1.093750000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 1.237519319341922608e-01 1.237519319341922608e-01 1.237519319341922608e-01 -1.093750000000000000e-01 3.906250000000000000e-01 -7.812500000000000000e-02 1.414845492563110985e-01 1.414845492563110985e-01 1.414845492563110985e-01 -1.093750000000000000e-01 4.218750000000000000e-01 -7.812500000000000000e-02 1.447122571103920119e-01 1.447122571103920119e-01 1.447122571103920119e-01 -7.812500000000000000e-02 4.218750000000000000e-01 -4.687500000000000000e-02 7.376479035212953062e-02 7.376479035212953062e-02 7.376479035212953062e-02 -7.812500000000000000e-02 4.218750000000000000e-01 -1.562500000000000000e-02 4.552555595542392974e-02 4.552555595542392974e-02 4.552555595542392974e-02 -1.093750000000000000e-01 4.531250000000000000e-01 -7.812500000000000000e-02 1.469689254208853268e-01 1.469689254208853268e-01 1.469689254208853268e-01 -7.812500000000000000e-02 4.531250000000000000e-01 -4.687500000000000000e-02 9.257443195726235141e-02 9.257443195726235141e-02 9.257443195726235141e-02 -7.812500000000000000e-02 4.531250000000000000e-01 -1.562500000000000000e-02 8.915738126624593585e-02 8.915738126624593585e-02 8.915738126624593585e-02 -7.812500000000000000e-02 4.843750000000000000e-01 -4.687500000000000000e-02 8.061733448999748586e-02 8.061733448999748586e-02 8.061733448999748586e-02 -7.812500000000000000e-02 4.843750000000000000e-01 -1.562500000000000000e-02 1.024213481515880292e-01 1.024213481515880292e-01 1.024213481515880292e-01 -1.093750000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 1.334681264231738496e-01 1.334681264231738496e-01 1.334681264231738496e-01 -1.093750000000000000e-01 4.843750000000000000e-01 -4.687500000000000000e-02 1.174746592465067546e-01 1.174746592465067546e-01 1.174746592465067546e-01 -1.093750000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 1.360190755997486567e-01 1.360190755997486567e-01 1.360190755997486567e-01 -1.406250000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 1.333926248058404374e-01 1.333926248058404374e-01 1.333926248058404374e-01 -1.406250000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 1.246130706338265393e-01 1.246130706338265393e-01 1.246130706338265393e-01 -1.406250000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 8.856991037717219795e-02 8.856991037717219795e-02 8.856991037717219795e-02 -1.718750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 1.299676684237786317e-01 1.299676684237786317e-01 1.299676684237786317e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 1.394759003270593656e-01 1.394759003270593656e-01 1.394759003270593656e-01 -1.406250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 1.453362603376855411e-01 1.453362603376855411e-01 1.453362603376855411e-01 -1.718750000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 1.185945464492492024e-01 1.185945464492492024e-01 1.185945464492492024e-01 -1.718750000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 1.836200801446473685e-01 1.836200801446473685e-01 1.836200801446473685e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 1.431261267352016697e-01 1.431261267352016697e-01 1.431261267352016697e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 1.749110320217286685e-01 1.749110320217286685e-01 1.749110320217286685e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 1.158558564336775731e-01 1.158558564336775731e-01 1.158558564336775731e-01 -1.406250000000000000e-01 3.593750000000000000e-01 -2.343750000000000000e-01 1.169548784691758353e-01 1.169548784691758353e-01 1.169548784691758353e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 1.160711631026306451e-01 1.160711631026306451e-01 1.160711631026306451e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -2.343750000000000000e-01 1.046342072032197673e-01 1.046342072032197673e-01 1.046342072032197673e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 1.165403368332221662e-01 1.165403368332221662e-01 1.165403368332221662e-01 -1.406250000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 1.097989151995277940e-01 1.097989151995277940e-01 1.097989151995277940e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 1.324930256159217723e-01 1.324930256159217723e-01 1.324930256159217723e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 1.559202882448405270e-01 1.559202882448405270e-01 1.559202882448405270e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 1.233912470348376561e-01 1.233912470348376561e-01 1.233912470348376561e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 1.377659793358972373e-01 1.377659793358972373e-01 1.377659793358972373e-01 -2.031250000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 1.085551732637674988e-01 1.085551732637674988e-01 1.085551732637674988e-01 -2.031250000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 1.195200081843423023e-01 1.195200081843423023e-01 1.195200081843423023e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 1.339034641537704406e-01 1.339034641537704406e-01 1.339034641537704406e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 1.456052949850162870e-01 1.456052949850162870e-01 1.456052949850162870e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 7.109651679235592936e-02 7.109651679235592936e-02 7.109651679235592936e-02 -2.343750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 1.251777862508396399e-01 1.251777862508396399e-01 1.251777862508396399e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 7.963090309864437333e-02 7.963090309864437333e-02 7.963090309864437333e-02 -2.343750000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 1.681182994663408536e-01 1.681182994663408536e-01 1.681182994663408536e-01 -2.031250000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 1.487107730846455034e-01 1.487107730846455034e-01 1.487107730846455034e-01 -2.031250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 1.809951828653380279e-01 1.809951828653380279e-01 1.809951828653380279e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 1.697633478392388540e-01 1.697633478392388540e-01 1.697633478392388540e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 1.742800329268182069e-01 1.742800329268182069e-01 1.742800329268182069e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 1.772206391719882701e-01 1.772206391719882701e-01 1.772206391719882701e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 1.980001076486037903e-01 1.980001076486037903e-01 1.980001076486037903e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 1.833487644555310825e-01 1.833487644555310825e-01 1.833487644555310825e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 1.140506319553343251e-01 1.140506319553343251e-01 1.140506319553343251e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -2.031250000000000000e-01 1.347918028424206216e-01 1.347918028424206216e-01 1.347918028424206216e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -2.031250000000000000e-01 7.330380710308703751e-02 7.330380710308703751e-02 7.330380710308703751e-02 -2.343750000000000000e-01 3.281250000000000000e-01 -2.031250000000000000e-01 1.237607682922801933e-01 1.237607682922801933e-01 1.237607682922801933e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 1.181205645286082795e-01 1.181205645286082795e-01 1.181205645286082795e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 1.268349586989967470e-01 1.268349586989967470e-01 1.268349586989967470e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 1.830220606216142465e-01 1.830220606216142465e-01 1.830220606216142465e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 1.689452435556337007e-01 1.689452435556337007e-01 1.689452435556337007e-01 -2.343750000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 1.280117472974719728e-01 1.280117472974719728e-01 1.280117472974719728e-01 -2.343750000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 1.553381225936426302e-01 1.553381225936426302e-01 1.553381225936426302e-01 -1.406250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 1.222047510020278921e-01 1.222047510020278921e-01 1.222047510020278921e-01 -1.406250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 5.034173071059459825e-02 5.034173071059459825e-02 5.034173071059459825e-02 -1.406250000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 1.108867719044887429e-01 1.108867719044887429e-01 1.108867719044887429e-01 -1.406250000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 9.070841238435238540e-02 9.070841238435238540e-02 9.070841238435238540e-02 -1.718750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 1.354921859240085791e-01 1.354921859240085791e-01 1.354921859240085791e-01 -1.718750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 5.636303111071025440e-02 5.636303111071025440e-02 5.636303111071025440e-02 -1.718750000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 1.539585739284159427e-01 1.539585739284159427e-01 1.539585739284159427e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 5.704785704829218318e-02 5.704785704829218318e-02 5.704785704829218318e-02 -1.406250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 4.333527419937011765e-02 4.333527419937011765e-02 4.333527419937011765e-02 -1.406250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 6.687613131431563440e-02 6.687613131431563440e-02 6.687613131431563440e-02 -1.406250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 3.965269391549719469e-02 3.965269391549719469e-02 3.965269391549719469e-02 -1.406250000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 8.374862949034124482e-02 8.374862949034124482e-02 8.374862949034124482e-02 -1.718750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 1.188781309072940440e-01 1.188781309072940440e-01 1.188781309072940440e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 1.305010201841368955e-01 1.305010201841368955e-01 1.305010201841368955e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 1.110466550696246057e-01 1.110466550696246057e-01 1.110466550696246057e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 1.333452354566461995e-01 1.333452354566461995e-01 1.333452354566461995e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -7.812500000000000000e-02 7.883237750691642065e-02 7.883237750691642065e-02 7.883237750691642065e-02 -1.718750000000000000e-01 3.593750000000000000e-01 -1.093750000000000000e-01 1.079670405365259489e-01 1.079670405365259489e-01 1.079670405365259489e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -7.812500000000000000e-02 7.800868623714435346e-02 7.800868623714435346e-02 7.800868623714435346e-02 -1.406250000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 1.015993446996886346e-01 1.015993446996886346e-01 1.015993446996886346e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 3.072336926100385085e-02 3.072336926100385085e-02 3.072336926100385085e-02 -1.406250000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 7.917630308925606430e-02 7.917630308925606430e-02 7.917630308925606430e-02 -1.406250000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 5.820870329065543775e-02 5.820870329065543775e-02 5.820870329065543775e-02 -1.718750000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 7.688509923426133097e-02 7.688509923426133097e-02 7.688509923426133097e-02 -1.718750000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 5.873071283581280527e-02 5.873071283581280527e-02 5.873071283581280527e-02 -1.718750000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 8.552961970822620108e-02 8.552961970822620108e-02 8.552961970822620108e-02 -1.718750000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 9.396949842023127886e-02 9.396949842023127886e-02 9.396949842023127886e-02 -2.031250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 5.114648895353535174e-02 5.114648895353535174e-02 5.114648895353535174e-02 -2.031250000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 1.299178673259086259e-01 1.299178673259086259e-01 1.299178673259086259e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 9.984281650703590028e-02 9.984281650703590028e-02 9.984281650703590028e-02 -2.343750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 7.765382445025904856e-02 7.765382445025904856e-02 7.765382445025904856e-02 -2.343750000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 7.826042415936898533e-02 7.826042415936898533e-02 7.826042415936898533e-02 -2.343750000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 1.034627011693032145e-01 1.034627011693032145e-01 1.034627011693032145e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 1.225477682408668556e-01 1.225477682408668556e-01 1.225477682408668556e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 1.558825479786081214e-01 1.558825479786081214e-01 1.558825479786081214e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 1.214865790255715283e-01 1.214865790255715283e-01 1.214865790255715283e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 1.237551451554258081e-01 1.237551451554258081e-01 1.237551451554258081e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 1.232313883997053772e-01 1.232313883997053772e-01 1.232313883997053772e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 1.548603421188422813e-01 1.548603421188422813e-01 1.548603421188422813e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -1.093750000000000000e-01 1.454133569255944558e-01 1.454133569255944558e-01 1.454133569255944558e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 1.192420494414472704e-01 1.192420494414472704e-01 1.192420494414472704e-01 -2.343750000000000000e-01 3.593750000000000000e-01 -1.093750000000000000e-01 1.174955468118854263e-01 1.174955468118854263e-01 1.174955468118854263e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 1.300712867382864679e-01 1.300712867382864679e-01 1.300712867382864679e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 1.012249004603607838e-01 1.012249004603607838e-01 1.012249004603607838e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 7.941115864821772508e-02 7.941115864821772508e-02 7.941115864821772508e-02 -2.031250000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 9.259452237178135425e-02 9.259452237178135425e-02 9.259452237178135425e-02 -1.406250000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 1.026792771224177697e-01 1.026792771224177697e-01 1.026792771224177697e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -1.718750000000000000e-01 9.936872410062540240e-02 9.936872410062540240e-02 9.936872410062540240e-02 -1.718750000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 1.473784918864592952e-01 1.473784918864592952e-01 1.473784918864592952e-01 -2.031250000000000000e-01 3.906250000000000000e-01 -1.718750000000000000e-01 1.204984795869350200e-01 1.204984795869350200e-01 1.204984795869350200e-01 -2.031250000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 1.515198144886875375e-01 1.515198144886875375e-01 1.515198144886875375e-01 -2.343750000000000000e-01 3.906250000000000000e-01 -1.718750000000000000e-01 9.237111668007966236e-02 9.237111668007966236e-02 9.237111668007966236e-02 -2.343750000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 1.158976323995693225e-01 1.158976323995693225e-01 1.158976323995693225e-01 -1.406250000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 1.061761016951967840e-01 1.061761016951967840e-01 1.061761016951967840e-01 -1.406250000000000000e-01 3.906250000000000000e-01 -7.812500000000000000e-02 8.102884633272527948e-02 8.102884633272527948e-02 8.102884633272527948e-02 -1.406250000000000000e-01 4.218750000000000000e-01 -7.812500000000000000e-02 1.507424795126638406e-01 1.507424795126638406e-01 1.507424795126638406e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 1.147785110509951245e-01 1.147785110509951245e-01 1.147785110509951245e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -7.812500000000000000e-02 8.024753464977218975e-02 8.024753464977218975e-02 8.024753464977218975e-02 -1.718750000000000000e-01 4.218750000000000000e-01 -7.812500000000000000e-02 1.240354982141294582e-01 1.240354982141294582e-01 1.240354982141294582e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -4.687500000000000000e-02 8.166057721422435856e-02 8.166057721422435856e-02 8.166057721422435856e-02 -1.718750000000000000e-01 4.218750000000000000e-01 -4.687500000000000000e-02 1.332263603561590626e-01 1.332263603561590626e-01 1.332263603561590626e-01 -1.718750000000000000e-01 4.218750000000000000e-01 -1.562500000000000000e-02 8.534236040737346041e-02 8.534236040737346041e-02 8.534236040737346041e-02 -1.406250000000000000e-01 4.531250000000000000e-01 -7.812500000000000000e-02 1.479599120724558181e-01 1.479599120724558181e-01 1.479599120724558181e-01 -1.406250000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 1.573961596673444652e-01 1.573961596673444652e-01 1.573961596673444652e-01 -1.406250000000000000e-01 4.531250000000000000e-01 -1.562500000000000000e-02 8.510286075219936075e-02 8.510286075219936075e-02 8.510286075219936075e-02 -1.406250000000000000e-01 4.843750000000000000e-01 -4.687500000000000000e-02 1.240949425767051972e-01 1.240949425767051972e-01 1.240949425767051972e-01 -1.406250000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 1.429309703058337377e-01 1.429309703058337377e-01 1.429309703058337377e-01 -1.718750000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 1.527106963778503967e-01 1.527106963778503967e-01 1.527106963778503967e-01 -1.718750000000000000e-01 4.531250000000000000e-01 -1.562500000000000000e-02 1.135798368918193996e-01 1.135798368918193996e-01 1.135798368918193996e-01 -1.718750000000000000e-01 4.843750000000000000e-01 -4.687500000000000000e-02 1.024623275760373348e-01 1.024623275760373348e-01 1.024623275760373348e-01 -1.718750000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 1.218858320230347542e-01 1.218858320230347542e-01 1.218858320230347542e-01 -2.031250000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 1.338207341021276087e-01 1.338207341021276087e-01 1.338207341021276087e-01 -2.343750000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 9.286935873860749369e-02 9.286935873860749369e-02 9.286935873860749369e-02 -2.031250000000000000e-01 3.906250000000000000e-01 -4.687500000000000000e-02 7.448756818659950374e-02 7.448756818659950374e-02 7.448756818659950374e-02 -2.031250000000000000e-01 3.906250000000000000e-01 -1.562500000000000000e-02 9.722241657623011124e-02 9.722241657623011124e-02 9.722241657623011124e-02 -2.031250000000000000e-01 4.218750000000000000e-01 -4.687500000000000000e-02 7.751067364652503011e-02 7.751067364652503011e-02 7.751067364652503011e-02 -2.031250000000000000e-01 4.218750000000000000e-01 -1.562500000000000000e-02 8.773892507739526614e-02 8.773892507739526614e-02 8.773892507739526614e-02 -2.031250000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 1.010730330940395744e-01 1.010730330940395744e-01 1.010730330940395744e-01 -2.656250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 6.712517091111501466e-02 6.712517091111501466e-02 6.712517091111501466e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 3.718376863096858193e-02 3.718376863096858193e-02 3.718376863096858193e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 4.029825930371747078e-02 4.029825930371747078e-02 4.029825930371747078e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 4.952755707116007072e-02 4.952755707116007072e-02 4.952755707116007072e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 6.150615811904969199e-02 6.150615811904969199e-02 6.150615811904969199e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 6.440940794292535077e-02 6.440940794292535077e-02 6.440940794292535077e-02 -2.656250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 8.439882408051428697e-02 8.439882408051428697e-02 8.439882408051428697e-02 -2.656250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 8.815361513931647963e-02 8.815361513931647963e-02 8.815361513931647963e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 8.217415629821345213e-02 8.217415629821345213e-02 8.217415629821345213e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 8.997790456212213794e-02 8.997790456212213794e-02 8.997790456212213794e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 6.954567023051085040e-02 6.954567023051085040e-02 6.954567023051085040e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 1.008938453037235422e-01 1.008938453037235422e-01 1.008938453037235422e-01 -2.968750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 4.518904494005854255e-02 4.518904494005854255e-02 4.518904494005854255e-02 -2.968750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 7.791239546985861963e-02 7.791239546985861963e-02 7.791239546985861963e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 7.680335543702263013e-02 7.680335543702263013e-02 7.680335543702263013e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 1.155401258360821276e-01 1.155401258360821276e-01 1.155401258360821276e-01 -2.656250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.121762728018462080e-01 1.121762728018462080e-01 1.121762728018462080e-01 -2.656250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 1.100198621756130618e-01 1.100198621756130618e-01 1.100198621756130618e-01 -2.968750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 1.074640711597646819e-01 1.074640711597646819e-01 1.074640711597646819e-01 -2.968750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 9.891069997000186131e-02 9.891069997000186131e-02 9.891069997000186131e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 9.359501866885985844e-02 9.359501866885985844e-02 9.359501866885985844e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 7.956756789066900259e-02 7.956756789066900259e-02 7.956756789066900259e-02 -3.281250000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 4.219198438776862459e-02 4.219198438776862459e-02 4.219198438776862459e-02 -3.281250000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 5.017818908641281939e-02 5.017818908641281939e-02 5.017818908641281939e-02 -3.281250000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 3.249057522124037395e-02 3.249057522124037395e-02 3.249057522124037395e-02 -3.593750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 5.713532911262840519e-02 5.713532911262840519e-02 5.713532911262840519e-02 -3.593750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 3.883728628326283544e-02 3.883728628326283544e-02 3.883728628326283544e-02 -3.593750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 6.084637247031408902e-02 6.084637247031408902e-02 6.084637247031408902e-02 -3.281250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 7.811968571819170870e-02 7.811968571819170870e-02 7.811968571819170870e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 4.497081458297773338e-02 4.497081458297773338e-02 4.497081458297773338e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 7.030080031117899586e-02 7.030080031117899586e-02 7.030080031117899586e-02 -3.281250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 7.886275940068457335e-02 7.886275940068457335e-02 7.886275940068457335e-02 -3.593750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 4.219254727183608528e-02 4.219254727183608528e-02 4.219254727183608528e-02 -3.593750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 7.249364374271730083e-02 7.249364374271730083e-02 7.249364374271730083e-02 -3.593750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 7.826339807008617089e-02 7.826339807008617089e-02 7.826339807008617089e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 9.210511844674408588e-02 9.210511844674408588e-02 9.210511844674408588e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 8.895325370081853811e-02 8.895325370081853811e-02 8.895325370081853811e-02 -3.281250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 8.984610706500900656e-02 8.984610706500900656e-02 8.984610706500900656e-02 -3.281250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 1.101154717699076996e-01 1.101154717699076996e-01 1.101154717699076996e-01 -3.593750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 7.624802590783372191e-02 7.624802590783372191e-02 7.624802590783372191e-02 -3.593750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.238362789490923682e-01 1.238362789490923682e-01 1.238362789490923682e-01 -3.593750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 8.847748980576579381e-02 8.847748980576579381e-02 8.847748980576579381e-02 -3.593750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 9.084583390670213088e-02 9.084583390670213088e-02 9.084583390670213088e-02 -2.656250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 1.294792950361323414e-01 1.294792950361323414e-01 1.294792950361323414e-01 -2.968750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 1.006182328113592317e-01 1.006182328113592317e-01 1.006182328113592317e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 1.410307804924100517e-01 1.410307804924100517e-01 1.410307804924100517e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 1.738256462896591303e-01 1.738256462896591303e-01 1.738256462896591303e-01 -2.656250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 1.573801002763340617e-01 1.573801002763340617e-01 1.573801002763340617e-01 -2.656250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 1.723107380244893738e-01 1.723107380244893738e-01 1.723107380244893738e-01 -2.968750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 8.959858435277436028e-02 8.959858435277436028e-02 8.959858435277436028e-02 -2.968750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 8.189365733000572578e-02 8.189365733000572578e-02 8.189365733000572578e-02 -2.968750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 8.015365778429915655e-02 8.015365778429915655e-02 8.015365778429915655e-02 -2.656250000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 8.457965600539991968e-02 8.457965600539991968e-02 8.457965600539991968e-02 -2.656250000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 8.843409228342340167e-02 8.843409228342340167e-02 8.843409228342340167e-02 -2.968750000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 7.404788982820802168e-02 7.404788982820802168e-02 7.404788982820802168e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 7.350226734699585873e-02 7.350226734699585873e-02 7.350226734699585873e-02 -2.968750000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 7.579324602645177988e-02 7.579324602645177988e-02 7.579324602645177988e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.471065843489795910e-02 8.471065843489795910e-02 8.471065843489795910e-02 -3.593750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 7.447639540247863454e-02 7.447639540247863454e-02 7.447639540247863454e-02 -3.281250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 7.446200742642075654e-02 7.446200742642075654e-02 7.446200742642075654e-02 -3.281250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 7.729510300555882119e-02 7.729510300555882119e-02 7.729510300555882119e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 7.778315025215250256e-02 7.778315025215250256e-02 7.778315025215250256e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 5.422964598217797777e-02 5.422964598217797777e-02 5.422964598217797777e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 8.519689258101451057e-02 8.519689258101451057e-02 8.519689258101451057e-02 -3.593750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 8.581653547388204406e-02 8.581653547388204406e-02 8.581653547388204406e-02 -3.281250000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 7.168588370012371480e-02 7.168588370012371480e-02 7.168588370012371480e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 5.278918708284210948e-02 5.278918708284210948e-02 5.278918708284210948e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 6.768900399948463154e-02 6.768900399948463154e-02 6.768900399948463154e-02 -3.281250000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 8.086327736780724029e-02 8.086327736780724029e-02 8.086327736780724029e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 7.276243979312288501e-02 7.276243979312288501e-02 7.276243979312288501e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 6.490557229350711610e-02 6.490557229350711610e-02 6.490557229350711610e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 1.116636886272163592e-01 1.116636886272163592e-01 1.116636886272163592e-01 -3.593750000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 7.647862999446186638e-02 7.647862999446186638e-02 7.647862999446186638e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 9.570927955529613673e-02 9.570927955529613673e-02 9.570927955529613673e-02 -3.906250000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 1.152002922816269953e-01 1.152002922816269953e-01 1.152002922816269953e-01 -3.906250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 1.097346396016390668e-01 1.097346396016390668e-01 1.097346396016390668e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 1.023377822017472599e-01 1.023377822017472599e-01 1.023377822017472599e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 1.043031660750073919e-01 1.043031660750073919e-01 1.043031660750073919e-01 -3.906250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 1.303684858147887426e-01 1.303684858147887426e-01 1.303684858147887426e-01 -3.906250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 1.669581548395495385e-01 1.669581548395495385e-01 1.669581548395495385e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 1.330119028049535357e-01 1.330119028049535357e-01 1.330119028049535357e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 1.567513725992384088e-01 1.567513725992384088e-01 1.567513725992384088e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 1.455362294598842310e-01 1.455362294598842310e-01 1.455362294598842310e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 1.596853930569658020e-01 1.596853930569658020e-01 1.596853930569658020e-01 -3.906250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 7.427150716558303389e-02 7.427150716558303389e-02 7.427150716558303389e-02 -3.906250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 7.226785115109496394e-02 7.226785115109496394e-02 7.226785115109496394e-02 -4.218750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 6.392079722042057210e-02 6.392079722042057210e-02 6.392079722042057210e-02 -3.906250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 8.178756577482484968e-02 8.178756577482484968e-02 8.178756577482484968e-02 -3.906250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.150460411166122632e-01 1.150460411166122632e-01 1.150460411166122632e-01 -3.906250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 6.724398294552613731e-02 6.724398294552613731e-02 6.724398294552613731e-02 -4.218750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 5.741318092142607549e-02 5.741318092142607549e-02 5.741318092142607549e-02 -4.218750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 9.453121477911259618e-02 9.453121477911259618e-02 9.453121477911259618e-02 -4.218750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 7.895398538843120817e-02 7.895398538843120817e-02 7.895398538843120817e-02 -4.218750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 9.000603204878356023e-02 9.000603204878356023e-02 9.000603204878356023e-02 -4.531250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 9.312651472287641896e-02 9.312651472287641896e-02 9.312651472287641896e-02 -4.531250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 1.175887374221351728e-01 1.175887374221351728e-01 1.175887374221351728e-01 -4.531250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 7.707864763838442879e-02 7.707864763838442879e-02 7.707864763838442879e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 5.861614919523321088e-02 5.861614919523321088e-02 5.861614919523321088e-02 -4.531250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 7.103614904345290082e-02 7.103614904345290082e-02 7.103614904345290082e-02 -4.531250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 6.932131629348299573e-02 6.932131629348299573e-02 6.932131629348299573e-02 -4.531250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 9.744098738893790246e-02 9.744098738893790246e-02 9.744098738893790246e-02 -4.531250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 9.401610736602870888e-02 9.401610736602870888e-02 9.401610736602870888e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 6.332526371926749942e-02 6.332526371926749942e-02 6.332526371926749942e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 6.232905365583350094e-02 6.232905365583350094e-02 6.232905365583350094e-02 -3.906250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 7.383673083015816763e-02 7.383673083015816763e-02 7.383673083015816763e-02 -3.906250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 6.772461522384233545e-02 6.772461522384233545e-02 6.772461522384233545e-02 -4.218750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 5.798520209564020367e-02 5.798520209564020367e-02 5.798520209564020367e-02 -4.218750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 4.535195343532818363e-02 4.535195343532818363e-02 4.535195343532818363e-02 -3.906250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 7.889844605491330709e-02 7.889844605491330709e-02 7.889844605491330709e-02 -4.218750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 5.578480772445850583e-02 5.578480772445850583e-02 5.578480772445850583e-02 -4.218750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 7.065641798377095273e-02 7.065641798377095273e-02 7.065641798377095273e-02 -3.906250000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 8.459572993461904333e-02 8.459572993461904333e-02 8.459572993461904333e-02 -3.906250000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 9.923372778576580733e-02 9.923372778576580733e-02 9.923372778576580733e-02 -3.906250000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 5.567836014089734553e-02 5.567836014089734553e-02 5.567836014089734553e-02 -3.906250000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 8.336927991042175634e-02 8.336927991042175634e-02 8.336927991042175634e-02 -4.218750000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 8.398170355701005396e-02 8.398170355701005396e-02 8.398170355701005396e-02 -4.531250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.925864120495992371e-02 8.925864120495992371e-02 8.925864120495992371e-02 -4.531250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 5.460036942623033851e-02 5.460036942623033851e-02 5.460036942623033851e-02 -4.843750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 6.201922273687099363e-02 6.201922273687099363e-02 6.201922273687099363e-02 -4.843750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 3.800361591261865180e-02 3.800361591261865180e-02 3.800361591261865180e-02 -4.531250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 1.148805421419216294e-01 1.148805421419216294e-01 1.148805421419216294e-01 -4.531250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 6.456054063560301426e-02 6.456054063560301426e-02 6.456054063560301426e-02 -4.843750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 7.481519532423511198e-02 7.481519532423511198e-02 7.481519532423511198e-02 -4.843750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 7.092948048691062601e-02 7.092948048691062601e-02 7.092948048691062601e-02 -4.843750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 4.647147806634986666e-02 4.647147806634986666e-02 4.647147806634986666e-02 -4.843750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 4.579026088338739725e-02 4.579026088338739725e-02 4.579026088338739725e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 7.646520690958921729e-02 7.646520690958921729e-02 7.646520690958921729e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 7.633169933877811952e-02 7.633169933877811952e-02 7.633169933877811952e-02 -2.656250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 8.432890229392099590e-02 8.432890229392099590e-02 8.432890229392099590e-02 -2.656250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 5.438079779866683561e-02 5.438079779866683561e-02 5.438079779866683561e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.281185811780597150e-01 1.281185811780597150e-01 1.281185811780597150e-01 -2.968750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 6.969655212149837575e-02 6.969655212149837575e-02 6.969655212149837575e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 9.668402270332056292e-02 9.668402270332056292e-02 9.668402270332056292e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 5.659168225980912292e-02 5.659168225980912292e-02 5.659168225980912292e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 7.113172459302816164e-02 7.113172459302816164e-02 7.113172459302816164e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 8.588725965108112703e-02 8.588725965108112703e-02 8.588725965108112703e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 5.495075015250961564e-02 5.495075015250961564e-02 5.495075015250961564e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 8.646269496388797604e-02 8.646269496388797604e-02 8.646269496388797604e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 3.488935808535047201e-02 3.488935808535047201e-02 3.488935808535047201e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 5.186448506708361134e-02 5.186448506708361134e-02 5.186448506708361134e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 8.222800555843351455e-02 8.222800555843351455e-02 8.222800555843351455e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 5.715510679045560094e-02 5.715510679045560094e-02 5.715510679045560094e-02 -2.656250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 1.051468361653922629e-01 1.051468361653922629e-01 1.051468361653922629e-01 -2.656250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 6.165649234000202678e-02 6.165649234000202678e-02 6.165649234000202678e-02 -2.968750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 6.991174120157914174e-02 6.991174120157914174e-02 6.991174120157914174e-02 -2.968750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 7.737089841608378593e-02 7.737089841608378593e-02 7.737089841608378593e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 9.762902209827095668e-02 9.762902209827095668e-02 9.762902209827095668e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 5.989676042786824806e-02 5.989676042786824806e-02 5.989676042786824806e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 4.647236255139031158e-02 4.647236255139031158e-02 4.647236255139031158e-02 -2.656250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 5.421573678478770753e-02 5.421573678478770753e-02 5.421573678478770753e-02 -2.656250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 4.648860491126789035e-02 4.648860491126789035e-02 4.648860491126789035e-02 -2.968750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 6.711777529829558719e-02 6.711777529829558719e-02 6.711777529829558719e-02 -3.593750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 1.572411864103916146e-01 1.572411864103916146e-01 1.572411864103916146e-01 -3.593750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 1.560495685971743651e-01 1.560495685971743651e-01 1.560495685971743651e-01 -3.281250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 9.110942540960915992e-02 9.110942540960915992e-02 9.110942540960915992e-02 -3.281250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 8.666602517275340256e-02 8.666602517275340256e-02 8.666602517275340256e-02 -3.281250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 8.943865855908179896e-02 8.943865855908179896e-02 8.943865855908179896e-02 -3.281250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 8.864063213402799402e-02 8.864063213402799402e-02 8.864063213402799402e-02 -3.593750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.236507153995831942e-01 1.236507153995831942e-01 1.236507153995831942e-01 -3.593750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.617754359678445220e-01 1.617754359678445220e-01 1.617754359678445220e-01 -3.593750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.275474600632910682e-01 1.275474600632910682e-01 1.275474600632910682e-01 -3.281250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 8.579805073550726691e-02 8.579805073550726691e-02 8.579805073550726691e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 7.096492951046744213e-02 7.096492951046744213e-02 7.096492951046744213e-02 -3.281250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 6.604122405916676430e-02 6.604122405916676430e-02 6.604122405916676430e-02 -3.593750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 1.009669668268792647e-01 1.009669668268792647e-01 1.009669668268792647e-01 -3.593750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.207009204603690100e-01 1.207009204603690100e-01 1.207009204603690100e-01 -3.281250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 8.029849173807721008e-02 8.029849173807721008e-02 8.029849173807721008e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 9.303329577355069768e-02 9.303329577355069768e-02 9.303329577355069768e-02 -3.593750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 8.063260547488788899e-02 8.063260547488788899e-02 8.063260547488788899e-02 -3.593750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.032995888939836765e-01 1.032995888939836765e-01 1.032995888939836765e-01 -3.593750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.058008752715631079e-01 1.058008752715631079e-01 1.058008752715631079e-01 -3.593750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 9.996736574364289973e-02 9.996736574364289973e-02 9.996736574364289973e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.044638658219326360e-01 1.044638658219326360e-01 1.044638658219326360e-01 -2.656250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.227429741196430918e-01 1.227429741196430918e-01 1.227429741196430918e-01 -2.656250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 8.659449800371134265e-02 8.659449800371134265e-02 8.659449800371134265e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.195320583971403589e-01 1.195320583971403589e-01 1.195320583971403589e-01 -2.656250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.286607810165301957e-01 1.286607810165301957e-01 1.286607810165301957e-01 -2.656250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 9.188010414883188148e-02 9.188010414883188148e-02 9.188010414883188148e-02 -2.656250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 1.004462758509357817e-01 1.004462758509357817e-01 1.004462758509357817e-01 -2.968750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.034450239928825926e-01 1.034450239928825926e-01 1.034450239928825926e-01 -2.968750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.125514694928173992e-01 1.125514694928173992e-01 1.125514694928173992e-01 -2.656250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 3.647376368049080192e-02 3.647376368049080192e-02 3.647376368049080192e-02 -2.656250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 5.317165571638892557e-02 5.317165571638892557e-02 5.317165571638892557e-02 -2.656250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.200727094210177759e-01 1.200727094210177759e-01 1.200727094210177759e-01 -2.968750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 6.693545715006095354e-02 6.693545715006095354e-02 6.693545715006095354e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.064123247130618760e-01 1.064123247130618760e-01 1.064123247130618760e-01 -2.656250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 8.221112743596749317e-02 8.221112743596749317e-02 8.221112743596749317e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 5.376043034279257005e-02 5.376043034279257005e-02 5.376043034279257005e-02 -2.656250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.149424034489984620e-01 1.149424034489984620e-01 1.149424034489984620e-01 -2.656250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.181310082281395585e-01 1.181310082281395585e-01 1.181310082281395585e-01 -2.968750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.112571540286551308e-01 1.112571540286551308e-01 1.112571540286551308e-01 -2.968750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.238427053846937742e-01 1.238427053846937742e-01 1.238427053846937742e-01 -3.281250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.266453856836191050e-01 1.266453856836191050e-01 1.266453856836191050e-01 -3.281250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.259585813999575532e-01 1.259585813999575532e-01 1.259585813999575532e-01 -3.281250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.231928294853972261e-01 1.231928294853972261e-01 1.231928294853972261e-01 -3.281250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.108883787720408992e-01 1.108883787720408992e-01 1.108883787720408992e-01 -3.593750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 9.637143117466380471e-02 9.637143117466380471e-02 9.637143117466380471e-02 -3.593750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.103717691974249321e-01 1.103717691974249321e-01 1.103717691974249321e-01 -3.593750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.187640545599182723e-01 1.187640545599182723e-01 1.187640545599182723e-01 -3.281250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.103709657584938525e-01 1.103709657584938525e-01 1.103709657584938525e-01 -3.281250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.098848837314253812e-01 1.098848837314253812e-01 1.098848837314253812e-01 -3.281250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 9.699982730742025272e-02 9.699982730742025272e-02 9.699982730742025272e-02 -3.593750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.006744803354589768e-01 1.006744803354589768e-01 1.006744803354589768e-01 -3.593750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.152701872434180180e-01 1.152701872434180180e-01 1.152701872434180180e-01 -3.593750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 1.083527018265506708e-01 1.083527018265506708e-01 1.083527018265506708e-01 -3.281250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 8.812950531052193837e-02 8.812950531052193837e-02 8.812950531052193837e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 9.465014706732746697e-02 9.465014706732746697e-02 9.465014706732746697e-02 -3.281250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.735168834530498083e-02 7.735168834530498083e-02 7.735168834530498083e-02 -3.281250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.035599255701905447e-01 1.035599255701905447e-01 1.035599255701905447e-01 -3.593750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.169789796613756871e-01 1.169789796613756871e-01 1.169789796613756871e-01 -3.281250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.060587934081745620e-01 1.060587934081745620e-01 1.060587934081745620e-01 -3.281250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.239471348913154941e-01 1.239471348913154941e-01 1.239471348913154941e-01 -3.593750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.193055140945168818e-01 1.193055140945168818e-01 1.193055140945168818e-01 -3.593750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 1.090380495156841045e-01 1.090380495156841045e-01 1.090380495156841045e-01 -3.593750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.087343439915843674e-01 1.087343439915843674e-01 1.087343439915843674e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 1.575607682402802856e-01 1.575607682402802856e-01 1.575607682402802856e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 8.260253822200910867e-02 8.260253822200910867e-02 8.260253822200910867e-02 -2.656250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 1.053244075050462497e-01 1.053244075050462497e-01 1.053244075050462497e-01 -2.656250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 7.510022020319771785e-02 7.510022020319771785e-02 7.510022020319771785e-02 -2.968750000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 9.666232615828278252e-02 9.666232615828278252e-02 9.666232615828278252e-02 -2.968750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 8.233490025180899285e-02 8.233490025180899285e-02 8.233490025180899285e-02 -2.968750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 5.986444190682280869e-02 5.986444190682280869e-02 5.986444190682280869e-02 -2.656250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 6.574740474242793398e-02 6.574740474242793398e-02 6.574740474242793398e-02 -2.656250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 6.883185116170184581e-02 6.883185116170184581e-02 6.883185116170184581e-02 -2.656250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 8.822433726210962557e-02 8.822433726210962557e-02 8.822433726210962557e-02 -2.656250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 9.815776691698580025e-02 9.815776691698580025e-02 9.815776691698580025e-02 -2.968750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 6.741166999729493459e-02 6.741166999729493459e-02 6.741166999729493459e-02 -2.968750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 8.926024850453699588e-02 8.926024850453699588e-02 8.926024850453699588e-02 -2.656250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 7.228939351185013906e-02 7.228939351185013906e-02 7.228939351185013906e-02 -2.656250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 4.696421513445183521e-02 4.696421513445183521e-02 4.696421513445183521e-02 -2.656250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 1.187945820490205751e-01 1.187945820490205751e-01 1.187945820490205751e-01 -2.968750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 4.383221181461046528e-02 4.383221181461046528e-02 4.383221181461046528e-02 -2.968750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 6.444043840192226202e-02 6.444043840192226202e-02 6.444043840192226202e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 4.428966510342809831e-02 4.428966510342809831e-02 4.428966510342809831e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 9.502140753867922840e-02 9.502140753867922840e-02 9.502140753867922840e-02 -2.656250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 7.722758635493216783e-02 7.722758635493216783e-02 7.722758635493216783e-02 -2.656250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 1.219324247990739712e-01 1.219324247990739712e-01 1.219324247990739712e-01 -2.656250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 1.373844748606933841e-01 1.373844748606933841e-01 1.373844748606933841e-01 -2.656250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 1.538581983933904607e-01 1.538581983933904607e-01 1.538581983933904607e-01 -2.968750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 9.241531569708698324e-02 9.241531569708698324e-02 9.241531569708698324e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 7.524851955051237162e-02 7.524851955051237162e-02 7.524851955051237162e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 8.360878472622747248e-02 8.360878472622747248e-02 8.360878472622747248e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 4.288272057450803754e-02 4.288272057450803754e-02 4.288272057450803754e-02 -3.593750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 9.342545752143660565e-02 9.342545752143660565e-02 9.342545752143660565e-02 -3.281250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 8.337812070488680172e-02 8.337812070488680172e-02 8.337812070488680172e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 8.757899558704973497e-02 8.757899558704973497e-02 8.757899558704973497e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.346665043087174884e-01 1.346665043087174884e-01 1.346665043087174884e-01 -3.593750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 7.803585339437948964e-02 7.803585339437948964e-02 7.803585339437948964e-02 -3.593750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 1.121955549014275050e-01 1.121955549014275050e-01 1.121955549014275050e-01 -3.281250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 3.557106966683272475e-02 3.557106966683272475e-02 3.557106966683272475e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 5.181632405011301484e-02 5.181632405011301484e-02 5.181632405011301484e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 5.545187716257106436e-02 5.545187716257106436e-02 5.545187716257106436e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 6.055140867004495803e-02 6.055140867004495803e-02 6.055140867004495803e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 4.614445915881478649e-02 4.614445915881478649e-02 4.614445915881478649e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 7.513735534996938970e-02 7.513735534996938970e-02 7.513735534996938970e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 3.263871186598483326e-02 3.263871186598483326e-02 3.263871186598483326e-02 -3.281250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 8.103366872466119530e-02 8.103366872466119530e-02 8.103366872466119530e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 5.730786104895514016e-02 5.730786104895514016e-02 5.730786104895514016e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 7.014863340825237825e-02 7.014863340825237825e-02 7.014863340825237825e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 6.061982364618175023e-02 6.061982364618175023e-02 6.061982364618175023e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 8.150786918602952180e-02 8.150786918602952180e-02 8.150786918602952180e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 4.484336585083619625e-02 4.484336585083619625e-02 4.484336585083619625e-02 -2.656250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.212166603836470208e-01 1.212166603836470208e-01 1.212166603836470208e-01 -2.656250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 9.778571735365690354e-02 9.778571735365690354e-02 9.778571735365690354e-02 -2.656250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.317106874285799423e-01 1.317106874285799423e-01 1.317106874285799423e-01 -2.968750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 5.798319219000284269e-02 5.798319219000284269e-02 5.798319219000284269e-02 -2.968750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.811228174661831669e-01 1.811228174661831669e-01 1.811228174661831669e-01 -2.968750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.229124734902845850e-01 1.229124734902845850e-01 1.229124734902845850e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.513182541779153623e-01 1.513182541779153623e-01 1.513182541779153623e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 1.528231185721226348e-01 1.528231185721226348e-01 1.528231185721226348e-01 -2.968750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 7.627840877754536730e-02 7.627840877754536730e-02 7.627840877754536730e-02 -2.968750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 9.603955246411208235e-02 9.603955246411208235e-02 9.603955246411208235e-02 -2.968750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.188508168670224102e-01 1.188508168670224102e-01 1.188508168670224102e-01 -2.968750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 1.215259420851850514e-01 1.215259420851850514e-01 1.215259420851850514e-01 -2.656250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 1.140233162760689450e-01 1.140233162760689450e-01 1.140233162760689450e-01 -2.656250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 9.488801111630182361e-02 9.488801111630182361e-02 9.488801111630182361e-02 -2.968750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 1.007773328492635456e-01 1.007773328492635456e-01 1.007773328492635456e-01 -2.968750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.417463686530898714e-01 1.417463686530898714e-01 1.417463686530898714e-01 -2.968750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 9.072046691324649192e-02 9.072046691324649192e-02 9.072046691324649192e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 1.322592888229808250e-01 1.322592888229808250e-01 1.322592888229808250e-01 -2.656250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 1.438489242019690140e-01 1.438489242019690140e-01 1.438489242019690140e-01 -2.968750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 1.469906084036948779e-01 1.469906084036948779e-01 1.469906084036948779e-01 -2.968750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 8.230114404818604512e-02 8.230114404818604512e-02 8.230114404818604512e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 1.402806509411138047e-01 1.402806509411138047e-01 1.402806509411138047e-01 -2.968750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 1.290174260291602204e-01 1.290174260291602204e-01 1.290174260291602204e-01 -3.281250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 8.527485050961981783e-02 8.527485050961981783e-02 8.527485050961981783e-02 -3.281250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 7.174512560684696838e-02 7.174512560684696838e-02 7.174512560684696838e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 7.333636136864070398e-02 7.333636136864070398e-02 7.333636136864070398e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 8.944106950305867609e-02 8.944106950305867609e-02 8.944106950305867609e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 7.794679652516493806e-02 7.794679652516493806e-02 7.794679652516493806e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 8.528047633659775750e-02 8.528047633659775750e-02 8.528047633659775750e-02 -3.593750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 6.550945452307034567e-02 6.550945452307034567e-02 6.550945452307034567e-02 -3.281250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 9.493783390234758479e-02 9.493783390234758479e-02 9.493783390234758479e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 8.021691215689313870e-02 8.021691215689313870e-02 8.021691215689313870e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 9.591660431339972537e-02 9.591660431339972537e-02 9.591660431339972537e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 9.535007609340036272e-02 9.535007609340036272e-02 9.535007609340036272e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 1.066437261805334019e-01 1.066437261805334019e-01 1.066437261805334019e-01 -3.593750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.707048740711620063e-02 1.707048740711620063e-02 1.707048740711620063e-02 -3.281250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 7.651568412729152502e-02 7.651568412729152502e-02 7.651568412729152502e-02 -3.281250000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 7.784029788334605182e-02 7.784029788334605182e-02 7.784029788334605182e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 5.926710969032298465e-02 5.926710969032298465e-02 5.926710969032298465e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 7.385634364205538593e-02 7.385634364205538593e-02 7.385634364205538593e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 8.384025179019501117e-02 8.384025179019501117e-02 8.384025179019501117e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 6.584338851685005156e-02 6.584338851685005156e-02 6.584338851685005156e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 9.136015798897477447e-02 9.136015798897477447e-02 9.136015798897477447e-02 -3.281250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 6.064538880447980368e-02 6.064538880447980368e-02 6.064538880447980368e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 9.329607650033677757e-02 9.329607650033677757e-02 9.329607650033677757e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 1.075042445482016218e-01 1.075042445482016218e-01 1.075042445482016218e-01 -3.593750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 8.647716116173571888e-02 8.647716116173571888e-02 8.647716116173571888e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 8.436587244151746989e-02 8.436587244151746989e-02 8.436587244151746989e-02 -3.906250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 1.965025086775173124e-01 1.965025086775173124e-01 1.965025086775173124e-01 -3.906250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 1.775754634530833931e-01 1.775754634530833931e-01 1.775754634530833931e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.543223338181058391e-01 1.543223338181058391e-01 1.543223338181058391e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 1.864519833726392406e-01 1.864519833726392406e-01 1.864519833726392406e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 1.515840567126754412e-01 1.515840567126754412e-01 1.515840567126754412e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 1.667734935978504862e-01 1.667734935978504862e-01 1.667734935978504862e-01 -3.906250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 1.392751129909533536e-01 1.392751129909533536e-01 1.392751129909533536e-01 -3.906250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 9.263631041790097720e-02 9.263631041790097720e-02 9.263631041790097720e-02 -3.906250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.572612606833054261e-01 1.572612606833054261e-01 1.572612606833054261e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 1.096366192160029562e-01 1.096366192160029562e-01 1.096366192160029562e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.070671570037068782e-01 1.070671570037068782e-01 1.070671570037068782e-01 -3.906250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 1.201634870227409335e-01 1.201634870227409335e-01 1.201634870227409335e-01 -3.906250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.166977986364267916e-01 1.166977986364267916e-01 1.166977986364267916e-01 -3.906250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 1.226064103859046822e-01 1.226064103859046822e-01 1.226064103859046822e-01 -3.906250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 1.468813903568534085e-01 1.468813903568534085e-01 1.468813903568534085e-01 -4.218750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 9.621473316474016269e-02 9.621473316474016269e-02 9.621473316474016269e-02 -3.906250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.491195276310627316e-01 1.491195276310627316e-01 1.491195276310627316e-01 -4.218750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 7.618709937791709463e-02 7.618709937791709463e-02 7.618709937791709463e-02 -4.218750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 7.639744842904687416e-02 7.639744842904687416e-02 7.639744842904687416e-02 -4.531250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.265489924536345179e-01 1.265489924536345179e-01 1.265489924536345179e-01 -4.531250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 4.678104723600685910e-02 4.678104723600685910e-02 4.678104723600685910e-02 -4.531250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 9.177161488748282470e-02 9.177161488748282470e-02 9.177161488748282470e-02 -4.531250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.091625845181917742e-01 1.091625845181917742e-01 1.091625845181917742e-01 -4.531250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 9.413745121893687950e-02 9.413745121893687950e-02 9.413745121893687950e-02 -4.843750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 9.841249532338744443e-02 9.841249532338744443e-02 9.841249532338744443e-02 -4.843750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 9.266443697519388678e-02 9.266443697519388678e-02 9.266443697519388678e-02 -4.531250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 6.575142416575809057e-02 6.575142416575809057e-02 6.575142416575809057e-02 -4.531250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 5.487485321780408154e-02 5.487485321780408154e-02 5.487485321780408154e-02 -4.843750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 9.279221178305373241e-02 9.279221178305373241e-02 9.279221178305373241e-02 -3.906250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 8.777830465186338416e-02 8.777830465186338416e-02 8.777830465186338416e-02 -3.906250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 9.247639066245288975e-02 9.247639066245288975e-02 9.247639066245288975e-02 -3.906250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.098656010780655751e-01 1.098656010780655751e-01 1.098656010780655751e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.050873778011871817e-01 1.050873778011871817e-01 1.050873778011871817e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.107598292656684497e-01 1.107598292656684497e-01 1.107598292656684497e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.068156698954994543e-01 1.068156698954994543e-01 1.068156698954994543e-01 -3.906250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 2.388338472035981541e-01 2.388338472035981541e-01 2.388338472035981541e-01 -3.906250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.003627078496235892e-01 1.003627078496235892e-01 1.003627078496235892e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.328167218401216099e-01 1.328167218401216099e-01 1.328167218401216099e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.458679040566709939e-01 1.458679040566709939e-01 1.458679040566709939e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 6.600159267903711602e-02 6.600159267903711602e-02 6.600159267903711602e-02 -3.906250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 9.983719169824975537e-02 9.983719169824975537e-02 9.983719169824975537e-02 -3.906250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 9.283239249831040651e-02 9.283239249831040651e-02 9.283239249831040651e-02 -3.906250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 8.537129320335772042e-02 8.537129320335772042e-02 8.537129320335772042e-02 -3.906250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 8.326319030106572872e-02 8.326319030106572872e-02 8.326319030106572872e-02 -4.218750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.082241482686305684e-01 1.082241482686305684e-01 1.082241482686305684e-01 -4.218750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 9.591660431339972537e-02 9.591660431339972537e-02 9.591660431339972537e-02 -3.906250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.052464690015071092e-01 1.052464690015071092e-01 1.052464690015071092e-01 -3.906250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 9.645178901009938965e-02 9.645178901009938965e-02 9.645178901009938965e-02 -4.218750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 8.590011858572188519e-02 8.590011858572188519e-02 8.590011858572188519e-02 -4.218750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 7.594620603662222136e-02 7.594620603662222136e-02 7.594620603662222136e-02 -4.531250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.061624425198838956e-01 1.061624425198838956e-01 1.061624425198838956e-01 -4.531250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.352359685085264551e-01 1.352359685085264551e-01 1.352359685085264551e-01 -4.531250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 9.778491378902803843e-02 9.778491378902803843e-02 9.778491378902803843e-02 -4.531250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 4.926994007368563216e-02 4.926994007368563216e-02 4.926994007368563216e-02 -4.843750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 4.664604306147147189e-02 4.664604306147147189e-02 4.664604306147147189e-02 -4.531250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.054834982366616158e-01 1.054834982366616158e-01 1.054834982366616158e-01 -4.531250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 9.670812996870659095e-02 9.670812996870659095e-02 9.670812996870659095e-02 -4.843750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.194501169145076452e-01 1.194501169145076452e-01 1.194501169145076452e-01 -4.843750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.065288290073095612e-01 1.065288290073095612e-01 1.065288290073095612e-01 -4.843750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.964673689285671487e-02 7.964673689285671487e-02 7.964673689285671487e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 7.467236098787964627e-02 7.467236098787964627e-02 7.467236098787964627e-02 -4.531250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 6.517069580069420609e-02 6.517069580069420609e-02 6.517069580069420609e-02 -4.531250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 7.529642540591741096e-02 7.529642540591741096e-02 7.529642540591741096e-02 -4.843750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.275659352120269985e-01 1.275659352120269985e-01 1.275659352120269985e-01 -4.843750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 9.178366925709516289e-02 9.178366925709516289e-02 9.178366925709516289e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 6.580496286545536866e-02 6.580496286545536866e-02 6.580496286545536866e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 5.232060625756659172e-02 5.232060625756659172e-02 5.232060625756659172e-02 -3.906250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.166728939839943718e-01 1.166728939839943718e-01 1.166728939839943718e-01 -3.906250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 1.277763909547900700e-01 1.277763909547900700e-01 1.277763909547900700e-01 -4.218750000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 1.164447348737640137e-01 1.164447348737640137e-01 1.164447348737640137e-01 -4.218750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.275305914455133194e-01 1.275305914455133194e-01 1.275305914455133194e-01 -4.218750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 1.119031092280891732e-01 1.119031092280891732e-01 1.119031092280891732e-01 -4.218750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 1.062532358181063341e-01 1.062532358181063341e-01 1.062532358181063341e-01 -3.906250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.452607698570952399e-01 1.452607698570952399e-01 1.452607698570952399e-01 -3.906250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.311452144334214476e-01 1.311452144334214476e-01 1.311452144334214476e-01 -3.906250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.095217263168734995e-01 1.095217263168734995e-01 1.095217263168734995e-01 -3.906250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 8.117753661761516193e-02 8.117753661761516193e-02 8.117753661761516193e-02 -3.906250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 9.210913655348085260e-02 9.210913655348085260e-02 9.210913655348085260e-02 -3.906250000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 6.671969739674793454e-02 6.671969739674793454e-02 6.671969739674793454e-02 -4.218750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 7.770148774388713209e-02 7.770148774388713209e-02 7.770148774388713209e-02 -3.906250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 7.432512057574970632e-02 7.432512057574970632e-02 7.432512057574970632e-02 -4.531250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 6.699896307750498325e-02 6.699896307750498325e-02 6.699896307750498325e-02 -4.531250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 5.178713797737186098e-02 5.178713797737186098e-02 5.178713797737186098e-02 -3.906250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 9.171455751356094588e-02 9.171455751356094588e-02 9.171455751356094588e-02 -3.906250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 8.859241276110335628e-02 8.859241276110335628e-02 8.859241276110335628e-02 -3.906250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 8.885199337774173090e-02 8.885199337774173090e-02 8.885199337774173090e-02 -4.218750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 9.751973702154116685e-02 9.751973702154116685e-02 9.751973702154116685e-02 -4.218750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.131829529063366757e-01 1.131829529063366757e-01 1.131829529063366757e-01 -4.218750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 8.451616395361914724e-02 8.451616395361914724e-02 8.451616395361914724e-02 -4.218750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.188106491438814527e-01 1.188106491438814527e-01 1.188106491438814527e-01 -3.906250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 9.390842458831404060e-02 9.390842458831404060e-02 9.390842458831404060e-02 -3.906250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 1.163804645850650965e-01 1.163804645850650965e-01 1.163804645850650965e-01 -4.218750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.087656787415606369e-01 1.087656787415606369e-01 1.087656787415606369e-01 -4.218750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 1.579373592697798090e-01 1.579373592697798090e-01 1.579373592697798090e-01 -4.218750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.303957959451326198e-01 1.303957959451326198e-01 1.303957959451326198e-01 -4.218750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 1.688288296105107944e-01 1.688288296105107944e-01 1.688288296105107944e-01 -3.906250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 1.111117330508825801e-01 1.111117330508825801e-01 1.111117330508825801e-01 -3.906250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 8.388847401137849991e-02 8.388847401137849991e-02 8.388847401137849991e-02 -3.906250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 1.046213512624864367e-01 1.046213512624864367e-01 1.046213512624864367e-01 -4.218750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 8.131095577445290878e-02 8.131095577445290878e-02 8.131095577445290878e-02 -4.218750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.115712945806575929e-01 1.115712945806575929e-01 1.115712945806575929e-01 -4.218750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 5.279200113240328091e-02 5.279200113240328091e-02 5.279200113240328091e-02 -4.218750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 1.072881114820064125e-01 1.072881114820064125e-01 1.072881114820064125e-01 -4.218750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 1.104400614776505918e-01 1.104400614776505918e-01 1.104400614776505918e-01 -4.218750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 1.339701300558272246e-01 1.339701300558272246e-01 1.339701300558272246e-01 -4.531250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 7.342984428515351991e-02 7.342984428515351991e-02 7.342984428515351991e-02 -4.531250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.075821808645943400e-01 1.075821808645943400e-01 1.075821808645943400e-01 -4.531250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 5.841114016808642700e-02 5.841114016808642700e-02 5.841114016808642700e-02 -4.531250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.140072482251257430e-01 1.140072482251257430e-01 1.140072482251257430e-01 -4.843750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 4.126217496213647334e-02 4.126217496213647334e-02 4.126217496213647334e-02 -4.843750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 7.517834867390177367e-02 7.517834867390177367e-02 7.517834867390177367e-02 -4.531250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.010537483285881138e-01 1.010537483285881138e-01 1.010537483285881138e-01 -4.531250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 9.430138566998143290e-02 9.430138566998143290e-02 9.430138566998143290e-02 -4.531250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.036981286485851583e-01 1.036981286485851583e-01 1.036981286485851583e-01 -4.531250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 1.197658321683228583e-01 1.197658321683228583e-01 1.197658321683228583e-01 -4.843750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 7.130093081745082773e-02 7.130093081745082773e-02 7.130093081745082773e-02 -4.531250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 7.427657110241160654e-02 7.427657110241160654e-02 7.427657110241160654e-02 -4.531250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 1.015495260387405674e-01 1.015495260387405674e-01 1.015495260387405674e-01 -4.531250000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 9.974880179427753069e-02 9.974880179427753069e-02 9.974880179427753069e-02 -4.531250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 9.500855006182276630e-02 9.500855006182276630e-02 9.500855006182276630e-02 -4.531250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 8.273997359045862088e-02 8.273997359045862088e-02 8.273997359045862088e-02 -2.656250000000000000e-01 2.656250000000000000e-01 -3.593750000000000000e-01 9.120827200055652006e-02 9.120827200055652006e-02 9.120827200055652006e-02 -2.656250000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 9.957523588207810306e-02 9.957523588207810306e-02 9.957523588207810306e-02 -2.656250000000000000e-01 2.968750000000000000e-01 -3.593750000000000000e-01 8.640000807650227710e-02 8.640000807650227710e-02 8.640000807650227710e-02 -2.656250000000000000e-01 2.968750000000000000e-01 -3.281250000000000000e-01 1.187913686296633575e-01 1.187913686296633575e-01 1.187913686296633575e-01 -2.968750000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 6.230019296415285901e-02 6.230019296415285901e-02 6.230019296415285901e-02 -2.656250000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 9.437933477708314312e-02 9.437933477708314312e-02 9.437933477708314312e-02 -2.656250000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 9.078797224168666524e-02 9.078797224168666524e-02 9.078797224168666524e-02 -2.656250000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 5.651546528232443550e-02 5.651546528232443550e-02 5.651546528232443550e-02 -2.968750000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 7.846610599578840439e-02 7.846610599578840439e-02 7.846610599578840439e-02 -2.968750000000000000e-01 2.656250000000000000e-01 -2.656250000000000000e-01 6.890652915145371871e-02 6.890652915145371871e-02 6.890652915145371871e-02 -2.968750000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 3.071637241866453927e-02 3.071637241866453927e-02 3.071637241866453927e-02 -2.968750000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 5.794178812245213278e-02 5.794178812245213278e-02 5.794178812245213278e-02 -2.656250000000000000e-01 3.281250000000000000e-01 -3.281250000000000000e-01 9.238799267124420123e-02 9.238799267124420123e-02 9.238799267124420123e-02 -3.281250000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 4.960458471482809273e-02 4.960458471482809273e-02 4.960458471482809273e-02 -3.281250000000000000e-01 2.656250000000000000e-01 -2.656250000000000000e-01 1.120758451251896992e-01 1.120758451251896992e-01 1.120758451251896992e-01 -2.656250000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 1.408364221150819606e-01 1.408364221150819606e-01 1.408364221150819606e-01 -2.656250000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 6.337205120302487338e-02 6.337205120302487338e-02 6.337205120302487338e-02 -2.656250000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 7.443194538991065867e-02 7.443194538991065867e-02 7.443194538991065867e-02 -2.968750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 8.703330412899144830e-02 8.703330412899144830e-02 8.703330412899144830e-02 -2.968750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 9.027846633938313436e-02 9.027846633938313436e-02 9.027846633938313436e-02 -2.968750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 7.085166942353565700e-02 7.085166942353565700e-02 7.085166942353565700e-02 -2.968750000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 7.316080932134229331e-02 7.316080932134229331e-02 7.316080932134229331e-02 -2.656250000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 1.727996543022476961e-01 1.727996543022476961e-01 1.727996543022476961e-01 -2.656250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 1.489010971691436536e-01 1.489010971691436536e-01 1.489010971691436536e-01 -2.656250000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 1.255545288891825317e-01 1.255545288891825317e-01 1.255545288891825317e-01 -2.656250000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 1.411689192189375386e-01 1.411689192189375386e-01 1.411689192189375386e-01 -2.656250000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 1.315797615062837544e-01 1.315797615062837544e-01 1.315797615062837544e-01 -2.656250000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 1.398349068350207280e-01 1.398349068350207280e-01 1.398349068350207280e-01 -2.656250000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 8.316915621218366750e-02 8.316915621218366750e-02 8.316915621218366750e-02 -2.656250000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 1.092035605091300904e-01 1.092035605091300904e-01 1.092035605091300904e-01 -3.281250000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 6.334745160155316746e-02 6.334745160155316746e-02 6.334745160155316746e-02 -2.656250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 1.018653115450473823e-01 1.018653115450473823e-01 1.018653115450473823e-01 -2.656250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 1.159908248607110226e-01 1.159908248607110226e-01 1.159908248607110226e-01 -2.656250000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 7.138436824508419265e-02 7.138436824508419265e-02 7.138436824508419265e-02 -2.656250000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 8.990879126738215987e-02 8.990879126738215987e-02 8.990879126738215987e-02 -2.968750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 7.031092868435924459e-02 7.031092868435924459e-02 7.031092868435924459e-02 -2.656250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 1.418861123995395490e-01 1.418861123995395490e-01 1.418861123995395490e-01 -2.656250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 1.214881856814335054e-01 1.214881856814335054e-01 1.214881856814335054e-01 -2.656250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 1.152999126685312625e-01 1.152999126685312625e-01 1.152999126685312625e-01 -2.968750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 1.219814275171782203e-01 1.219814275171782203e-01 1.219814275171782203e-01 -3.281250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 6.810395819082218360e-02 6.810395819082218360e-02 6.810395819082218360e-02 -3.593750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 6.491811302487522639e-02 6.491811302487522639e-02 6.491811302487522639e-02 -3.593750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 1.007829575923218091e-01 1.007829575923218091e-01 1.007829575923218091e-01 -3.906250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 8.115101350583704687e-02 8.115101350583704687e-02 8.115101350583704687e-02 -4.218750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 7.633997826141931953e-02 7.633997826141931953e-02 7.633997826141931953e-02 -3.906250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 1.049772993622863360e-01 1.049772993622863360e-01 1.049772993622863360e-01 -3.906250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 1.073692618834786311e-01 1.073692618834786311e-01 1.073692618834786311e-01 -3.906250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 5.841765222757341197e-02 5.841765222757341197e-02 5.841765222757341197e-02 -3.906250000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 7.524538477037975848e-02 7.524538477037975848e-02 7.524538477037975848e-02 -4.218750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 1.090484943942586632e-01 1.090484943942586632e-01 1.090484943942586632e-01 -4.218750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 7.129538439578859965e-02 7.129538439578859965e-02 7.129538439578859965e-02 -4.218750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 6.820862084336933029e-02 6.820862084336933029e-02 6.820862084336933029e-02 -4.531250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 5.386881007210931466e-02 5.386881007210931466e-02 5.386881007210931466e-02 -4.531250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 1.041617500322029044e-01 1.041617500322029044e-01 1.041617500322029044e-01 -4.531250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 9.679571963882409313e-02 9.679571963882409313e-02 9.679571963882409313e-02 -4.531250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 5.387202608558376571e-02 5.387202608558376571e-02 5.387202608558376571e-02 -4.531250000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 6.218603636640014642e-02 6.218603636640014642e-02 6.218603636640014642e-02 -1.093750000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 1.092091846631216834e-01 1.092091846631216834e-01 1.092091846631216834e-01 -1.093750000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 7.929027483216109784e-02 7.929027483216109784e-02 7.929027483216109784e-02 -1.406250000000000000e-01 5.156250000000000000e-01 -4.687500000000000000e-02 7.075151168365031995e-02 7.075151168365031995e-02 7.075151168365031995e-02 -1.406250000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 1.291499626241626453e-01 1.291499626241626453e-01 1.291499626241626453e-01 -1.406250000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 1.013309663874588512e-01 1.013309663874588512e-01 1.013309663874588512e-01 -1.718750000000000000e-01 5.156250000000000000e-01 -4.687500000000000000e-02 6.540856663314670305e-02 6.540856663314670305e-02 6.540856663314670305e-02 -1.718750000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 1.129290746742780960e-01 1.129290746742780960e-01 1.129290746742780960e-01 -1.718750000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 1.928907347801659886e-02 1.928907347801659886e-02 1.928907347801659886e-02 -1.406250000000000000e-01 5.781250000000000000e-01 -1.562500000000000000e-02 3.535490410951176721e-02 3.535490410951176721e-02 3.535490410951176721e-02 -1.406250000000000000e-01 6.093750000000000000e-01 -1.562500000000000000e-02 2.536457487381348769e-02 2.536457487381348769e-02 2.536457487381348769e-02 -1.718750000000000000e-01 5.781250000000000000e-01 -1.562500000000000000e-02 4.393425250818062955e-02 4.393425250818062955e-02 4.393425250818062955e-02 -1.718750000000000000e-01 6.093750000000000000e-01 -1.562500000000000000e-02 3.405419924231621598e-02 3.405419924231621598e-02 3.405419924231621598e-02 -2.031250000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 6.948731093625107325e-02 6.948731093625107325e-02 6.948731093625107325e-02 -2.031250000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 5.252522879644858783e-02 5.252522879644858783e-02 5.252522879644858783e-02 -2.343750000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 6.844310649159135451e-02 6.844310649159135451e-02 6.844310649159135451e-02 -2.343750000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 6.478330006025226351e-02 6.478330006025226351e-02 6.478330006025226351e-02 -2.031250000000000000e-01 5.781250000000000000e-01 -1.562500000000000000e-02 5.431551311277061506e-02 5.431551311277061506e-02 5.431551311277061506e-02 -2.031250000000000000e-01 6.093750000000000000e-01 -1.562500000000000000e-02 3.765388512194933757e-02 3.765388512194933757e-02 3.765388512194933757e-02 -2.343750000000000000e-01 5.781250000000000000e-01 -1.562500000000000000e-02 4.928063392924675323e-02 4.928063392924675323e-02 4.928063392924675323e-02 -2.343750000000000000e-01 6.093750000000000000e-01 -1.562500000000000000e-02 2.802857486159909470e-02 2.802857486159909470e-02 2.802857486159909470e-02 -2.656250000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 6.959020332738881376e-02 6.959020332738881376e-02 6.959020332738881376e-02 -5.156250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.053485121815697784e-01 1.053485121815697784e-01 1.053485121815697784e-01 -5.156250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 9.502622909197956658e-02 9.502622909197956658e-02 9.502622909197956658e-02 -5.468750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 6.006631185918163973e-02 6.006631185918163973e-02 6.006631185918163973e-02 -5.468750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 5.436552183011542083e-02 5.436552183011542083e-02 5.436552183011542083e-02 -5.156250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 8.784018680139805968e-02 8.784018680139805968e-02 8.784018680139805968e-02 -5.468750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 5.957775515423153340e-02 5.957775515423153340e-02 5.957775515423153340e-02 -5.468750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 5.875016853962568286e-02 5.875016853962568286e-02 5.875016853962568286e-02 -5.468750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 7.345106481169923207e-02 7.345106481169923207e-02 7.345106481169923207e-02 -5.468750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 6.787630439346205302e-02 6.787630439346205302e-02 6.787630439346205302e-02 -5.156250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 8.175782796531680385e-02 8.175782796531680385e-02 8.175782796531680385e-02 -5.156250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 8.486496777147523041e-02 8.486496777147523041e-02 8.486496777147523041e-02 -5.156250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.340400087131231321e-01 1.340400087131231321e-01 1.340400087131231321e-01 -5.156250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 1.081036291215148049e-01 1.081036291215148049e-01 1.081036291215148049e-01 -5.468750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 7.109362299982607825e-02 7.109362299982607825e-02 7.109362299982607825e-02 -5.468750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.004727926024436419e-01 1.004727926024436419e-01 1.004727926024436419e-01 -5.468750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 7.113558298122352186e-02 7.113558298122352186e-02 7.113558298122352186e-02 -5.156250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.026929368890827921e-01 1.026929368890827921e-01 1.026929368890827921e-01 -5.156250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.045305561226474445e-01 1.045305561226474445e-01 1.045305561226474445e-01 -5.468750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 3.630866592414706828e-02 3.630866592414706828e-02 3.630866592414706828e-02 -5.468750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 5.849547531739980599e-02 5.849547531739980599e-02 5.849547531739980599e-02 -5.156250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.480578857785376512e-01 1.480578857785376512e-01 1.480578857785376512e-01 -5.156250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 1.210238607992700083e-01 1.210238607992700083e-01 1.210238607992700083e-01 -5.781250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 9.408923514036145186e-02 9.408923514036145186e-02 9.408923514036145186e-02 -1.562500000000000000e-02 1.562500000000000000e-02 1.562500000000000000e-02 4.093712585464929221e-01 4.093712585464929221e-01 4.093712585464929221e-01 -1.562500000000000000e-02 1.562500000000000000e-02 4.687500000000000000e-02 3.777717541866543738e-01 3.777717541866543738e-01 3.777717541866543738e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.562500000000000000e-02 3.456102857440805920e-01 3.456102857440805920e-01 3.456102857440805920e-01 -1.562500000000000000e-02 4.687500000000000000e-02 4.687500000000000000e-02 4.755003742912752851e-01 4.755003742912752851e-01 4.755003742912752851e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.562500000000000000e-02 1.947183551875846519e-01 1.947183551875846519e-01 1.947183551875846519e-01 -4.687500000000000000e-02 1.562500000000000000e-02 4.687500000000000000e-02 1.086025772171361342e-01 1.086025772171361342e-01 1.086025772171361342e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.562500000000000000e-02 2.861007033859099824e-01 2.861007033859099824e-01 2.861007033859099824e-01 -4.687500000000000000e-02 4.687500000000000000e-02 4.687500000000000000e-02 1.067843343860376548e-01 1.067843343860376548e-01 1.067843343860376548e-01 -1.562500000000000000e-02 1.562500000000000000e-02 7.812500000000000000e-02 8.702767842458014602e-02 8.702767842458014602e-02 8.702767842458014602e-02 -1.562500000000000000e-02 1.562500000000000000e-02 1.093750000000000000e-01 1.198148362060462713e-01 1.198148362060462713e-01 1.198148362060462713e-01 -1.562500000000000000e-02 4.687500000000000000e-02 7.812500000000000000e-02 1.856974610745987797e-01 1.856974610745987797e-01 1.856974610745987797e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.093750000000000000e-01 1.309219157640264530e-01 1.309219157640264530e-01 1.309219157640264530e-01 -1.562500000000000000e-02 7.812500000000000000e-02 4.687500000000000000e-02 8.910416962877190095e-01 8.910416962877190095e-01 8.910416962877190095e-01 -4.687500000000000000e-02 7.812500000000000000e-02 4.687500000000000000e-02 5.169937413567602391e-01 5.169937413567602391e-01 5.169937413567602391e-01 -4.687500000000000000e-02 1.093750000000000000e-01 4.687500000000000000e-02 9.759357989437822400e-01 9.759357989437822400e-01 9.759357989437822400e-01 -1.562500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 5.092984593516746150e-01 5.092984593516746150e-01 5.092984593516746150e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 2.789421309234931812e-01 2.789421309234931812e-01 2.789421309234931812e-01 -1.562500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 8.964441864162341345e-01 8.964441864162341345e-01 8.964441864162341345e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 2.362412336969660909e-01 2.362412336969660909e-01 2.362412336969660909e-01 -4.687500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 1.918120987287507129e-01 1.918120987287507129e-01 1.918120987287507129e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 1.976036398945525130e-01 1.976036398945525130e-01 1.976036398945525130e-01 -4.687500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 1.562500000000000000e-02 2.316173183267284663e-01 2.316173183267284663e-01 2.316173183267284663e-01 -7.812500000000000000e-02 1.562500000000000000e-02 4.687500000000000000e-02 1.923691192837844732e-01 1.923691192837844732e-01 1.923691192837844732e-01 -7.812500000000000000e-02 4.687500000000000000e-02 1.562500000000000000e-02 3.178692537093874559e-01 3.178692537093874559e-01 3.178692537093874559e-01 -7.812500000000000000e-02 4.687500000000000000e-02 4.687500000000000000e-02 1.408259813625260259e-01 1.408259813625260259e-01 1.408259813625260259e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 2.198782464772820189e-01 2.198782464772820189e-01 2.198782464772820189e-01 -1.093750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.582850419601971870e-01 1.582850419601971870e-01 1.582850419601971870e-01 -1.093750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 6.582431369661486675e-01 6.582431369661486675e-01 6.582431369661486675e-01 -1.093750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 1.611716335276463519e-01 1.611716335276463519e-01 1.611716335276463519e-01 -7.812500000000000000e-02 1.562500000000000000e-02 7.812500000000000000e-02 1.824007577782187084e-01 1.824007577782187084e-01 1.824007577782187084e-01 -7.812500000000000000e-02 4.687500000000000000e-02 7.812500000000000000e-02 2.186362051082494373e-01 2.186362051082494373e-01 2.186362051082494373e-01 -7.812500000000000000e-02 4.687500000000000000e-02 1.093750000000000000e-01 1.850826004373893330e-01 1.850826004373893330e-01 1.850826004373893330e-01 -1.093750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 1.959711994493687215e-01 1.959711994493687215e-01 1.959711994493687215e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.685141096880509448e-01 1.685141096880509448e-01 1.685141096880509448e-01 -1.093750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 2.580736909251399869e-01 2.580736909251399869e-01 2.580736909251399869e-01 -1.093750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.725877106648759929e-01 1.725877106648759929e-01 1.725877106648759929e-01 -7.812500000000000000e-02 7.812500000000000000e-02 1.562500000000000000e-02 7.096114674908650111e-01 7.096114674908650111e-01 7.096114674908650111e-01 -7.812500000000000000e-02 7.812500000000000000e-02 4.687500000000000000e-02 5.367537978197731707e-01 5.367537978197731707e-01 5.367537978197731707e-01 -7.812500000000000000e-02 1.093750000000000000e-01 4.687500000000000000e-02 5.942047914677330844e-01 5.942047914677330844e-01 5.942047914677330844e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 7.998655230714289965e-01 7.998655230714289965e-01 7.998655230714289965e-01 -1.093750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 5.923208207393334535e-01 5.923208207393334535e-01 5.923208207393334535e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 6.928315995787062143e-01 6.928315995787062143e-01 6.928315995787062143e-01 -1.093750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 2.968457845220473512e-01 2.968457845220473512e-01 2.968457845220473512e-01 -7.812500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 2.140971350395405592e-01 2.140971350395405592e-01 2.140971350395405592e-01 -7.812500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 2.190068938807893106e-01 2.190068938807893106e-01 2.190068938807893106e-01 -7.812500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 1.031011217878906733e-01 1.031011217878906733e-01 1.031011217878906733e-01 -7.812500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 1.515141932916450884e-01 1.515141932916450884e-01 1.515141932916450884e-01 -1.093750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 1.631066758706596898e-01 1.631066758706596898e-01 1.631066758706596898e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.828727557251152436e-01 1.828727557251152436e-01 1.828727557251152436e-01 -1.093750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.408372252498515387e-01 1.408372252498515387e-01 1.408372252498515387e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.373539544245331034e-01 1.373539544245331034e-01 1.373539544245331034e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.406250000000000000e-01 1.773009162956261098e-01 1.773009162956261098e-01 1.773009162956261098e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 1.692752159605236950e-01 1.692752159605236950e-01 1.692752159605236950e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 1.352006281113215247e-01 1.352006281113215247e-01 1.352006281113215247e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 1.762548990965896734e-01 1.762548990965896734e-01 1.762548990965896734e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.406250000000000000e-01 9.239281438236550403e-02 9.239281438236550403e-02 9.239281438236550403e-02 -4.687500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 1.140514353575200202e-01 1.140514353575200202e-01 1.140514353575200202e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 8.762400090290529964e-02 8.762400090290529964e-02 8.762400090290529964e-02 -1.562500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 1.505987359618384258e-01 1.505987359618384258e-01 1.505987359618384258e-01 -1.562500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 2.124144767428147729e-01 2.124144767428147729e-01 2.124144767428147729e-01 -1.562500000000000000e-02 4.687500000000000000e-02 2.343750000000000000e-01 1.599760592092990263e-01 1.599760592092990263e-01 1.599760592092990263e-01 -4.687500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 1.024189375965554871e-01 1.024189375965554871e-01 1.024189375965554871e-01 -4.687500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 2.078622161784802191e-01 2.078622161784802191e-01 2.078622161784802191e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 1.825203629620777424e-01 1.825203629620777424e-01 1.825203629620777424e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.718750000000000000e-01 2.088877611308834481e-01 2.088877611308834481e-01 2.088877611308834481e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 1.809959855993045763e-01 1.809959855993045763e-01 1.809959855993045763e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 1.017150524383373111e-01 1.017150524383373111e-01 1.017150524383373111e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.718750000000000000e-01 2.279221664647249901e-01 2.279221664647249901e-01 2.279221664647249901e-01 -4.687500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 2.057741726717310093e-01 2.057741726717310093e-01 2.057741726717310093e-01 -4.687500000000000000e-02 1.093750000000000000e-01 1.718750000000000000e-01 2.376113505016098637e-01 2.376113505016098637e-01 2.376113505016098637e-01 -1.562500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 2.442201517954718792e-01 2.442201517954718792e-01 2.442201517954718792e-01 -1.562500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 2.082963490880815061e-01 2.082963490880815061e-01 2.082963490880815061e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 2.770483578889592624e-01 2.770483578889592624e-01 2.770483578889592624e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 1.321074800266977822e-01 1.321074800266977822e-01 1.321074800266977822e-01 -4.687500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 1.830734342853608809e-01 1.830734342853608809e-01 1.830734342853608809e-01 -4.687500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 1.853828071319008342e-01 1.853828071319008342e-01 1.853828071319008342e-01 -4.687500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 2.885385934746442782e-01 2.885385934746442782e-01 2.885385934746442782e-01 -4.687500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 1.305194946546605339e-01 1.305194946546605339e-01 1.305194946546605339e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.406250000000000000e-01 8.219344558959142122e-02 8.219344558959142122e-02 8.219344558959142122e-02 -7.812500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 1.124679140642480119e-01 1.124679140642480119e-01 1.124679140642480119e-01 -7.812500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 9.675795162762225454e-02 9.675795162762225454e-02 9.675795162762225454e-02 -7.812500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 7.935244735692911222e-01 7.935244735692911222e-01 7.935244735692911222e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 2.867035689742162274e-01 2.867035689742162274e-01 2.867035689742162274e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.256179885629782611e-01 1.256179885629782611e-01 1.256179885629782611e-01 -1.093750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 3.516086480325836261e-01 3.516086480325836261e-01 3.516086480325836261e-01 -1.093750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 2.331038350243737900e-01 2.331038350243737900e-01 2.331038350243737900e-01 -7.812500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 2.362067398229243942e-01 2.362067398229243942e-01 2.362067398229243942e-01 -7.812500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 1.269201057554511236e-01 1.269201057554511236e-01 1.269201057554511236e-01 -7.812500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 1.513712541491999963e-01 1.513712541491999963e-01 1.513712541491999963e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 2.639599008294399862e-01 2.639599008294399862e-01 2.639599008294399862e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.497523301804771223e-01 1.497523301804771223e-01 1.497523301804771223e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.904789258030617216e-01 1.904789258030617216e-01 1.904789258030617216e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.689251721978006215e-01 1.689251721978006215e-01 1.689251721978006215e-01 -7.812500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 2.455291738857796890e-01 2.455291738857796890e-01 2.455291738857796890e-01 -7.812500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 1.944045391236200737e-01 1.944045391236200737e-01 1.944045391236200737e-01 -7.812500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 9.407396670945644690e-02 9.407396670945644690e-02 9.407396670945644690e-02 -7.812500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 9.608857095547744531e-02 9.608857095547744531e-02 9.608857095547744531e-02 -1.093750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 2.155711372581297913e-01 2.155711372581297913e-01 2.155711372581297913e-01 -1.093750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.751430393504734839e-01 1.751430393504734839e-01 1.751430393504734839e-01 -1.093750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.382406486941222534e-01 1.382406486941222534e-01 1.382406486941222534e-01 -1.093750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 1.225991805347251967e-01 1.225991805347251967e-01 1.225991805347251967e-01 -4.687500000000000000e-02 1.406250000000000000e-01 4.687500000000000000e-02 7.216684159580342151e-01 7.216684159580342151e-01 7.216684159580342151e-01 -1.562500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 4.948220438442799129e-01 4.948220438442799129e-01 4.948220438442799129e-01 -1.562500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 2.521533653271095798e-01 2.521533653271095798e-01 2.521533653271095798e-01 -1.562500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 2.094478732769915752e-01 2.094478732769915752e-01 2.094478732769915752e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 2.698761503334214384e-01 2.698761503334214384e-01 2.698761503334214384e-01 -4.687500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 4.856668011409584484e-01 4.856668011409584484e-01 4.856668011409584484e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 1.297491859589177676e-01 1.297491859589177676e-01 1.297491859589177676e-01 -4.687500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 4.323563448008141963e-01 4.323563448008141963e-01 4.323563448008141963e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 3.020382451033044036e-01 3.020382451033044036e-01 3.020382451033044036e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.562500000000000000e-02 3.942363651935701374e-01 3.942363651935701374e-01 3.942363651935701374e-01 -1.562500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 1.759594750456723866e-01 1.759594750456723866e-01 1.759594750456723866e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 1.194830541871609308e-01 1.194830541871609308e-01 1.194830541871609308e-01 -1.562500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 1.023884038932727641e-01 1.023884038932727641e-01 1.023884038932727641e-01 -4.687500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 7.672225457676085103e-02 7.672225457676085103e-02 7.672225457676085103e-02 -4.687500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 6.588623550815618513e-02 6.588623550815618513e-02 6.588623550815618513e-02 -1.562500000000000000e-02 2.031250000000000000e-01 7.812500000000000000e-02 1.657466087872102589e-01 1.657466087872102589e-01 1.657466087872102589e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 2.499958910152048353e-01 2.499958910152048353e-01 2.499958910152048353e-01 -1.562500000000000000e-02 2.343750000000000000e-01 7.812500000000000000e-02 1.113945404567930481e-01 1.113945404567930481e-01 1.113945404567930481e-01 -4.687500000000000000e-02 2.031250000000000000e-01 7.812500000000000000e-02 2.026933669362531165e-01 2.026933669362531165e-01 2.026933669362531165e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 2.140682484987148082e-01 2.140682484987148082e-01 2.140682484987148082e-01 -4.687500000000000000e-02 2.343750000000000000e-01 7.812500000000000000e-02 5.031833318296246443e-02 5.031833318296246443e-02 5.031833318296246443e-02 -4.687500000000000000e-02 2.343750000000000000e-01 1.093750000000000000e-01 5.094475742545474806e-02 5.094475742545474806e-02 5.094475742545474806e-02 -7.812500000000000000e-02 1.406250000000000000e-01 4.687500000000000000e-02 2.030922171502655138e-01 2.030922171502655138e-01 2.030922171502655138e-01 -7.812500000000000000e-02 1.718750000000000000e-01 4.687500000000000000e-02 2.237173810247583827e-01 2.237173810247583827e-01 2.237173810247583827e-01 -1.093750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 4.677395317275488407e-01 4.677395317275488407e-01 4.677395317275488407e-01 -1.093750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 1.292736632491787718e-01 1.292736632491787718e-01 1.292736632491787718e-01 -1.093750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 2.736271062124557285e-01 2.736271062124557285e-01 2.736271062124557285e-01 -1.093750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 2.140297330948195687e-01 2.140297330948195687e-01 2.140297330948195687e-01 -7.812500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 1.628360939104425698e-01 1.628360939104425698e-01 1.628360939104425698e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 1.554778427341232117e-01 1.554778427341232117e-01 1.554778427341232117e-01 -7.812500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 1.714934624726945356e-01 1.714934624726945356e-01 1.714934624726945356e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 1.071812499373588634e-01 1.071812499373588634e-01 1.071812499373588634e-01 -1.093750000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 1.801193953314260132e-01 1.801193953314260132e-01 1.801193953314260132e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.562500000000000000e-02 2.153135699553338223e-01 2.153135699553338223e-01 2.153135699553338223e-01 -7.812500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 1.353058460664026408e-01 1.353058460664026408e-01 1.353058460664026408e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 8.210664374193525628e-02 8.210664374193525628e-02 8.210664374193525628e-02 -7.812500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 1.007668868968212283e-01 1.007668868968212283e-01 1.007668868968212283e-01 -1.093750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 1.466557261286446368e-01 1.466557261286446368e-01 1.466557261286446368e-01 -1.093750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 1.736016632397873738e-01 1.736016632397873738e-01 1.736016632397873738e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 8.501686573562214355e-02 8.501686573562214355e-02 8.501686573562214355e-02 -1.093750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 6.240775727213680041e-02 6.240775727213680041e-02 6.240775727213680041e-02 -7.812500000000000000e-02 2.031250000000000000e-01 7.812500000000000000e-02 9.879498819811173560e-02 9.879498819811173560e-02 9.879498819811173560e-02 -7.812500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 7.131644471950294994e-02 7.131644471950294994e-02 7.131644471950294994e-02 -7.812500000000000000e-02 2.343750000000000000e-01 1.093750000000000000e-01 1.482899705570236148e-01 1.482899705570236148e-01 1.482899705570236148e-01 -1.093750000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 1.569930679836549769e-01 1.569930679836549769e-01 1.569930679836549769e-01 -1.093750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 6.055197142567849550e-02 6.055197142567849550e-02 6.055197142567849550e-02 -1.093750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 8.821871164097988549e-02 8.821871164097988549e-02 8.821871164097988549e-02 -1.093750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 4.391905496626865441e-02 4.391905496626865441e-02 4.391905496626865441e-02 -1.562500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 2.039894222762379250e-01 2.039894222762379250e-01 2.039894222762379250e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 2.001958936808296008e-01 2.001958936808296008e-01 2.001958936808296008e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 2.367113115298126180e-01 2.367113115298126180e-01 2.367113115298126180e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.718750000000000000e-01 2.495772220109341022e-01 2.495772220109341022e-01 2.495772220109341022e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 2.467178629940639245e-01 2.467178629940639245e-01 2.467178629940639245e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.718750000000000000e-01 1.531362938563690101e-01 1.531362938563690101e-01 1.531362938563690101e-01 -1.562500000000000000e-02 1.406250000000000000e-01 2.031250000000000000e-01 3.227262074680907200e-01 3.227262074680907200e-01 3.227262074680907200e-01 -1.562500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 3.437565347170195573e-01 3.437565347170195573e-01 3.437565347170195573e-01 -1.562500000000000000e-02 1.718750000000000000e-01 2.031250000000000000e-01 2.009623180439075729e-01 2.009623180439075729e-01 2.009623180439075729e-01 -1.562500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 2.532705774290804346e-01 2.532705774290804346e-01 2.532705774290804346e-01 -4.687500000000000000e-02 1.406250000000000000e-01 2.031250000000000000e-01 2.724901312163032219e-01 2.724901312163032219e-01 2.724901312163032219e-01 -4.687500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 4.769181694806335498e-02 4.769181694806335498e-02 4.769181694806335498e-02 -4.687500000000000000e-02 1.718750000000000000e-01 2.031250000000000000e-01 1.602699360747305846e-01 1.602699360747305846e-01 1.602699360747305846e-01 -4.687500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 5.048444744137121909e-02 5.048444744137121909e-02 5.048444744137121909e-02 -4.687500000000000000e-02 2.031250000000000000e-01 1.406250000000000000e-01 2.709017069447886006e-01 2.709017069447886006e-01 2.709017069447886006e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.718750000000000000e-01 1.726166121028498979e-01 1.726166121028498979e-01 1.726166121028498979e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 1.410323867580251800e-01 1.410323867580251800e-01 1.410323867580251800e-01 -1.562500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 1.280551234766210411e-01 1.280551234766210411e-01 1.280551234766210411e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 1.109630980782376486e-01 1.109630980782376486e-01 1.109630980782376486e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.343750000000000000e-01 1.210648307496080128e-01 1.210648307496080128e-01 1.210648307496080128e-01 -4.687500000000000000e-02 2.031250000000000000e-01 2.031250000000000000e-01 1.641360030833336203e-01 1.641360030833336203e-01 1.641360030833336203e-01 -4.687500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 5.982729970987941265e-02 5.982729970987941265e-02 5.982729970987941265e-02 -4.687500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 1.772182308570381948e-01 1.772182308570381948e-01 1.772182308570381948e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.343750000000000000e-01 1.127049220250067735e-01 1.127049220250067735e-01 1.127049220250067735e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 1.190388015447508829e-01 1.190388015447508829e-01 1.190388015447508829e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.718750000000000000e-01 1.539690129768598315e-01 1.539690129768598315e-01 1.539690129768598315e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 1.342753467333136219e-01 1.342753467333136219e-01 1.342753467333136219e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 2.031250000000000000e-01 7.658689874681824661e-02 7.658689874681824661e-02 7.658689874681824661e-02 -7.812500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 1.078441106117759146e-01 1.078441106117759146e-01 1.078441106117759146e-01 -7.812500000000000000e-02 1.718750000000000000e-01 2.031250000000000000e-01 2.147671393957344688e-01 2.147671393957344688e-01 2.147671393957344688e-01 -7.812500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 4.831022105216396106e-02 4.831022105216396106e-02 4.831022105216396106e-02 -7.812500000000000000e-02 2.031250000000000000e-01 1.406250000000000000e-01 1.122927687497272259e-01 1.122927687497272259e-01 1.122927687497272259e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.718750000000000000e-01 1.500221531041970868e-01 1.500221531041970868e-01 1.500221531041970868e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.406250000000000000e-01 1.104826436936380968e-01 1.104826436936380968e-01 1.104826436936380968e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 1.316954261357106970e-01 1.316954261357106970e-01 1.316954261357106970e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 1.034345783868002855e-01 1.034345783868002855e-01 1.034345783868002855e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 8.675844782507551034e-02 8.675844782507551034e-02 8.675844782507551034e-02 -7.812500000000000000e-02 2.031250000000000000e-01 2.031250000000000000e-01 1.856420756484134515e-01 1.856420756484134515e-01 1.856420756484134515e-01 -7.812500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 2.129657377719029743e-01 2.129657377719029743e-01 2.129657377719029743e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.329685292981274969e-01 1.329685292981274969e-01 1.329685292981274969e-01 -1.406250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 8.032445251356194749e-02 8.032445251356194749e-02 8.032445251356194749e-02 -1.406250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 8.011949879495157412e-02 8.011949879495157412e-02 8.011949879495157412e-02 -1.406250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 1.616557999400834722e-01 1.616557999400834722e-01 1.616557999400834722e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.815578974142475210e-01 1.815578974142475210e-01 1.815578974142475210e-01 -1.406250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 1.539617859434673774e-01 1.539617859434673774e-01 1.539617859434673774e-01 -1.406250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.334657167981802561e-01 1.334657167981802561e-01 1.334657167981802561e-01 -1.718750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 8.952947073220043905e-02 8.952947073220043905e-02 8.952947073220043905e-02 -1.718750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.014153369114400433e-01 1.014153369114400433e-01 1.014153369114400433e-01 -1.718750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 4.872487317678307617e-02 4.872487317678307617e-02 4.872487317678307617e-02 -1.406250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 2.757703165165907300e-01 2.757703165165907300e-01 2.757703165165907300e-01 -1.406250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 1.783300619250181573e-01 1.783300619250181573e-01 1.783300619250181573e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 6.504751631771032994e-01 6.504751631771032994e-01 6.504751631771032994e-01 -1.406250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 1.429727322153163116e-01 1.429727322153163116e-01 1.429727322153163116e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 1.188090424345486784e-01 1.188090424345486784e-01 1.188090424345486784e-01 -1.718750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 1.932736675019986750e-01 1.932736675019986750e-01 1.932736675019986750e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 3.635199351102516019e-01 3.635199351102516019e-01 3.635199351102516019e-01 -1.406250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 1.742655825079000298e-01 1.742655825079000298e-01 1.742655825079000298e-01 -1.406250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.228409785386209568e-01 1.228409785386209568e-01 1.228409785386209568e-01 -1.406250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.689051008349602701e-01 1.689051008349602701e-01 1.689051008349602701e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.360214851482696441e-01 1.360214851482696441e-01 1.360214851482696441e-01 -1.718750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 1.067843343860376548e-01 1.067843343860376548e-01 1.067843343860376548e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 6.214061485817306413e-02 6.214061485817306413e-02 6.214061485817306413e-02 -1.718750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.596661223357067616e-01 1.596661223357067616e-01 1.596661223357067616e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.724969921949131846e-01 1.724969921949131846e-01 1.724969921949131846e-01 -2.031250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 8.724868794484257062e-02 8.724868794484257062e-02 8.724868794484257062e-02 -2.343750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.217251670711309991e-01 1.217251670711309991e-01 1.217251670711309991e-01 -2.343750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.447186818787180584e-01 1.447186818787180584e-01 1.447186818787180584e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.105035330743667360e-01 1.105035330743667360e-01 1.105035330743667360e-01 -2.343750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 4.507775878919619006e-02 4.507775878919619006e-02 4.507775878919619006e-02 -2.031250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 5.071030117574120560e-02 5.071030117574120560e-02 5.071030117574120560e-02 -2.031250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 5.204699817532835310e-02 5.204699817532835310e-02 5.204699817532835310e-02 -2.031250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 6.450944447035640399e-03 6.450944447035640399e-03 6.450944447035640399e-03 -2.031250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 6.066331656785211440e-02 6.066331656785211440e-02 6.066331656785211440e-02 -2.343750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 1.179775660449196573e-01 1.179775660449196573e-01 1.179775660449196573e-01 -2.343750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 5.971177289680656974e-02 5.971177289680656974e-02 5.971177289680656974e-02 -2.343750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 9.489845783205130836e-02 9.489845783205130836e-02 9.489845783205130836e-02 -2.343750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 4.993898675124178177e-02 4.993898675124178177e-02 4.993898675124178177e-02 -2.031250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 1.972601399369172115e-01 1.972601399369172115e-01 1.972601399369172115e-01 -2.031250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 1.807021844307778180e-01 1.807021844307778180e-01 1.807021844307778180e-01 -2.343750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 7.905574042102300747e-02 7.905574042102300747e-02 7.905574042102300747e-02 -2.343750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 1.141076734909211299e-01 1.141076734909211299e-01 1.141076734909211299e-01 -2.031250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 7.921263260451763544e-02 7.921263260451763544e-02 7.921263260451763544e-02 -2.031250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.728309641104218974e-01 1.728309641104218974e-01 1.728309641104218974e-01 -2.031250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 2.934077391424313452e-01 2.934077391424313452e-01 2.934077391424313452e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.796345372713657185e-01 1.796345372713657185e-01 1.796345372713657185e-01 -2.343750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 2.110302893873340080e-01 2.110302893873340080e-01 2.110302893873340080e-01 -2.343750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 2.388362536748530607e-01 2.388362536748530607e-01 2.388362536748530607e-01 -2.343750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.258734333258867688e-01 1.258734333258867688e-01 1.258734333258867688e-01 -2.343750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.953395629166920500e-01 1.953395629166920500e-01 1.953395629166920500e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 2.997025610180031885e-01 2.997025610180031885e-01 2.997025610180031885e-01 -1.406250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.264381400963766056e-01 1.264381400963766056e-01 1.264381400963766056e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.316576745041209140e-01 1.316576745041209140e-01 1.316576745041209140e-01 -1.718750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.128350752522271627e-01 1.128350752522271627e-01 1.128350752522271627e-01 -1.406250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.361869406405436522e-01 1.361869406405436522e-01 1.361869406405436522e-01 -1.406250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 9.063688880909229195e-02 9.063688880909229195e-02 9.063688880909229195e-02 -1.718750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.177590510171247773e-01 1.177590510171247773e-01 1.177590510171247773e-01 -1.718750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.011863309976578917e-01 1.011863309976578917e-01 1.011863309976578917e-01 -1.406250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 2.020874639343930579e-01 2.020874639343930579e-01 2.020874639343930579e-01 -1.406250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.292045837028220345e-01 1.292045837028220345e-01 1.292045837028220345e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.021127965207897365e-01 1.021127965207897365e-01 1.021127965207897365e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.536124785551200023e-01 1.536124785551200023e-01 1.536124785551200023e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 1.099322869013117654e-01 1.099322869013117654e-01 1.099322869013117654e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 8.839230205460679723e-02 8.839230205460679723e-02 8.839230205460679723e-02 -1.406250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.330625052000214970e-01 1.330625052000214970e-01 1.330625052000214970e-01 -1.406250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.063713473004988114e-01 1.063713473004988114e-01 1.063713473004988114e-01 -1.406250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.358054286776294306e-01 1.358054286776294306e-01 1.358054286776294306e-01 -1.406250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 1.415134618695851609e-01 1.415134618695851609e-01 1.415134618695851609e-01 -1.718750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 6.827550197553719502e-02 6.827550197553719502e-02 6.827550197553719502e-02 -1.718750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.077918854234942297e-01 1.077918854234942297e-01 1.077918854234942297e-01 -1.718750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 8.497668111691694670e-02 8.497668111691694670e-02 8.497668111691694670e-02 -2.031250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 6.308384951757672887e-02 6.308384951757672887e-02 6.308384951757672887e-02 -2.031250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 8.585993440817447919e-02 8.585993440817447919e-02 8.585993440817447919e-02 -2.031250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.133878224145775798e-01 1.133878224145775798e-01 1.133878224145775798e-01 -2.343750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 7.541643105604169117e-02 7.541643105604169117e-02 7.541643105604169117e-02 -2.343750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 5.297893420418371691e-02 5.297893420418371691e-02 5.297893420418371691e-02 -2.343750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 6.242407680703880579e-02 6.242407680703880579e-02 6.242407680703880579e-02 -2.031250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 6.667218837184167579e-02 6.667218837184167579e-02 6.667218837184167579e-02 -2.031250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 8.283481189493650809e-02 8.283481189493650809e-02 8.283481189493650809e-02 -2.031250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.152316245133914174e-01 1.152316245133914174e-01 1.152316245133914174e-01 -2.031250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 8.569357169959727905e-02 8.569357169959727905e-02 8.569357169959727905e-02 -2.343750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 4.507856288042885740e-02 4.507856288042885740e-02 4.507856288042885740e-02 -2.343750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 8.963635572498242221e-02 8.963635572498242221e-02 8.963635572498242221e-02 -2.343750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.242074047641009843e-01 1.242074047641009843e-01 1.242074047641009843e-01 -2.343750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.082345932528694932e-01 1.082345932528694932e-01 1.082345932528694932e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 9.726661292816599080e-02 9.726661292816599080e-02 9.726661292816599080e-02 -2.031250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 8.253582974216067125e-02 8.253582974216067125e-02 8.253582974216067125e-02 -2.343750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 1.509440412658985819e-01 1.509440412658985819e-01 1.509440412658985819e-01 -2.343750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 9.933497504315511040e-02 9.933497504315511040e-02 9.933497504315511040e-02 -2.031250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 9.467505853784917436e-02 9.467505853784917436e-02 9.467505853784917436e-02 -2.031250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 9.703920234927322641e-02 9.703920234927322641e-02 9.703920234927322641e-02 -2.031250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.046366176918796798e-01 1.046366176918796798e-01 1.046366176918796798e-01 -2.343750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.077637641542361496e-01 1.077637641542361496e-01 1.077637641542361496e-01 -2.343750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.129885272435066229e-01 1.129885272435066229e-01 1.129885272435066229e-01 -2.343750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 8.467288475011813809e-02 8.467288475011813809e-02 8.467288475011813809e-02 -2.343750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 9.195162661890349254e-02 9.195162661890349254e-02 9.195162661890349254e-02 -1.406250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 3.708976248321643188e-01 3.708976248321643188e-01 3.708976248321643188e-01 -1.406250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 9.067787423640621958e-02 9.067787423640621958e-02 9.067787423640621958e-02 -1.406250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.319902095435194211e-01 1.319902095435194211e-01 1.319902095435194211e-01 -1.406250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.425310186133948720e-01 1.425310186133948720e-01 1.425310186133948720e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 2.194024538258175505e-01 2.194024538258175505e-01 2.194024538258175505e-01 -1.718750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.735510863357773714e-01 1.735510863357773714e-01 1.735510863357773714e-01 -1.406250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 1.420483433409686636e-01 1.420483433409686636e-01 1.420483433409686636e-01 -1.406250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 7.021229756747951467e-02 7.021229756747951467e-02 7.021229756747951467e-02 -1.718750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 8.956724213685574032e-02 8.956724213685574032e-02 8.956724213685574032e-02 -1.718750000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 2.333290517617789359e-03 2.333290517617789359e-03 2.333290517617789359e-03 -1.718750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 3.876089165368518108e-02 3.876089165368518108e-02 3.876089165368518108e-02 -1.406250000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 1.379731957453376734e-01 1.379731957453376734e-01 1.379731957453376734e-01 -1.406250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 1.446150824271159874e-01 1.446150824271159874e-01 1.446150824271159874e-01 -1.718750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 1.341412121781863920e-01 1.341412121781863920e-01 1.341412121781863920e-01 -1.718750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 9.460112769956251222e-02 9.460112769956251222e-02 9.460112769956251222e-02 -1.406250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 1.415777120841016645e-01 1.415777120841016645e-01 1.415777120841016645e-01 -1.406250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 8.447035320161103145e-02 8.447035320161103145e-02 8.447035320161103145e-02 -1.406250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 9.924417393727119618e-02 9.924417393727119618e-02 9.924417393727119618e-02 -1.406250000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 5.862418875428511422e-02 5.862418875428511422e-02 5.862418875428511422e-02 -1.718750000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 3.928479652472268574e-02 3.928479652472268574e-02 3.928479652472268574e-02 -1.718750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 3.633729468746591668e-02 3.633729468746591668e-02 3.633729468746591668e-02 -1.718750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 5.032428307034986226e-02 5.032428307034986226e-02 5.032428307034986226e-02 -2.031250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 2.057236159886833005e-01 2.057236159886833005e-01 2.057236159886833005e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 2.022527836166975734e-01 2.022527836166975734e-01 2.022527836166975734e-01 -2.031250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.925473008374109507e-01 1.925473008374109507e-01 1.925473008374109507e-01 -2.343750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 1.901305795681232647e-01 1.901305795681232647e-01 1.901305795681232647e-01 -2.343750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.465256276026640214e-01 1.465256276026640214e-01 1.465256276026640214e-01 -2.343750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.566036248970058831e-01 1.566036248970058831e-01 1.566036248970058831e-01 -2.031250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 1.461256937795336330e-01 1.461256937795336330e-01 1.461256937795336330e-01 -2.031250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 6.254860359249014845e-02 6.254860359249014845e-02 6.254860359249014845e-02 -2.343750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 8.461662603778857816e-02 8.461662603778857816e-02 8.461662603778857816e-02 -2.343750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 9.489685064510947066e-02 9.489685064510947066e-02 9.489685064510947066e-02 -2.343750000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 8.024423931644746044e-02 8.024423931644746044e-02 8.024423931644746044e-02 -2.343750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.258782530305873060e-01 1.258782530305873060e-01 1.258782530305873060e-01 -2.031250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 9.510739186239680620e-02 9.510739186239680620e-02 9.510739186239680620e-02 -2.031250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 4.413415218367007509e-02 4.413415218367007509e-02 4.413415218367007509e-02 -2.343750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 1.654920934804846588e-01 1.654920934804846588e-01 1.654920934804846588e-01 -2.343750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 1.911218373590103381e-01 1.911218373590103381e-01 1.911218373590103381e-01 -2.343750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 3.308874964135839758e-02 3.308874964135839758e-02 3.308874964135839758e-02 -2.031250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 2.906461805601251447e-02 2.906461805601251447e-02 2.906461805601251447e-02 -2.343750000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 4.567214083935759034e-02 4.567214083935759034e-02 4.567214083935759034e-02 -2.343750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 9.382243898322406572e-02 9.382243898322406572e-02 9.382243898322406572e-02 -2.343750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 1.162270190631877059e-01 1.162270190631877059e-01 1.162270190631877059e-01 -2.343750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 1.062781436961776904e-01 1.062781436961776904e-01 1.062781436961776904e-01 -1.718750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 2.133974359115104469e-01 2.133974359115104469e-01 2.133974359115104469e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.902317125013754662e-01 1.902317125013754662e-01 1.902317125013754662e-01 -1.406250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 1.202518545012536688e-01 1.202518545012536688e-01 1.202518545012536688e-01 -1.406250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 1.328560793567350462e-01 1.328560793567350462e-01 1.328560793567350462e-01 -1.406250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 1.114106090295462204e-01 1.114106090295462204e-01 1.114106090295462204e-01 -1.718750000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 1.519349789558773478e-01 1.519349789558773478e-01 1.519349789558773478e-01 -1.718750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 8.469779931014520535e-02 8.469779931014520535e-02 8.469779931014520535e-02 -1.718750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 1.962023434722432458e-01 1.962023434722432458e-01 1.962023434722432458e-01 -1.718750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 9.324866352746949416e-02 9.324866352746949416e-02 9.324866352746949416e-02 -1.406250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 3.567464879055142618e-02 3.567464879055142618e-02 3.567464879055142618e-02 -1.406250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 6.538565581979909058e-02 6.538565581979909058e-02 6.538565581979909058e-02 -1.406250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 6.684453908311310810e-02 6.684453908311310810e-02 6.684453908311310810e-02 -1.718750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 9.530186074154400888e-02 9.530186074154400888e-02 9.530186074154400888e-02 -1.718750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 8.008453604964595185e-02 8.008453604964595185e-02 8.008453604964595185e-02 -1.718750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.110008594216369965e-01 1.110008594216369965e-01 1.110008594216369965e-01 -1.718750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.176522033793992728e-01 1.176522033793992728e-01 1.176522033793992728e-01 -1.718750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.466565292053072234e-01 1.466565292053072234e-01 1.466565292053072234e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.545126446282591715e-01 1.545126446282591715e-01 1.545126446282591715e-01 -2.343750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 1.698091100510369655e-01 1.698091100510369655e-01 1.698091100510369655e-01 -2.343750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 1.067754961632154387e-01 1.067754961632154387e-01 1.067754961632154387e-01 -2.343750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.087664821965227263e-01 1.087664821965227263e-01 1.087664821965227263e-01 -2.031250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 9.367698648875415202e-02 9.367698648875415202e-02 9.367698648875415202e-02 -2.031250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 8.686614017299483514e-02 8.686614017299483514e-02 8.686614017299483514e-02 -2.031250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 1.176578269428012608e-01 1.176578269428012608e-01 1.176578269428012608e-01 -2.343750000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 1.102560739080466340e-01 1.102560739080466340e-01 1.102560739080466340e-01 -2.343750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 1.106818960274358471e-01 1.106818960274358471e-01 1.106818960274358471e-01 -2.343750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 8.198769290968967172e-02 8.198769290968967172e-02 8.198769290968967172e-02 -2.031250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 6.387063366140997844e-02 6.387063366140997844e-02 6.387063366140997844e-02 -2.031250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 5.693980319047151767e-02 5.693980319047151767e-02 5.693980319047151767e-02 -2.031250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 7.372749381083264220e-02 7.372749381083264220e-02 7.372749381083264220e-02 -2.031250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 8.841882277925917910e-02 8.841882277925917910e-02 8.841882277925917910e-02 -2.343750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 9.119782480561948457e-02 9.119782480561948457e-02 9.119782480561948457e-02 -2.343750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 1.047499105772703304e-01 1.047499105772703304e-01 1.047499105772703304e-01 -2.343750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.033783327923212952e-01 1.033783327923212952e-01 1.033783327923212952e-01 -2.031250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.013333769750892344e-01 1.013333769750892344e-01 1.013333769750892344e-01 -2.031250000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 9.481006250203659336e-02 9.481006250203659336e-02 9.481006250203659336e-02 -2.031250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.316070712254460706e-01 1.316070712254460706e-01 1.316070712254460706e-01 -2.031250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 8.222157579791669613e-02 8.222157579791669613e-02 8.222157579791669613e-02 -2.343750000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 8.182775198643520154e-02 8.182775198643520154e-02 8.182775198643520154e-02 -2.343750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.117785784675516120e-01 1.117785784675516120e-01 1.117785784675516120e-01 -2.343750000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 9.301641991772593987e-02 9.301641991772593987e-02 9.301641991772593987e-02 -1.562500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 9.969657135082593546e-02 9.969657135082593546e-02 9.969657135082593546e-02 -1.562500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 1.439332501501138228e-01 1.439332501501138228e-01 1.439332501501138228e-01 -4.687500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 1.511889662227078601e-01 1.511889662227078601e-01 1.511889662227078601e-01 -1.562500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 1.415712870649625255e-01 1.415712870649625255e-01 1.415712870649625255e-01 -1.562500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 1.256220049963373553e-01 1.256220049963373553e-01 1.256220049963373553e-01 -4.687500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 1.298375429095371958e-01 1.298375429095371958e-01 1.298375429095371958e-01 -4.687500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 1.358728961880105446e-01 1.358728961880105446e-01 1.358728961880105446e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 1.523750348917045638e-01 1.523750348917045638e-01 1.523750348917045638e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 1.090950946052711146e-01 1.090950946052711146e-01 1.090950946052711146e-01 -4.687500000000000000e-02 7.812500000000000000e-02 2.656250000000000000e-01 9.976326560337460403e-02 9.976326560337460403e-02 9.976326560337460403e-02 -4.687500000000000000e-02 7.812500000000000000e-02 2.968750000000000000e-01 7.950029427124175041e-02 7.950029427124175041e-02 7.950029427124175041e-02 -4.687500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 1.309572580407529219e-01 1.309572580407529219e-01 1.309572580407529219e-01 -4.687500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 1.097756153012260510e-01 1.097756153012260510e-01 1.097756153012260510e-01 -1.562500000000000000e-02 7.812500000000000000e-02 3.281250000000000000e-01 9.779294943499129700e-02 9.779294943499129700e-02 9.779294943499129700e-02 -1.562500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 7.543893711919452683e-02 7.543893711919452683e-02 7.543893711919452683e-02 -4.687500000000000000e-02 7.812500000000000000e-02 3.281250000000000000e-01 1.060170123331363040e-01 1.060170123331363040e-01 1.060170123331363040e-01 -4.687500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 8.811343208731760301e-02 8.811343208731760301e-02 8.811343208731760301e-02 -7.812500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 6.953433599071540128e-02 6.953433599071540128e-02 6.953433599071540128e-02 -7.812500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 9.977371168612517160e-02 9.977371168612517160e-02 9.977371168612517160e-02 -7.812500000000000000e-02 4.687500000000000000e-02 2.968750000000000000e-01 7.063391058272766587e-02 7.063391058272766587e-02 7.063391058272766587e-02 -7.812500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 5.836209871554920436e-02 5.836209871554920436e-02 5.836209871554920436e-02 -7.812500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 8.144598216575331395e-02 8.144598216575331395e-02 8.144598216575331395e-02 -1.093750000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 7.256180741943789314e-02 7.256180741943789314e-02 7.256180741943789314e-02 -1.093750000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 5.390740222533600690e-02 5.390740222533600690e-02 5.390740222533600690e-02 -7.812500000000000000e-02 7.812500000000000000e-02 2.656250000000000000e-01 8.602951150104141964e-02 8.602951150104141964e-02 8.602951150104141964e-02 -7.812500000000000000e-02 7.812500000000000000e-02 2.968750000000000000e-01 7.839376777798715001e-02 7.839376777798715001e-02 7.839376777798715001e-02 -7.812500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 9.482292001063147291e-02 9.482292001063147291e-02 9.482292001063147291e-02 -7.812500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 7.770687297090221601e-02 7.770687297090221601e-02 7.770687297090221601e-02 -1.093750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 7.483529017394592586e-02 7.483529017394592586e-02 7.483529017394592586e-02 -1.093750000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 7.985370117520346200e-02 7.985370117520346200e-02 7.985370117520346200e-02 -1.093750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.053420842685387077e-01 1.053420842685387077e-01 1.053420842685387077e-01 -1.093750000000000000e-01 7.812500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 2.656250000000000000e-01 6.601308819293207064e-02 6.601308819293207064e-02 6.601308819293207064e-02 -4.687500000000000000e-02 1.718750000000000000e-01 2.968750000000000000e-01 4.323291110224541933e-02 4.323291110224541933e-02 4.323291110224541933e-02 -4.687500000000000000e-02 2.031250000000000000e-01 2.656250000000000000e-01 8.237428247145063553e-02 8.237428247145063553e-02 8.237428247145063553e-02 -4.687500000000000000e-02 2.031250000000000000e-01 2.968750000000000000e-01 1.000686120777753568e-01 1.000686120777753568e-01 1.000686120777753568e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.656250000000000000e-01 1.171798226489778744e-01 1.171798226489778744e-01 1.171798226489778744e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.968750000000000000e-01 1.179486449723908398e-01 1.179486449723908398e-01 1.179486449723908398e-01 -7.812500000000000000e-02 1.406250000000000000e-01 2.656250000000000000e-01 7.418445563042071200e-02 7.418445563042071200e-02 7.418445563042071200e-02 -7.812500000000000000e-02 1.406250000000000000e-01 2.968750000000000000e-01 5.135626026114208098e-02 5.135626026114208098e-02 5.135626026114208098e-02 -7.812500000000000000e-02 1.718750000000000000e-01 2.656250000000000000e-01 6.075609066972178368e-02 6.075609066972178368e-02 6.075609066972178368e-02 -7.812500000000000000e-02 1.718750000000000000e-01 2.968750000000000000e-01 7.528444894473146354e-02 7.528444894473146354e-02 7.528444894473146354e-02 -1.093750000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 8.881341798305204815e-02 8.881341798305204815e-02 8.881341798305204815e-02 -1.093750000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 6.454888413483432508e-02 6.454888413483432508e-02 6.454888413483432508e-02 -1.093750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 9.042553225443242249e-02 9.042553225443242249e-02 9.042553225443242249e-02 -7.812500000000000000e-02 1.718750000000000000e-01 3.281250000000000000e-01 4.200221182421789295e-02 4.200221182421789295e-02 4.200221182421789295e-02 -1.093750000000000000e-01 1.718750000000000000e-01 3.281250000000000000e-01 6.626767722990137277e-02 6.626767722990137277e-02 6.626767722990137277e-02 -7.812500000000000000e-02 2.031250000000000000e-01 2.968750000000000000e-01 9.155704680647230864e-02 9.155704680647230864e-02 9.155704680647230864e-02 -7.812500000000000000e-02 2.343750000000000000e-01 2.968750000000000000e-01 1.421551585842145971e-01 1.421551585842145971e-01 1.421551585842145971e-01 -1.093750000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 7.796809623660468092e-02 7.796809623660468092e-02 7.796809623660468092e-02 -1.093750000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 1.390678999347033096e-01 1.390678999347033096e-01 1.390678999347033096e-01 -7.812500000000000000e-02 2.031250000000000000e-01 3.281250000000000000e-01 9.861177755224335983e-02 9.861177755224335983e-02 9.861177755224335983e-02 -7.812500000000000000e-02 2.343750000000000000e-01 3.281250000000000000e-01 5.590580726131238326e-02 5.590580726131238326e-02 5.590580726131238326e-02 -1.093750000000000000e-01 2.031250000000000000e-01 3.281250000000000000e-01 7.957359599002135353e-02 7.957359599002135353e-02 7.957359599002135353e-02 -1.093750000000000000e-01 2.343750000000000000e-01 3.281250000000000000e-01 9.116326868964649832e-02 9.116326868964649832e-02 9.116326868964649832e-02 -1.406250000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 8.612434592793827282e-02 8.612434592793827282e-02 8.612434592793827282e-02 -1.406250000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 7.131314902034825709e-02 7.131314902034825709e-02 7.131314902034825709e-02 -1.718750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 7.817128716267496280e-02 7.817128716267496280e-02 7.817128716267496280e-02 -1.718750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 7.641810552821330649e-02 7.641810552821330649e-02 7.641810552821330649e-02 -1.718750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 8.189365733000572578e-02 8.189365733000572578e-02 8.189365733000572578e-02 -1.718750000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 5.772391394018783900e-02 5.772391394018783900e-02 5.772391394018783900e-02 -1.406250000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 9.570847596990998685e-02 9.570847596990998685e-02 9.570847596990998685e-02 -1.406250000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 7.761130523194172126e-02 7.761130523194172126e-02 7.761130523194172126e-02 -1.718750000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 7.609378042137396325e-02 7.609378042137396325e-02 7.609378042137396325e-02 -1.718750000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 5.928423381158031552e-02 5.928423381158031552e-02 5.928423381158031552e-02 -1.406250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 7.269218636663954403e-02 7.269218636663954403e-02 7.269218636663954403e-02 -1.406250000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 8.614202691042061044e-02 8.614202691042061044e-02 8.614202691042061044e-02 -1.406250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 9.890105732870513311e-02 9.890105732870513311e-02 9.890105732870513311e-02 -1.718750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 7.377507905014719924e-02 7.377507905014719924e-02 7.377507905014719924e-02 -1.718750000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 6.001156342752578254e-02 6.001156342752578254e-02 6.001156342752578254e-02 -1.406250000000000000e-01 7.812500000000000000e-02 3.281250000000000000e-01 8.056589536165176257e-02 8.056589536165176257e-02 8.056589536165176257e-02 -1.406250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 8.092194990405844612e-02 8.092194990405844612e-02 8.092194990405844612e-02 -1.406250000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 8.731860719393175208e-02 8.731860719393175208e-02 8.731860719393175208e-02 -1.406250000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 6.704172906623423467e-02 6.704172906623423467e-02 6.704172906623423467e-02 -1.718750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 1.246178904140490401e-01 1.246178904140490401e-01 1.246178904140490401e-01 -1.718750000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 8.334838348328053870e-02 8.334838348328053870e-02 8.334838348328053870e-02 -1.406250000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 6.241780624721815496e-02 6.241780624721815496e-02 6.241780624721815496e-02 -1.406250000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 9.843901274521374423e-02 9.843901274521374423e-02 9.843901274521374423e-02 -1.718750000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 1.126294009200796559e-01 1.126294009200796559e-01 1.126294009200796559e-01 -1.718750000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 9.765312908049940399e-02 9.765312908049940399e-02 9.765312908049940399e-02 -1.718750000000000000e-01 2.031250000000000000e-01 3.281250000000000000e-01 4.850978823250837180e-02 4.850978823250837180e-02 4.850978823250837180e-02 -2.031250000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 1.244403616521981698e-01 1.244403616521981698e-01 1.244403616521981698e-01 -2.031250000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 7.716473151734408453e-02 7.716473151734408453e-02 7.716473151734408453e-02 -2.343750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 9.676277307683624207e-02 9.676277307683624207e-02 9.676277307683624207e-02 -2.343750000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 4.922772747202263516e-02 4.922772747202263516e-02 4.922772747202263516e-02 -2.031250000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 9.458184138275890773e-02 9.458184138275890773e-02 9.458184138275890773e-02 -2.031250000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 8.605844404991468133e-02 8.605844404991468133e-02 8.605844404991468133e-02 -2.343750000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 8.010913053413462603e-02 8.010913053413462603e-02 8.010913053413462603e-02 -2.343750000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 5.556564132261710559e-02 5.556564132261710559e-02 5.556564132261710559e-02 -2.343750000000000000e-01 2.343750000000000000e-01 2.656250000000000000e-01 6.783426232581710180e-02 6.783426232581710180e-02 6.783426232581710180e-02 -2.343750000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 4.448682996559892577e-02 4.448682996559892577e-02 4.448682996559892577e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.562500000000000000e-02 9.912926619620310298e-02 9.912926619620310298e-02 9.912926619620310298e-02 -1.562500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 5.160808159141978824e-02 5.160808159141978824e-02 5.160808159141978824e-02 -1.562500000000000000e-02 2.968750000000000000e-01 1.562500000000000000e-02 1.102544670278478856e-01 1.102544670278478856e-01 1.102544670278478856e-01 -1.562500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 9.533962943629187281e-02 9.533962943629187281e-02 9.533962943629187281e-02 -4.687500000000000000e-02 2.656250000000000000e-01 1.562500000000000000e-02 6.628251067549084316e-03 6.628251067549084316e-03 6.628251067549084316e-03 -4.687500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 3.663644857124032095e-02 3.663644857124032095e-02 3.663644857124032095e-02 -4.687500000000000000e-02 2.968750000000000000e-01 1.562500000000000000e-02 8.778955595531906519e-02 8.778955595531906519e-02 8.778955595531906519e-02 -4.687500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 9.562731380588665453e-02 9.562731380588665453e-02 9.562731380588665453e-02 -1.562500000000000000e-02 2.656250000000000000e-01 7.812500000000000000e-02 1.559419688153279027e-01 1.559419688153279027e-01 1.559419688153279027e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.093750000000000000e-01 1.260726475466455443e-01 1.260726475466455443e-01 1.260726475466455443e-01 -1.562500000000000000e-02 2.968750000000000000e-01 7.812500000000000000e-02 1.773779822589792443e-01 1.773779822589792443e-01 1.773779822589792443e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.093750000000000000e-01 1.286872884705019537e-01 1.286872884705019537e-01 1.286872884705019537e-01 -1.562500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 9.279542624101058679e-02 9.279542624101058679e-02 9.279542624101058679e-02 -4.687500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 8.301162877426951359e-02 8.301162877426951359e-02 8.301162877426951359e-02 -1.562500000000000000e-02 3.281250000000000000e-01 7.812500000000000000e-02 8.499757712114351660e-02 8.499757712114351660e-02 8.499757712114351660e-02 -1.562500000000000000e-02 3.281250000000000000e-01 1.093750000000000000e-01 9.366493240283013666e-02 9.366493240283013666e-02 9.366493240283013666e-02 -1.562500000000000000e-02 3.593750000000000000e-01 1.093750000000000000e-01 7.337108590404682607e-02 7.337108590404682607e-02 7.337108590404682607e-02 -7.812500000000000000e-02 2.656250000000000000e-01 1.562500000000000000e-02 6.495469014685202602e-02 6.495469014685202602e-02 6.495469014685202602e-02 -7.812500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 4.718268130561217855e-02 4.718268130561217855e-02 4.718268130561217855e-02 -7.812500000000000000e-02 2.968750000000000000e-01 1.562500000000000000e-02 7.341449155223302159e-02 7.341449155223302159e-02 7.341449155223302159e-02 -7.812500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 7.031052676481530650e-02 7.031052676481530650e-02 7.031052676481530650e-02 -1.093750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 7.638249815162510836e-02 7.638249815162510836e-02 7.638249815162510836e-02 -1.093750000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 3.634983987268143590e-02 3.634983987268143590e-02 3.634983987268143590e-02 -1.093750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 7.219550736006476177e-02 7.219550736006476177e-02 7.219550736006476177e-02 -1.093750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 6.158598803713505321e-02 6.158598803713505321e-02 6.158598803713505321e-02 -7.812500000000000000e-02 2.968750000000000000e-01 7.812500000000000000e-02 1.441452692863853802e-01 1.441452692863853802e-01 1.441452692863853802e-01 -1.093750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 7.058142008371239007e-02 7.058142008371239007e-02 7.058142008371239007e-02 -7.812500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 7.755439856811073562e-02 7.755439856811073562e-02 7.755439856811073562e-02 -7.812500000000000000e-02 3.281250000000000000e-01 4.687500000000000000e-02 7.436659659266713074e-02 7.436659659266713074e-02 7.436659659266713074e-02 -7.812500000000000000e-02 3.593750000000000000e-01 1.562500000000000000e-02 7.885464148839937959e-02 7.885464148839937959e-02 7.885464148839937959e-02 -7.812500000000000000e-02 3.593750000000000000e-01 4.687500000000000000e-02 1.134553087265922217e-01 1.134553087265922217e-01 1.134553087265922217e-01 -1.093750000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 6.394636132982149668e-02 6.394636132982149668e-02 6.394636132982149668e-02 -1.093750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 3.805194603108542906e-02 3.805194603108542906e-02 3.805194603108542906e-02 -1.093750000000000000e-01 3.593750000000000000e-01 1.562500000000000000e-02 6.435699377256387521e-02 6.435699377256387521e-02 6.435699377256387521e-02 -1.093750000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 5.069397926461356035e-02 5.069397926461356035e-02 5.069397926461356035e-02 -7.812500000000000000e-02 3.593750000000000000e-01 7.812500000000000000e-02 8.988227103387491645e-02 8.988227103387491645e-02 8.988227103387491645e-02 -7.812500000000000000e-02 3.593750000000000000e-01 1.093750000000000000e-01 6.646454707587416688e-02 6.646454707587416688e-02 6.646454707587416688e-02 -1.093750000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 4.932533905443260008e-02 4.932533905443260008e-02 4.932533905443260008e-02 -1.093750000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 5.375729472531391717e-02 5.375729472531391717e-02 5.375729472531391717e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 6.098665877154300918e-02 6.098665877154300918e-02 6.098665877154300918e-02 -1.562500000000000000e-02 2.968750000000000000e-01 1.406250000000000000e-01 1.305194946546605339e-01 1.305194946546605339e-01 1.305194946546605339e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 5.481117692076862419e-02 5.481117692076862419e-02 5.481117692076862419e-02 -4.687500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 9.766759326637283745e-02 9.766759326637283745e-02 9.766759326637283745e-02 -4.687500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 4.301821353123772701e-02 4.301821353123772701e-02 4.301821353123772701e-02 -1.562500000000000000e-02 2.656250000000000000e-01 2.031250000000000000e-01 7.318026153593383543e-02 7.318026153593383543e-02 7.318026153593383543e-02 -1.562500000000000000e-02 2.656250000000000000e-01 2.343750000000000000e-01 1.802333847160206559e-01 1.802333847160206559e-01 1.802333847160206559e-01 -1.562500000000000000e-02 2.968750000000000000e-01 2.031250000000000000e-01 1.554457231830781438e-01 1.554457231830781438e-01 1.554457231830781438e-01 -1.562500000000000000e-02 2.968750000000000000e-01 2.343750000000000000e-01 2.083324598530290339e-01 2.083324598530290339e-01 2.083324598530290339e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.031250000000000000e-01 1.112161790836160707e-01 1.112161790836160707e-01 1.112161790836160707e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.343750000000000000e-01 2.141597225090711154e-01 2.141597225090711154e-01 2.141597225090711154e-01 -4.687500000000000000e-02 2.968750000000000000e-01 2.343750000000000000e-01 2.558826919176084846e-01 2.558826919176084846e-01 2.558826919176084846e-01 -1.562500000000000000e-02 3.281250000000000000e-01 1.406250000000000000e-01 6.252882724047682805e-02 6.252882724047682805e-02 6.252882724047682805e-02 -1.562500000000000000e-02 3.281250000000000000e-01 1.718750000000000000e-01 1.135589483098168873e-01 1.135589483098168873e-01 1.135589483098168873e-01 -1.562500000000000000e-02 3.593750000000000000e-01 1.406250000000000000e-01 7.137343617857214162e-02 7.137343617857214162e-02 7.137343617857214162e-02 -1.562500000000000000e-02 3.593750000000000000e-01 1.718750000000000000e-01 1.108988234104190673e-01 1.108988234104190673e-01 1.108988234104190673e-01 -4.687500000000000000e-02 3.281250000000000000e-01 1.406250000000000000e-01 9.147266594369993231e-02 9.147266594369993231e-02 9.147266594369993231e-02 -4.687500000000000000e-02 3.281250000000000000e-01 1.718750000000000000e-01 1.001361095630853154e-01 1.001361095630853154e-01 1.001361095630853154e-01 -4.687500000000000000e-02 3.593750000000000000e-01 1.406250000000000000e-01 8.446151252716632696e-02 8.446151252716632696e-02 8.446151252716632696e-02 -4.687500000000000000e-02 3.593750000000000000e-01 1.718750000000000000e-01 1.054489482560269226e-01 1.054489482560269226e-01 1.054489482560269226e-01 -1.562500000000000000e-02 3.281250000000000000e-01 2.343750000000000000e-01 1.884498279220538641e-01 1.884498279220538641e-01 1.884498279220538641e-01 -1.562500000000000000e-02 3.593750000000000000e-01 2.031250000000000000e-01 1.353419896069993078e-01 1.353419896069993078e-01 1.353419896069993078e-01 -1.562500000000000000e-02 3.593750000000000000e-01 2.343750000000000000e-01 1.055116203029733274e-01 1.055116203029733274e-01 1.055116203029733274e-01 -4.687500000000000000e-02 3.281250000000000000e-01 2.343750000000000000e-01 2.300120419819841888e-01 2.300120419819841888e-01 2.300120419819841888e-01 -4.687500000000000000e-02 3.593750000000000000e-01 2.031250000000000000e-01 1.357122591655151311e-01 1.357122591655151311e-01 1.357122591655151311e-01 -4.687500000000000000e-02 3.593750000000000000e-01 2.343750000000000000e-01 1.261055821082022743e-01 1.261055821082022743e-01 1.261055821082022743e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.406250000000000000e-01 1.590165357400328550e-01 1.590165357400328550e-01 1.590165357400328550e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 1.459024366842861797e-01 1.459024366842861797e-01 1.459024366842861797e-01 -7.812500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 1.102705358283196657e-01 1.102705358283196657e-01 1.102705358283196657e-01 -1.093750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 9.178447288166582951e-02 9.178447288166582951e-02 9.178447288166582951e-02 -1.093750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 9.808705352549899892e-02 9.808705352549899892e-02 9.808705352549899892e-02 -1.093750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 7.477524674810516470e-02 7.477524674810516470e-02 7.477524674810516470e-02 -1.093750000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 8.445990513170024971e-02 8.445990513170024971e-02 8.445990513170024971e-02 -7.812500000000000000e-02 2.656250000000000000e-01 2.031250000000000000e-01 2.149003372016773383e-01 2.149003372016773383e-01 2.149003372016773383e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.343750000000000000e-01 1.656871951914388186e-01 1.656871951914388186e-01 1.656871951914388186e-01 -7.812500000000000000e-02 2.968750000000000000e-01 2.031250000000000000e-01 1.779896907245337723e-01 1.779896907245337723e-01 1.779896907245337723e-01 -7.812500000000000000e-02 2.968750000000000000e-01 2.343750000000000000e-01 2.196808690915505735e-01 2.196808690915505735e-01 2.196808690915505735e-01 -1.093750000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 1.806604421012130701e-01 1.806604421012130701e-01 1.806604421012130701e-01 -1.093750000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 1.177389668855205879e-01 1.177389668855205879e-01 1.177389668855205879e-01 -1.093750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 1.262445497438798858e-01 1.262445497438798858e-01 1.262445497438798858e-01 -1.093750000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 1.331307782223126457e-01 1.331307782223126457e-01 1.331307782223126457e-01 -7.812500000000000000e-02 3.281250000000000000e-01 1.718750000000000000e-01 1.102046537260184533e-01 1.102046537260184533e-01 1.102046537260184533e-01 -7.812500000000000000e-02 3.593750000000000000e-01 1.406250000000000000e-01 8.417619933032620405e-02 8.417619933032620405e-02 8.417619933032620405e-02 -7.812500000000000000e-02 3.593750000000000000e-01 1.718750000000000000e-01 7.215684359618454446e-02 7.215684359618454446e-02 7.215684359618454446e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 8.245706544173628250e-02 8.245706544173628250e-02 8.245706544173628250e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 9.317633859977392241e-02 9.317633859977392241e-02 9.317633859977392241e-02 -1.093750000000000000e-01 3.593750000000000000e-01 1.406250000000000000e-01 6.945202203118067130e-02 6.945202203118067130e-02 6.945202203118067130e-02 -7.812500000000000000e-02 3.281250000000000000e-01 2.031250000000000000e-01 1.962175925337505400e-01 1.962175925337505400e-01 1.962175925337505400e-01 -7.812500000000000000e-02 3.281250000000000000e-01 2.343750000000000000e-01 2.178001432083193079e-01 2.178001432083193079e-01 2.178001432083193079e-01 -7.812500000000000000e-02 3.593750000000000000e-01 2.031250000000000000e-01 1.357387642963199803e-01 1.357387642963199803e-01 1.357387642963199803e-01 -7.812500000000000000e-02 3.593750000000000000e-01 2.343750000000000000e-01 1.238539516457699413e-01 1.238539516457699413e-01 1.238539516457699413e-01 -1.093750000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 1.233542948157406866e-01 1.233542948157406866e-01 1.233542948157406866e-01 -1.562500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 6.692452447899897849e-02 6.692452447899897849e-02 6.692452447899897849e-02 -1.562500000000000000e-02 4.218750000000000000e-01 4.687500000000000000e-02 7.187357670117580644e-02 7.187357670117580644e-02 7.187357670117580644e-02 -4.687500000000000000e-02 3.906250000000000000e-01 1.562500000000000000e-02 9.233656106804716268e-02 9.233656106804716268e-02 9.233656106804716268e-02 -4.687500000000000000e-02 3.906250000000000000e-01 4.687500000000000000e-02 1.251344085203709711e-01 1.251344085203709711e-01 1.251344085203709711e-01 -4.687500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 7.431033067305790885e-02 7.431033067305790885e-02 7.431033067305790885e-02 -4.687500000000000000e-02 4.218750000000000000e-01 4.687500000000000000e-02 9.491613688641767355e-02 9.491613688641767355e-02 9.491613688641767355e-02 -1.562500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 6.514320274260472499e-02 6.514320274260472499e-02 6.514320274260472499e-02 -1.562500000000000000e-02 4.218750000000000000e-01 7.812500000000000000e-02 7.020441993433773620e-02 7.020441993433773620e-02 7.020441993433773620e-02 -1.562500000000000000e-02 4.218750000000000000e-01 1.093750000000000000e-01 5.699752840935020520e-02 5.699752840935020520e-02 5.699752840935020520e-02 -4.687500000000000000e-02 3.906250000000000000e-01 7.812500000000000000e-02 6.862341158351953352e-02 6.862341158351953352e-02 6.862341158351953352e-02 -4.687500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 8.067761467665533759e-02 8.067761467665533759e-02 8.067761467665533759e-02 -4.687500000000000000e-02 4.218750000000000000e-01 7.812500000000000000e-02 4.748742333594383608e-02 4.748742333594383608e-02 4.748742333594383608e-02 -1.562500000000000000e-02 4.531250000000000000e-01 4.687500000000000000e-02 7.048576349664144314e-02 7.048576349664144314e-02 7.048576349664144314e-02 -4.687500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 8.468011801026992247e-02 8.468011801026992247e-02 8.468011801026992247e-02 -4.687500000000000000e-02 4.843750000000000000e-01 1.562500000000000000e-02 5.108666905535493019e-02 5.108666905535493019e-02 5.108666905535493019e-02 -1.562500000000000000e-02 4.531250000000000000e-01 7.812500000000000000e-02 6.577272710608583761e-02 6.577272710608583761e-02 6.577272710608583761e-02 -7.812500000000000000e-02 3.906250000000000000e-01 1.562500000000000000e-02 7.001214113951030604e-02 7.001214113951030604e-02 7.001214113951030604e-02 -7.812500000000000000e-02 3.906250000000000000e-01 4.687500000000000000e-02 8.897575597751410104e-02 8.897575597751410104e-02 8.897575597751410104e-02 -7.812500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 7.732162738851679207e-02 7.732162738851679207e-02 7.732162738851679207e-02 -7.812500000000000000e-02 4.218750000000000000e-01 4.687500000000000000e-02 9.198778964135592706e-02 9.198778964135592706e-02 9.198778964135592706e-02 -1.093750000000000000e-01 3.906250000000000000e-01 1.562500000000000000e-02 6.266155380251361984e-02 6.266155380251361984e-02 6.266155380251361984e-02 -1.093750000000000000e-01 3.906250000000000000e-01 4.687500000000000000e-02 6.486971865330287690e-02 6.486971865330287690e-02 6.486971865330287690e-02 -1.093750000000000000e-01 4.218750000000000000e-01 4.687500000000000000e-02 9.109335278170761774e-02 9.109335278170761774e-02 9.109335278170761774e-02 -7.812500000000000000e-02 3.906250000000000000e-01 7.812500000000000000e-02 8.089623044139360175e-02 8.089623044139360175e-02 8.089623044139360175e-02 -7.812500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 8.187276051959636869e-02 8.187276051959636869e-02 8.187276051959636869e-02 -1.093750000000000000e-01 3.906250000000000000e-01 7.812500000000000000e-02 4.118216404934938596e-02 4.118216404934938596e-02 4.118216404934938596e-02 -1.093750000000000000e-01 3.906250000000000000e-01 1.093750000000000000e-01 3.825636361539811597e-02 3.825636361539811597e-02 3.825636361539811597e-02 -1.093750000000000000e-01 4.218750000000000000e-01 7.812500000000000000e-02 9.111103267222983582e-02 9.111103267222983582e-02 9.111103267222983582e-02 -7.812500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 8.414565870281669191e-02 8.414565870281669191e-02 8.414565870281669191e-02 -7.812500000000000000e-02 4.531250000000000000e-01 4.687500000000000000e-02 8.246510261878606252e-02 8.246510261878606252e-02 8.246510261878606252e-02 -7.812500000000000000e-02 4.843750000000000000e-01 1.562500000000000000e-02 9.090530279681702241e-02 9.090530279681702241e-02 9.090530279681702241e-02 -7.812500000000000000e-02 4.843750000000000000e-01 4.687500000000000000e-02 8.272711415072421526e-02 8.272711415072421526e-02 8.272711415072421526e-02 -1.093750000000000000e-01 4.531250000000000000e-01 4.687500000000000000e-02 8.602790413690211691e-02 8.602790413690211691e-02 8.602790413690211691e-02 -1.093750000000000000e-01 4.843750000000000000e-01 1.562500000000000000e-02 7.282819180032169826e-02 7.282819180032169826e-02 7.282819180032169826e-02 -1.093750000000000000e-01 4.843750000000000000e-01 4.687500000000000000e-02 9.377824073923973769e-02 9.377824073923973769e-02 9.377824073923973769e-02 -1.093750000000000000e-01 4.531250000000000000e-01 7.812500000000000000e-02 9.972389189469955950e-02 9.972389189469955950e-02 9.972389189469955950e-02 -1.093750000000000000e-01 4.843750000000000000e-01 7.812500000000000000e-02 9.848079775582375961e-02 9.848079775582375961e-02 9.848079775582375961e-02 -1.562500000000000000e-02 3.906250000000000000e-01 1.406250000000000000e-01 6.839929623212957777e-02 6.839929623212957777e-02 6.839929623212957777e-02 -4.687500000000000000e-02 3.906250000000000000e-01 1.406250000000000000e-01 7.407586212440170348e-02 7.407586212440170348e-02 7.407586212440170348e-02 -7.812500000000000000e-02 3.906250000000000000e-01 1.406250000000000000e-01 6.966367484491781115e-02 6.966367484491781115e-02 6.966367484491781115e-02 -1.406250000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 9.344554772344505766e-02 9.344554772344505766e-02 9.344554772344505766e-02 -1.406250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 9.024551710844294639e-02 9.024551710844294639e-02 9.024551710844294639e-02 -1.718750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 1.029894336060268728e-01 1.029894336060268728e-01 1.029894336060268728e-01 -1.406250000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 6.433504733831536815e-02 6.433504733831536815e-02 6.433504733831536815e-02 -1.406250000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 5.465335275008210980e-02 5.465335275008210980e-02 5.465335275008210980e-02 -1.718750000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 6.505035331035455282e-02 6.505035331035455282e-02 6.505035331035455282e-02 -1.718750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 9.777286031856044501e-02 9.777286031856044501e-02 9.777286031856044501e-02 -1.718750000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 9.010648727804748681e-02 9.010648727804748681e-02 9.010648727804748681e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 1.471600566976282165e-01 1.471600566976282165e-01 1.471600566976282165e-01 -1.406250000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 4.560355233393934005e-02 4.560355233393934005e-02 4.560355233393934005e-02 -1.406250000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 5.219292796178013477e-02 5.219292796178013477e-02 5.219292796178013477e-02 -1.718750000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 7.630469236194604987e-02 7.630469236194604987e-02 7.630469236194604987e-02 -1.718750000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 1.169380076303329768e-01 1.169380076303329768e-01 1.169380076303329768e-01 -1.718750000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 4.346891694714700993e-02 4.346891694714700993e-02 4.346891694714700993e-02 -1.718750000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 7.167647894292929200e-02 7.167647894292929200e-02 7.167647894292929200e-02 -2.031250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 2.143490894280841164e-01 2.143490894280841164e-01 2.143490894280841164e-01 -2.031250000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 1.452985151062445024e-01 1.452985151062445024e-01 1.452985151062445024e-01 -2.031250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 1.491147093184575778e-01 1.491147093184575778e-01 1.491147093184575778e-01 -2.343750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 1.774510343018927128e-01 1.774510343018927128e-01 1.774510343018927128e-01 -2.343750000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 1.132938235285077394e-01 1.132938235285077394e-01 1.132938235285077394e-01 -2.343750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 1.664338763815614575e-01 1.664338763815614575e-01 1.664338763815614575e-01 -2.343750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 8.266040577418555524e-02 8.266040577418555524e-02 8.266040577418555524e-02 -2.031250000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 9.008077075131330769e-02 9.008077075131330769e-02 9.008077075131330769e-02 -2.031250000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 5.957799633813404272e-02 5.957799633813404272e-02 5.957799633813404272e-02 -2.031250000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 1.285788488308528821e-01 1.285788488308528821e-01 1.285788488308528821e-01 -2.031250000000000000e-01 3.593750000000000000e-01 1.562500000000000000e-02 8.090346404109464984e-02 8.090346404109464984e-02 8.090346404109464984e-02 -2.031250000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 9.519417968471524660e-02 9.519417968471524660e-02 9.519417968471524660e-02 -2.343750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 1.059197909014577416e-01 1.059197909014577416e-01 1.059197909014577416e-01 -2.343750000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 7.370747906495050961e-02 7.370747906495050961e-02 7.370747906495050961e-02 -2.031250000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 8.141785168624614266e-02 8.141785168624614266e-02 8.141785168624614266e-02 -2.031250000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 6.792863588484129855e-02 6.792863588484129855e-02 6.792863588484129855e-02 -2.343750000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 1.027371302359699756e-01 1.027371302359699756e-01 1.027371302359699756e-01 -2.343750000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 8.291116468595777222e-02 8.291116468595777222e-02 8.291116468595777222e-02 -2.343750000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 7.653473364230711784e-02 7.653473364230711784e-02 7.653473364230711784e-02 -2.343750000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 7.030112184686389265e-02 7.030112184686389265e-02 7.030112184686389265e-02 -1.406250000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 1.027258810227164448e-01 1.027258810227164448e-01 1.027258810227164448e-01 -1.406250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 4.013670761417303251e-02 4.013670761417303251e-02 4.013670761417303251e-02 -1.406250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 8.777026800558983266e-02 8.777026800558983266e-02 8.777026800558983266e-02 -1.718750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 7.425543117357444323e-02 7.425543117357444323e-02 7.425543117357444323e-02 -1.718750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 1.009573244320282892e-01 1.009573244320282892e-01 1.009573244320282892e-01 -1.718750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.072736490256222391e-01 1.072736490256222391e-01 1.072736490256222391e-01 -1.718750000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 7.943695896043043159e-02 7.943695896043043159e-02 7.943695896043043159e-02 -1.406250000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 1.576322323451414542e-01 1.576322323451414542e-01 1.576322323451414542e-01 -1.406250000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 1.156999997540835989e-01 1.156999997540835989e-01 1.156999997540835989e-01 -1.718750000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 1.490737536495650439e-01 1.490737536495650439e-01 1.490737536495650439e-01 -1.718750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 9.830562198925356376e-02 9.830562198925356376e-02 9.830562198925356376e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 9.645018185416939782e-02 9.645018185416939782e-02 9.645018185416939782e-02 -1.718750000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 1.330689308987023090e-01 1.330689308987023090e-01 1.330689308987023090e-01 -1.406250000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 1.079590059066538876e-01 1.079590059066538876e-01 1.079590059066538876e-01 -1.406250000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 1.334102954034805943e-01 1.334102954034805943e-01 1.334102954034805943e-01 -1.718750000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 8.172246406942991481e-02 8.172246406942991481e-02 8.172246406942991481e-02 -1.718750000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 1.126711785613645628e-01 1.126711785613645628e-01 1.126711785613645628e-01 -2.031250000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 6.975491126398050690e-02 6.975491126398050690e-02 6.975491126398050690e-02 -2.031250000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 1.035904588288645983e-01 1.035904588288645983e-01 1.035904588288645983e-01 -2.031250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.022293070412524929e-01 1.022293070412524929e-01 1.022293070412524929e-01 -2.031250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 7.087932129765749101e-02 7.087932129765749101e-02 7.087932129765749101e-02 -2.343750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 1.310271393149509134e-01 1.310271393149509134e-01 1.310271393149509134e-01 -2.343750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 9.597205154188405418e-02 9.597205154188405418e-02 9.597205154188405418e-02 -2.343750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.081044325830884667e-01 1.081044325830884667e-01 1.081044325830884667e-01 -2.343750000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 9.936068861202883296e-02 9.936068861202883296e-02 9.936068861202883296e-02 -2.031250000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 1.395313175435863307e-01 1.395313175435863307e-01 1.395313175435863307e-01 -2.031250000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 1.079501678128732128e-01 1.079501678128732128e-01 1.079501678128732128e-01 -2.031250000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 1.140972292691106033e-01 1.140972292691106033e-01 1.140972292691106033e-01 -2.031250000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 1.033751187571649438e-01 1.033751187571649438e-01 1.033751187571649438e-01 -2.343750000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 9.555338384264012996e-02 9.555338384264012996e-02 9.555338384264012996e-02 -2.343750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 1.006576060823527186e-01 1.006576060823527186e-01 1.006576060823527186e-01 -2.343750000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 9.295534536232757938e-02 9.295534536232757938e-02 9.295534536232757938e-02 -2.343750000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 5.976089392110423004e-02 5.976089392110423004e-02 5.976089392110423004e-02 -2.343750000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 8.777348266419915390e-02 8.777348266419915390e-02 8.777348266419915390e-02 -2.031250000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 8.200698224579107409e-02 8.200698224579107409e-02 8.200698224579107409e-02 -2.343750000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 9.815535623420516831e-02 9.815535623420516831e-02 9.815535623420516831e-02 -1.406250000000000000e-01 3.906250000000000000e-01 4.687500000000000000e-02 6.558284937861247332e-02 6.558284937861247332e-02 6.558284937861247332e-02 -1.406250000000000000e-01 4.218750000000000000e-01 4.687500000000000000e-02 8.862455901293679605e-02 8.862455901293679605e-02 8.862455901293679605e-02 -1.718750000000000000e-01 3.906250000000000000e-01 4.687500000000000000e-02 7.035972170237601853e-02 7.035972170237601853e-02 7.035972170237601853e-02 -1.718750000000000000e-01 4.218750000000000000e-01 1.562500000000000000e-02 7.983674218025449409e-02 7.983674218025449409e-02 7.983674218025449409e-02 -1.718750000000000000e-01 4.218750000000000000e-01 4.687500000000000000e-02 8.826934221698654048e-02 8.826934221698654048e-02 8.826934221698654048e-02 -1.406250000000000000e-01 3.906250000000000000e-01 7.812500000000000000e-02 3.430342087728652234e-02 3.430342087728652234e-02 3.430342087728652234e-02 -1.406250000000000000e-01 4.218750000000000000e-01 7.812500000000000000e-02 9.062403063152167648e-02 9.062403063152167648e-02 9.062403063152167648e-02 -1.718750000000000000e-01 4.531250000000000000e-01 1.562500000000000000e-02 9.466702258046952312e-02 9.466702258046952312e-02 9.466702258046952312e-02 -1.718750000000000000e-01 4.531250000000000000e-01 4.687500000000000000e-02 1.270060559946432077e-01 1.270060559946432077e-01 1.270060559946432077e-01 -1.718750000000000000e-01 4.843750000000000000e-01 4.687500000000000000e-02 9.708741665997053238e-02 9.708741665997053238e-02 9.708741665997053238e-02 -1.406250000000000000e-01 4.531250000000000000e-01 7.812500000000000000e-02 1.004840421307492820e-01 1.004840421307492820e-01 1.004840421307492820e-01 -1.406250000000000000e-01 4.843750000000000000e-01 7.812500000000000000e-02 9.616410758861507202e-02 9.616410758861507202e-02 9.616410758861507202e-02 -1.718750000000000000e-01 4.531250000000000000e-01 7.812500000000000000e-02 1.038451700352842899e-01 1.038451700352842899e-01 1.038451700352842899e-01 -1.718750000000000000e-01 4.843750000000000000e-01 7.812500000000000000e-02 1.009541103001544982e-01 1.009541103001544982e-01 1.009541103001544982e-01 -2.031250000000000000e-01 3.906250000000000000e-01 1.562500000000000000e-02 8.504579864866046446e-02 8.504579864866046446e-02 8.504579864866046446e-02 -2.031250000000000000e-01 3.906250000000000000e-01 4.687500000000000000e-02 6.749286063024727278e-02 6.749286063024727278e-02 6.749286063024727278e-02 -2.031250000000000000e-01 4.218750000000000000e-01 1.562500000000000000e-02 7.616555806078391389e-02 7.616555806078391389e-02 7.616555806078391389e-02 -2.031250000000000000e-01 4.531250000000000000e-01 1.562500000000000000e-02 1.012618628447768815e-01 1.012618628447768815e-01 1.012618628447768815e-01 -2.031250000000000000e-01 4.531250000000000000e-01 4.687500000000000000e-02 1.196308700740270486e-01 1.196308700740270486e-01 1.196308700740270486e-01 -2.031250000000000000e-01 4.843750000000000000e-01 1.562500000000000000e-02 1.187423639685316057e-01 1.187423639685316057e-01 1.187423639685316057e-01 -2.031250000000000000e-01 4.843750000000000000e-01 4.687500000000000000e-02 1.307074520700297615e-01 1.307074520700297615e-01 1.307074520700297615e-01 -2.031250000000000000e-01 4.843750000000000000e-01 7.812500000000000000e-02 1.121770762227491530e-01 1.121770762227491530e-01 1.121770762227491530e-01 -1.562500000000000000e-02 2.968750000000000000e-01 2.656250000000000000e-01 1.436248576817639733e-01 1.436248576817639733e-01 1.436248576817639733e-01 -4.687500000000000000e-02 2.968750000000000000e-01 2.656250000000000000e-01 1.952231871568590182e-01 1.952231871568590182e-01 1.952231871568590182e-01 -1.562500000000000000e-02 3.281250000000000000e-01 2.656250000000000000e-01 1.444159141144159553e-01 1.444159141144159553e-01 1.444159141144159553e-01 -4.687500000000000000e-02 3.281250000000000000e-01 2.656250000000000000e-01 1.718097763920702070e-01 1.718097763920702070e-01 1.718097763920702070e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.656250000000000000e-01 1.424394631270313460e-01 1.424394631270313460e-01 1.424394631270313460e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.968750000000000000e-01 1.037350898967469570e-01 1.037350898967469570e-01 1.037350898967469570e-01 -1.093750000000000000e-01 2.656250000000000000e-01 2.656250000000000000e-01 8.945312422184145684e-02 8.945312422184145684e-02 8.945312422184145684e-02 -1.093750000000000000e-01 2.656250000000000000e-01 2.968750000000000000e-01 9.081449217666584528e-02 9.081449217666584528e-02 9.081449217666584528e-02 -1.093750000000000000e-01 2.968750000000000000e-01 2.656250000000000000e-01 1.212158570530088991e-01 1.212158570530088991e-01 1.212158570530088991e-01 -1.093750000000000000e-01 2.968750000000000000e-01 2.968750000000000000e-01 8.771963711551002130e-02 8.771963711551002130e-02 8.771963711551002130e-02 -1.093750000000000000e-01 3.281250000000000000e-01 2.656250000000000000e-01 1.349331650564233043e-01 1.349331650564233043e-01 1.349331650564233043e-01 -1.406250000000000000e-01 2.656250000000000000e-01 2.968750000000000000e-01 8.038674226575960591e-02 8.038674226575960591e-02 8.038674226575960591e-02 -1.406250000000000000e-01 2.968750000000000000e-01 2.968750000000000000e-01 8.677853969197057982e-02 8.677853969197057982e-02 8.677853969197057982e-02 -1.718750000000000000e-01 2.656250000000000000e-01 2.968750000000000000e-01 8.166379211696409013e-02 8.166379211696409013e-02 8.166379211696409013e-02 -1.718750000000000000e-01 2.968750000000000000e-01 2.968750000000000000e-01 8.706866569055918270e-02 8.706866569055918270e-02 8.706866569055918270e-02 -1.406250000000000000e-01 3.281250000000000000e-01 2.656250000000000000e-01 1.294070026709486232e-01 1.294070026709486232e-01 1.294070026709486232e-01 -1.406250000000000000e-01 3.281250000000000000e-01 2.968750000000000000e-01 8.789081761559659756e-02 8.789081761559659756e-02 8.789081761559659756e-02 -1.718750000000000000e-01 3.281250000000000000e-01 2.656250000000000000e-01 1.203546819904335458e-01 1.203546819904335458e-01 1.203546819904335458e-01 -1.718750000000000000e-01 3.281250000000000000e-01 2.968750000000000000e-01 9.518132223546967030e-02 9.518132223546967030e-02 9.518132223546967030e-02 -2.031250000000000000e-01 2.656250000000000000e-01 2.656250000000000000e-01 9.471684550336678665e-02 9.471684550336678665e-02 9.471684550336678665e-02 -2.031250000000000000e-01 2.656250000000000000e-01 2.968750000000000000e-01 7.684965281910269286e-02 7.684965281910269286e-02 7.684965281910269286e-02 -2.031250000000000000e-01 2.968750000000000000e-01 2.656250000000000000e-01 1.301981989106673343e-01 1.301981989106673343e-01 1.301981989106673343e-01 -2.031250000000000000e-01 2.968750000000000000e-01 2.968750000000000000e-01 7.928754208422605920e-02 7.928754208422605920e-02 7.928754208422605920e-02 -2.031250000000000000e-01 3.281250000000000000e-01 2.656250000000000000e-01 1.153601668749446585e-01 1.153601668749446585e-01 1.153601668749446585e-01 -2.656250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.158285413673123820e-01 1.158285413673123820e-01 1.158285413673123820e-01 -2.656250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 2.294777449997069396e-01 2.294777449997069396e-01 2.294777449997069396e-01 -2.656250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.120573664190164520e-01 1.120573664190164520e-01 1.120573664190164520e-01 -2.656250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 1.834322463034864237e-01 1.834322463034864237e-01 1.834322463034864237e-01 -2.968750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.226843320741449889e-01 1.226843320741449889e-01 1.226843320741449889e-01 -2.968750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.171123394610764368e-01 1.171123394610764368e-01 1.171123394610764368e-01 -2.968750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.170295921414983426e-01 1.170295921414983426e-01 1.170295921414983426e-01 -2.656250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 8.308717768604684251e-02 8.308717768604684251e-02 8.308717768604684251e-02 -2.656250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 7.150011944650491724e-02 7.150011944650491724e-02 7.150011944650491724e-02 -2.656250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 1.354721062187172476e-01 1.354721062187172476e-01 1.354721062187172476e-01 -2.968750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 1.020870838314709983e-01 1.020870838314709983e-01 1.020870838314709983e-01 -2.968750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 8.183177060648508250e-02 8.183177060648508250e-02 8.183177060648508250e-02 -2.968750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.160599157535873588e-01 1.160599157535873588e-01 1.160599157535873588e-01 -2.656250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 1.026013360564142635e-01 1.026013360564142635e-01 1.026013360564142635e-01 -2.656250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 7.418485753061239418e-02 7.418485753061239418e-02 7.418485753061239418e-02 -2.656250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 1.462855069312904988e-01 1.462855069312904988e-01 1.462855069312904988e-01 -2.656250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 7.493238841700079755e-02 7.493238841700079755e-02 7.493238841700079755e-02 -2.656250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 8.068404456056406382e-02 8.068404456056406382e-02 8.068404456056406382e-02 -2.656250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 9.613196434914084154e-02 9.613196434914084154e-02 9.613196434914084154e-02 -3.281250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 9.318276748486457872e-02 9.318276748486457872e-02 9.318276748486457872e-02 -3.281250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 8.080621225726512813e-02 8.080621225726512813e-02 8.080621225726512813e-02 -3.281250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.153842685448676214e-01 1.153842685448676214e-01 1.153842685448676214e-01 -3.593750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 5.092714910943269002e-02 5.092714910943269002e-02 5.092714910943269002e-02 -3.593750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.376254252660282229e-01 1.376254252660282229e-01 1.376254252660282229e-01 -3.281250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 6.703216299177654214e-02 6.703216299177654214e-02 6.703216299177654214e-02 -3.281250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 5.132739563302721880e-02 5.132739563302721880e-02 5.132739563302721880e-02 -3.281250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.406308193536460471e-01 1.406308193536460471e-01 1.406308193536460471e-01 -3.593750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 6.726207001252330897e-02 6.726207001252330897e-02 6.726207001252330897e-02 -3.593750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.210206474689511508e-01 1.210206474689511508e-01 1.210206474689511508e-01 -3.281250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 1.066967555897558873e-01 1.066967555897558873e-01 1.066967555897558873e-01 -3.281250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 2.322943967963036482e-01 2.322943967963036482e-01 2.322943967963036482e-01 -3.593750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 1.165057916004743899e-01 1.165057916004743899e-01 1.165057916004743899e-01 -3.593750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 7.108767464821064141e-02 7.108767464821064141e-02 7.108767464821064141e-02 -3.281250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.652640727742790971e-01 1.652640727742790971e-01 1.652640727742790971e-01 -3.281250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 6.361089204065771552e-02 6.361089204065771552e-02 6.361089204065771552e-02 -3.281250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.084764344320786333e-01 1.084764344320786333e-01 1.084764344320786333e-01 -3.593750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.657835415408561441e-01 1.657835415408561441e-01 1.657835415408561441e-01 -3.593750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 6.402578687573451388e-02 6.402578687573451388e-02 6.402578687573451388e-02 -2.656250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 9.471523831277911532e-02 9.471523831277911532e-02 9.471523831277911532e-02 -2.656250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 9.296498871625943905e-02 9.296498871625943905e-02 9.296498871625943905e-02 -2.656250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 5.543459142806055756e-02 5.543459142806055756e-02 5.543459142806055756e-02 -2.968750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.129612112036346983e-01 1.129612112036346983e-01 1.129612112036346983e-01 -2.968750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 9.528016382376737481e-02 9.528016382376737481e-02 9.528016382376737481e-02 -2.968750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 3.401137975295342453e-01 3.401137975295342453e-01 3.401137975295342453e-01 -2.968750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 9.171295026301487519e-02 9.171295026301487519e-02 9.171295026301487519e-02 -2.656250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.381980811671622011e-01 1.381980811671622011e-01 1.381980811671622011e-01 -2.656250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.432586400902252088e-01 1.432586400902252088e-01 1.432586400902252088e-01 -2.968750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 1.110538859590404770e-01 1.110538859590404770e-01 1.110538859590404770e-01 -2.968750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.203852088759952421e-01 1.203852088759952421e-01 1.203852088759952421e-01 -2.968750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 9.374047131150083090e-02 9.374047131150083090e-02 9.374047131150083090e-02 -2.968750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.161233829168671489e-01 1.161233829168671489e-01 1.161233829168671489e-01 -2.968750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 2.525648027443163079e-01 2.525648027443163079e-01 2.525648027443163079e-01 -2.968750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.188733107832245367e-01 1.188733107832245367e-01 1.188733107832245367e-01 -2.968750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.323926232966515237e-01 1.323926232966515237e-01 1.323926232966515237e-01 -2.968750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.286230279609624216e-01 1.286230279609624216e-01 1.286230279609624216e-01 -2.656250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.324247520524524102e-01 1.324247520524524102e-01 1.324247520524524102e-01 -2.656250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 8.843087765120956345e-02 8.843087765120956345e-02 8.843087765120956345e-02 -2.968750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.188347497801654079e-01 1.188347497801654079e-01 1.188347497801654079e-01 -3.281250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 9.734054131713082425e-02 9.734054131713082425e-02 9.734054131713082425e-02 -3.281250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.267851556619428166e-01 1.267851556619428166e-01 1.267851556619428166e-01 -3.281250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 9.325509240678085676e-02 9.325509240678085676e-02 9.325509240678085676e-02 -3.593750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.011694568519055509e-01 1.011694568519055509e-01 1.011694568519055509e-01 -3.593750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.191946517565064950e-01 1.191946517565064950e-01 1.191946517565064950e-01 -3.593750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 9.072528872430554725e-02 9.072528872430554725e-02 9.072528872430554725e-02 -3.281250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 1.320705318107084636e-01 1.320705318107084636e-01 1.320705318107084636e-01 -3.281250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.261112050807813856e-01 1.261112050807813856e-01 1.261112050807813856e-01 -3.593750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 1.058667609801153681e-01 1.058667609801153681e-01 1.058667609801153681e-01 -3.593750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.022670724840966106e-01 1.022670724840966106e-01 1.022670724840966106e-01 -3.593750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.041979075667948812e-01 1.041979075667948812e-01 1.041979075667948812e-01 -3.593750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 9.828633656044570566e-02 9.828633656044570566e-02 9.828633656044570566e-02 -3.281250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 1.483084409431545125e-01 1.483084409431545125e-01 1.483084409431545125e-01 -3.281250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 6.730210270630974934e-02 6.730210270630974934e-02 6.730210270630974934e-02 -3.281250000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.033944029661771763e-01 1.033944029661771763e-01 1.033944029661771763e-01 -3.281250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 7.608003575972122068e-02 7.608003575972122068e-02 7.608003575972122068e-02 -3.593750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 7.595890580370463774e-02 7.595890580370463774e-02 7.595890580370463774e-02 -3.593750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 5.606491534543629751e-02 5.606491534543629751e-02 5.606491534543629751e-02 -3.593750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 8.626016792091951990e-02 8.626016792091951990e-02 8.626016792091951990e-02 -3.593750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 8.423004725056437714e-02 8.423004725056437714e-02 8.423004725056437714e-02 -3.593750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 9.030739736030830855e-02 9.030739736030830855e-02 9.030739736030830855e-02 -2.656250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 1.372077774381548487e-01 1.372077774381548487e-01 1.372077774381548487e-01 -2.656250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 6.240952589184699251e-02 6.240952589184699251e-02 6.240952589184699251e-02 -2.656250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.508436619698360626e-01 1.508436619698360626e-01 1.508436619698360626e-01 -2.656250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 2.688378067580458539e-02 2.688378067580458539e-02 2.688378067580458539e-02 -2.968750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 9.658357568642944591e-02 9.658357568642944591e-02 9.658357568642944591e-02 -2.968750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 4.358494954991058018e-02 4.358494954991058018e-02 4.358494954991058018e-02 -2.968750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.159707402876918869e-01 1.159707402876918869e-01 1.159707402876918869e-01 -2.968750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 6.387618059494980238e-02 6.387618059494980238e-02 6.387618059494980238e-02 -2.656250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 1.121441359589531311e-01 1.121441359589531311e-01 1.121441359589531311e-01 -2.656250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 1.030440724481884313e-01 1.030440724481884313e-01 1.030440724481884313e-01 -2.656250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 8.216933397463740962e-02 8.216933397463740962e-02 8.216933397463740962e-02 -2.656250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.078417002192138124e-01 1.078417002192138124e-01 1.078417002192138124e-01 -2.968750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 7.234485702606552326e-02 7.234485702606552326e-02 7.234485702606552326e-02 -2.968750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 9.737188050500117376e-02 9.737188050500117376e-02 9.737188050500117376e-02 -2.656250000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 1.620660945693497834e-01 1.620660945693497834e-01 1.620660945693497834e-01 -2.656250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 1.156019866360066539e-01 1.156019866360066539e-01 1.156019866360066539e-01 -2.656250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 1.336287679264059058e-01 1.336287679264059058e-01 1.336287679264059058e-01 -2.968750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 9.065697970744573952e-02 9.065697970744573952e-02 9.065697970744573952e-02 -2.968750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 1.565931861904011346e-01 1.565931861904011346e-01 1.565931861904011346e-01 -2.968750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 9.881186284186527224e-02 9.881186284186527224e-02 9.881186284186527224e-02 -2.968750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 8.837140693204049990e-02 8.837140693204049990e-02 8.837140693204049990e-02 -2.656250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 8.814156022582234074e-02 8.814156022582234074e-02 8.814156022582234074e-02 -2.656250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 1.051661199497609250e-01 1.051661199497609250e-01 1.051661199497609250e-01 -2.656250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 1.242636357988473189e-01 1.242636357988473189e-01 1.242636357988473189e-01 -3.281250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 1.016547880118950226e-01 1.016547880118950226e-01 1.016547880118950226e-01 -3.281250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 5.838010738355568774e-02 5.838010738355568774e-02 5.838010738355568774e-02 -3.281250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.025121456717658919e-01 1.025121456717658919e-01 1.025121456717658919e-01 -3.281250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 5.932587837291580096e-02 5.932587837291580096e-02 5.932587837291580096e-02 -3.593750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 6.340356440699333740e-02 6.340356440699333740e-02 6.340356440699333740e-02 -3.593750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 6.860604829310548713e-02 6.860604829310548713e-02 6.860604829310548713e-02 -3.593750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 6.003326985863632892e-02 6.003326985863632892e-02 6.003326985863632892e-02 -3.281250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 7.113453800109477421e-02 7.113453800109477421e-02 7.113453800109477421e-02 -3.281250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 9.269417075363005354e-02 9.269417075363005354e-02 9.269417075363005354e-02 -3.281250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 8.357181423073387072e-02 8.357181423073387072e-02 8.357181423073387072e-02 -3.593750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 6.347495141522466189e-02 6.347495141522466189e-02 6.347495141522466189e-02 -3.593750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 8.621355448172950131e-02 8.621355448172950131e-02 8.621355448172950131e-02 -3.593750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.015744353730617527e-01 1.015744353730617527e-01 1.015744353730617527e-01 -3.281250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 8.599897157704620987e-02 8.599897157704620987e-02 8.599897157704620987e-02 -3.593750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 8.576670703897687487e-02 8.576670703897687487e-02 8.576670703897687487e-02 -3.593750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 7.851859135089193920e-02 7.851859135089193920e-02 7.851859135089193920e-02 -3.593750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 9.358939342325327260e-02 9.358939342325327260e-02 9.358939342325327260e-02 -2.656250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 1.810072238740667860e-01 1.810072238740667860e-01 1.810072238740667860e-01 -2.656250000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 1.341388025733518397e-01 1.341388025733518397e-01 1.341388025733518397e-01 -2.656250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 2.296638668737358002e-01 2.296638668737358002e-01 2.296638668737358002e-01 -2.656250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.724415976806691619e-01 1.724415976806691619e-01 1.724415976806691619e-01 -2.968750000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 1.074166665355962974e-01 1.074166665355962974e-01 1.074166665355962974e-01 -2.968750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 7.358891771714071162e-02 7.358891771714071162e-02 7.358891771714071162e-02 -2.968750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 6.109141107648050767e-02 6.109141107648050767e-02 6.109141107648050767e-02 -2.968750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 8.218138978301768593e-02 8.218138978301768593e-02 8.218138978301768593e-02 -2.656250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 9.413021880899979932e-02 9.413021880899979932e-02 9.413021880899979932e-02 -2.656250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 1.366142318912370590e-01 1.366142318912370590e-01 1.366142318912370590e-01 -2.656250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 8.435140586404096807e-02 8.435140586404096807e-02 8.435140586404096807e-02 -2.968750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 1.174561817803086994e-01 1.174561817803086994e-01 1.174561817803086994e-01 -2.968750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 9.292962974617385852e-02 9.292962974617385852e-02 9.292962974617385852e-02 -2.968750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 7.448523717420173218e-02 7.448523717420173218e-02 7.448523717420173218e-02 -2.656250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 1.712927550261691689e-01 1.712927550261691689e-01 1.712927550261691689e-01 -2.656250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.507954798632468174e-01 1.507954798632468174e-01 1.507954798632468174e-01 -2.656250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.064533021047540662e-01 1.064533021047540662e-01 1.064533021047540662e-01 -2.968750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 1.093031883216095818e-01 1.093031883216095818e-01 1.093031883216095818e-01 -2.968750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.071916950570110244e-01 1.071916950570110244e-01 1.071916950570110244e-01 -2.968750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.220497099434421778e-01 1.220497099434421778e-01 1.220497099434421778e-01 -2.656250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.139028058157117163e-01 1.139028058157117163e-01 1.139028058157117163e-01 -2.656250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.318898065967605837e-01 1.318898065967605837e-01 1.318898065967605837e-01 -2.656250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 1.023506385073819497e-01 1.023506385073819497e-01 1.023506385073819497e-01 -2.968750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.131950040683191994e-01 1.131950040683191994e-01 1.131950040683191994e-01 -2.968750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.147246835729433673e-01 1.147246835729433673e-01 1.147246835729433673e-01 -2.968750000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 7.856271760302530049e-02 7.856271760302530049e-02 7.856271760302530049e-02 -3.281250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 9.163098044209053161e-02 9.163098044209053161e-02 9.163098044209053161e-02 -3.281250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 7.264918223662539254e-02 7.264918223662539254e-02 7.264918223662539254e-02 -3.281250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 7.906361718752187573e-02 7.906361718752187573e-02 7.906361718752187573e-02 -3.593750000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 6.992130693365856964e-02 6.992130693365856964e-02 6.992130693365856964e-02 -3.593750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 8.958411871616842048e-02 8.958411871616842048e-02 8.958411871616842048e-02 -3.593750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 7.842206006646125493e-02 7.842206006646125493e-02 7.842206006646125493e-02 -3.593750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.082715524170230620e-01 1.082715524170230620e-01 1.082715524170230620e-01 -3.281250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 9.404021543084110923e-02 9.404021543084110923e-02 9.404021543084110923e-02 -3.281250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 1.078979426934363467e-01 1.078979426934363467e-01 1.078979426934363467e-01 -3.593750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 8.067198852780921303e-02 8.067198852780921303e-02 8.067198852780921303e-02 -3.593750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 1.082892285330038645e-01 1.082892285330038645e-01 1.082892285330038645e-01 -3.593750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 9.535971916031853179e-02 9.535971916031853179e-02 9.535971916031853179e-02 -3.281250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 7.449448084361598443e-02 7.449448084361598443e-02 7.449448084361598443e-02 -3.281250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 4.263851103110641305e-02 4.263851103110641305e-02 4.263851103110641305e-02 -3.281250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 7.011969513740269611e-02 7.011969513740269611e-02 7.011969513740269611e-02 -3.593750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 7.709279401510270302e-02 7.709279401510270302e-02 7.709279401510270302e-02 -3.593750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.077203770337938626e-01 1.077203770337938626e-01 1.077203770337938626e-01 -3.593750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 9.401048214986398865e-02 9.401048214986398865e-02 9.401048214986398865e-02 -3.593750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.141968510218635685e-01 1.141968510218635685e-01 1.141968510218635685e-01 -3.281250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 9.512024932345725103e-02 9.512024932345725103e-02 9.512024932345725103e-02 -3.281250000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 6.456504245613488291e-02 6.456504245613488291e-02 6.456504245613488291e-02 -3.281250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 4.365450470281512924e-02 4.365450470281512924e-02 4.365450470281512924e-02 -3.593750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.110731683276032777e-01 1.110731683276032777e-01 1.110731683276032777e-01 -3.593750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.268574503830505740e-01 1.268574503830505740e-01 1.268574503830505740e-01 -3.593750000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 6.021600561864433321e-02 6.021600561864433321e-02 6.021600561864433321e-02 -3.906250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.965113370489540157e-01 1.965113370489540157e-01 1.965113370489540157e-01 -3.906250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.925071698912899920e-01 1.925071698912899920e-01 1.925071698912899920e-01 -3.906250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 7.614594581179222332e-02 7.614594581179222332e-02 7.614594581179222332e-02 -4.218750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.240748600266952939e-01 1.240748600266952939e-01 1.240748600266952939e-01 -4.218750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 8.806039042793363525e-02 8.806039042793363525e-02 8.806039042793363525e-02 -3.906250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 8.203270135339296720e-02 8.203270135339296720e-02 8.203270135339296720e-02 -3.906250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.297515956952250138e-01 1.297515956952250138e-01 1.297515956952250138e-01 -4.218750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 1.325147125004409177e-01 1.325147125004409177e-01 1.325147125004409177e-01 -4.218750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 8.895486100649659111e-02 8.895486100649659111e-02 8.895486100649659111e-02 -3.906250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 8.341830612203597617e-02 8.341830612203597617e-02 8.341830612203597617e-02 -3.906250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 9.201270193626925886e-02 9.201270193626925886e-02 9.201270193626925886e-02 -4.218750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 7.770341678047049117e-02 7.770341678047049117e-02 7.770341678047049117e-02 -4.218750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 7.832544829031866385e-02 7.832544829031866385e-02 7.832544829031866385e-02 -4.218750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 8.889780163492298770e-02 8.889780163492298770e-02 8.889780163492298770e-02 -4.218750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 9.868409759387547497e-02 9.868409759387547497e-02 9.868409759387547497e-02 -3.906250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 8.341268016484269798e-02 8.341268016484269798e-02 8.341268016484269798e-02 -3.906250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.011582074194556508e-01 1.011582074194556508e-01 1.011582074194556508e-01 -4.218750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 9.136176524658649878e-02 9.136176524658649878e-02 9.136176524658649878e-02 -4.218750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.009380396388594031e-01 1.009380396388594031e-01 1.009380396388594031e-01 -4.218750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.075620941923324803e-01 1.075620941923324803e-01 1.075620941923324803e-01 -4.218750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 9.322776966613297023e-02 9.322776966613297023e-02 9.322776966613297023e-02 -4.531250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 9.459389533130742322e-02 9.459389533130742322e-02 9.459389533130742322e-02 -4.531250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 5.715181051114941180e-02 5.715181051114941180e-02 5.715181051114941180e-02 -4.843750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.154043532642940045e-01 1.154043532642940045e-01 1.154043532642940045e-01 -4.843750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 7.456609915053463711e-02 7.456609915053463711e-02 7.456609915053463711e-02 -4.843750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 6.860661099238393734e-02 6.860661099238393734e-02 6.860661099238393734e-02 -4.531250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 1.255320368408824327e-01 1.255320368408824327e-01 1.255320368408824327e-01 -4.531250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 9.212681622076714094e-02 9.212681622076714094e-02 9.212681622076714094e-02 -4.531250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 9.845910169532733069e-02 9.845910169532733069e-02 9.845910169532733069e-02 -4.531250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 9.716777378026383860e-02 9.716777378026383860e-02 9.716777378026383860e-02 -4.531250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 7.596630060384522432e-02 7.596630060384522432e-02 7.596630060384522432e-02 -4.531250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 5.307919447278582059e-02 5.307919447278582059e-02 5.307919447278582059e-02 -4.843750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 7.336377124621576429e-02 7.336377124621576429e-02 7.336377124621576429e-02 -4.843750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 5.871897509486807831e-02 5.871897509486807831e-02 5.871897509486807831e-02 -3.906250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 7.505995025194564518e-02 7.505995025194564518e-02 7.505995025194564518e-02 -3.906250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 9.090369553010421710e-02 9.090369553010421710e-02 9.090369553010421710e-02 -4.218750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 6.719004326829171314e-02 6.719004326829171314e-02 6.719004326829171314e-02 -3.906250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 9.545614976578850608e-02 9.545614976578850608e-02 9.545614976578850608e-02 -3.906250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 8.255994124727847328e-02 8.255994124727847328e-02 8.255994124727847328e-02 -3.906250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 6.264812841220114559e-02 6.264812841220114559e-02 6.264812841220114559e-02 -3.906250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 8.386034438586585649e-02 8.386034438586585649e-02 8.386034438586585649e-02 -3.906250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 6.094831119371242611e-02 6.094831119371242611e-02 6.094831119371242611e-02 -3.906250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 7.779158977830359645e-02 7.779158977830359645e-02 7.779158977830359645e-02 -4.531250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 9.002049760952983426e-02 9.002049760952983426e-02 9.002049760952983426e-02 -3.906250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 5.468921094340018635e-02 5.468921094340018635e-02 5.468921094340018635e-02 -3.906250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 5.950604310910328348e-02 5.950604310910328348e-02 5.950604310910328348e-02 -3.906250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 6.111633294016078494e-02 6.111633294016078494e-02 6.111633294016078494e-02 -4.218750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 8.369397754249227606e-02 8.369397754249227606e-02 8.369397754249227606e-02 -4.218750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 7.418767083191582512e-02 7.418767083191582512e-02 7.418767083191582512e-02 -4.218750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 8.818736888750507152e-02 8.818736888750507152e-02 8.818736888750507152e-02 -4.218750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.143454800204598276e-01 1.143454800204598276e-01 1.143454800204598276e-01 -3.906250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 5.094435540915289579e-02 5.094435540915289579e-02 5.094435540915289579e-02 -3.906250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 8.658646123918534165e-02 8.658646123918534165e-02 8.658646123918534165e-02 -3.906250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.331364007039018416e-01 1.331364007039018416e-01 1.331364007039018416e-01 -4.218750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 1.244732968819685787e-01 1.244732968819685787e-01 1.244732968819685787e-01 -4.218750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 1.294029864265218988e-01 1.294029864265218988e-01 1.294029864265218988e-01 -4.218750000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 1.431397796363991504e-01 1.431397796363991504e-01 1.431397796363991504e-01 -4.218750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.348343721716291355e-01 1.348343721716291355e-01 1.348343721716291355e-01 -3.906250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 9.342304669685563834e-02 9.342304669685563834e-02 9.342304669685563834e-02 -4.218750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 8.908023075121927759e-02 8.908023075121927759e-02 8.908023075121927759e-02 -4.218750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 9.617696488080189343e-02 9.617696488080189343e-02 9.617696488080189343e-02 -4.218750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 7.852325314187205696e-02 7.852325314187205696e-02 7.852325314187205696e-02 -4.218750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 1.032505747958946812e-01 1.032505747958946812e-01 1.032505747958946812e-01 -3.906250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 9.327920069963210881e-02 9.327920069963210881e-02 9.327920069963210881e-02 -3.906250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 9.255835962202792200e-02 9.255835962202792200e-02 9.255835962202792200e-02 -4.218750000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 1.352199046935298188e-01 1.352199046935298188e-01 1.352199046935298188e-01 -4.218750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 1.142322006464134981e-01 1.142322006464134981e-01 1.142322006464134981e-01 -4.218750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 8.930766382790021607e-02 8.930766382790021607e-02 8.930766382790021607e-02 -4.531250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 9.910596320771725143e-02 9.910596320771725143e-02 9.910596320771725143e-02 -4.531250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 1.250998669775294225e-01 1.250998669775294225e-01 1.250998669775294225e-01 -4.531250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 7.641882892846571518e-02 7.641882892846571518e-02 7.641882892846571518e-02 -4.531250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 1.124285465726483080e-01 1.124285465726483080e-01 1.124285465726483080e-01 -3.906250000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 6.242359445629661052e-02 6.242359445629661052e-02 6.242359445629661052e-02 -3.906250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 7.847607258959277132e-02 7.847607258959277132e-02 7.847607258959277132e-02 -3.906250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 9.895248473561743530e-02 9.895248473561743530e-02 9.895248473561743530e-02 -3.906250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 9.154177789500619888e-02 9.154177789500619888e-02 9.154177789500619888e-02 -3.906250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.211282939648304913e-01 1.211282939648304913e-01 1.211282939648304913e-01 -3.906250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.056192875516663160e-01 1.056192875516663160e-01 1.056192875516663160e-01 -2.968750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 1.044662763156783136e-01 1.044662763156783136e-01 1.044662763156783136e-01 -2.656250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 1.363885388630179107e-01 1.363885388630179107e-01 1.363885388630179107e-01 -2.656250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.243672614599311693e-01 1.243672614599311693e-01 1.243672614599311693e-01 -2.968750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 1.093738918556196593e-01 1.093738918556196593e-01 1.093738918556196593e-01 -2.968750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.658879166225111779e-01 1.658879166225111779e-01 1.658879166225111779e-01 -3.281250000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 1.136794592852309882e-01 1.136794592852309882e-01 1.136794592852309882e-01 -3.593750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 7.576045161961979246e-02 7.576045161961979246e-02 7.576045161961979246e-02 -3.281250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 1.202237375868101810e-01 1.202237375868101810e-01 1.202237375868101810e-01 -3.281250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.353010269264224574e-01 1.353010269264224574e-01 1.353010269264224574e-01 -3.593750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 7.385369108990076648e-02 7.385369108990076648e-02 7.385369108990076648e-02 -3.593750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 8.011483709644465212e-02 8.011483709644465212e-02 8.011483709644465212e-02 -2.656250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 1.382944604412380540e-01 1.382944604412380540e-01 1.382944604412380540e-01 -2.968750000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 1.258075639992091432e-01 1.258075639992091432e-01 1.258075639992091432e-01 -3.281250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 1.402501316036033896e-01 1.402501316036033896e-01 1.402501316036033896e-01 -2.656250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 1.567096178413367735e-01 1.567096178413367735e-01 1.567096178413367735e-01 -2.656250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 8.239035684128696857e-02 8.239035684128696857e-02 8.239035684128696857e-02 -2.968750000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 7.829659333634594875e-02 7.829659333634594875e-02 7.829659333634594875e-02 -2.968750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 7.668319110052319865e-02 7.668319110052319865e-02 7.668319110052319865e-02 -2.968750000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 6.207766784065395227e-02 6.207766784065395227e-02 6.207766784065395227e-02 -2.968750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 7.089153956458295325e-02 7.089153956458295325e-02 7.089153956458295325e-02 -2.656250000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 9.848963688989956222e-02 9.848963688989956222e-02 9.848963688989956222e-02 -2.656250000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 6.308569851354163538e-02 6.308569851354163538e-02 6.308569851354163538e-02 -2.968750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 7.974913404511196902e-02 7.974913404511196902e-02 7.974913404511196902e-02 -2.656250000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 8.037340020676858598e-02 8.037340020676858598e-02 8.037340020676858598e-02 -2.656250000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 6.781352263616825804e-02 6.781352263616825804e-02 6.781352263616825804e-02 -2.968750000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 1.012763263818808740e-01 1.012763263818808740e-01 1.012763263818808740e-01 -2.968750000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 9.021658606526583579e-02 9.021658606526583579e-02 9.021658606526583579e-02 -2.968750000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 6.300450343297968325e-02 6.300450343297968325e-02 6.300450343297968325e-02 -2.968750000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 6.598881095188789681e-02 6.598881095188789681e-02 6.598881095188789681e-02 -3.281250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 1.134537019102892785e-01 1.134537019102892785e-01 1.134537019102892785e-01 -3.281250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 8.466966996761775277e-02 8.466966996761775277e-02 8.466966996761775277e-02 -3.281250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 7.522086917803091910e-02 7.522086917803091910e-02 7.522086917803091910e-02 -3.593750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 1.047916923103386910e-01 1.047916923103386910e-01 1.047916923103386910e-01 -3.593750000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 1.103500763433449966e-01 1.103500763433449966e-01 1.103500763433449966e-01 -3.593750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 6.531065300627075798e-02 6.531065300627075798e-02 6.531065300627075798e-02 -3.281250000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 8.454670444048423272e-02 8.454670444048423272e-02 8.454670444048423272e-02 -3.281250000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 5.856903736306251496e-02 5.856903736306251496e-02 5.856903736306251496e-02 -3.593750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 8.627624151439299005e-02 8.627624151439299005e-02 8.627624151439299005e-02 -3.593750000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 9.035963389951680302e-02 9.035963389951680302e-02 9.035963389951680302e-02 -3.593750000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 7.720339287466566891e-02 7.720339287466566891e-02 7.720339287466566891e-02 -3.593750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 7.491864355693629574e-02 7.491864355693629574e-02 7.491864355693629574e-02 -3.281250000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 6.049818804908951159e-02 6.049818804908951159e-02 6.049818804908951159e-02 -2.656250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 8.354046966688433162e-02 8.354046966688433162e-02 8.354046966688433162e-02 -2.656250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 9.860856332666396995e-02 9.860856332666396995e-02 9.860856332666396995e-02 -2.968750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.554633889377388944e-01 1.554633889377388944e-01 1.554633889377388944e-01 -2.656250000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 7.567934970806423911e-02 7.567934970806423911e-02 7.567934970806423911e-02 -2.656250000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 7.085392015782072950e-02 7.085392015782072950e-02 7.085392015782072950e-02 -2.968750000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 6.157457228331146559e-02 6.157457228331146559e-02 6.157457228331146559e-02 -2.968750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 8.675121475177426100e-02 8.675121475177426100e-02 8.675121475177426100e-02 -2.968750000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 5.370535601788536950e-02 5.370535601788536950e-02 5.370535601788536950e-02 -2.656250000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 7.427343628440821743e-02 7.427343628440821743e-02 7.427343628440821743e-02 -2.656250000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 1.126133325907457683e-01 1.126133325907457683e-01 1.126133325907457683e-01 -2.968750000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 1.166512028288018699e-01 1.166512028288018699e-01 1.166512028288018699e-01 -2.968750000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 1.474106146583284149e-01 1.474106146583284149e-01 1.474106146583284149e-01 -2.656250000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 9.813044584126608127e-02 9.813044584126608127e-02 9.813044584126608127e-02 -2.656250000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 5.849426938167196638e-02 5.849426938167196638e-02 5.849426938167196638e-02 -2.968750000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 8.734593194142330208e-02 8.734593194142330208e-02 8.734593194142330208e-02 -3.281250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.369869051142546812e-01 1.369869051142546812e-01 1.369869051142546812e-01 -3.281250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 1.000774510374248527e-01 1.000774510374248527e-01 1.000774510374248527e-01 -3.593750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 4.540775715794941048e-02 4.540775715794941048e-02 4.540775715794941048e-02 -3.593750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 6.050220773467464980e-02 6.050220773467464980e-02 6.050220773467464980e-02 -3.593750000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 7.903034186252906601e-02 7.903034186252906601e-02 7.903034186252906601e-02 -3.281250000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 5.065313427051048450e-02 5.065313427051048450e-02 5.065313427051048450e-02 -3.281250000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 7.384991321245489015e-02 7.384991321245489015e-02 7.384991321245489015e-02 -3.281250000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 4.789058159922893187e-02 4.789058159922893187e-02 4.789058159922893187e-02 -3.593750000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 8.514465268969910461e-02 8.514465268969910461e-02 8.514465268969910461e-02 -3.593750000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 6.271348672844261063e-02 6.271348672844261063e-02 6.271348672844261063e-02 -3.593750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 7.493021817611006385e-02 7.493021817611006385e-02 7.493021817611006385e-02 -3.281250000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 1.155553901937273337e-01 1.155553901937273337e-01 1.155553901937273337e-01 -3.281250000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 1.253721824593627965e-01 1.253721824593627965e-01 1.253721824593627965e-01 -3.906250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 7.529964056297502872e-02 7.529964056297502872e-02 7.529964056297502872e-02 -3.906250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 1.236997170711293115e-01 1.236997170711293115e-01 1.236997170711293115e-01 -4.218750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 8.735477229892051054e-02 8.735477229892051054e-02 8.735477229892051054e-02 -4.218750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 4.403508691983665929e-02 4.403508691983665929e-02 4.403508691983665929e-02 -3.906250000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 1.261433363451152645e-01 1.261433363451152645e-01 1.261433363451152645e-01 -4.531250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 7.393133848935462549e-02 7.393133848935462549e-02 7.393133848935462549e-02 -3.906250000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 6.789479324992060694e-02 6.789479324992060694e-02 6.789479324992060694e-02 -3.906250000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 1.170946652834632951e-01 1.170946652834632951e-01 1.170946652834632951e-01 -3.906250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 8.269094696548837109e-02 8.269094696548837109e-02 8.269094696548837109e-02 -3.906250000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 9.701589875540718444e-02 9.701589875540718444e-02 9.701589875540718444e-02 -1.093750000000000000e-01 5.156250000000000000e-01 1.562500000000000000e-02 8.667325825371344217e-02 8.667325825371344217e-02 8.667325825371344217e-02 -1.093750000000000000e-01 5.156250000000000000e-01 4.687500000000000000e-02 7.284185663615615203e-02 7.284185663615615203e-02 7.284185663615615203e-02 -1.093750000000000000e-01 5.468750000000000000e-01 1.562500000000000000e-02 9.496113809813379325e-02 9.496113809813379325e-02 9.496113809813379325e-02 -1.093750000000000000e-01 5.468750000000000000e-01 4.687500000000000000e-02 7.537656315730190126e-02 7.537656315730190126e-02 7.537656315730190126e-02 -1.093750000000000000e-01 5.156250000000000000e-01 7.812500000000000000e-02 7.365595513797801308e-02 7.365595513797801308e-02 7.365595513797801308e-02 -1.093750000000000000e-01 5.468750000000000000e-01 7.812500000000000000e-02 7.609177096807398510e-02 7.609177096807398510e-02 7.609177096807398510e-02 -1.406250000000000000e-01 5.468750000000000000e-01 1.562500000000000000e-02 9.893239590869842837e-02 9.893239590869842837e-02 9.893239590869842837e-02 -1.406250000000000000e-01 5.468750000000000000e-01 4.687500000000000000e-02 8.149742073139282228e-02 8.149742073139282228e-02 8.149742073139282228e-02 -1.406250000000000000e-01 5.156250000000000000e-01 7.812500000000000000e-02 6.893522670281329590e-02 6.893522670281329590e-02 6.893522670281329590e-02 -1.406250000000000000e-01 5.156250000000000000e-01 1.093750000000000000e-01 4.861439597255338974e-02 4.861439597255338974e-02 4.861439597255338974e-02 -1.406250000000000000e-01 5.468750000000000000e-01 7.812500000000000000e-02 7.819724862457021197e-02 7.819724862457021197e-02 7.819724862457021197e-02 -1.406250000000000000e-01 5.468750000000000000e-01 1.093750000000000000e-01 5.285423180323038650e-02 5.285423180323038650e-02 5.285423180323038650e-02 -1.718750000000000000e-01 5.156250000000000000e-01 1.093750000000000000e-01 5.244908836832181537e-02 5.244908836832181537e-02 5.244908836832181537e-02 -1.718750000000000000e-01 5.468750000000000000e-01 1.093750000000000000e-01 5.302178804719672595e-02 5.302178804719672595e-02 5.302178804719672595e-02 -1.406250000000000000e-01 5.781250000000000000e-01 1.562500000000000000e-02 5.400524933087684498e-02 5.400524933087684498e-02 5.400524933087684498e-02 -1.406250000000000000e-01 5.781250000000000000e-01 4.687500000000000000e-02 8.077245541226142633e-02 8.077245541226142633e-02 8.077245541226142633e-02 -1.406250000000000000e-01 6.093750000000000000e-01 1.562500000000000000e-02 3.100324245604188511e-02 3.100324245604188511e-02 3.100324245604188511e-02 -1.718750000000000000e-01 5.781250000000000000e-01 1.562500000000000000e-02 5.627788974675484307e-02 5.627788974675484307e-02 5.627788974675484307e-02 -1.718750000000000000e-01 5.781250000000000000e-01 4.687500000000000000e-02 5.906965946555260694e-02 5.906965946555260694e-02 5.906965946555260694e-02 -1.718750000000000000e-01 6.093750000000000000e-01 1.562500000000000000e-02 4.581583075434949442e-02 4.581583075434949442e-02 4.581583075434949442e-02 -1.718750000000000000e-01 6.093750000000000000e-01 4.687500000000000000e-02 3.777056944300316577e-02 3.777056944300316577e-02 3.777056944300316577e-02 -1.406250000000000000e-01 5.781250000000000000e-01 7.812500000000000000e-02 6.296205686317941919e-02 6.296205686317941919e-02 6.296205686317941919e-02 -1.718750000000000000e-01 5.781250000000000000e-01 7.812500000000000000e-02 5.187590219876765663e-02 5.187590219876765663e-02 5.187590219876765663e-02 -1.718750000000000000e-01 6.093750000000000000e-01 7.812500000000000000e-02 3.273529809819492042e-02 3.273529809819492042e-02 3.273529809819492042e-02 -2.031250000000000000e-01 5.156250000000000000e-01 1.562500000000000000e-02 7.996887757242993056e-02 7.996887757242993056e-02 7.996887757242993056e-02 -2.031250000000000000e-01 5.156250000000000000e-01 4.687500000000000000e-02 1.240467444482561826e-01 1.240467444482561826e-01 1.240467444482561826e-01 -2.343750000000000000e-01 5.156250000000000000e-01 1.562500000000000000e-02 7.696981690697957124e-02 7.696981690697957124e-02 7.696981690697957124e-02 -2.343750000000000000e-01 5.156250000000000000e-01 4.687500000000000000e-02 8.357342164392536632e-02 8.357342164392536632e-02 8.357342164392536632e-02 -2.343750000000000000e-01 5.468750000000000000e-01 4.687500000000000000e-02 9.037088484196846572e-02 9.037088484196846572e-02 9.037088484196846572e-02 -2.031250000000000000e-01 5.156250000000000000e-01 7.812500000000000000e-02 1.255135612250850019e-01 1.255135612250850019e-01 1.255135612250850019e-01 -2.031250000000000000e-01 5.156250000000000000e-01 1.093750000000000000e-01 6.971496017514670906e-02 6.971496017514670906e-02 6.971496017514670906e-02 -2.031250000000000000e-01 5.468750000000000000e-01 7.812500000000000000e-02 8.343196915928076385e-02 8.343196915928076385e-02 8.343196915928076385e-02 -2.031250000000000000e-01 5.468750000000000000e-01 1.093750000000000000e-01 6.736142822795046503e-02 6.736142822795046503e-02 6.736142822795046503e-02 -2.343750000000000000e-01 5.156250000000000000e-01 7.812500000000000000e-02 1.102102778100290115e-01 1.102102778100290115e-01 1.102102778100290115e-01 -2.343750000000000000e-01 5.468750000000000000e-01 7.812500000000000000e-02 6.954406253701332641e-02 6.954406253701332641e-02 6.954406253701332641e-02 -2.031250000000000000e-01 6.093750000000000000e-01 1.562500000000000000e-02 3.731919076875372249e-02 3.731919076875372249e-02 3.731919076875372249e-02 -2.031250000000000000e-01 6.093750000000000000e-01 4.687500000000000000e-02 4.132907849848135168e-02 4.132907849848135168e-02 4.132907849848135168e-02 -2.343750000000000000e-01 5.781250000000000000e-01 1.562500000000000000e-02 5.786155260662048661e-02 5.786155260662048661e-02 5.786155260662048661e-02 -2.343750000000000000e-01 5.781250000000000000e-01 4.687500000000000000e-02 6.368412784715725417e-02 6.368412784715725417e-02 6.368412784715725417e-02 -2.343750000000000000e-01 6.093750000000000000e-01 1.562500000000000000e-02 4.345186987013278240e-02 4.345186987013278240e-02 4.345186987013278240e-02 -2.343750000000000000e-01 6.093750000000000000e-01 4.687500000000000000e-02 4.003160636571428260e-02 4.003160636571428260e-02 4.003160636571428260e-02 -2.031250000000000000e-01 5.781250000000000000e-01 7.812500000000000000e-02 4.774456360239430486e-02 4.774456360239430486e-02 4.774456360239430486e-02 -2.031250000000000000e-01 6.093750000000000000e-01 7.812500000000000000e-02 3.372278715332967941e-02 3.372278715332967941e-02 3.372278715332967941e-02 -2.343750000000000000e-01 5.781250000000000000e-01 7.812500000000000000e-02 5.364312600537493592e-02 5.364312600537493592e-02 5.364312600537493592e-02 -2.343750000000000000e-01 6.093750000000000000e-01 7.812500000000000000e-02 3.281716710348947519e-02 3.281716710348947519e-02 3.281716710348947519e-02 -2.656250000000000000e-01 5.156250000000000000e-01 1.562500000000000000e-02 6.066846175482840803e-02 6.066846175482840803e-02 6.066846175482840803e-02 -2.656250000000000000e-01 5.156250000000000000e-01 4.687500000000000000e-02 5.639703939237279001e-02 5.639703939237279001e-02 5.639703939237279001e-02 -2.656250000000000000e-01 5.468750000000000000e-01 1.562500000000000000e-02 9.508569489217566506e-02 9.508569489217566506e-02 9.508569489217566506e-02 -2.656250000000000000e-01 5.468750000000000000e-01 4.687500000000000000e-02 8.563972475888619040e-02 8.563972475888619040e-02 8.563972475888619040e-02 -2.656250000000000000e-01 5.781250000000000000e-01 1.562500000000000000e-02 6.160889993253349656e-02 6.160889993253349656e-02 6.160889993253349656e-02 -2.656250000000000000e-01 5.781250000000000000e-01 4.687500000000000000e-02 6.451069903428327534e-02 6.451069903428327534e-02 6.451069903428327534e-02 -5.156250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 9.522873406940352004e-02 9.522873406940352004e-02 9.522873406940352004e-02 -5.156250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 7.666438275334529207e-02 7.666438275334529207e-02 7.666438275334529207e-02 -5.156250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 7.641915043970079480e-02 7.641915043970079480e-02 7.641915043970079480e-02 -5.156250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 5.538940730451159117e-02 5.538940730451159117e-02 5.538940730451159117e-02 -5.468750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.196541671183774941e-01 1.196541671183774941e-01 1.196541671183774941e-01 -5.468750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 9.208342066686933669e-02 9.208342066686933669e-02 9.208342066686933669e-02 -5.156250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 6.659943761097349146e-02 6.659943761097349146e-02 6.659943761097349146e-02 -5.781250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.067361258861275197e-01 1.067361258861275197e-01 1.067361258861275197e-01 diff --git a/tensorflow/script/ocnn_lrp_results/molecule_heatmap-1_filt.ply b/tensorflow/script/ocnn_lrp_results/molecule_heatmap-1_filt.ply deleted file mode 100644 index b417448..0000000 --- a/tensorflow/script/ocnn_lrp_results/molecule_heatmap-1_filt.ply +++ /dev/null @@ -1,6985 +0,0 @@ -ply -format ascii 1.0 -element vertex 6973 -property float x -property float y -property float z -property float nx -property float ny -property float nz -element face 0 -property list uchar int vertex_indices -end_header -14.088999999999999 18.2851 19.9071 0.075390468696817 0.075390468696817 0.075390468696817 -14.088999999999999 18.2851 20.9071 0.11750197375398513 0.11750197375398513 0.11750197375398513 -14.088999999999999 18.2851 21.9071 0.1641576814399686 0.1641576814399686 0.1641576814399686 -14.088999999999999 18.2851 22.9071 0.11119287959575685 0.11119287959575685 0.11119287959575685 -15.088999999999999 18.2851 19.9071 0.09077350681894854 0.09077350681894854 0.09077350681894854 -15.088999999999999 18.2851 20.9071 0.10891833504122034 0.10891833504122034 0.10891833504122034 -15.088999999999999 18.2851 21.9071 0.13940682953997424 0.13940682953997424 0.13940682953997424 -15.088999999999999 18.2851 22.9071 0.10221805775699419 0.10221805775699419 0.10221805775699419 -16.089 18.2851 21.9071 0.09864311624493516 0.09864311624493516 0.09864311624493516 -16.089 18.2851 22.9071 0.12209951591193385 0.12209951591193385 0.12209951591193385 -14.088999999999999 19.2851 18.9071 0.09290230689501444 0.09290230689501444 0.09290230689501444 -14.088999999999999 20.2851 18.9071 0.11440171794832178 0.11440171794832178 0.11440171794832178 -14.088999999999999 21.2851 18.9071 0.10069938994070356 0.10069938994070356 0.10069938994070356 -15.088999999999999 19.2851 18.9071 0.0981641954040358 0.0981641954040358 0.0981641954040358 -15.088999999999999 20.2851 18.9071 0.11574739949787798 0.11574739949787798 0.11574739949787798 -16.089 19.2851 18.9071 0.07788490676557656 0.07788490676557656 0.07788490676557656 -16.089 20.2851 18.9071 0.09781625280378538 0.09781625280378538 0.09781625280378538 -15.088999999999999 21.2851 18.9071 0.11951518809871059 0.11951518809871059 0.11951518809871059 -16.089 21.2851 18.9071 0.09699580944493082 0.09699580944493082 0.09699580944493082 -9.088999999999999 20.2851 20.9071 0.05403371099740653 0.05403371099740653 0.05403371099740653 -10.088999999999999 19.2851 20.9071 0.05058020821570668 0.05058020821570668 0.05058020821570668 -10.088999999999999 20.2851 20.9071 0.04910840639823603 0.04910840639823603 0.04910840639823603 -9.088999999999999 19.2851 21.9071 0.03195705585947524 0.03195705585947524 0.03195705585947524 -9.088999999999999 19.2851 22.9071 0.028180178040921187 0.028180178040921187 0.028180178040921187 -9.088999999999999 20.2851 21.9071 0.05135256172998134 0.05135256172998134 0.05135256172998134 -9.088999999999999 20.2851 22.9071 0.03901186784339425 0.03901186784339425 0.03901186784339425 -10.088999999999999 19.2851 21.9071 0.051893751514084825 0.051893751514084825 0.051893751514084825 -10.088999999999999 19.2851 22.9071 0.042517571950856044 0.042517571950856044 0.042517571950856044 -9.088999999999999 21.2851 20.9071 0.04709656534062948 0.04709656534062948 0.04709656534062948 -10.088999999999999 21.2851 20.9071 0.0 0.0 0.0 -10.088999999999999 22.2851 20.9071 0.06430771477449196 0.06430771477449196 0.06430771477449196 -9.088999999999999 21.2851 21.9071 0.05130584765875142 0.05130584765875142 0.05130584765875142 -9.088999999999999 21.2851 22.9071 0.03341300689274473 0.03341300689274473 0.03341300689274473 -9.088999999999999 22.2851 21.9071 0.03214677169660658 0.03214677169660658 0.03214677169660658 -9.088999999999999 22.2851 22.9071 0.02910812803952768 0.02910812803952768 0.02910812803952768 -10.088999999999999 22.2851 21.9071 0.045987180843518154 0.045987180843518154 0.045987180843518154 -10.088999999999999 22.2851 22.9071 0.04718396781792828 0.04718396781792828 0.04718396781792828 -11.088999999999999 19.2851 20.9071 0.05462521290107958 0.05462521290107958 0.05462521290107958 -11.088999999999999 20.2851 20.9071 0.08326399401074855 0.08326399401074855 0.08326399401074855 -12.088999999999999 19.2851 20.9071 0.07944009357724872 0.07944009357724872 0.07944009357724872 -12.088999999999999 20.2851 19.9071 0.08314022262425974 0.08314022262425974 0.08314022262425974 -12.088999999999999 20.2851 20.9071 0.09597446229008486 0.09597446229008486 0.09597446229008486 -11.088999999999999 19.2851 21.9071 0.056466905060691436 0.056466905060691436 0.056466905060691436 -11.088999999999999 19.2851 22.9071 0.04316608956008198 0.04316608956008198 0.04316608956008198 -11.088999999999999 20.2851 21.9071 0.06482566527978557 0.06482566527978557 0.06482566527978557 -12.088999999999999 19.2851 21.9071 0.07500087154446441 0.07500087154446441 0.07500087154446441 -12.088999999999999 19.2851 22.9071 0.07545091355738329 0.07545091355738329 0.07545091355738329 -12.088999999999999 20.2851 22.9071 0.07677289238809258 0.07677289238809258 0.07677289238809258 -11.088999999999999 21.2851 20.9071 0.05859460317302752 0.05859460317302752 0.05859460317302752 -11.088999999999999 22.2851 20.9071 0.062432196377354476 0.062432196377354476 0.062432196377354476 -12.088999999999999 21.2851 19.9071 0.05223650584117988 0.05223650584117988 0.05223650584117988 -12.088999999999999 22.2851 19.9071 0.061115127043698744 0.061115127043698744 0.061115127043698744 -11.088999999999999 22.2851 21.9071 0.05004914051998748 0.05004914051998748 0.05004914051998748 -12.088999999999999 22.2851 22.9071 0.06773490469432279 0.06773490469432279 0.06773490469432279 -9.088999999999999 20.2851 23.9071 0.02561269742777865 0.02561269742777865 0.02561269742777865 -10.088999999999999 20.2851 23.9071 0.031225612274659753 0.031225612274659753 0.031225612274659753 -10.088999999999999 21.2851 23.9071 0.03269910843276819 0.03269910843276819 0.03269910843276819 -10.088999999999999 22.2851 23.9071 0.0446614796764942 0.0446614796764942 0.0446614796764942 -11.088999999999999 20.2851 23.9071 0.06050550387671496 0.06050550387671496 0.06050550387671496 -12.088999999999999 20.2851 23.9071 0.08401224424675746 0.08401224424675746 0.08401224424675746 -11.088999999999999 21.2851 23.9071 0.06285344820861408 0.06285344820861408 0.06285344820861408 -11.088999999999999 22.2851 23.9071 0.05954656203035947 0.05954656203035947 0.05954656203035947 -12.088999999999999 21.2851 23.9071 0.08768427584005889 0.08768427584005889 0.08768427584005889 -12.088999999999999 22.2851 23.9071 0.07309939816674427 0.07309939816674427 0.07309939816674427 -12.088999999999999 22.2851 24.9071 0.07098148845942286 0.07098148845942286 0.07098148845942286 -10.088999999999999 24.2851 20.9071 0.07378408165981773 0.07378408165981773 0.07378408165981773 -10.088999999999999 24.2851 21.9071 0.08179319184565938 0.08179319184565938 0.08179319184565938 -10.088999999999999 24.2851 22.9071 0.0609237912444441 0.0609237912444441 0.0609237912444441 -10.088999999999999 25.2851 20.9071 0.08047828802049517 0.08047828802049517 0.08047828802049517 -10.088999999999999 26.2851 20.9071 0.07765896855075938 0.07765896855075938 0.07765896855075938 -10.088999999999999 25.2851 21.9071 0.116758051795937 0.116758051795937 0.116758051795937 -10.088999999999999 25.2851 22.9071 0.1067160390026334 0.1067160390026334 0.1067160390026334 -10.088999999999999 26.2851 21.9071 0.11039506892307846 0.11039506892307846 0.11039506892307846 -10.088999999999999 26.2851 22.9071 0.10227028656351822 0.10227028656351822 0.10227028656351822 -11.088999999999999 23.2851 20.9071 0.07631377506646458 0.07631377506646458 0.07631377506646458 -11.088999999999999 24.2851 20.9071 0.07712639164985303 0.07712639164985303 0.07712639164985303 -12.088999999999999 23.2851 19.9071 0.05623696718941598 0.05623696718941598 0.05623696718941598 -12.088999999999999 23.2851 20.9071 0.05731686550145202 0.05731686550145202 0.05731686550145202 -12.088999999999999 24.2851 20.9071 0.05183602263315288 0.05183602263315288 0.05183602263315288 -11.088999999999999 23.2851 21.9071 0.06553895717294182 0.06553895717294182 0.06553895717294182 -11.088999999999999 23.2851 22.9071 0.06000103178662628 0.06000103178662628 0.06000103178662628 -11.088999999999999 24.2851 21.9071 0.09216297916449226 0.09216297916449226 0.09216297916449226 -11.088999999999999 24.2851 22.9071 0.11427156725548504 0.11427156725548504 0.11427156725548504 -12.088999999999999 23.2851 21.9071 0.0461591738320979 0.0461591738320979 0.0461591738320979 -12.088999999999999 23.2851 22.9071 0.05403009298951191 0.05403009298951191 0.05403009298951191 -12.088999999999999 24.2851 21.9071 0.05664980971627568 0.05664980971627568 0.05664980971627568 -12.088999999999999 24.2851 22.9071 0.0850771426260467 0.0850771426260467 0.0850771426260467 -11.088999999999999 25.2851 20.9071 0.08582216126298234 0.08582216126298234 0.08582216126298234 -11.088999999999999 26.2851 20.9071 0.07236294294634364 0.07236294294634364 0.07236294294634364 -12.088999999999999 25.2851 20.9071 0.0751239320413148 0.0751239320413148 0.0751239320413148 -12.088999999999999 26.2851 20.9071 0.07277321090800634 0.07277321090800634 0.07277321090800634 -11.088999999999999 26.2851 21.9071 0.12051856302968188 0.12051856302968188 0.12051856302968188 -11.088999999999999 26.2851 22.9071 0.09774875337218995 0.09774875337218995 0.09774875337218995 -10.088999999999999 25.2851 23.9071 0.06972203401123031 0.06972203401123031 0.06972203401123031 -10.088999999999999 26.2851 23.9071 0.07682963884991119 0.07682963884991119 0.07682963884991119 -11.088999999999999 24.2851 23.9071 0.07763742762771028 0.07763742762771028 0.07763742762771028 -12.088999999999999 23.2851 23.9071 0.09391003179501908 0.09391003179501908 0.09391003179501908 -12.088999999999999 23.2851 24.9071 0.11181553600370024 0.11181553600370024 0.11181553600370024 -12.088999999999999 24.2851 23.9071 0.10976677740700222 0.10976677740700222 0.10976677740700222 -12.088999999999999 24.2851 24.9071 0.09863749135227351 0.09863749135227351 0.09863749135227351 -12.088999999999999 23.2851 25.9071 0.11236748675163495 0.11236748675163495 0.11236748675163495 -12.088999999999999 24.2851 25.9071 0.09147668408202327 0.09147668408202327 0.09147668408202327 -11.088999999999999 25.2851 23.9071 0.10364911479329303 0.10364911479329303 0.10364911479329303 -11.088999999999999 26.2851 23.9071 0.07504813451392356 0.07504813451392356 0.07504813451392356 -12.088999999999999 25.2851 23.9071 0.13172434226708993 0.13172434226708993 0.13172434226708993 -12.088999999999999 25.2851 24.9071 0.1104890711959757 0.1104890711959757 0.1104890711959757 -12.088999999999999 26.2851 23.9071 0.13574599296685194 0.13574599296685194 0.13574599296685194 -12.088999999999999 26.2851 24.9071 0.11724168218816154 0.11724168218816154 0.11724168218816154 -13.088999999999999 19.2851 19.9071 0.07710798529187476 0.07710798529187476 0.07710798529187476 -13.088999999999999 19.2851 20.9071 0.08367468861087096 0.08367468861087096 0.08367468861087096 -13.088999999999999 20.2851 19.9071 0.08635660943353773 0.08635660943353773 0.08635660943353773 -13.088999999999999 20.2851 20.9071 0.06700209817896385 0.06700209817896385 0.06700209817896385 -14.088999999999999 19.2851 19.9071 0.1140867850459621 0.1140867850459621 0.1140867850459621 -14.088999999999999 19.2851 20.9071 0.09533320072354814 0.09533320072354814 0.09533320072354814 -14.088999999999999 20.2851 19.9071 0.11797435259292986 0.11797435259292986 0.11797435259292986 -13.088999999999999 19.2851 21.9071 0.0637614635001859 0.0637614635001859 0.0637614635001859 -13.088999999999999 19.2851 22.9071 0.08661941196869004 0.08661941196869004 0.08661941196869004 -14.088999999999999 19.2851 21.9071 0.12052257971762251 0.12052257971762251 0.12052257971762251 -14.088999999999999 19.2851 22.9071 0.09061599426948758 0.09061599426948758 0.09061599426948758 -13.088999999999999 21.2851 19.9071 0.07637984568275578 0.07637984568275578 0.07637984568275578 -13.088999999999999 22.2851 19.9071 0.07649743838506456 0.07649743838506456 0.07649743838506456 -14.088999999999999 21.2851 19.9071 0.11829569715675908 0.11829569715675908 0.11829569715675908 -14.088999999999999 21.2851 20.9071 0.0799829430667292 0.0799829430667292 0.0799829430667292 -14.088999999999999 22.2851 19.9071 0.060494811513025645 0.060494811513025645 0.060494811513025645 -14.088999999999999 22.2851 20.9071 0.06630425373832714 0.06630425373832714 0.06630425373832714 -13.088999999999999 22.2851 22.9071 0.07183234054619754 0.07183234054619754 0.07183234054619754 -14.088999999999999 22.2851 21.9071 0.05028134738657666 0.05028134738657666 0.05028134738657666 -14.088999999999999 22.2851 22.9071 0.047717627434159776 0.047717627434159776 0.047717627434159776 -15.088999999999999 19.2851 19.9071 0.10866363989553404 0.10866363989553404 0.10866363989553404 -16.089 19.2851 19.9071 0.0855754298570903 0.0855754298570903 0.0855754298570903 -16.089 19.2851 20.9071 0.09182626134852857 0.09182626134852857 0.09182626134852857 -16.089 20.2851 19.9071 0.07572420092396337 0.07572420092396337 0.07572420092396337 -16.089 20.2851 20.9071 0.09558954524619014 0.09558954524619014 0.09558954524619014 -15.088999999999999 19.2851 22.9071 0.10628135761536425 0.10628135761536425 0.10628135761536425 -16.089 19.2851 22.9071 0.15670801188866879 0.15670801188866879 0.15670801188866879 -15.088999999999999 21.2851 19.9071 0.1291419301094638 0.1291419301094638 0.1291419301094638 -15.088999999999999 21.2851 20.9071 0.09567874330546207 0.09567874330546207 0.09567874330546207 -15.088999999999999 22.2851 19.9071 0.073892354038338 0.073892354038338 0.073892354038338 -15.088999999999999 22.2851 20.9071 0.08709840153711862 0.08709840153711862 0.08709840153711862 -16.089 21.2851 19.9071 0.12527980415436604 0.12527980415436604 0.12527980415436604 -16.089 21.2851 20.9071 0.13190346140487016 0.13190346140487016 0.13190346140487016 -16.089 22.2851 19.9071 0.1066308705609191 0.1066308705609191 0.1066308705609191 -16.089 22.2851 20.9071 0.1058273902583172 0.1058273902583172 0.1058273902583172 -15.088999999999999 21.2851 21.9071 0.10189343487607533 0.10189343487607533 0.10189343487607533 -15.088999999999999 21.2851 22.9071 0.08123862011445983 0.08123862011445983 0.08123862011445983 -15.088999999999999 22.2851 21.9071 0.07100351346392463 0.07100351346392463 0.07100351346392463 -15.088999999999999 22.2851 22.9071 0.07634134468546751 0.07634134468546751 0.07634134468546751 -16.089 21.2851 21.9071 0.11016608856793932 0.11016608856793932 0.11016608856793932 -16.089 21.2851 22.9071 0.09841812023177954 0.09841812023177954 0.09841812023177954 -16.089 22.2851 22.9071 0.10452975262538222 0.10452975262538222 0.10452975262538222 -13.088999999999999 19.2851 23.9071 0.08143553370307942 0.08143553370307942 0.08143553370307942 -13.088999999999999 20.2851 23.9071 0.1017471934473214 0.1017471934473214 0.1017471934473214 -14.088999999999999 19.2851 23.9071 0.09368341533385731 0.09368341533385731 0.09368341533385731 -14.088999999999999 20.2851 23.9071 0.12913791385182252 0.12913791385182252 0.12913791385182252 -13.088999999999999 21.2851 23.9071 0.0935122471581151 0.0935122471581151 0.0935122471581151 -13.088999999999999 22.2851 23.9071 0.06180634392560215 0.06180634392560215 0.06180634392560215 -13.088999999999999 22.2851 24.9071 0.09347045956695618 0.09347045956695618 0.09347045956695618 -14.088999999999999 21.2851 23.9071 0.13677165441153605 0.13677165441153605 0.13677165441153605 -14.088999999999999 22.2851 23.9071 0.06819157900753459 0.06819157900753459 0.06819157900753459 -14.088999999999999 22.2851 24.9071 0.118396920428527 0.118396920428527 0.118396920428527 -14.088999999999999 22.2851 25.9071 0.10072429953825365 0.10072429953825365 0.10072429953825365 -14.088999999999999 22.2851 26.9071 0.12206015313292862 0.12206015313292862 0.12206015313292862 -15.088999999999999 19.2851 23.9071 0.10605798992617171 0.10605798992617171 0.10605798992617171 -15.088999999999999 20.2851 23.9071 0.1005362720629816 0.1005362720629816 0.1005362720629816 -16.089 19.2851 23.9071 0.14565348019998353 0.14565348019998353 0.14565348019998353 -16.089 20.2851 23.9071 0.15043973441650263 0.15043973441650263 0.15043973441650263 -15.088999999999999 21.2851 23.9071 0.11983491981944885 0.11983491981944885 0.11983491981944885 -15.088999999999999 22.2851 23.9071 0.1351452079117144 0.1351452079117144 0.1351452079117144 -15.088999999999999 22.2851 24.9071 0.0 0.0 0.0 -16.089 21.2851 24.9071 0.11525170927092414 0.11525170927092414 0.11525170927092414 -16.089 22.2851 23.9071 0.10011441394898968 0.10011441394898968 0.10011441394898968 -16.089 22.2851 24.9071 0.1293298907431289 0.1293298907431289 0.1293298907431289 -15.088999999999999 21.2851 25.9071 0.11193042562719542 0.11193042562719542 0.11193042562719542 -15.088999999999999 21.2851 26.9071 0.12390536310493275 0.12390536310493275 0.12390536310493275 -15.088999999999999 22.2851 25.9071 0.13179823900005483 0.13179823900005483 0.13179823900005483 -15.088999999999999 22.2851 26.9071 0.12357279464731949 0.12357279464731949 0.12357279464731949 -16.089 21.2851 25.9071 0.12484281316964818 0.12484281316964818 0.12484281316964818 -16.089 21.2851 26.9071 0.13409302006783677 0.13409302006783677 0.13409302006783677 -16.089 22.2851 25.9071 0.11516976342869664 0.11516976342869664 0.11516976342869664 -13.088999999999999 23.2851 19.9071 0.06136796293764334 0.06136796293764334 0.06136796293764334 -13.088999999999999 24.2851 19.9071 0.04447139129889229 0.04447139129889229 0.04447139129889229 -13.088999999999999 24.2851 20.9071 0.05720961597492155 0.05720961597492155 0.05720961597492155 -14.088999999999999 23.2851 19.9071 0.04451746606108815 0.04451746606108815 0.04451746606108815 -14.088999999999999 23.2851 20.9071 0.06792662622757749 0.06792662622757749 0.06792662622757749 -14.088999999999999 24.2851 20.9071 0.055331359336291366 0.055331359336291366 0.055331359336291366 -13.088999999999999 23.2851 21.9071 0.0384680985121254 0.0384680985121254 0.0384680985121254 -13.088999999999999 23.2851 22.9071 0.055780546607887775 0.055780546607887775 0.055780546607887775 -13.088999999999999 24.2851 21.9071 0.050071653680425696 0.050071653680425696 0.050071653680425696 -13.088999999999999 24.2851 22.9071 0.05991010588303691 0.05991010588303691 0.05991010588303691 -14.088999999999999 23.2851 21.9071 0.046670728177601255 0.046670728177601255 0.046670728177601255 -14.088999999999999 23.2851 22.9071 0.07787397558230029 0.07787397558230029 0.07787397558230029 -14.088999999999999 24.2851 21.9071 0.07347694741603734 0.07347694741603734 0.07347694741603734 -14.088999999999999 24.2851 22.9071 0.11885804705504877 0.11885804705504877 0.11885804705504877 -13.088999999999999 25.2851 20.9071 0.07365531209343945 0.07365531209343945 0.07365531209343945 -13.088999999999999 26.2851 20.9071 0.08594351747492761 0.08594351747492761 0.08594351747492761 -14.088999999999999 25.2851 20.9071 0.06852485878352327 0.06852485878352327 0.06852485878352327 -14.088999999999999 26.2851 19.9071 0.05780889298109218 0.05780889298109218 0.05780889298109218 -14.088999999999999 26.2851 20.9071 0.07995529432131956 0.07995529432131956 0.07995529432131956 -14.088999999999999 25.2851 21.9071 0.08393348139172385 0.08393348139172385 0.08393348139172385 -14.088999999999999 26.2851 21.9071 0.08069690432685775 0.08069690432685775 0.08069690432685775 -14.088999999999999 26.2851 22.9071 0.05472908909477084 0.05472908909477084 0.05472908909477084 -15.088999999999999 23.2851 19.9071 0.050636490733520084 0.050636490733520084 0.050636490733520084 -15.088999999999999 23.2851 20.9071 0.06596839233949159 0.06596839233949159 0.06596839233949159 -15.088999999999999 24.2851 20.9071 0.0984928511202302 0.0984928511202302 0.0984928511202302 -16.089 23.2851 19.9071 0.07227114681112394 0.07227114681112394 0.07227114681112394 -16.089 24.2851 19.9071 0.12715064497488499 0.12715064497488499 0.12715064497488499 -16.089 24.2851 20.9071 0.11740797967457588 0.11740797967457588 0.11740797967457588 -15.088999999999999 23.2851 22.9071 0.07864309322780622 0.07864309322780622 0.07864309322780622 -15.088999999999999 24.2851 21.9071 0.09492256563248709 0.09492256563248709 0.09492256563248709 -15.088999999999999 24.2851 22.9071 0.14979328550393795 0.14979328550393795 0.14979328550393795 -15.088999999999999 25.2851 19.9071 0.06757999979266543 0.06757999979266543 0.06757999979266543 -15.088999999999999 25.2851 20.9071 0.10875684073639456 0.10875684073639456 0.10875684073639456 -15.088999999999999 26.2851 19.9071 0.08063180173891799 0.08063180173891799 0.08063180173891799 -16.089 25.2851 19.9071 0.07865064853240633 0.07865064853240633 0.07865064853240633 -16.089 25.2851 20.9071 0.0800613079185091 0.0800613079185091 0.0800613079185091 -16.089 26.2851 19.9071 0.06158799785276944 0.06158799785276944 0.06158799785276944 -15.088999999999999 25.2851 21.9071 0.13043756436182175 0.13043756436182175 0.13043756436182175 -15.088999999999999 25.2851 22.9071 0.09929801177347451 0.09929801177347451 0.09929801177347451 -15.088999999999999 26.2851 21.9071 0.08820504941661385 0.08820504941661385 0.08820504941661385 -15.088999999999999 26.2851 22.9071 0.0628917948783758 0.0628917948783758 0.0628917948783758 -16.089 25.2851 21.9071 0.09990227874727386 0.09990227874727386 0.09990227874727386 -16.089 25.2851 22.9071 0.058148325870754025 0.058148325870754025 0.058148325870754025 -16.089 26.2851 22.9071 0.07723707084022596 0.07723707084022596 0.07723707084022596 -13.088999999999999 23.2851 24.9071 0.12493117550875714 0.12493117550875714 0.12493117550875714 -13.088999999999999 24.2851 24.9071 0.10566830020671579 0.10566830020671579 0.10566830020671579 -14.088999999999999 23.2851 24.9071 0.11606714619244618 0.11606714619244618 0.11606714619244618 -13.088999999999999 23.2851 25.9071 0.10262463803251216 0.10262463803251216 0.10262463803251216 -13.088999999999999 24.2851 25.9071 0.1005748418373217 0.1005748418373217 0.1005748418373217 -14.088999999999999 23.2851 25.9071 0.08696097361373122 0.08696097361373122 0.08696097361373122 -14.088999999999999 23.2851 26.9071 0.09549391838810647 0.09549391838810647 0.09549391838810647 -14.088999999999999 24.2851 25.9071 0.09157070846165298 0.09157070846165298 0.09157070846165298 -14.088999999999999 24.2851 26.9071 0.08697463604937784 0.08697463604937784 0.08697463604937784 -13.088999999999999 25.2851 24.9071 0.07757457311031002 0.07757457311031002 0.07757457311031002 -13.088999999999999 26.2851 24.9071 0.10410068393687062 0.10410068393687062 0.10410068393687062 -14.088999999999999 25.2851 24.9071 0.08066153996463532 0.08066153996463532 0.08066153996463532 -14.088999999999999 26.2851 24.9071 0.08279784104376547 0.08279784104376547 0.08279784104376547 -13.088999999999999 26.2851 25.9071 0.04308407026281656 0.04308407026281656 0.04308407026281656 -13.088999999999999 26.2851 26.9071 0.046986568343737975 0.046986568343737975 0.046986568343737975 -14.088999999999999 25.2851 25.9071 0.14253503420251057 0.14253503420251057 0.14253503420251057 -14.088999999999999 25.2851 26.9071 0.07459672379430263 0.07459672379430263 0.07459672379430263 -14.088999999999999 26.2851 25.9071 0.06200145606003657 0.06200145606003657 0.06200145606003657 -14.088999999999999 26.2851 26.9071 0.07681629620101756 0.07681629620101756 0.07681629620101756 -15.088999999999999 23.2851 24.9071 0.11558350873971725 0.11558350873971725 0.11558350873971725 -15.088999999999999 23.2851 25.9071 0.10859052536722051 0.10859052536722051 0.10859052536722051 -15.088999999999999 24.2851 25.9071 0.06561934580979412 0.06561934580979412 0.06561934580979412 -15.088999999999999 24.2851 26.9071 0.10559598644289384 0.10559598644289384 0.10559598644289384 -15.088999999999999 25.2851 24.9071 0.10761110566383969 0.10761110566383969 0.10761110566383969 -15.088999999999999 26.2851 24.9071 0.06735756965876936 0.06735756965876936 0.06735756965876936 -16.089 25.2851 23.9071 0.08784018680139806 0.08784018680139806 0.08784018680139806 -16.089 25.2851 24.9071 0.0697867435056608 0.0697867435056608 0.0697867435056608 -16.089 26.2851 23.9071 0.07426780968770104 0.07426780968770104 0.07426780968770104 -16.089 26.2851 24.9071 0.11949269436198592 0.11949269436198592 0.11949269436198592 -15.088999999999999 25.2851 25.9071 0.09036445573218366 0.09036445573218366 0.09036445573218366 -15.088999999999999 25.2851 26.9071 0.10761914032845521 0.10761914032845521 0.10761914032845521 -15.088999999999999 26.2851 25.9071 0.03967191298978431 0.03967191298978431 0.03967191298978431 -15.088999999999999 26.2851 26.9071 0.06912766884156869 0.06912766884156869 0.06912766884156869 -16.089 25.2851 25.9071 0.08408377371155003 0.08408377371155003 0.08408377371155003 -16.089 25.2851 26.9071 0.09825258704893054 0.09825258704893054 0.09825258704893054 -16.089 26.2851 25.9071 0.06473836235517212 0.06473836235517212 0.06473836235517212 -16.089 26.2851 26.9071 0.07751421022193797 0.07751421022193797 0.07751421022193797 -18.089 18.2851 18.9071 0.07306362855902059 0.07306362855902059 0.07306362855902059 -19.089 18.2851 18.9071 0.09557508068671697 0.09557508068671697 0.09557508068671697 -20.089 18.2851 18.9071 0.07043391597124482 0.07043391597124482 0.07043391597124482 -17.089 17.2851 19.9071 0.05086154000764064 0.05086154000764064 0.05086154000764064 -17.089 17.2851 20.9071 0.053129445161841884 0.053129445161841884 0.053129445161841884 -17.089 18.2851 19.9071 0.07451586184874961 0.07451586184874961 0.07451586184874961 -17.089 18.2851 20.9071 0.08600459735338961 0.08600459735338961 0.08600459735338961 -18.089 17.2851 19.9071 0.07260666037332275 0.07260666037332275 0.07260666037332275 -18.089 17.2851 20.9071 0.06541435462706142 0.06541435462706142 0.06541435462706142 -18.089 18.2851 19.9071 0.0716311431749252 0.0716311431749252 0.0716311431749252 -17.089 18.2851 21.9071 0.10763922698645674 0.10763922698645674 0.10763922698645674 -17.089 18.2851 22.9071 0.12721651320194927 0.12721651320194927 0.12721651320194927 -18.089 17.2851 21.9071 0.07778017632368338 0.07778017632368338 0.07778017632368338 -18.089 18.2851 21.9071 0.11579399582893413 0.11579399582893413 0.11579399582893413 -19.089 17.2851 19.9071 0.061462504867497124 0.061462504867497124 0.061462504867497124 -19.089 17.2851 20.9071 0.05353973081357209 0.05353973081357209 0.05353973081357209 -19.089 18.2851 19.9071 0.07589661262324587 0.07589661262324587 0.07589661262324587 -19.089 18.2851 20.9071 0.11962203326233689 0.11962203326233689 0.11962203326233689 -20.089 18.2851 19.9071 0.09095753894782467 0.09095753894782467 0.09095753894782467 -20.089 18.2851 20.9071 0.09508569489217567 0.09508569489217567 0.09508569489217567 -19.089 18.2851 21.9071 0.08300841392538809 0.08300841392538809 0.08300841392538809 -19.089 18.2851 26.9071 0.14434042277027367 0.14434042277027367 0.14434042277027367 -20.089 17.2851 26.9071 0.12761573776576252 0.12761573776576252 0.12761573776576252 -20.089 18.2851 26.9071 0.20733017949209484 0.20733017949209484 0.20733017949209484 -21.089 18.2851 19.9071 0.06521925076921332 0.06521925076921332 0.06521925076921332 -21.089 18.2851 20.9071 0.07646070575488277 0.07646070575488277 0.07646070575488277 -21.089 17.2851 26.9071 0.13519179300959475 0.13519179300959475 0.13519179300959475 -21.089 18.2851 26.9071 0.22492965901750567 0.22492965901750567 0.22492965901750567 -22.089 18.2851 26.9071 0.2225516193068742 0.2225516193068742 0.2225516193068742 -23.089 17.2851 25.9071 0.10339600998339514 0.10339600998339514 0.10339600998339514 -23.089 17.2851 26.9071 0.18753559344330453 0.18753559344330453 0.18753559344330453 -23.089 18.2851 25.9071 0.13231953032940783 0.13231953032940783 0.13231953032940783 -23.089 18.2851 26.9071 0.22914962392313684 0.22914962392313684 0.22914962392313684 -24.089 17.2851 25.9071 0.0988938253469608 0.0988938253469608 0.0988938253469608 -24.089 17.2851 26.9071 0.2306859250078792 0.2306859250078792 0.2306859250078792 -24.089 18.2851 25.9071 0.13377896744178297 0.13377896744178297 0.13377896744178297 -17.089 19.2851 17.9071 0.07126942070666066 0.07126942070666066 0.07126942070666066 -17.089 19.2851 18.9071 0.09742330888939298 0.09742330888939298 0.09742330888939298 -17.089 20.2851 17.9071 0.07393801005330529 0.07393801005330529 0.07393801005330529 -17.089 20.2851 18.9071 0.10127391579254114 0.10127391579254114 0.10127391579254114 -18.089 19.2851 17.9071 0.0784272844936491 0.0784272844936491 0.0784272844936491 -18.089 19.2851 18.9071 0.07851296505106362 0.07851296505106362 0.07851296505106362 -18.089 20.2851 17.9071 0.06385785159569374 0.06385785159569374 0.06385785159569374 -17.089 21.2851 17.9071 0.06833699719824046 0.06833699719824046 0.06833699719824046 -17.089 21.2851 18.9071 0.11663674205544838 0.11663674205544838 0.11663674205544838 -17.089 22.2851 18.9071 0.08799690112298655 0.08799690112298655 0.08799690112298655 -18.089 21.2851 17.9071 0.07904722065229092 0.07904722065229092 0.07904722065229092 -18.089 22.2851 17.9071 0.07917493671335561 0.07917493671335561 0.07917493671335561 -18.089 22.2851 18.9071 0.11580122629169128 0.11580122629169128 0.11580122629169128 -19.089 19.2851 18.9071 0.05128880224218856 0.05128880224218856 0.05128880224218856 -19.089 20.2851 17.9071 0.05794114495230301 0.05794114495230301 0.05794114495230301 -19.089 20.2851 18.9071 0.06942983583236695 0.06942983583236695 0.06942983583236695 -20.089 19.2851 18.9071 0.07717694882978378 0.07717694882978378 0.07717694882978378 -20.089 20.2851 18.9071 0.08871296113924575 0.08871296113924575 0.08871296113924575 -19.089 21.2851 17.9071 0.073446563488358 0.073446563488358 0.073446563488358 -19.089 22.2851 17.9071 0.0755887630362624 0.0755887630362624 0.0755887630362624 -19.089 22.2851 18.9071 0.1154413091349223 0.1154413091349223 0.1154413091349223 -20.089 21.2851 17.9071 0.06622675975351372 0.06622675975351372 0.06622675975351372 -20.089 21.2851 18.9071 0.12168982073865668 0.12168982073865668 0.12168982073865668 -20.089 22.2851 18.9071 0.12108089739111341 0.12108089739111341 0.12108089739111341 -18.089 24.2851 14.9071 0.10353099931443255 0.10353099931443255 0.10353099931443255 -18.089 25.2851 14.9071 0.10677871006253423 0.10677871006253423 0.10677871006253423 -18.089 26.2851 14.9071 0.10393114492922968 0.10393114492922968 0.10393114492922968 -19.089 24.2851 14.9071 0.10464867013407811 0.10464867013407811 0.10464867013407811 -20.089 24.2851 14.9071 0.09688571993446168 0.09688571993446168 0.09688571993446168 -19.089 25.2851 14.9071 0.1225373251146741 0.1225373251146741 0.1225373251146741 -19.089 26.2851 14.9071 0.13733467835361218 0.13733467835361218 0.13733467835361218 -20.089 25.2851 13.9071 0.08748014453704415 0.08748014453704415 0.08748014453704415 -20.089 25.2851 14.9071 0.10652481162066796 0.10652481162066796 0.10652481162066796 -20.089 26.2851 13.9071 0.09827026536625601 0.09827026536625601 0.09827026536625601 -20.089 26.2851 14.9071 0.1617762388936174 0.1617762388936174 0.1617762388936174 -18.089 24.2851 15.9071 0.11036453824672078 0.11036453824672078 0.11036453824672078 -18.089 24.2851 16.9071 0.11628566581552714 0.11628566581552714 0.11628566581552714 -17.089 24.2851 18.9071 0.11747465924650675 0.11747465924650675 0.11747465924650675 -18.089 23.2851 18.9071 0.10343779241958131 0.10343779241958131 0.10343779241958131 -18.089 24.2851 17.9071 0.12217342148577388 0.12217342148577388 0.12217342148577388 -18.089 24.2851 18.9071 0.12998855274596693 0.12998855274596693 0.12998855274596693 -18.089 25.2851 15.9071 0.10429191708069915 0.10429191708069915 0.10429191708069915 -18.089 25.2851 16.9071 0.09675955877738641 0.09675955877738641 0.09675955877738641 -18.089 26.2851 15.9071 0.12072743053702635 0.12072743053702635 0.12072743053702635 -18.089 26.2851 16.9071 0.1268012211611443 0.1268012211611443 0.1268012211611443 -17.089 25.2851 18.9071 0.11207423828133616 0.11207423828133616 0.11207423828133616 -18.089 25.2851 17.9071 0.11567911172253864 0.11567911172253864 0.11567911172253864 -18.089 25.2851 18.9071 0.0 0.0 0.0 -18.089 26.2851 17.9071 0.12234854529190005 0.12234854529190005 0.12234854529190005 -18.089 26.2851 18.9071 0.1303837473593485 0.1303837473593485 0.1303837473593485 -19.089 23.2851 15.9071 0.09222566156174958 0.09222566156174958 0.09222566156174958 -19.089 23.2851 16.9071 0.10495158758842983 0.10495158758842983 0.10495158758842983 -19.089 24.2851 15.9071 0.1346448180042184 0.1346448180042184 0.1346448180042184 -19.089 24.2851 16.9071 0.1557877957427627 0.1557877957427627 0.1557877957427627 -20.089 23.2851 15.9071 0.11022634661932652 0.11022634661932652 0.11022634661932652 -20.089 23.2851 16.9071 0.10996201429870302 0.10996201429870302 0.10996201429870302 -20.089 24.2851 15.9071 0.13219021184007654 0.13219021184007654 0.13219021184007654 -20.089 24.2851 16.9071 0.16863373551789237 0.16863373551789237 0.16863373551789237 -19.089 23.2851 18.9071 0.12375193193419226 0.12375193193419226 0.12375193193419226 -19.089 24.2851 17.9071 0.14824499916434045 0.14824499916434045 0.14824499916434045 -19.089 24.2851 18.9071 0.14873165254206047 0.14873165254206047 0.14873165254206047 -20.089 23.2851 18.9071 0.12810813877492758 0.12810813877492758 0.12810813877492758 -20.089 24.2851 17.9071 0.1444062769254943 0.1444062769254943 0.1444062769254943 -20.089 24.2851 18.9071 0.16508181632254193 0.16508181632254193 0.16508181632254193 -19.089 26.2851 15.9071 0.1505666144628587 0.1505666144628587 0.1505666144628587 -19.089 26.2851 16.9071 0.13119742446457305 0.13119742446457305 0.13119742446457305 -19.089 25.2851 18.9071 0.15207872011932494 0.15207872011932494 0.15207872011932494 -19.089 26.2851 18.9071 0.11809003678377389 0.11809003678377389 0.11809003678377389 -20.089 25.2851 18.9071 0.1395602308587966 0.1395602308587966 0.1395602308587966 -21.089 20.2851 16.9071 0.04475362895679715 0.04475362895679715 0.04475362895679715 -22.089 20.2851 16.9071 0.07397667296122236 0.07397667296122236 0.07397667296122236 -21.089 20.2851 17.9071 0.055279260847148896 0.055279260847148896 0.055279260847148896 -21.089 20.2851 18.9071 0.13791376163596408 0.13791376163596408 0.13791376163596408 -22.089 20.2851 17.9071 0.0762460968363544 0.0762460968363544 0.0762460968363544 -22.089 20.2851 18.9071 0.08168951133427516 0.08168951133427516 0.08168951133427516 -21.089 21.2851 16.9071 0.05302243125667358 0.05302243125667358 0.05302243125667358 -21.089 22.2851 16.9071 0.05223353096824834 0.05223353096824834 0.05223353096824834 -22.089 21.2851 15.9071 0.03955000447425485 0.03955000447425485 0.03955000447425485 -22.089 21.2851 16.9071 0.06952452905855803 0.06952452905855803 0.06952452905855803 -22.089 22.2851 16.9071 0.0414908690318998 0.0414908690318998 0.0414908690318998 -21.089 21.2851 17.9071 0.0720390837850801 0.0720390837850801 0.0720390837850801 -21.089 21.2851 18.9071 0.0695463133078973 0.0695463133078973 0.0695463133078973 -21.089 22.2851 17.9071 0.06178447718802487 0.06178447718802487 0.06178447718802487 -21.089 22.2851 18.9071 0.06917823104810417 0.06917823104810417 0.06917823104810417 -23.089 20.2851 16.9071 0.06900363455004824 0.06900363455004824 0.06900363455004824 -23.089 20.2851 17.9071 0.08735879064292766 0.08735879064292766 0.08735879064292766 -23.089 20.2851 18.9071 0.08353404001125653 0.08353404001125653 0.08353404001125653 -23.089 21.2851 16.9071 0.05935594605439842 0.05935594605439842 0.05935594605439842 -23.089 22.2851 16.9071 0.06741440314864165 0.06741440314864165 0.06741440314864165 -24.089 22.2851 16.9071 0.09211476190258588 0.09211476190258588 0.09211476190258588 -23.089 21.2851 17.9071 0.08362726996762135 0.08362726996762135 0.08362726996762135 -23.089 21.2851 18.9071 0.08401385165114954 0.08401385165114954 0.08401385165114954 -24.089 21.2851 17.9071 0.08914371920126012 0.08914371920126012 0.08914371920126012 -24.089 21.2851 18.9071 0.10522075731367246 0.10522075731367246 0.10522075731367246 -24.089 22.2851 17.9071 0.14948652159402595 0.14948652159402595 0.14948652159402595 -24.089 22.2851 18.9071 0.15565048510129426 0.15565048510129426 0.15565048510129426 -21.089 24.2851 13.9071 0.09148873849580703 0.09148873849580703 0.09148873849580703 -21.089 24.2851 14.9071 0.12630479575413436 0.12630479575413436 0.12630479575413436 -22.089 24.2851 14.9071 0.11528946860150889 0.11528946860150889 0.11528946860150889 -21.089 25.2851 13.9071 0.0974417909570197 0.0974417909570197 0.0974417909570197 -21.089 26.2851 13.9071 0.119148860746221 0.119148860746221 0.119148860746221 -21.089 26.2851 14.9071 0.16680079137331422 0.16680079137331422 0.16680079137331422 -22.089 25.2851 13.9071 0.10309228316044315 0.10309228316044315 0.10309228316044315 -22.089 25.2851 14.9071 0.13062230902174418 0.13062230902174418 0.13062230902174418 -22.089 26.2851 13.9071 0.1490576925972403 0.1490576925972403 0.1490576925972403 -22.089 26.2851 14.9071 0.1526456520365796 0.1526456520365796 0.1526456520365796 -23.089 24.2851 14.9071 0.09282114190005988 0.09282114190005988 0.09282114190005988 -24.089 24.2851 13.9071 0.06178134188324158 0.06178134188324158 0.06178134188324158 -24.089 24.2851 14.9071 0.09017961860606259 0.09017961860606259 0.09017961860606259 -23.089 25.2851 13.9071 0.06770299125428675 0.06770299125428675 0.06770299125428675 -23.089 25.2851 14.9071 0.09173063001736262 0.09173063001736262 0.09173063001736262 -23.089 26.2851 13.9071 0.11824910227456335 0.11824910227456335 0.11824910227456335 -24.089 25.2851 13.9071 0.05339195425123115 0.05339195425123115 0.05339195425123115 -24.089 26.2851 13.9071 0.06568003917741354 0.06568003917741354 0.06568003917741354 -21.089 23.2851 16.9071 0.10393114492922968 0.10393114492922968 0.10393114492922968 -21.089 24.2851 15.9071 0.14189896238703917 0.14189896238703917 0.14189896238703917 -21.089 24.2851 16.9071 0.13974656086309864 0.13974656086309864 0.13974656086309864 -22.089 23.2851 15.9071 0.06087692194355685 0.06087692194355685 0.06087692194355685 -22.089 23.2851 16.9071 0.08998353006024468 0.08998353006024468 0.08998353006024468 -22.089 24.2851 15.9071 0.11877610488594156 0.11877610488594156 0.11877610488594156 -22.089 24.2851 16.9071 0.07890576020956538 0.07890576020956538 0.07890576020956538 -21.089 23.2851 17.9071 0.1145077665053362 0.1145077665053362 0.1145077665053362 -21.089 23.2851 18.9071 0.17458750511418308 0.17458750511418308 0.17458750511418308 -21.089 24.2851 17.9071 0.09802196500793148 0.09802196500793148 0.09802196500793148 -21.089 24.2851 18.9071 0.1283997222911622 0.1283997222911622 0.1283997222911622 -22.089 24.2851 17.9071 0.05883739756705946 0.05883739756705946 0.05883739756705946 -22.089 24.2851 18.9071 0.07623580845435013 0.07623580845435013 0.07623580845435013 -21.089 25.2851 16.9071 0.08629392246349407 0.08629392246349407 0.08629392246349407 -22.089 25.2851 15.9071 0.12117970716575924 0.12117970716575924 0.12117970716575924 -22.089 25.2851 16.9071 0.13705919066881708 0.13705919066881708 0.13705919066881708 -21.089 25.2851 17.9071 0.06827019650313013 0.06827019650313013 0.06827019650313013 -21.089 25.2851 18.9071 0.11082089030680749 0.11082089030680749 0.11082089030680749 -22.089 25.2851 17.9071 0.05260989172221697 0.05260989172221697 0.05260989172221697 -23.089 23.2851 15.9071 0.051329486107829364 0.051329486107829364 0.051329486107829364 -23.089 23.2851 16.9071 0.08828863004706897 0.08828863004706897 0.08828863004706897 -23.089 24.2851 15.9071 0.09285328646230832 0.09285328646230832 0.09285328646230832 -23.089 24.2851 16.9071 0.06651101118322948 0.06651101118322948 0.06651101118322948 -24.089 23.2851 16.9071 0.10707760213817138 0.10707760213817138 0.10707760213817138 -24.089 24.2851 15.9071 0.07904826552963293 0.07904826552963293 0.07904826552963293 -24.089 24.2851 16.9071 0.0914244482680778 0.0914244482680778 0.0914244482680778 -24.089 23.2851 17.9071 0.12921904221743594 0.12921904221743594 0.12921904221743594 -24.089 23.2851 18.9071 0.10134944755743402 0.10134944755743402 0.10134944755743402 -24.089 24.2851 17.9071 0.08509803860418087 0.08509803860418087 0.08509803860418087 -24.089 24.2851 18.9071 0.07763453407043568 0.07763453407043568 0.07763453407043568 -23.089 25.2851 15.9071 0.08163164308376783 0.08163164308376783 0.08163164308376783 -23.089 25.2851 16.9071 0.06384571265091808 0.06384571265091808 0.06384571265091808 -23.089 26.2851 16.9071 0.14929941109561176 0.14929941109561176 0.14929941109561176 -24.089 25.2851 16.9071 0.05646063403655455 0.05646063403655455 0.05646063403655455 -24.089 26.2851 16.9071 0.07163307235706166 0.07163307235706166 0.07163307235706166 -23.089 25.2851 17.9071 0.03896981068966573 0.03896981068966573 0.03896981068966573 -23.089 26.2851 17.9071 0.0840034035219735 0.0840034035219735 0.0840034035219735 -23.089 26.2851 18.9071 0.06945684511707671 0.06945684511707671 0.06945684511707671 -24.089 25.2851 17.9071 0.06281325251837365 0.06281325251837365 0.06281325251837365 -24.089 25.2851 18.9071 0.06310201791094674 0.06310201791094674 0.06310201791094674 -24.089 26.2851 17.9071 0.08580528389451916 0.08580528389451916 0.08580528389451916 -24.089 26.2851 18.9071 0.07627093362813048 0.07627093362813048 0.07627093362813048 -17.089 19.2851 19.9071 0.0808962304413936 0.0808962304413936 0.0808962304413936 -17.089 19.2851 20.9071 0.08657440609085537 0.08657440609085537 0.08657440609085537 -17.089 20.2851 20.9071 0.0876199825721621 0.0876199825721621 0.0876199825721621 -18.089 20.2851 20.9071 0.09233415021083698 0.09233415021083698 0.09233415021083698 -17.089 19.2851 21.9071 0.12425078299437632 0.12425078299437632 0.12425078299437632 -17.089 19.2851 22.9071 0.15724761017826472 0.15724761017826472 0.15724761017826472 -17.089 20.2851 21.9071 0.10827315933680842 0.10827315933680842 0.10827315933680842 -17.089 20.2851 22.9071 0.15144513283879524 0.15144513283879524 0.15144513283879524 -18.089 19.2851 21.9071 0.09835142486413352 0.09835142486413352 0.09835142486413352 -18.089 19.2851 22.9071 0.08331623512323041 0.08331623512323041 0.08331623512323041 -18.089 20.2851 21.9071 0.0808536325632378 0.0808536325632378 0.0808536325632378 -18.089 20.2851 22.9071 0.09509774876523519 0.09509774876523519 0.09509774876523519 -17.089 21.2851 19.9071 0.09284846477878356 0.09284846477878356 0.09284846477878356 -17.089 21.2851 20.9071 0.07483641548536721 0.07483641548536721 0.07483641548536721 -17.089 22.2851 19.9071 0.07518928022343471 0.07518928022343471 0.07518928022343471 -17.089 22.2851 20.9071 0.12566216931897167 0.12566216931897167 0.12566216931897167 -18.089 21.2851 20.9071 0.052751961217955945 0.052751961217955945 0.052751961217955945 -17.089 21.2851 21.9071 0.10647338905384542 0.10647338905384542 0.10647338905384542 -17.089 21.2851 22.9071 0.1238499351241273 0.1238499351241273 0.1238499351241273 -17.089 22.2851 21.9071 0.08084881016052843 0.08084881016052843 0.08084881016052843 -17.089 22.2851 22.9071 0.1567361160555965 0.1567361160555965 0.1567361160555965 -18.089 21.2851 21.9071 0.08653984798902455 0.08653984798902455 0.08653984798902455 -18.089 21.2851 22.9071 0.08890101624848044 0.08890101624848044 0.08890101624848044 -18.089 22.2851 21.9071 0.06150294241072164 0.06150294241072164 0.06150294241072164 -18.089 22.2851 22.9071 0.10002522080733026 0.10002522080733026 0.10002522080733026 -19.089 20.2851 20.9071 0.0628014349816286 0.0628014349816286 0.0628014349816286 -20.089 19.2851 19.9071 0.09421138248330546 0.09421138248330546 0.09421138248330546 -20.089 19.2851 20.9071 0.09392931827286818 0.09392931827286818 0.09392931827286818 -20.089 20.2851 19.9071 0.06976487893697833 0.06976487893697833 0.06976487893697833 -20.089 20.2851 20.9071 0.07156595286801744 0.07156595286801744 0.07156595286801744 -19.089 19.2851 21.9071 0.09585954987899167 0.09585954987899167 0.09585954987899167 -19.089 19.2851 22.9071 0.06941600964739976 0.06941600964739976 0.06941600964739976 -19.089 20.2851 21.9071 0.0749952449986305 0.0749952449986305 0.0749952449986305 -19.089 20.2851 22.9071 0.08926507040311121 0.08926507040311121 0.08926507040311121 -20.089 19.2851 21.9071 0.06288906157338486 0.06288906157338486 0.06288906157338486 -20.089 20.2851 21.9071 0.05818466488256675 0.05818466488256675 0.05818466488256675 -20.089 21.2851 19.9071 0.09349617501024478 0.09349617501024478 0.09349617501024478 -20.089 21.2851 20.9071 0.08220710883486612 0.08220710883486612 0.08220710883486612 -20.089 22.2851 19.9071 0.11809244686931727 0.11809244686931727 0.11809244686931727 -20.089 22.2851 20.9071 0.09203038162474692 0.09203038162474692 0.09203038162474692 -19.089 21.2851 21.9071 0.09185920993209683 0.09185920993209683 0.09185920993209683 -19.089 21.2851 22.9071 0.10449279174229263 0.10449279174229263 0.10449279174229263 -19.089 22.2851 22.9071 0.10571249191927173 0.10571249191927173 0.10571249191927173 -20.089 21.2851 21.9071 0.09842695937274144 0.09842695937274144 0.09842695937274144 -20.089 21.2851 22.9071 0.13157172923417138 0.13157172923417138 0.13157172923417138 -20.089 22.2851 21.9071 0.08865750890773118 0.08865750890773118 0.08865750890773118 -20.089 22.2851 22.9071 0.11069394756405526 0.11069394756405526 0.11069394756405526 -17.089 19.2851 23.9071 0.14088059451480828 0.14088059451480828 0.14088059451480828 -17.089 19.2851 24.9071 0.026384727669449583 0.026384727669449583 0.026384727669449583 -17.089 20.2851 23.9071 0.1483606398375743 0.1483606398375743 0.1483606398375743 -17.089 20.2851 24.9071 0.12854832505407965 0.12854832505407965 0.12854832505407965 -18.089 19.2851 23.9071 0.09288141294372929 0.09288141294372929 0.09288141294372929 -18.089 19.2851 24.9071 0.12927767950006128 0.12927767950006128 0.12927767950006128 -18.089 20.2851 23.9071 0.11966461061881702 0.11966461061881702 0.11966461061881702 -17.089 19.2851 25.9071 0.12966002566493423 0.12966002566493423 0.12966002566493423 -17.089 20.2851 25.9071 0.1618573343540823 0.1618573343540823 0.1618573343540823 -17.089 20.2851 26.9071 0.1376695994287304 0.1376695994287304 0.1376695994287304 -18.089 19.2851 25.9071 0.1642219135735042 0.1642219135735042 0.1642219135735042 -18.089 20.2851 26.9071 0.18046056026140184 0.18046056026140184 0.18046056026140184 -17.089 21.2851 23.9071 0.12880697353273257 0.12880697353273257 0.12880697353273257 -17.089 21.2851 24.9071 0.14601888380767178 0.14601888380767178 0.14601888380767178 -17.089 22.2851 23.9071 0.10603549242669126 0.10603549242669126 0.10603549242669126 -17.089 22.2851 24.9071 0.10111401320526013 0.10111401320526013 0.10111401320526013 -18.089 21.2851 23.9071 0.1431381734128575 0.1431381734128575 0.1431381734128575 -18.089 22.2851 23.9071 0.13952730180453 0.13952730180453 0.13952730180453 -18.089 22.2851 24.9071 0.1631074787831292 0.1631074787831292 0.1631074787831292 -17.089 21.2851 25.9071 0.1670617255243636 0.1670617255243636 0.1670617255243636 -17.089 21.2851 26.9071 0.11960516298277377 0.11960516298277377 0.11960516298277377 -17.089 22.2851 25.9071 0.14168211857326138 0.14168211857326138 0.14168211857326138 -17.089 22.2851 26.9071 0.14467852706834752 0.14467852706834752 0.14467852706834752 -18.089 21.2851 26.9071 0.13237816535235436 0.13237816535235436 0.13237816535235436 -18.089 22.2851 25.9071 0.1283306419944182 0.1283306419944182 0.1283306419944182 -19.089 19.2851 24.9071 0.03280309336096206 0.03280309336096206 0.03280309336096206 -19.089 20.2851 23.9071 0.14637304264365236 0.14637304264365236 0.14637304264365236 -19.089 20.2851 24.9071 0.1962087641300807 0.1962087641300807 0.1962087641300807 -20.089 20.2851 24.9071 0.17563836071646247 0.17563836071646247 0.17563836071646247 -19.089 19.2851 25.9071 0.17773922797810468 0.17773922797810468 0.17773922797810468 -19.089 19.2851 26.9071 0.17254596412503687 0.17254596412503687 0.17254596412503687 -19.089 20.2851 25.9071 0.21681242356912317 0.21681242356912317 0.21681242356912317 -19.089 20.2851 26.9071 0.2083701755235671 0.2083701755235671 0.2083701755235671 -20.089 19.2851 26.9071 0.19966942412904248 0.19966942412904248 0.19966942412904248 -20.089 20.2851 25.9071 0.15818868663067367 0.15818868663067367 0.15818868663067367 -20.089 20.2851 26.9071 0.13796677043833774 0.13796677043833774 0.13796677043833774 -19.089 21.2851 23.9071 0.17717568394776534 0.17717568394776534 0.17717568394776534 -19.089 21.2851 24.9071 0.19533876032582617 0.19533876032582617 0.19533876032582617 -19.089 22.2851 23.9071 0.15720424973514113 0.15720424973514113 0.15720424973514113 -19.089 22.2851 24.9071 0.1395441679071769 0.1395441679071769 0.1395441679071769 -20.089 21.2851 23.9071 0.19142844255893127 0.19142844255893127 0.19142844255893127 -20.089 21.2851 24.9071 0.19696238528236015 0.19696238528236015 0.19696238528236015 -20.089 22.2851 23.9071 0.16430702107144762 0.16430702107144762 0.16430702107144762 -20.089 22.2851 24.9071 0.17175438140464266 0.17175438140464266 0.17175438140464266 -19.089 21.2851 25.9071 0.17361209973984087 0.17361209973984087 0.17361209973984087 -19.089 21.2851 26.9071 0.12706148180110136 0.12706148180110136 0.12706148180110136 -19.089 22.2851 25.9071 0.07143275869815933 0.07143275869815933 0.07143275869815933 -19.089 22.2851 26.9071 0.061274867969598114 0.061274867969598114 0.061274867969598114 -20.089 21.2851 25.9071 0.065716535564507 0.065716535564507 0.065716535564507 -20.089 21.2851 26.9071 0.05925416610329707 0.05925416610329707 0.05925416610329707 -20.089 22.2851 25.9071 0.051248681176686184 0.051248681176686184 0.051248681176686184 -20.089 22.2851 26.9071 0.06959068563516663 0.06959068563516663 0.06959068563516663 -17.089 23.2851 19.9071 0.11851662079985713 0.11851662079985713 0.11851662079985713 -17.089 23.2851 20.9071 0.07166651150676163 0.07166651150676163 0.07166651150676163 -17.089 24.2851 19.9071 0.14349957290382595 0.14349957290382595 0.14349957290382595 -18.089 23.2851 19.9071 0.09046249960064236 0.09046249960064236 0.09046249960064236 -17.089 23.2851 22.9071 0.09057259790065365 0.09057259790065365 0.09057259790065365 -18.089 23.2851 22.9071 0.11294916000663249 0.11294916000663249 0.11294916000663249 -18.089 24.2851 22.9071 0.08556015981036715 0.08556015981036715 0.08556015981036715 -17.089 25.2851 19.9071 0.1641103102086342 0.1641103102086342 0.1641103102086342 -17.089 26.2851 19.9071 0.13238539432483662 0.13238539432483662 0.13238539432483662 -18.089 25.2851 19.9071 0.12875235218414913 0.12875235218414913 0.12875235218414913 -18.089 26.2851 19.9071 0.10094446790376266 0.10094446790376266 0.10094446790376266 -17.089 26.2851 22.9071 0.05452431136162801 0.05452431136162801 0.05452431136162801 -18.089 25.2851 22.9071 0.06463136389017887 0.06463136389017887 0.06463136389017887 -18.089 26.2851 22.9071 0.0722963867396515 0.0722963867396515 0.0722963867396515 -19.089 23.2851 19.9071 0.10767779335578818 0.10767779335578818 0.10767779335578818 -19.089 24.2851 19.9071 0.11053245682335011 0.11053245682335011 0.11053245682335011 -20.089 23.2851 19.9071 0.14517483911746337 0.14517483911746337 0.14517483911746337 -20.089 23.2851 20.9071 0.10777340573337327 0.10777340573337327 0.10777340573337327 -20.089 24.2851 19.9071 0.13176129064206551 0.13176129064206551 0.13176129064206551 -20.089 24.2851 20.9071 0.12348844735618562 0.12348844735618562 0.12348844735618562 -19.089 23.2851 22.9071 0.07564671601195813 0.07564671601195813 0.07564671601195813 -19.089 24.2851 22.9071 0.08589770753563218 0.08589770753563218 0.08589770753563218 -20.089 23.2851 21.9071 0.1083350257245152 0.1083350257245152 0.1083350257245152 -20.089 23.2851 22.9071 0.09371877397266179 0.09371877397266179 0.09371877397266179 -20.089 24.2851 21.9071 0.10515888853115764 0.10515888853115764 0.10515888853115764 -20.089 24.2851 22.9071 0.09656830772888797 0.09656830772888797 0.09656830772888797 -19.089 25.2851 19.9071 0.10085688275023183 0.10085688275023183 0.10085688275023183 -19.089 25.2851 20.9071 0.04860297837802454 0.04860297837802454 0.04860297837802454 -19.089 26.2851 19.9071 0.07718482578022554 0.07718482578022554 0.07718482578022554 -20.089 25.2851 19.9071 0.1393433807414624 0.1393433807414624 0.1393433807414624 -20.089 25.2851 20.9071 0.07740063784715073 0.07740063784715073 0.07740063784715073 -20.089 26.2851 19.9071 0.06874889339966718 0.06874889339966718 0.06874889339966718 -20.089 26.2851 20.9071 0.06461231155653786 0.06461231155653786 0.06461231155653786 -19.089 25.2851 21.9071 0.06382360529642367 0.06382360529642367 0.06382360529642367 -19.089 25.2851 22.9071 0.039159349160945746 0.039159349160945746 0.039159349160945746 -19.089 26.2851 21.9071 0.07268479126554074 0.07268479126554074 0.07268479126554074 -19.089 26.2851 22.9071 0.09084020846887306 0.09084020846887306 0.09084020846887306 -20.089 25.2851 21.9071 0.11945734704869464 0.11945734704869464 0.11945734704869464 -20.089 25.2851 22.9071 0.11324401210846434 0.11324401210846434 0.11324401210846434 -20.089 26.2851 21.9071 0.07229743170468968 0.07229743170468968 0.07229743170468968 -20.089 26.2851 22.9071 0.10689521382622734 0.10689521382622734 0.10689521382622734 -17.089 23.2851 23.9071 0.09862463445329464 0.09862463445329464 0.09862463445329464 -18.089 23.2851 23.9071 0.13472915359995247 0.13472915359995247 0.13472915359995247 -18.089 23.2851 24.9071 0.0904890196428887 0.0904890196428887 0.0904890196428887 -18.089 24.2851 23.9071 0.10871104378497591 0.10871104378497591 0.10871104378497591 -18.089 24.2851 24.9071 0.09363278816486408 0.09363278816486408 0.09363278816486408 -17.089 23.2851 26.9071 0.10814058834581304 0.10814058834581304 0.10814058834581304 -17.089 24.2851 26.9071 0.11124992315750812 0.11124992315750812 0.11124992315750812 -18.089 23.2851 25.9071 0.11178580929118555 0.11178580929118555 0.11178580929118555 -18.089 23.2851 26.9071 0.12531113246099293 0.12531113246099293 0.12531113246099293 -18.089 24.2851 25.9071 0.10965911570850094 0.10965911570850094 0.10965911570850094 -18.089 24.2851 26.9071 0.11747465924650675 0.11747465924650675 0.11747465924650675 -17.089 25.2851 23.9071 0.0603391691259558 0.0603391691259558 0.0603391691259558 -17.089 25.2851 24.9071 0.05506515821429118 0.05506515821429118 0.05506515821429118 -17.089 26.2851 23.9071 0.05949559179675216 0.05949559179675216 0.05949559179675216 -17.089 26.2851 24.9071 0.04909329023879169 0.04909329023879169 0.04909329023879169 -18.089 25.2851 24.9071 0.07695679579040197 0.07695679579040197 0.07695679579040197 -18.089 26.2851 23.9071 0.04355720788256575 0.04355720788256575 0.04355720788256575 -18.089 26.2851 24.9071 0.07461786363346286 0.07461786363346286 0.07461786363346286 -17.089 25.2851 25.9071 0.0757359361842012 0.0757359361842012 0.0757359361842012 -17.089 25.2851 26.9071 0.11049228494695193 0.11049228494695193 0.11049228494695193 -17.089 26.2851 26.9071 0.11087713069843044 0.11087713069843044 0.11087713069843044 -18.089 25.2851 25.9071 0.09550597220000498 0.09550597220000498 0.09550597220000498 -18.089 25.2851 26.9071 0.12158297832108791 0.12158297832108791 0.12158297832108791 -18.089 26.2851 25.9071 0.059684760340378853 0.059684760340378853 0.059684760340378853 -18.089 26.2851 26.9071 0.0893148966713905 0.0893148966713905 0.0893148966713905 -19.089 23.2851 23.9071 0.1282519225141801 0.1282519225141801 0.1282519225141801 -19.089 24.2851 23.9071 0.1004052953995953 0.1004052953995953 0.1004052953995953 -19.089 24.2851 24.9071 0.09262505979223057 0.09262505979223057 0.09262505979223057 -20.089 23.2851 23.9071 0.09608214230257779 0.09608214230257779 0.09608214230257779 -20.089 24.2851 23.9071 0.07927998683943518 0.07927998683943518 0.07927998683943518 -20.089 24.2851 24.9071 0.10681808031880143 0.10681808031880143 0.10681808031880143 -19.089 23.2851 25.9071 0.03271237797864099 0.03271237797864099 0.03271237797864099 -19.089 23.2851 26.9071 0.06429477199838059 0.06429477199838059 0.06429477199838059 -19.089 24.2851 25.9071 0.05904280748388366 0.05904280748388366 0.05904280748388366 -19.089 24.2851 26.9071 0.14021880911358087 0.14021880911358087 0.14021880911358087 -20.089 23.2851 25.9071 0.0537937161208944 0.0537937161208944 0.0537937161208944 -20.089 23.2851 26.9071 0.10298782658070564 0.10298782658070564 0.10298782658070564 -20.089 24.2851 25.9071 0.08778312663925644 0.08778312663925644 0.08778312663925644 -20.089 24.2851 26.9071 0.06637652243907233 0.06637652243907233 0.06637652243907233 -19.089 26.2851 24.9071 0.058887403473771055 0.058887403473771055 0.058887403473771055 -19.089 25.2851 25.9071 0.11936656865021981 0.11936656865021981 0.11936656865021981 -19.089 26.2851 25.9071 0.03785203124289703 0.03785203124289703 0.03785203124289703 -20.089 25.2851 25.9071 0.09597285512461974 0.09597285512461974 0.09597285512461974 -20.089 25.2851 26.9071 0.09284926839273631 0.09284926839273631 0.09284926839273631 -20.089 26.2851 25.9071 0.04546098776220845 0.04546098776220845 0.04546098776220845 -20.089 26.2851 26.9071 0.07012218704446052 0.07012218704446052 0.07012218704446052 -21.089 19.2851 19.9071 0.06788940736609074 0.06788940736609074 0.06788940736609074 -21.089 19.2851 20.9071 0.06979237041576189 0.06979237041576189 0.06979237041576189 -21.089 20.2851 19.9071 0.08922890615679609 0.08922890615679609 0.08922890615679609 -22.089 20.2851 19.9071 0.08445267185175015 0.08445267185175015 0.08445267185175015 -21.089 21.2851 19.9071 0.07193048738331037 0.07193048738331037 0.07193048738331037 -21.089 22.2851 19.9071 0.06915990325671668 0.06915990325671668 0.06915990325671668 -22.089 21.2851 19.9071 0.06633118368447243 0.06633118368447243 0.06633118368447243 -22.089 21.2851 20.9071 0.0528370259119781 0.0528370259119781 0.0528370259119781 -22.089 22.2851 19.9071 0.049136548176875766 0.049136548176875766 0.049136548176875766 -22.089 22.2851 20.9071 0.08241768326261677 0.08241768326261677 0.08241768326261677 -21.089 21.2851 21.9071 0.07933351653723304 0.07933351653723304 0.07933351653723304 -21.089 21.2851 22.9071 0.10302478815518681 0.10302478815518681 0.10302478815518681 -21.089 22.2851 21.9071 0.10114454739219905 0.10114454739219905 0.10114454739219905 -22.089 21.2851 22.9071 0.0891822944375984 0.0891822944375984 0.0891822944375984 -22.089 22.2851 21.9071 0.05949711929633723 0.05949711929633723 0.05949711929633723 -23.089 20.2851 19.9071 0.0649013116599745 0.0649013116599745 0.0649013116599745 -23.089 21.2851 19.9071 0.0217599153072024 0.0217599153072024 0.0217599153072024 -23.089 21.2851 20.9071 0.07906417981366448 0.07906417981366448 0.07906417981366448 -23.089 22.2851 20.9071 0.10529307141475817 0.10529307141475817 0.10529307141475817 -24.089 21.2851 19.9071 0.10692253192570376 0.10692253192570376 0.10692253192570376 -24.089 22.2851 19.9071 0.14421513910662295 0.14421513910662295 0.14421513910662295 -24.089 22.2851 20.9071 0.12327717708645404 0.12327717708645404 0.12327717708645404 -23.089 21.2851 22.9071 0.07928826545869634 0.07928826545869634 0.07928826545869634 -23.089 22.2851 21.9071 0.08931087842508134 0.08931087842508134 0.08931087842508134 -23.089 22.2851 22.9071 0.1014281933644792 0.1014281933644792 0.1014281933644792 -24.089 22.2851 21.9071 0.0829617986021448 0.0829617986021448 0.0829617986021448 -21.089 20.2851 23.9071 0.12540029757459947 0.12540029757459947 0.12540029757459947 -21.089 19.2851 26.9071 0.18264558699088734 0.18264558699088734 0.18264558699088734 -21.089 20.2851 26.9071 0.03956198625607378 0.03956198625607378 0.03956198625607378 -22.089 19.2851 26.9071 0.19451690307237754 0.19451690307237754 0.19451690307237754 -22.089 20.2851 25.9071 0.06874937571248851 0.06874937571248851 0.06874937571248851 -22.089 20.2851 26.9071 0.057516571135412094 0.057516571135412094 0.057516571135412094 -21.089 21.2851 23.9071 0.16723755452119218 0.16723755452119218 0.16723755452119218 -21.089 21.2851 24.9071 0.10164835980374588 0.10164835980374588 0.10164835980374588 -21.089 22.2851 24.9071 0.08275845903145468 0.08275845903145468 0.08275845903145468 -22.089 21.2851 23.9071 0.1382117349046817 0.1382117349046817 0.1382117349046817 -22.089 21.2851 24.9071 0.08383542956649949 0.08383542956649949 0.08383542956649949 -22.089 22.2851 24.9071 0.06976045779184224 0.06976045779184224 0.06976045779184224 -21.089 21.2851 25.9071 0.07991189220180382 0.07991189220180382 0.07991189220180382 -21.089 21.2851 26.9071 0.06601188236988122 0.06601188236988122 0.06601188236988122 -21.089 22.2851 25.9071 0.11299575795837935 0.11299575795837935 0.11299575795837935 -22.089 21.2851 25.9071 0.10689039298417304 0.10689039298417304 0.10689039298417304 -22.089 21.2851 26.9071 0.08453384528954427 0.08453384528954427 0.08453384528954427 -22.089 22.2851 25.9071 0.05813699002522544 0.05813699002522544 0.05813699002522544 -23.089 19.2851 25.9071 0.16014307133007688 0.16014307133007688 0.16014307133007688 -23.089 19.2851 26.9071 0.2151715465104368 0.2151715465104368 0.2151715465104368 -23.089 20.2851 25.9071 0.12020204738893527 0.12020204738893527 0.12020204738893527 -23.089 20.2851 26.9071 0.1532816388946176 0.1532816388946176 0.1532816388946176 -24.089 19.2851 25.9071 0.1447781109612738 0.1447781109612738 0.1447781109612738 -24.089 20.2851 25.9071 0.1269891872633503 0.1269891872633503 0.1269891872633503 -24.089 20.2851 26.9071 0.19584519357387653 0.19584519357387653 0.19584519357387653 -23.089 21.2851 23.9071 0.11902032443777724 0.11902032443777724 0.11902032443777724 -23.089 21.2851 24.9071 0.05635000665859785 0.05635000665859785 0.05635000665859785 -23.089 22.2851 23.9071 0.14220254274444918 0.14220254274444918 0.14220254274444918 -23.089 22.2851 24.9071 0.10280301845353731 0.10280301845353731 0.10280301845353731 -23.089 21.2851 25.9071 0.10230644494819495 0.10230644494819495 0.10230644494819495 -23.089 21.2851 26.9071 0.15027832343544537 0.15027832343544537 0.15027832343544537 -23.089 22.2851 25.9071 0.12600115540319062 0.12600115540319062 0.12600115540319062 -23.089 22.2851 26.9071 0.19426809697489258 0.19426809697489258 0.19426809697489258 -24.089 22.2851 26.9071 0.1665085441194459 0.1665085441194459 0.1665085441194459 -21.089 23.2851 19.9071 0.11212887095408602 0.11212887095408602 0.11212887095408602 -21.089 23.2851 20.9071 0.1085768666018301 0.1085768666018301 0.1085768666018301 -21.089 24.2851 19.9071 0.11293550198119062 0.11293550198119062 0.11293550198119062 -21.089 24.2851 20.9071 0.12161511139392574 0.12161511139392574 0.12161511139392574 -22.089 23.2851 20.9071 0.07351207379431823 0.07351207379431823 0.07351207379431823 -22.089 24.2851 19.9071 0.07715564890889197 0.07715564890889197 0.07715564890889197 -22.089 24.2851 20.9071 0.10602585063928147 0.10602585063928147 0.10602585063928147 -21.089 23.2851 21.9071 0.09220958915685895 0.09220958915685895 0.09220958915685895 -21.089 23.2851 22.9071 0.09999629328068707 0.09999629328068707 0.09999629328068707 -21.089 24.2851 21.9071 0.09815053486842718 0.09815053486842718 0.09815053486842718 -21.089 24.2851 22.9071 0.1002269096623312 0.1002269096623312 0.1002269096623312 -22.089 23.2851 21.9071 0.08646108760842093 0.08646108760842093 0.08646108760842093 -22.089 23.2851 22.9071 0.0980525003684129 0.0980525003684129 0.0980525003684129 -22.089 24.2851 21.9071 0.09405789467378133 0.09405789467378133 0.09405789467378133 -22.089 24.2851 22.9071 0.09788053792408533 0.09788053792408533 0.09788053792408533 -21.089 25.2851 19.9071 0.1343797626992576 0.1343797626992576 0.1343797626992576 -21.089 25.2851 20.9071 0.1416949685933247 0.1416949685933247 0.1416949685933247 -21.089 26.2851 20.9071 0.07747225356712897 0.07747225356712897 0.07747225356712897 -22.089 25.2851 20.9071 0.1335042707893638 0.1335042707893638 0.1335042707893638 -22.089 26.2851 20.9071 0.1281916779619812 0.1281916779619812 0.1281916779619812 -21.089 25.2851 21.9071 0.09241531569708698 0.09241531569708698 0.09241531569708698 -21.089 25.2851 22.9071 0.106168066886469 0.106168066886469 0.106168066886469 -21.089 26.2851 21.9071 0.09352831930279255 0.09352831930279255 0.09352831930279255 -21.089 26.2851 22.9071 0.1359058267380028 0.1359058267380028 0.1359058267380028 -22.089 25.2851 21.9071 0.11981162282743875 0.11981162282743875 0.11981162282743875 -22.089 25.2851 22.9071 0.08915416666293173 0.08915416666293173 0.08915416666293173 -22.089 26.2851 21.9071 0.1591152989350712 0.1591152989350712 0.1591152989350712 -22.089 26.2851 22.9071 0.09383047502498104 0.09383047502498104 0.09383047502498104 -24.089 23.2851 20.9071 0.14556674679226053 0.14556674679226053 0.14556674679226053 -23.089 23.2851 21.9071 0.09021658606526584 0.09021658606526584 0.09021658606526584 -23.089 23.2851 22.9071 0.10260294308947328 0.10260294308947328 0.10260294308947328 -23.089 24.2851 21.9071 0.08706062897338096 0.08706062897338096 0.08706062897338096 -23.089 24.2851 22.9071 0.08172166034434761 0.08172166034434761 0.08172166034434761 -24.089 23.2851 21.9071 0.12132912659449364 0.12132912659449364 0.12132912659449364 -24.089 24.2851 21.9071 0.09856356415505144 0.09856356415505144 0.09856356415505144 -24.089 24.2851 22.9071 0.11601813987196144 0.11601813987196144 0.11601813987196144 -24.089 26.2851 19.9071 0.12761734429924873 0.12761734429924873 0.12761734429924873 -23.089 25.2851 21.9071 0.10198584003742293 0.10198584003742293 0.10198584003742293 -23.089 25.2851 22.9071 0.11991686091016626 0.11991686091016626 0.11991686091016626 -23.089 26.2851 21.9071 0.08342071724641166 0.08342071724641166 0.08342071724641166 -23.089 26.2851 22.9071 0.08158261578340584 0.08158261578340584 0.08158261578340584 -24.089 25.2851 21.9071 0.07080882507654128 0.07080882507654128 0.07080882507654128 -24.089 25.2851 22.9071 0.11640376257065131 0.11640376257065131 0.11640376257065131 -21.089 23.2851 24.9071 0.06000593583332024 0.06000593583332024 0.06000593583332024 -21.089 24.2851 24.9071 0.045312231453563126 0.045312231453563126 0.045312231453563126 -22.089 23.2851 23.9071 0.09755027257263736 0.09755027257263736 0.09755027257263736 -22.089 23.2851 24.9071 0.07867869960391562 0.07867869960391562 0.07867869960391562 -22.089 24.2851 24.9071 0.06719157062179726 0.06719157062179726 0.06719157062179726 -21.089 23.2851 25.9071 0.1129756726376581 0.1129756726376581 0.1129756726376581 -21.089 24.2851 25.9071 0.07025707144725787 0.07025707144725787 0.07025707144725787 -21.089 24.2851 26.9071 0.19559960193728046 0.19559960193728046 0.19559960193728046 -22.089 23.2851 25.9071 0.19703782726671137 0.19703782726671137 0.19703782726671137 -21.089 25.2851 24.9071 0.04002412784776433 0.04002412784776433 0.04002412784776433 -22.089 25.2851 24.9071 0.05338495938002822 0.05338495938002822 0.05338495938002822 -22.089 26.2851 23.9071 0.05995769929543171 0.05995769929543171 0.05995769929543171 -22.089 26.2851 24.9071 0.06550053137614766 0.06550053137614766 0.06550053137614766 -21.089 25.2851 25.9071 0.1067264841826648 0.1067264841826648 0.1067264841826648 -21.089 25.2851 26.9071 0.08466886627195919 0.08466886627195919 0.08466886627195919 -21.089 26.2851 25.9071 0.10780233046386978 0.10780233046386978 0.10780233046386978 -21.089 26.2851 26.9071 0.4084419207704598 0.4084419207704598 0.4084419207704598 -22.089 25.2851 25.9071 0.0965257181477996 0.0965257181477996 0.0965257181477996 -22.089 25.2851 26.9071 0.05688183673817317 0.05688183673817317 0.05688183673817317 -22.089 26.2851 25.9071 0.6548891305709614 0.6548891305709614 0.6548891305709614 -22.089 26.2851 26.9071 0.5033997903916577 0.5033997903916577 0.5033997903916577 -23.089 23.2851 23.9071 0.12166813093604752 0.12166813093604752 0.12166813093604752 -23.089 24.2851 23.9071 0.13372434946864478 0.13372434946864478 0.13372434946864478 -23.089 24.2851 24.9071 0.09589169322730172 0.09589169322730172 0.09589169322730172 -24.089 24.2851 23.9071 0.1576836222240208 0.1576836222240208 0.1576836222240208 -24.089 24.2851 24.9071 0.16621549292253232 0.16621549292253232 0.16621549292253232 -23.089 23.2851 25.9071 0.17366588783398587 0.17366588783398587 0.17366588783398587 -23.089 24.2851 25.9071 0.09594955122188362 0.09594955122188362 0.09594955122188362 -24.089 23.2851 25.9071 0.10421558457779476 0.10421558457779476 0.10421558457779476 -24.089 23.2851 26.9071 0.19685484020361874 0.19685484020361874 0.19685484020361874 -24.089 24.2851 25.9071 0.10443413639295268 0.10443413639295268 0.10443413639295268 -24.089 24.2851 26.9071 0.16436884438614105 0.16436884438614105 0.16436884438614105 -23.089 25.2851 24.9071 0.10601379840338986 0.10601379840338986 0.10601379840338986 -23.089 26.2851 23.9071 0.10117267097519414 0.10117267097519414 0.10117267097519414 -23.089 26.2851 24.9071 0.13025201603725683 0.13025201603725683 0.13025201603725683 -24.089 26.2851 24.9071 0.09808062503226732 0.09808062503226732 0.09808062503226732 -23.089 25.2851 25.9071 0.0766704110702252 0.0766704110702252 0.0766704110702252 -23.089 26.2851 25.9071 0.08450009000852138 0.08450009000852138 0.08450009000852138 -24.089 25.2851 25.9071 0.10307942697333808 0.10307942697333808 0.10307942697333808 -24.089 25.2851 26.9071 0.20669943460907983 0.20669943460907983 0.20669943460907983 -24.089 26.2851 25.9071 0.04819467770014394 0.04819467770014394 0.04819467770014394 -11.088999999999999 26.2851 32.9071 0.08820906771813568 0.08820906771813568 0.08820906771813568 -12.088999999999999 26.2851 31.9071 0.07684595545970407 0.07684595545970407 0.07684595545970407 -12.088999999999999 26.2851 32.9071 0.10412077147334727 0.10412077147334727 0.10412077147334727 -12.088999999999999 25.2851 34.9071 0.07596742589946504 0.07596742589946504 0.07596742589946504 -12.088999999999999 26.2851 33.9071 0.0906336742648923 0.0906336742648923 0.0906336742648923 -12.088999999999999 26.2851 34.9071 0.08966689426828006 0.08966689426828006 0.08966689426828006 -14.088999999999999 22.2851 27.9071 0.10842822694605399 0.10842822694605399 0.10842822694605399 -15.088999999999999 21.2851 27.9071 0.10744237752165035 0.10744237752165035 0.10744237752165035 -15.088999999999999 22.2851 27.9071 0.12620518899282776 0.12620518899282776 0.12620518899282776 -15.088999999999999 22.2851 28.9071 0.08489148965889486 0.08489148965889486 0.08489148965889486 -16.089 21.2851 27.9071 0.11020626060721207 0.11020626060721207 0.11020626060721207 -16.089 22.2851 27.9071 0.12480023855344974 0.12480023855344974 0.12480023855344974 -16.089 22.2851 28.9071 0.1284013288089937 0.1284013288089937 0.1284013288089937 -16.089 22.2851 29.9071 0.08017254568984561 0.08017254568984561 0.08017254568984561 -14.088999999999999 23.2851 27.9071 0.09902560802323476 0.09902560802323476 0.09902560802323476 -14.088999999999999 23.2851 28.9071 0.051096397832147616 0.051096397832147616 0.051096397832147616 -14.088999999999999 24.2851 27.9071 0.10722785122991811 0.10722785122991811 0.10722785122991811 -14.088999999999999 24.2851 28.9071 0.05807765770125178 0.05807765770125178 0.05807765770125178 -13.088999999999999 23.2851 29.9071 0.02973142004495849 0.02973142004495849 0.02973142004495849 -13.088999999999999 23.2851 30.9071 0.029117537774100095 0.029117537774100095 0.029117537774100095 -13.088999999999999 24.2851 29.9071 0.04223789963145824 0.04223789963145824 0.04223789963145824 -13.088999999999999 24.2851 30.9071 0.043439245381534264 0.043439245381534264 0.043439245381534264 -14.088999999999999 23.2851 29.9071 0.06549578844179862 0.06549578844179862 0.06549578844179862 -14.088999999999999 23.2851 30.9071 0.06534570256128512 0.06534570256128512 0.06534570256128512 -14.088999999999999 24.2851 29.9071 0.07518260876322543 0.07518260876322543 0.07518260876322543 -14.088999999999999 24.2851 30.9071 0.07557702775453966 0.07557702775453966 0.07557702775453966 -13.088999999999999 26.2851 27.9071 0.038905558896092436 0.038905558896092436 0.038905558896092436 -14.088999999999999 25.2851 27.9071 0.1068855721418477 0.1068855721418477 0.1068855721418477 -14.088999999999999 25.2851 28.9071 0.0871016162225734 0.0871016162225734 0.0871016162225734 -14.088999999999999 26.2851 27.9071 0.0745243017176414 0.0745243017176414 0.0745243017176414 -14.088999999999999 26.2851 28.9071 0.10149568970917104 0.10149568970917104 0.10149568970917104 -14.088999999999999 25.2851 29.9071 0.05099460743162024 0.05099460743162024 0.05099460743162024 -14.088999999999999 25.2851 30.9071 0.06493290465422222 0.06493290465422222 0.06493290465422222 -14.088999999999999 26.2851 29.9071 0.07018424354392773 0.07018424354392773 0.07018424354392773 -14.088999999999999 26.2851 30.9071 0.07578038547633532 0.07578038547633532 0.07578038547633532 -15.088999999999999 23.2851 27.9071 0.08919515284558911 0.08919515284558911 0.08919515284558911 -15.088999999999999 23.2851 28.9071 0.04119076824177712 0.04119076824177712 0.04119076824177712 -15.088999999999999 24.2851 27.9071 0.08507151678485045 0.08507151678485045 0.08507151678485045 -15.088999999999999 23.2851 29.9071 0.06282338183420465 0.06282338183420465 0.06282338183420465 -15.088999999999999 23.2851 30.9071 0.07156780166905716 0.07156780166905716 0.07156780166905716 -16.089 23.2851 29.9071 0.07670216019834714 0.07670216019834714 0.07670216019834714 -16.089 23.2851 30.9071 0.08185105997996976 0.08185105997996976 0.08185105997996976 -15.088999999999999 25.2851 27.9071 0.10878817547760894 0.10878817547760894 0.10878817547760894 -15.088999999999999 26.2851 27.9071 0.10179460141213165 0.10179460141213165 0.10179460141213165 -15.088999999999999 26.2851 28.9071 0.11019902964161474 0.11019902964161474 0.11019902964161474 -16.089 26.2851 27.9071 0.09494024468153812 0.09494024468153812 0.09494024468153812 -16.089 26.2851 28.9071 0.11199952000708724 0.11199952000708724 0.11199952000708724 -15.088999999999999 26.2851 29.9071 0.08425898044655945 0.08425898044655945 0.08425898044655945 -15.088999999999999 26.2851 30.9071 0.08730574848602286 0.08730574848602286 0.08730574848602286 -16.089 25.2851 30.9071 0.05866076873779828 0.05866076873779828 0.05866076873779828 -16.089 26.2851 29.9071 0.07011012942891091 0.07011012942891091 0.07011012942891091 -16.089 26.2851 30.9071 0.06044842432481878 0.06044842432481878 0.06044842432481878 -14.088999999999999 24.2851 31.9071 0.07782864330643913 0.07782864330643913 0.07782864330643913 -13.088999999999999 26.2851 31.9071 0.0837430035562466 0.0837430035562466 0.0837430035562466 -13.088999999999999 26.2851 32.9071 0.05724137278366139 0.05724137278366139 0.05724137278366139 -14.088999999999999 25.2851 31.9071 0.07103116528585816 0.07103116528585816 0.07103116528585816 -14.088999999999999 26.2851 31.9071 0.07811872120490512 0.07811872120490512 0.07811872120490512 -14.088999999999999 26.2851 32.9071 0.11493195933556632 0.11493195933556632 0.11493195933556632 -13.088999999999999 25.2851 34.9071 0.08896289753445873 0.08896289753445873 0.08896289753445873 -13.088999999999999 26.2851 33.9071 0.054169908776410675 0.054169908776410675 0.054169908776410675 -13.088999999999999 26.2851 34.9071 0.0974924157291727 0.0974924157291727 0.0974924157291727 -14.088999999999999 25.2851 34.9071 0.097070541654506 0.097070541654506 0.097070541654506 -14.088999999999999 26.2851 33.9071 0.10531476563241829 0.10531476563241829 0.10531476563241829 -14.088999999999999 26.2851 34.9071 0.14059307191459144 0.14059307191459144 0.14059307191459144 -15.088999999999999 23.2851 31.9071 0.059743689506843896 0.059743689506843896 0.059743689506843896 -15.088999999999999 24.2851 31.9071 0.1126968878682736 0.1126968878682736 0.1126968878682736 -16.089 23.2851 31.9071 0.06853289735248694 0.06853289735248694 0.06853289735248694 -16.089 24.2851 31.9071 0.09839562059586945 0.09839562059586945 0.09839562059586945 -16.089 24.2851 32.9071 0.11500506810119088 0.11500506810119088 0.11500506810119088 -16.089 23.2851 34.9071 0.12145605255791987 0.12145605255791987 0.12145605255791987 -16.089 24.2851 33.9071 0.14634091945751132 0.14634091945751132 0.14634091945751132 -16.089 24.2851 34.9071 0.18517250202489388 0.18517250202489388 0.18517250202489388 -15.088999999999999 25.2851 31.9071 0.07082867977676129 0.07082867977676129 0.07082867977676129 -15.088999999999999 26.2851 31.9071 0.07707012766028375 0.07707012766028375 0.07707012766028375 -16.089 25.2851 31.9071 0.07743929909111036 0.07743929909111036 0.07743929909111036 -16.089 25.2851 32.9071 0.12448373975687109 0.12448373975687109 0.12448373975687109 -15.088999999999999 25.2851 34.9071 0.16619863241023192 0.16619863241023192 0.16619863241023192 -15.088999999999999 26.2851 34.9071 0.14293659210260334 0.14293659210260334 0.14293659210260334 -16.089 25.2851 33.9071 0.17863832139227614 0.17863832139227614 0.17863832139227614 -16.089 25.2851 34.9071 0.22228524880786182 0.22228524880786182 0.22228524880786182 -16.089 26.2851 33.9071 0.19873124042769363 0.19873124042769363 0.19873124042769363 -16.089 26.2851 34.9071 0.24326163252946403 0.24326163252946403 0.24326163252946403 -12.088999999999999 25.2851 35.9071 0.09265720443282148 0.09265720443282148 0.09265720443282148 -12.088999999999999 25.2851 36.9071 0.04698761363754212 0.04698761363754212 0.04698761363754212 -12.088999999999999 26.2851 35.9071 0.12570875990810354 0.12570875990810354 0.12570875990810354 -12.088999999999999 26.2851 36.9071 0.0938497615219015 0.0938497615219015 0.0938497615219015 -13.088999999999999 25.2851 35.9071 0.10725838309662347 0.10725838309662347 0.10725838309662347 -13.088999999999999 25.2851 36.9071 0.07016197716296739 0.07016197716296739 0.07016197716296739 -13.088999999999999 26.2851 36.9071 0.10431200456942939 0.10431200456942939 0.10431200456942939 -14.088999999999999 25.2851 35.9071 0.10390382581401321 0.10390382581401321 0.10390382581401321 -14.088999999999999 25.2851 36.9071 0.06819310634202695 0.06819310634202695 0.06819310634202695 -14.088999999999999 26.2851 35.9071 0.14939336792388497 0.14939336792388497 0.14939336792388497 -14.088999999999999 26.2851 36.9071 0.10407175787553465 0.10407175787553465 0.10407175787553465 -16.089 24.2851 35.9071 0.18428311404370323 0.18428311404370323 0.18428311404370323 -15.088999999999999 26.2851 35.9071 0.12395597122796415 0.12395597122796415 0.12395597122796415 -16.089 25.2851 35.9071 0.22570868440713607 0.22570868440713607 0.22570868440713607 -16.089 26.2851 35.9071 0.20986835605055168 0.20986835605055168 0.20986835605055168 -19.089 17.2851 27.9071 0.12323861819409083 0.12323861819409083 0.12323861819409083 -19.089 17.2851 28.9071 0.12079089401839453 0.12079089401839453 0.12079089401839453 -19.089 18.2851 27.9071 0.11496811203016095 0.11496811203016095 0.11496811203016095 -19.089 18.2851 28.9071 0.15964845750383855 0.15964845750383855 0.15964845750383855 -20.089 17.2851 27.9071 0.22991978374750802 0.22991978374750802 0.22991978374750802 -20.089 17.2851 28.9071 0.18596475542145785 0.18596475542145785 0.18596475542145785 -20.089 18.2851 28.9071 0.25538144839943333 0.25538144839943333 0.25538144839943333 -19.089 18.2851 29.9071 0.11627200835646602 0.11627200835646602 0.11627200835646602 -20.089 18.2851 29.9071 0.1866887734861001 0.1866887734861001 0.1866887734861001 -21.089 17.2851 27.9071 0.18401420870213095 0.18401420870213095 0.18401420870213095 -21.089 17.2851 28.9071 0.18197049873377688 0.18197049873377688 0.18197049873377688 -21.089 18.2851 27.9071 0.23496655489874363 0.23496655489874363 0.23496655489874363 -21.089 18.2851 28.9071 0.2822581307858592 0.2822581307858592 0.2822581307858592 -22.089 18.2851 27.9071 0.25937286420649486 0.25937286420649486 0.25937286420649486 -22.089 18.2851 28.9071 0.2427891866144631 0.2427891866144631 0.2427891866144631 -21.089 18.2851 29.9071 0.18776274837065351 0.18776274837065351 0.18776274837065351 -23.089 17.2851 27.9071 0.1761834515315428 0.1761834515315428 0.1761834515315428 -23.089 18.2851 27.9071 0.2864606595797801 0.2864606595797801 0.2864606595797801 -23.089 18.2851 28.9071 0.22213280746285985 0.22213280746285985 0.22213280746285985 -24.089 17.2851 27.9071 0.20583917407468483 0.20583917407468483 0.20583917407468483 -24.089 18.2851 27.9071 0.3001923068477756 0.3001923068477756 0.3001923068477756 -24.089 18.2851 28.9071 0.23981006646663489 0.23981006646663489 0.23981006646663489 -17.089 22.2851 27.9071 0.13785272115363614 0.13785272115363614 0.13785272115363614 -17.089 22.2851 28.9071 0.13630902408659792 0.13630902408659792 0.13630902408659792 -18.089 22.2851 27.9071 0.14670872917150246 0.14670872917150246 0.14670872917150246 -18.089 22.2851 28.9071 0.11810449729593354 0.11810449729593354 0.11810449729593354 -17.089 22.2851 29.9071 0.11303994564630866 0.11303994564630866 0.11303994564630866 -19.089 19.2851 27.9071 0.15652493307531537 0.15652493307531537 0.15652493307531537 -19.089 19.2851 28.9071 0.14231497962315973 0.14231497962315973 0.14231497962315973 -19.089 20.2851 27.9071 0.010308900236629817 0.010308900236629817 0.010308900236629817 -19.089 20.2851 28.9071 0.0877244591064193 0.0877244591064193 0.0877244591064193 -20.089 19.2851 28.9071 0.18440432182916883 0.18440432182916883 0.18440432182916883 -20.089 20.2851 27.9071 0.059496476138621676 0.059496476138621676 0.059496476138621676 -20.089 20.2851 28.9071 0.0713380677178971 0.0713380677178971 0.0713380677178971 -20.089 19.2851 29.9071 0.18430880047706913 0.18430880047706913 0.18430880047706913 -20.089 19.2851 30.9071 0.13509541001863626 0.13509541001863626 0.13509541001863626 -20.089 20.2851 30.9071 0.12828967574390696 0.12828967574390696 0.12828967574390696 -19.089 21.2851 27.9071 0.06588591395484454 0.06588591395484454 0.06588591395484454 -19.089 21.2851 28.9071 0.07858064137430724 0.07858064137430724 0.07858064137430724 -19.089 22.2851 27.9071 0.0986905260388705 0.0986905260388705 0.0986905260388705 -19.089 22.2851 28.9071 0.0980235721324638 0.0980235721324638 0.0980235721324638 -20.089 21.2851 27.9071 0.07120527508586187 0.07120527508586187 0.07120527508586187 -20.089 21.2851 28.9071 0.07592442352008685 0.07592442352008685 0.07592442352008685 -20.089 22.2851 27.9071 0.09043115772125615 0.09043115772125615 0.09043115772125615 -19.089 21.2851 29.9071 0.08333793526766572 0.08333793526766572 0.08333793526766572 -19.089 22.2851 29.9071 0.10148122621150274 0.10148122621150274 0.10148122621150274 -20.089 21.2851 29.9071 0.07772825312236549 0.07772825312236549 0.07772825312236549 -20.089 21.2851 30.9071 0.012237599610492946 0.012237599610492946 0.012237599610492946 -20.089 22.2851 30.9071 0.041582941531167636 0.041582941531167636 0.041582941531167636 -19.089 20.2851 31.9071 0.0976683968321735 0.0976683968321735 0.0976683968321735 -20.089 19.2851 31.9071 0.14458777712309323 0.14458777712309323 0.14458777712309323 -20.089 19.2851 32.9071 0.06290176340169869 0.06290176340169869 0.06290176340169869 -20.089 20.2851 31.9071 0.17926045604272028 0.17926045604272028 0.17926045604272028 -20.089 20.2851 32.9071 0.10088259583271861 0.10088259583271861 0.10088259583271861 -19.089 21.2851 31.9071 0.1077822438465717 0.1077822438465717 0.1077822438465717 -20.089 21.2851 31.9071 0.1508982683224367 0.1508982683224367 0.1508982683224367 -20.089 21.2851 32.9071 0.14593456004550198 0.14593456004550198 0.14593456004550198 -20.089 22.2851 31.9071 0.12083829076295649 0.12083829076295649 0.12083829076295649 -20.089 22.2851 32.9071 0.13111629809389647 0.13111629809389647 0.13111629809389647 -17.089 24.2851 27.9071 0.10772519782611549 0.10772519782611549 0.10772519782611549 -17.089 24.2851 28.9071 0.09582097784407172 0.09582097784407172 0.09582097784407172 -18.089 23.2851 27.9071 0.1387908118743208 0.1387908118743208 0.1387908118743208 -18.089 23.2851 28.9071 0.11934809161850315 0.11934809161850315 0.11934809161850315 -18.089 24.2851 27.9071 0.12774907993529383 0.12774907993529383 0.12774907993529383 -18.089 24.2851 28.9071 0.16213916051672322 0.16213916051672322 0.16213916051672322 -17.089 23.2851 29.9071 0.09218387330233763 0.09218387330233763 0.09218387330233763 -17.089 23.2851 30.9071 0.0709773085308741 0.0709773085308741 0.0709773085308741 -17.089 24.2851 29.9071 0.07356432123937118 0.07356432123937118 0.07356432123937118 -17.089 24.2851 30.9071 0.07667338503971624 0.07667338503971624 0.07667338503971624 -18.089 24.2851 29.9071 0.12449096943871832 0.12449096943871832 0.12449096943871832 -18.089 24.2851 30.9071 0.15458250544559574 0.15458250544559574 0.15458250544559574 -17.089 25.2851 27.9071 0.11465639492955683 0.11465639492955683 0.11465639492955683 -17.089 25.2851 28.9071 0.10665417136997085 0.10665417136997085 0.10665417136997085 -17.089 26.2851 27.9071 0.12613048384091088 0.12613048384091088 0.12613048384091088 -17.089 26.2851 28.9071 0.0990376613060199 0.0990376613060199 0.0990376613060199 -18.089 25.2851 27.9071 0.15871783655869648 0.15871783655869648 0.15871783655869648 -18.089 25.2851 28.9071 0.1874505105138936 0.1874505105138936 0.1874505105138936 -18.089 26.2851 27.9071 0.12847924488493023 0.12847924488493023 0.12847924488493023 -18.089 26.2851 28.9071 0.12985360779923422 0.12985360779923422 0.12985360779923422 -17.089 25.2851 29.9071 0.10002120309590755 0.10002120309590755 0.10002120309590755 -17.089 25.2851 30.9071 0.08742308411955073 0.08742308411955073 0.08742308411955073 -17.089 26.2851 29.9071 0.12829288878391484 0.12829288878391484 0.12829288878391484 -17.089 26.2851 30.9071 0.13906227786759945 0.13906227786759945 0.13906227786759945 -18.089 25.2851 29.9071 0.1532495184667747 0.1532495184667747 0.1532495184667747 -18.089 26.2851 29.9071 0.1701856437528348 0.1701856437528348 0.1701856437528348 -19.089 23.2851 27.9071 0.08304377725603625 0.08304377725603625 0.08304377725603625 -19.089 23.2851 28.9071 0.07405841963050169 0.07405841963050169 0.07405841963050169 -19.089 24.2851 27.9071 0.09053000514553103 0.09053000514553103 0.09053000514553103 -19.089 24.2851 28.9071 0.06426526889226127 0.06426526889226127 0.06426526889226127 -20.089 23.2851 27.9071 0.13611465430226966 0.13611465430226966 0.13611465430226966 -20.089 24.2851 27.9071 0.047333363920818675 0.047333363920818675 0.047333363920818675 -20.089 24.2851 28.9071 0.0 0.0 0.0 -19.089 23.2851 29.9071 0.11669458513332089 0.11669458513332089 0.11669458513332089 -19.089 24.2851 29.9071 0.06621397806211882 0.06621397806211882 0.06621397806211882 -19.089 24.2851 30.9071 0.08857553597374503 0.08857553597374503 0.08857553597374503 -20.089 23.2851 29.9071 0.19830508151455342 0.19830508151455342 0.19830508151455342 -20.089 23.2851 30.9071 0.14965355549105802 0.14965355549105802 0.14965355549105802 -20.089 24.2851 30.9071 0.09849767246547644 0.09849767246547644 0.09849767246547644 -19.089 25.2851 27.9071 0.01807393422912629 0.01807393422912629 0.01807393422912629 -19.089 25.2851 28.9071 0.07075930887975636 0.07075930887975636 0.07075930887975636 -19.089 26.2851 27.9071 0.11706654726561408 0.11706654726561408 0.11706654726561408 -19.089 26.2851 28.9071 0.13036928905406142 0.13036928905406142 0.13036928905406142 -20.089 25.2851 27.9071 0.1203169250370164 0.1203169250370164 0.1203169250370164 -20.089 25.2851 28.9071 0.03685349527609525 0.03685349527609525 0.03685349527609525 -20.089 26.2851 27.9071 0.030248306410593718 0.030248306410593718 0.030248306410593718 -20.089 26.2851 28.9071 0.08096776267659526 0.08096776267659526 0.08096776267659526 -19.089 25.2851 29.9071 0.0472656613079075 0.0472656613079075 0.0472656613079075 -19.089 25.2851 30.9071 0.1315877937775942 0.1315877937775942 0.1315877937775942 -19.089 26.2851 29.9071 0.13321752503762477 0.13321752503762477 0.13321752503762477 -19.089 26.2851 30.9071 0.15893704332426328 0.15893704332426328 0.15893704332426328 -20.089 25.2851 29.9071 0.05242770149803674 0.05242770149803674 0.05242770149803674 -20.089 25.2851 30.9071 0.06375575577780614 0.06375575577780614 0.06375575577780614 -20.089 26.2851 29.9071 0.060121301435837604 0.060121301435837604 0.060121301435837604 -20.089 26.2851 30.9071 0.026409338575205745 0.026409338575205745 0.026409338575205745 -17.089 24.2851 31.9071 0.08040554974275532 0.08040554974275532 0.08040554974275532 -17.089 24.2851 32.9071 0.13153719045498424 0.13153719045498424 0.13153719045498424 -18.089 24.2851 31.9071 0.1258059574296021 0.1258059574296021 0.1258059574296021 -18.089 24.2851 32.9071 0.11599644854024076 0.11599644854024076 0.11599644854024076 -17.089 23.2851 33.9071 0.09358296457063713 0.09358296457063713 0.09358296457063713 -17.089 23.2851 34.9071 0.14038104341705632 0.14038104341705632 0.14038104341705632 -17.089 24.2851 33.9071 0.14737527960856875 0.14737527960856875 0.14737527960856875 -18.089 23.2851 34.9071 0.11978270241417777 0.11978270241417777 0.11978270241417777 -18.089 24.2851 33.9071 0.15359160036433792 0.15359160036433792 0.15359160036433792 -18.089 24.2851 34.9071 0.2081109802395117 0.2081109802395117 0.2081109802395117 -17.089 25.2851 31.9071 0.143813587587899 0.143813587587899 0.143813587587899 -17.089 25.2851 32.9071 0.1552538085983748 0.1552538085983748 0.1552538085983748 -17.089 26.2851 31.9071 0.1877796043644411 0.1877796043644411 0.1877796043644411 -17.089 26.2851 32.9071 0.16948957687066366 0.16948957687066366 0.16948957687066366 -18.089 25.2851 31.9071 0.17997730974564657 0.17997730974564657 0.17997730974564657 -18.089 25.2851 32.9071 0.16174733356120935 0.16174733356120935 0.16174733356120935 -18.089 26.2851 31.9071 0.22586192126330817 0.22586192126330817 0.22586192126330817 -18.089 26.2851 32.9071 0.19174869124530308 0.19174869124530308 0.19174869124530308 -17.089 26.2851 33.9071 0.19849849855150792 0.19849849855150792 0.19849849855150792 -17.089 26.2851 34.9071 0.21753054749942924 0.21753054749942924 0.21753054749942924 -18.089 25.2851 33.9071 0.19021405437933211 0.19021405437933211 0.19021405437933211 -18.089 25.2851 34.9071 0.23604710518992725 0.23604710518992725 0.23604710518992725 -18.089 26.2851 33.9071 0.22759965492785875 0.22759965492785875 0.22759965492785875 -18.089 26.2851 34.9071 0.23493206047819257 0.23493206047819257 0.23493206047819257 -19.089 24.2851 34.9071 0.15068466090856486 0.15068466090856486 0.15068466090856486 -19.089 25.2851 31.9071 0.137927415421735 0.137927415421735 0.137927415421735 -19.089 26.2851 31.9071 0.20530953148414866 0.20530953148414866 0.20530953148414866 -20.089 25.2851 32.9071 0.14071434553885834 0.14071434553885834 0.14071434553885834 -20.089 26.2851 32.9071 0.17579891804127412 0.17579891804127412 0.17579891804127412 -19.089 25.2851 33.9071 0.16446198071858995 0.16446198071858995 0.16446198071858995 -19.089 25.2851 34.9071 0.1900639601854856 0.1900639601854856 0.1900639601854856 -19.089 26.2851 34.9071 0.18881102393124244 0.18881102393124244 0.18881102393124244 -20.089 25.2851 33.9071 0.1815587001425996 0.1815587001425996 0.1815587001425996 -20.089 26.2851 33.9071 0.21262310581524327 0.21262310581524327 0.21262310581524327 -20.089 26.2851 34.9071 0.2198638042459631 0.2198638042459631 0.2198638042459631 -21.089 19.2851 27.9071 0.10389739778555741 0.10389739778555741 0.10389739778555741 -21.089 19.2851 28.9071 0.19267170664314995 0.19267170664314995 0.19267170664314995 -21.089 20.2851 27.9071 0.05758201401710854 0.05758201401710854 0.05758201401710854 -21.089 20.2851 28.9071 0.06691897775562397 0.06691897775562397 0.06691897775562397 -22.089 19.2851 27.9071 0.17532607580204818 0.17532607580204818 0.17532607580204818 -22.089 19.2851 28.9071 0.21479361849519782 0.21479361849519782 0.21479361849519782 -22.089 20.2851 27.9071 0.08064305404183733 0.08064305404183733 0.08064305404183733 -22.089 20.2851 28.9071 0.1095217263168735 0.1095217263168735 0.1095217263168735 -21.089 19.2851 29.9071 0.20042863064678304 0.20042863064678304 0.20042863064678304 -21.089 19.2851 30.9071 0.1586519941168775 0.1586519941168775 0.1586519941168775 -21.089 20.2851 29.9071 0.10121525809642297 0.10121525809642297 0.10121525809642297 -21.089 20.2851 30.9071 0.14747004175246858 0.14747004175246858 0.14747004175246858 -22.089 19.2851 30.9071 0.15887441288074974 0.15887441288074974 0.15887441288074974 -22.089 20.2851 30.9071 0.18955347730216807 0.18955347730216807 0.18955347730216807 -21.089 21.2851 29.9071 0.05882702656322092 0.05882702656322092 0.05882702656322092 -21.089 21.2851 30.9071 0.05904980186319765 0.05904980186319765 0.05904980186319765 -21.089 22.2851 30.9071 0.036335847165974516 0.036335847165974516 0.036335847165974516 -22.089 21.2851 29.9071 0.03718400988201266 0.03718400988201266 0.03718400988201266 -22.089 21.2851 30.9071 0.0786395567019981 0.0786395567019981 0.0786395567019981 -22.089 22.2851 29.9071 0.11370597167559712 0.11370597167559712 0.11370597167559712 -22.089 22.2851 30.9071 0.07576366675813377 0.07576366675813377 0.07576366675813377 -23.089 19.2851 27.9071 0.23090172683131016 0.23090172683131016 0.23090172683131016 -23.089 19.2851 28.9071 0.19805628713182405 0.19805628713182405 0.19805628713182405 -23.089 20.2851 27.9071 0.10140006987080444 0.10140006987080444 0.10140006987080444 -23.089 20.2851 28.9071 0.10052984376546356 0.10052984376546356 0.10052984376546356 -24.089 19.2851 27.9071 0.25085648157092744 0.25085648157092744 0.25085648157092744 -24.089 19.2851 28.9071 0.22195870304709184 0.22195870304709184 0.22195870304709184 -24.089 20.2851 27.9071 0.17202332772579304 0.17202332772579304 0.17202332772579304 -23.089 20.2851 30.9071 0.19539333648680504 0.19539333648680504 0.19539333648680504 -24.089 20.2851 30.9071 0.18840969493204066 0.18840969493204066 0.18840969493204066 -23.089 21.2851 27.9071 0.09913971236125393 0.09913971236125393 0.09913971236125393 -23.089 21.2851 28.9071 0.14521338749799512 0.14521338749799512 0.14521338749799512 -23.089 22.2851 27.9071 0.1240154156492992 0.1240154156492992 0.1240154156492992 -23.089 22.2851 28.9071 0.13251149962903247 0.13251149962903247 0.13251149962903247 -24.089 21.2851 27.9071 0.10555661558860817 0.10555661558860817 0.10555661558860817 -24.089 21.2851 28.9071 0.127172333299503 0.127172333299503 0.127172333299503 -24.089 22.2851 27.9071 0.13209944780727084 0.13209944780727084 0.13209944780727084 -24.089 22.2851 28.9071 0.1438416962594527 0.1438416962594527 0.1438416962594527 -23.089 21.2851 29.9071 0.07424715203642572 0.07424715203642572 0.07424715203642572 -23.089 21.2851 30.9071 0.1283507234821505 0.1283507234821505 0.1283507234821505 -23.089 22.2851 29.9071 0.09447657015532522 0.09447657015532522 0.09447657015532522 -23.089 22.2851 30.9071 0.10600817402602018 0.10600817402602018 0.10600817402602018 -24.089 21.2851 29.9071 0.11636359362578794 0.11636359362578794 0.11636359362578794 -24.089 21.2851 30.9071 0.1664443138114601 0.1664443138114601 0.1664443138114601 -24.089 22.2851 30.9071 0.16225478122094986 0.16225478122094986 0.16225478122094986 -21.089 19.2851 31.9071 0.16192317417277247 0.16192317417277247 0.16192317417277247 -21.089 19.2851 32.9071 0.08065912875755084 0.08065912875755084 0.08065912875755084 -21.089 20.2851 32.9071 0.14531698617915578 0.14531698617915578 0.14531698617915578 -22.089 19.2851 31.9071 0.1646370124999317 0.1646370124999317 0.1646370124999317 -22.089 20.2851 31.9071 0.22045031722148511 0.22045031722148511 0.22045031722148511 -22.089 20.2851 32.9071 0.17053728770817195 0.17053728770817195 0.17053728770817195 -21.089 21.2851 32.9071 0.17104146859723798 0.17104146859723798 0.17104146859723798 -21.089 22.2851 31.9071 0.10480374472930619 0.10480374472930619 0.10480374472930619 -21.089 22.2851 32.9071 0.1693940378089888 0.1693940378089888 0.1693940378089888 -22.089 21.2851 32.9071 0.21376493919387993 0.21376493919387993 0.21376493919387993 -22.089 22.2851 31.9071 0.13390266094979936 0.13390266094979936 0.13390266094979936 -22.089 22.2851 32.9071 0.18990583926128024 0.18990583926128024 0.18990583926128024 -21.089 22.2851 34.9071 0.061592097876532866 0.061592097876532866 0.061592097876532866 -22.089 22.2851 33.9071 0.1223043627162193 0.1223043627162193 0.1223043627162193 -22.089 22.2851 34.9071 0.10303684083886566 0.10303684083886566 0.10303684083886566 -23.089 20.2851 31.9071 0.21664793618005454 0.21664793618005454 0.21664793618005454 -23.089 20.2851 32.9071 0.18911763793761888 0.18911763793761888 0.18911763793761888 -24.089 20.2851 31.9071 0.21337737564035344 0.21337737564035344 0.21337737564035344 -24.089 20.2851 32.9071 0.18608194725747304 0.18608194725747304 0.18608194725747304 -23.089 21.2851 32.9071 0.2364738664148742 0.2364738664148742 0.2364738664148742 -23.089 22.2851 32.9071 0.23630621048931857 0.23630621048931857 0.23630621048931857 -24.089 21.2851 32.9071 0.14637223956416004 0.14637223956416004 0.14637223956416004 -24.089 22.2851 31.9071 0.17346919985234185 0.17346919985234185 0.17346919985234185 -24.089 22.2851 32.9071 0.21071011744250837 0.21071011744250837 0.21071011744250837 -23.089 21.2851 33.9071 0.14129982953738604 0.14129982953738604 0.14129982953738604 -23.089 22.2851 33.9071 0.14565990489312966 0.14565990489312966 0.14565990489312966 -23.089 22.2851 34.9071 0.09394539033422854 0.09394539033422854 0.09394539033422854 -24.089 22.2851 34.9071 0.06998778472092142 0.06998778472092142 0.06998778472092142 -21.089 24.2851 27.9071 0.2623207870027364 0.2623207870027364 0.2623207870027364 -22.089 23.2851 28.9071 0.22671474723012106 0.22671474723012106 0.22671474723012106 -21.089 23.2851 30.9071 0.12561316884266843 0.12561316884266843 0.12561316884266843 -21.089 24.2851 30.9071 0.10823218287200616 0.10823218287200616 0.10823218287200616 -22.089 23.2851 29.9071 0.21417657297332438 0.21417657297332438 0.21417657297332438 -22.089 23.2851 30.9071 0.10332530119579586 0.10332530119579586 0.10332530119579586 -22.089 24.2851 29.9071 0.1423711980036078 0.1423711980036078 0.1423711980036078 -22.089 24.2851 30.9071 0.15369277923840569 0.15369277923840569 0.15369277923840569 -21.089 25.2851 27.9071 0.0 0.0 0.0 -21.089 26.2851 27.9071 0.4203327920021654 0.4203327920021654 0.4203327920021654 -21.089 26.2851 28.9071 0.25056373744761523 0.25056373744761523 0.25056373744761523 -21.089 25.2851 30.9071 0.07135824381895191 0.07135824381895191 0.07135824381895191 -21.089 26.2851 30.9071 0.07534200024524039 0.07534200024524039 0.07534200024524039 -22.089 25.2851 29.9071 0.24362017621941076 0.24362017621941076 0.24362017621941076 -22.089 25.2851 30.9071 0.1382269949615097 0.1382269949615097 0.1382269949615097 -22.089 26.2851 30.9071 0.17896905679895134 0.17896905679895134 0.17896905679895134 -23.089 23.2851 27.9071 0.22146366677403784 0.22146366677403784 0.22146366677403784 -23.089 23.2851 28.9071 0.20686474481485 0.20686474481485 0.20686474481485 -23.089 24.2851 27.9071 0.43242836546192237 0.43242836546192237 0.43242836546192237 -23.089 24.2851 28.9071 0.4940112363767009 0.4940112363767009 0.4940112363767009 -24.089 23.2851 27.9071 0.15373533856806365 0.15373533856806365 0.15373533856806365 -24.089 23.2851 28.9071 0.06482277126171351 0.06482277126171351 0.06482277126171351 -24.089 24.2851 27.9071 0.02512915934773459 0.02512915934773459 0.02512915934773459 -24.089 24.2851 28.9071 0.0 0.0 0.0 -23.089 23.2851 29.9071 0.33917965361557495 0.33917965361557495 0.33917965361557495 -23.089 23.2851 30.9071 0.09288623462527945 0.09288623462527945 0.09288623462527945 -23.089 24.2851 29.9071 0.42890167804055584 0.42890167804055584 0.42890167804055584 -24.089 23.2851 29.9071 0.21663750526110795 0.21663750526110795 0.21663750526110795 -24.089 23.2851 30.9071 0.13452192883505215 0.13452192883505215 0.13452192883505215 -24.089 24.2851 29.9071 0.18580903449853167 0.18580903449853167 0.18580903449853167 -24.089 24.2851 30.9071 0.13263278543576065 0.13263278543576065 0.13263278543576065 -24.089 25.2851 27.9071 0.22409927864384524 0.22409927864384524 0.22409927864384524 -24.089 25.2851 28.9071 0.4638312325610008 0.4638312325610008 0.4638312325610008 -24.089 26.2851 28.9071 0.5597081186823158 0.5597081186823158 0.5597081186823158 -23.089 25.2851 29.9071 0.5162790848361615 0.5162790848361615 0.5162790848361615 -23.089 25.2851 30.9071 0.15214376491894138 0.15214376491894138 0.15214376491894138 -23.089 26.2851 29.9071 1.0 1.0 1.0 -23.089 26.2851 30.9071 0.6895213116879814 0.6895213116879814 0.6895213116879814 -24.089 25.2851 29.9071 0.27642938430160074 0.27642938430160074 0.27642938430160074 -24.089 25.2851 30.9071 0.12770570359114367 0.12770570359114367 0.12770570359114367 -24.089 26.2851 29.9071 0.3831103308559191 0.3831103308559191 0.3831103308559191 -24.089 26.2851 30.9071 0.16242740904647698 0.16242740904647698 0.16242740904647698 -21.089 24.2851 31.9071 0.10592943270157794 0.10592943270157794 0.10592943270157794 -21.089 24.2851 32.9071 0.09007755618489356 0.09007755618489356 0.09007755618489356 -22.089 24.2851 31.9071 0.09567713613410743 0.09567713613410743 0.09567713613410743 -22.089 24.2851 32.9071 0.1231357943907699 0.1231357943907699 0.1231357943907699 -21.089 23.2851 33.9071 0.11226786273365924 0.11226786273365924 0.11226786273365924 -21.089 23.2851 34.9071 0.08436506874284196 0.08436506874284196 0.08436506874284196 -21.089 24.2851 33.9071 0.14089826346790105 0.14089826346790105 0.14089826346790105 -21.089 24.2851 34.9071 0.11631458748587523 0.11631458748587523 0.11631458748587523 -22.089 23.2851 33.9071 0.1261939430604137 0.1261939430604137 0.1261939430604137 -22.089 24.2851 33.9071 0.34766185927848936 0.34766185927848936 0.34766185927848936 -21.089 25.2851 31.9071 0.08930364558124765 0.08930364558124765 0.08930364558124765 -21.089 25.2851 32.9071 0.1828711502946069 0.1828711502946069 0.1828711502946069 -21.089 26.2851 31.9071 0.09575026239868625 0.09575026239868625 0.09575026239868625 -21.089 26.2851 32.9071 0.19683156550347622 0.19683156550347622 0.19683156550347622 -22.089 25.2851 31.9071 0.11857365916917374 0.11857365916917374 0.11857365916917374 -22.089 25.2851 32.9071 0.15154631441230434 0.15154631441230434 0.15154631441230434 -22.089 26.2851 31.9071 0.12694179414223436 0.12694179414223436 0.12694179414223436 -21.089 25.2851 33.9071 0.18947963359806208 0.18947963359806208 0.18947963359806208 -21.089 25.2851 34.9071 0.17985448979979773 0.17985448979979773 0.17985448979979773 -21.089 26.2851 33.9071 0.22956679474315528 0.22956679474315528 0.22956679474315528 -21.089 26.2851 34.9071 0.2094912055727839 0.2094912055727839 0.2094912055727839 -22.089 25.2851 34.9071 0.13878840240875567 0.13878840240875567 0.13878840240875567 -22.089 26.2851 34.9071 0.16332025030643357 0.16332025030643357 0.16332025030643357 -23.089 23.2851 31.9071 0.1512114510993958 0.1512114510993958 0.1512114510993958 -23.089 23.2851 32.9071 0.16786138306726098 0.16786138306726098 0.16786138306726098 -23.089 24.2851 31.9071 0.11010342014663589 0.11010342014663589 0.11010342014663589 -23.089 24.2851 32.9071 0.13545443607391824 0.13545443607391824 0.13545443607391824 -24.089 23.2851 31.9071 0.16142214785605102 0.16142214785605102 0.16142214785605102 -24.089 23.2851 32.9071 0.173685958009161 0.173685958009161 0.173685958009161 -24.089 24.2851 31.9071 0.16834791780371447 0.16834791780371447 0.16834791780371447 -24.089 24.2851 32.9071 0.14685890426997428 0.14685890426997428 0.14685890426997428 -23.089 23.2851 33.9071 0.12684861436506759 0.12684861436506759 0.12684861436506759 -23.089 24.2851 33.9071 0.10629260633151513 0.10629260633151513 0.10629260633151513 -23.089 24.2851 34.9071 0.08682836750021225 0.08682836750021225 0.08682836750021225 -24.089 23.2851 33.9071 0.11128286378744046 0.11128286378744046 0.11128286378744046 -24.089 23.2851 34.9071 0.08737406034827806 0.08737406034827806 0.08737406034827806 -24.089 24.2851 33.9071 0.1616991579841122 0.1616991579841122 0.1616991579841122 -24.089 24.2851 34.9071 0.15133913295864834 0.15133913295864834 0.15133913295864834 -23.089 25.2851 31.9071 0.14083642211508196 0.14083642211508196 0.14083642211508196 -23.089 25.2851 32.9071 0.13803343297352869 0.13803343297352869 0.13803343297352869 -23.089 26.2851 31.9071 0.12206738303256469 0.12206738303256469 0.12206738303256469 -23.089 26.2851 32.9071 0.1459337569616328 0.1459337569616328 0.1459337569616328 -24.089 25.2851 32.9071 0.1494351264790041 0.1494351264790041 0.1494351264790041 -24.089 26.2851 31.9071 0.18235259456672573 0.18235259456672573 0.18235259456672573 -24.089 26.2851 32.9071 0.1643624211868292 0.1643624211868292 0.1643624211868292 -23.089 25.2851 33.9071 0.14503991964014304 0.14503991964014304 0.14503991964014304 -23.089 25.2851 34.9071 0.10949199875681555 0.10949199875681555 0.10949199875681555 -23.089 26.2851 33.9071 0.1564679216053766 0.1564679216053766 0.1564679216053766 -23.089 26.2851 34.9071 0.12852021103889763 0.12852021103889763 0.12852021103889763 -24.089 25.2851 33.9071 0.1651765576133035 0.1651765576133035 0.1651765576133035 -24.089 25.2851 34.9071 0.1671877764880251 0.1671877764880251 0.1671877764880251 -24.089 26.2851 33.9071 0.12486691199903947 0.12486691199903947 0.12486691199903947 -17.089 24.2851 35.9071 0.20032751053049064 0.20032751053049064 0.20032751053049064 -18.089 24.2851 35.9071 0.17996125486140793 0.17996125486140793 0.17996125486140793 -17.089 25.2851 35.9071 0.2417400098732858 0.2417400098732858 0.2417400098732858 -17.089 26.2851 35.9071 0.19168046794778398 0.19168046794778398 0.19168046794778398 -18.089 25.2851 35.9071 0.21248107762088225 0.21248107762088225 0.21248107762088225 -18.089 26.2851 35.9071 0.17905254319153538 0.17905254319153538 0.17905254319153538 -19.089 26.2851 35.9071 0.17409619129263215 0.17409619129263215 0.17409619129263215 -20.089 26.2851 35.9071 0.20153452330544383 0.20153452330544383 0.20153452330544383 -20.089 26.2851 36.9071 0.08035266374923979 0.08035266374923979 0.08035266374923979 -21.089 22.2851 35.9071 0.04427631705696229 0.04427631705696229 0.04427631705696229 -22.089 22.2851 35.9071 0.08834970814519343 0.08834970814519343 0.08834970814519343 -22.089 22.2851 36.9071 0.11725373274220598 0.11725373274220598 0.11725373274220598 -22.089 22.2851 37.9071 0.09279381901205713 0.09279381901205713 0.09279381901205713 -23.089 22.2851 35.9071 0.12014340349135774 0.12014340349135774 0.12014340349135774 -23.089 22.2851 36.9071 0.19002302535674653 0.19002302535674653 0.19002302535674653 -24.089 21.2851 35.9071 0.03280076114053809 0.03280076114053809 0.03280076114053809 -24.089 21.2851 36.9071 0.0819442918865836 0.0819442918865836 0.0819442918865836 -24.089 22.2851 35.9071 0.08197402962717017 0.08197402962717017 0.08197402962717017 -24.089 22.2851 36.9071 0.12400015289664987 0.12400015289664987 0.12400015289664987 -23.089 22.2851 37.9071 0.12086319412603874 0.12086319412603874 0.12086319412603874 -24.089 22.2851 37.9071 0.15850665878014616 0.15850665878014616 0.15850665878014616 -21.089 23.2851 35.9071 0.08300680650089028 0.08300680650089028 0.08300680650089028 -21.089 23.2851 36.9071 0.0883923020546068 0.0883923020546068 0.0883923020546068 -21.089 24.2851 35.9071 0.10183156353481587 0.10183156353481587 0.10183156353481587 -21.089 24.2851 36.9071 0.11936335525370823 0.11936335525370823 0.11936335525370823 -22.089 23.2851 36.9071 0.10206056761200923 0.10206056761200923 0.10206056761200923 -22.089 24.2851 36.9071 0.1355331485072583 0.1355331485072583 0.1355331485072583 -21.089 23.2851 37.9071 0.0857795659928855 0.0857795659928855 0.0857795659928855 -21.089 24.2851 37.9071 0.11772370294215397 0.11772370294215397 0.11772370294215397 -22.089 23.2851 37.9071 0.14046858555383862 0.14046858555383862 0.14046858555383862 -22.089 23.2851 38.9071 0.0792647155978025 0.0792647155978025 0.0792647155978025 -22.089 24.2851 37.9071 0.1521710676586802 0.1521710676586802 0.1521710676586802 -22.089 24.2851 38.9071 0.09622196538729275 0.09622196538729275 0.09622196538729275 -21.089 25.2851 36.9071 0.09975121242929573 0.09975121242929573 0.09975121242929573 -21.089 26.2851 35.9071 0.19498080399938264 0.19498080399938264 0.19498080399938264 -21.089 26.2851 36.9071 0.12825834859708302 0.12825834859708302 0.12825834859708302 -22.089 25.2851 35.9071 0.09381922456630008 0.09381922456630008 0.09381922456630008 -22.089 25.2851 36.9071 0.10675139191422325 0.10675139191422325 0.10675139191422325 -21.089 25.2851 37.9071 0.09660929013469716 0.09660929013469716 0.09660929013469716 -22.089 25.2851 37.9071 0.14063001621683383 0.14063001621683383 0.14063001621683383 -22.089 25.2851 38.9071 0.0900381777357968 0.0900381777357968 0.0900381777357968 -24.089 23.2851 36.9071 0.05069727580851342 0.05069727580851342 0.05069727580851342 -23.089 23.2851 37.9071 0.1293901344430518 0.1293901344430518 0.1293901344430518 -23.089 23.2851 38.9071 0.09608616021069581 0.09608616021069581 0.09608616021069581 -23.089 24.2851 38.9071 0.0972183987248567 0.0972183987248567 0.0972183987248567 -24.089 23.2851 37.9071 0.11361438338092937 0.11361438338092937 0.11361438338092937 -24.089 23.2851 38.9071 0.08409663293444386 0.08409663293444386 0.08409663293444386 -24.089 24.2851 37.9071 0.09072850326484508 0.09072850326484508 0.09072850326484508 -24.089 24.2851 38.9071 0.0940546802662646 0.0940546802662646 0.0940546802662646 -23.089 25.2851 35.9071 0.15452629559732617 0.15452629559732617 0.15452629559732617 -23.089 25.2851 36.9071 0.09421218608364487 0.09421218608364487 0.09421218608364487 -23.089 26.2851 35.9071 0.1246652849041255 0.1246652849041255 0.1246652849041255 -23.089 26.2851 36.9071 0.10782964825533789 0.10782964825533789 0.10782964825533789 -24.089 25.2851 35.9071 0.1406356381743866 0.1406356381743866 0.1406356381743866 -24.089 25.2851 36.9071 0.07913933055686381 0.07913933055686381 0.07913933055686381 -24.089 26.2851 35.9071 0.13534921831318086 0.13534921831318086 0.13534921831318086 -24.089 26.2851 36.9071 0.11976583216832286 0.11976583216832286 0.11976583216832286 -23.089 25.2851 37.9071 0.10353421334336171 0.10353421334336171 0.10353421334336171 -23.089 25.2851 38.9071 0.08376550729026475 0.08376550729026475 0.08376550729026475 -23.089 26.2851 37.9071 0.10470732532701192 0.10470732532701192 0.10470732532701192 -24.089 25.2851 37.9071 0.0875806029201828 0.0875806029201828 0.0875806029201828 -24.089 25.2851 38.9071 0.06632499381704283 0.06632499381704283 0.06632499381704283 -24.089 26.2851 37.9071 0.10650070729657 0.10650070729657 0.10650070729657 -8.088999999999999 29.2851 21.9071 0.07720033854773357 0.07720033854773357 0.07720033854773357 -8.088999999999999 29.2851 22.9071 0.09052679059706051 0.09052679059706051 0.09052679059706051 -8.088999999999999 30.2851 21.9071 0.1186194505068399 0.1186194505068399 0.1186194505068399 -8.088999999999999 30.2851 22.9071 0.13753466736473052 0.13753466736473052 0.13753466736473052 -8.088999999999999 28.2851 23.9071 0.1188933946316417 0.1188933946316417 0.1188933946316417 -8.088999999999999 28.2851 24.9071 0.09659161145239932 0.09659161145239932 0.09659161145239932 -8.088999999999999 29.2851 23.9071 0.15964926045083877 0.15964926045083877 0.15964926045083877 -8.088999999999999 29.2851 24.9071 0.09547543587302368 0.09547543587302368 0.09547543587302368 -8.088999999999999 30.2851 23.9071 0.15563281938769735 0.15563281938769735 0.15563281938769735 -8.088999999999999 30.2851 24.9071 0.08614041954854706 0.08614041954854706 0.08614041954854706 -8.088999999999999 31.2851 21.9071 0.1172601597036226 0.1172601597036226 0.1172601597036226 -8.088999999999999 31.2851 22.9071 0.16777467359739504 0.16777467359739504 0.16777467359739504 -8.088999999999999 31.2851 23.9071 0.15534133455361812 0.15534133455361812 0.15534133455361812 -14.088999999999999 28.2851 18.9071 0.06791384480623616 0.06791384480623616 0.06791384480623616 -14.088999999999999 29.2851 18.9071 0.06875411845503598 0.06875411845503598 0.06875411845503598 -14.088999999999999 30.2851 17.9071 0.03512635343548345 0.03512635343548345 0.03512635343548345 -14.088999999999999 30.2851 18.9071 0.07399146292523276 0.07399146292523276 0.07399146292523276 -16.089 28.2851 15.9071 0.042593963013393056 0.042593963013393056 0.042593963013393056 -16.089 28.2851 16.9071 0.07755680986824559 0.07755680986824559 0.07755680986824559 -15.088999999999999 28.2851 17.9071 0.08993209691991588 0.08993209691991588 0.08993209691991588 -15.088999999999999 28.2851 18.9071 0.07879853945828791 0.07879853945828791 0.07879853945828791 -16.089 27.2851 17.9071 0.07143203525305566 0.07143203525305566 0.07143203525305566 -16.089 27.2851 18.9071 0.0902013168993997 0.0902013168993997 0.0902013168993997 -16.089 28.2851 17.9071 0.08195152539205455 0.08195152539205455 0.08195152539205455 -15.088999999999999 29.2851 16.9071 0.04931874585408675 0.04931874585408675 0.04931874585408675 -16.089 29.2851 15.9071 0.04411766811820783 0.04411766811820783 0.04411766811820783 -16.089 29.2851 16.9071 0.08075075457583465 0.08075075457583465 0.08075075457583465 -16.089 30.2851 15.9071 0.03167831189769149 0.03167831189769149 0.03167831189769149 -16.089 30.2851 16.9071 0.0868139013655136 0.0868139013655136 0.0868139013655136 -15.088999999999999 29.2851 17.9071 0.07396871531641565 0.07396871531641565 0.07396871531641565 -15.088999999999999 30.2851 17.9071 0.061243434324802476 0.061243434324802476 0.061243434324802476 -16.089 30.2851 17.9071 0.0820487757914579 0.0820487757914579 0.0820487757914579 -14.088999999999999 31.2851 18.9071 0.07980210080977046 0.07980210080977046 0.07980210080977046 -16.089 31.2851 16.9071 0.07584991280086305 0.07584991280086305 0.07584991280086305 -15.088999999999999 31.2851 18.9071 0.09704322020959565 0.09704322020959565 0.09704322020959565 -16.089 31.2851 17.9071 0.11318777337135344 0.11318777337135344 0.11318777337135344 -16.089 31.2851 18.9071 0.07505086740586027 0.07505086740586027 0.07505086740586027 -10.088999999999999 28.2851 20.9071 0.09954871883474443 0.09954871883474443 0.09954871883474443 -9.088999999999999 28.2851 21.9071 0.08839551668836199 0.08839551668836199 0.08839551668836199 -9.088999999999999 28.2851 22.9071 0.1088452207443664 0.1088452207443664 0.1088452207443664 -10.088999999999999 27.2851 22.9071 0.11769638850995343 0.11769638850995343 0.11769638850995343 -10.088999999999999 28.2851 21.9071 0.1306134734172335 0.1306134734172335 0.1306134734172335 -10.088999999999999 28.2851 22.9071 0.12743901888732 0.12743901888732 0.12743901888732 -9.088999999999999 29.2851 20.9071 0.0956891899185559 0.0956891899185559 0.0956891899185559 -9.088999999999999 30.2851 20.9071 0.09331616673465296 0.09331616673465296 0.09331616673465296 -10.088999999999999 29.2851 19.9071 0.07773066441728972 0.07773066441728972 0.07773066441728972 -10.088999999999999 29.2851 20.9071 0.10773403594460972 0.10773403594460972 0.10773403594460972 -10.088999999999999 30.2851 19.9071 0.07246020493679636 0.07246020493679636 0.07246020493679636 -10.088999999999999 30.2851 20.9071 0.11677893954736251 0.11677893954736251 0.11677893954736251 -9.088999999999999 29.2851 21.9071 0.11395663384363935 0.11395663384363935 0.11395663384363935 -9.088999999999999 29.2851 22.9071 0.10288417337905607 0.10288417337905607 0.10288417337905607 -9.088999999999999 30.2851 21.9071 0.11137606159413715 0.11137606159413715 0.11137606159413715 -11.088999999999999 28.2851 20.9071 0.09596240854837632 0.09596240854837632 0.09596240854837632 -12.088999999999999 27.2851 20.9071 0.07199945535937824 0.07199945535937824 0.07199945535937824 -12.088999999999999 28.2851 20.9071 0.10663006708462947 0.10663006708462947 0.10663006708462947 -11.088999999999999 27.2851 21.9071 0.0693760583902774 0.0693760583902774 0.0693760583902774 -11.088999999999999 27.2851 22.9071 0.09938158088069636 0.09938158088069636 0.09938158088069636 -11.088999999999999 28.2851 21.9071 0.1104255995878682 0.1104255995878682 0.1104255995878682 -11.088999999999999 28.2851 22.9071 0.1329781678572326 0.1329781678572326 0.1329781678572326 -12.088999999999999 27.2851 21.9071 0.08273916987552317 0.08273916987552317 0.08273916987552317 -12.088999999999999 27.2851 22.9071 0.07700783534022179 0.07700783534022179 0.07700783534022179 -11.088999999999999 29.2851 19.9071 0.08314906344389501 0.08314906344389501 0.08314906344389501 -11.088999999999999 29.2851 20.9071 0.12346756134662969 0.12346756134662969 0.12346756134662969 -11.088999999999999 30.2851 19.9071 0.07701362249972805 0.07701362249972805 0.07701362249972805 -11.088999999999999 30.2851 20.9071 0.12778843993103278 0.12778843993103278 0.12778843993103278 -12.088999999999999 29.2851 19.9071 0.0704029682076166 0.0704029682076166 0.0704029682076166 -12.088999999999999 29.2851 20.9071 0.11828204003890558 0.11828204003890558 0.11828204003890558 -12.088999999999999 30.2851 20.9071 0.10911598434627044 0.10911598434627044 0.10911598434627044 -11.088999999999999 30.2851 22.9071 0.1522088096659711 0.1522088096659711 0.1522088096659711 -12.088999999999999 30.2851 22.9071 0.15638521475324582 0.15638521475324582 0.15638521475324582 -9.088999999999999 27.2851 23.9071 0.11278285330364629 0.11278285330364629 0.11278285330364629 -9.088999999999999 28.2851 23.9071 0.13193478713239726 0.13193478713239726 0.13193478713239726 -9.088999999999999 28.2851 24.9071 0.13560302580702283 0.13560302580702283 0.13560302580702283 -10.088999999999999 27.2851 23.9071 0.1356945890734608 0.1356945890734608 0.1356945890734608 -10.088999999999999 27.2851 24.9071 0.13036446961837644 0.13036446961837644 0.13036446961837644 -10.088999999999999 28.2851 24.9071 0.16088819810656146 0.16088819810656146 0.16088819810656146 -9.088999999999999 28.2851 25.9071 0.10140087339932648 0.10140087339932648 0.10140087339932648 -10.088999999999999 28.2851 25.9071 0.1640549099196507 0.1640549099196507 0.1640549099196507 -9.088999999999999 29.2851 24.9071 0.1252773942841353 0.1252773942841353 0.1252773942841353 -9.088999999999999 30.2851 23.9071 0.13566246162341766 0.13566246162341766 0.13566246162341766 -9.088999999999999 30.2851 24.9071 0.13564318514724444 0.13564318514724444 0.13564318514724444 -10.088999999999999 30.2851 24.9071 0.15249869981268663 0.15249869981268663 0.15249869981268663 -9.088999999999999 29.2851 25.9071 0.10761833686201727 0.10761833686201727 0.10761833686201727 -9.088999999999999 30.2851 25.9071 0.08947321541580495 0.08947321541580495 0.08947321541580495 -10.088999999999999 29.2851 25.9071 0.15281267937497833 0.15281267937497833 0.15281267937497833 -10.088999999999999 30.2851 25.9071 0.14768606690057504 0.14768606690057504 0.14768606690057504 -11.088999999999999 27.2851 23.9071 0.12933631673995014 0.12933631673995014 0.12933631673995014 -11.088999999999999 27.2851 24.9071 0.16185412265423355 0.16185412265423355 0.16185412265423355 -12.088999999999999 27.2851 23.9071 0.11108200607832122 0.11108200607832122 0.11108200607832122 -12.088999999999999 27.2851 24.9071 0.15213091656763558 0.15213091656763558 0.15213091656763558 -12.088999999999999 28.2851 24.9071 0.18119827430478808 0.18119827430478808 0.18119827430478808 -11.088999999999999 27.2851 25.9071 0.11361518678747139 0.11361518678747139 0.11361518678747139 -11.088999999999999 28.2851 25.9071 0.1783188232762893 0.1783188232762893 0.1783188232762893 -12.088999999999999 28.2851 25.9071 0.1597030578807243 0.1597030578807243 0.1597030578807243 -11.088999999999999 30.2851 23.9071 0.15156960221676355 0.15156960221676355 0.15156960221676355 -11.088999999999999 30.2851 24.9071 0.13343760450128572 0.13343760450128572 0.13343760450128572 -12.088999999999999 29.2851 24.9071 0.14226197368562934 0.14226197368562934 0.14226197368562934 -12.088999999999999 30.2851 23.9071 0.17326608890133804 0.17326608890133804 0.17326608890133804 -12.088999999999999 30.2851 24.9071 0.11746501882989172 0.11746501882989172 0.11746501882989172 -11.088999999999999 29.2851 25.9071 0.13743025549324295 0.13743025549324295 0.13743025549324295 -12.088999999999999 29.2851 25.9071 0.14486002665176695 0.14486002665176695 0.14486002665176695 -9.088999999999999 31.2851 20.9071 0.09196448458429965 0.09196448458429965 0.09196448458429965 -10.088999999999999 31.2851 20.9071 0.1198879405347346 0.1198879405347346 0.1198879405347346 -9.088999999999999 31.2851 21.9071 0.1350110748068275 0.1350110748068275 0.1350110748068275 -9.088999999999999 31.2851 22.9071 0.1653034144211241 0.1653034144211241 0.1653034144211241 -10.088999999999999 31.2851 21.9071 0.18536113449361588 0.18536113449361588 0.18536113449361588 -10.088999999999999 31.2851 22.9071 0.16941892614690154 0.16941892614690154 0.16941892614690154 -10.088999999999999 32.2851 22.9071 0.09834821062813492 0.09834821062813492 0.09834821062813492 -11.088999999999999 31.2851 20.9071 0.13010582614680577 0.13010582614680577 0.13010582614680577 -12.088999999999999 31.2851 20.9071 0.11460819114637238 0.11460819114637238 0.11460819114637238 -11.088999999999999 31.2851 21.9071 0.1713626012743695 0.1713626012743695 0.1713626012743695 -11.088999999999999 31.2851 22.9071 0.16869073836754356 0.16869073836754356 0.16869073836754356 -11.088999999999999 32.2851 21.9071 0.08913809364443405 0.08913809364443405 0.08913809364443405 -12.088999999999999 31.2851 21.9071 0.14986234737471826 0.14986234737471826 0.14986234737471826 -12.088999999999999 31.2851 22.9071 0.1470331712788521 0.1470331712788521 0.1470331712788521 -9.088999999999999 31.2851 23.9071 0.18697532872529868 0.18697532872529868 0.18697532872529868 -9.088999999999999 31.2851 24.9071 0.11521073636024352 0.11521073636024352 0.11521073636024352 -10.088999999999999 31.2851 23.9071 0.17561909381596388 0.17561909381596388 0.17561909381596388 -10.088999999999999 31.2851 24.9071 0.12977087358306702 0.12977087358306702 0.12977087358306702 -11.088999999999999 31.2851 23.9071 0.13962127004565353 0.13962127004565353 0.13962127004565353 -13.088999999999999 27.2851 20.9071 0.08354609561514162 0.08354609561514162 0.08354609561514162 -13.088999999999999 28.2851 20.9071 0.12045750934819108 0.12045750934819108 0.12045750934819108 -14.088999999999999 27.2851 19.9071 0.06782284745853526 0.06782284745853526 0.06782284745853526 -14.088999999999999 27.2851 20.9071 0.09302927771296877 0.09302927771296877 0.09302927771296877 -14.088999999999999 28.2851 19.9071 0.07578769991445825 0.07578769991445825 0.07578769991445825 -13.088999999999999 27.2851 21.9071 0.08651011193602312 0.08651011193602312 0.08651011193602312 -13.088999999999999 28.2851 21.9071 0.12136768640202035 0.12136768640202035 0.12136768640202035 -14.088999999999999 27.2851 21.9071 0.08149179463989314 0.08149179463989314 0.08149179463989314 -14.088999999999999 28.2851 21.9071 0.10555741907561818 0.10555741907561818 0.10555741907561818 -14.088999999999999 28.2851 22.9071 0.09640357431846587 0.09640357431846587 0.09640357431846587 -13.088999999999999 29.2851 20.9071 0.11934005812514749 0.11934005812514749 0.11934005812514749 -13.088999999999999 30.2851 20.9071 0.09849445823533844 0.09849445823533844 0.09849445823533844 -14.088999999999999 29.2851 19.9071 0.0834158949975702 0.0834158949975702 0.0834158949975702 -14.088999999999999 29.2851 20.9071 0.08707589873532069 0.08707589873532069 0.08707589873532069 -14.088999999999999 30.2851 19.9071 0.07758566508754336 0.07758566508754336 0.07758566508754336 -14.088999999999999 30.2851 20.9071 0.07209350250419877 0.07209350250419877 0.07209350250419877 -13.088999999999999 29.2851 21.9071 0.14147973048643384 0.14147973048643384 0.14147973048643384 -13.088999999999999 29.2851 22.9071 0.17242313283409436 0.17242313283409436 0.17242313283409436 -13.088999999999999 30.2851 21.9071 0.1397064035710575 0.1397064035710575 0.1397064035710575 -13.088999999999999 30.2851 22.9071 0.1369563845272574 0.1369563845272574 0.1369563845272574 -14.088999999999999 29.2851 21.9071 0.09772946780991419 0.09772946780991419 0.09772946780991419 -14.088999999999999 29.2851 22.9071 0.10977400841144912 0.10977400841144912 0.10977400841144912 -14.088999999999999 30.2851 22.9071 0.056887384153596045 0.056887384153596045 0.056887384153596045 -15.088999999999999 27.2851 19.9071 0.07234228480596336 0.07234228480596336 0.07234228480596336 -15.088999999999999 27.2851 20.9071 0.09161490791838163 0.09161490791838163 0.09161490791838163 -15.088999999999999 28.2851 19.9071 0.08130774085761401 0.08130774085761401 0.08130774085761401 -15.088999999999999 28.2851 20.9071 0.07693445090644405 0.07693445090644405 0.07693445090644405 -16.089 27.2851 19.9071 0.07176835613909346 0.07176835613909346 0.07176835613909346 -16.089 28.2851 19.9071 0.09063126335665356 0.09063126335665356 0.09063126335665356 -16.089 28.2851 20.9071 0.0728648457076581 0.0728648457076581 0.0728648457076581 -15.088999999999999 27.2851 21.9071 0.08431443570979685 0.08431443570979685 0.08431443570979685 -15.088999999999999 27.2851 22.9071 0.04504857027182748 0.04504857027182748 0.04504857027182748 -15.088999999999999 28.2851 21.9071 0.06787582207540674 0.06787582207540674 0.06787582207540674 -15.088999999999999 28.2851 22.9071 0.08379042213128444 0.08379042213128444 0.08379042213128444 -16.089 27.2851 21.9071 0.08319085639628919 0.08319085639628919 0.08319085639628919 -16.089 27.2851 22.9071 0.08075236204540759 0.08075236204540759 0.08075236204540759 -16.089 28.2851 21.9071 0.11611695586462234 0.11611695586462234 0.11611695586462234 -16.089 28.2851 22.9071 0.0919926113764619 0.0919926113764619 0.0919926113764619 -15.088999999999999 29.2851 20.9071 0.10136069696316183 0.10136069696316183 0.10136069696316183 -15.088999999999999 30.2851 20.9071 0.08731941086310337 0.08731941086310337 0.08731941086310337 -16.089 29.2851 20.9071 0.0842348694506254 0.0842348694506254 0.0842348694506254 -16.089 30.2851 20.9071 0.08849034832640079 0.08849034832640079 0.08849034832640079 -15.088999999999999 29.2851 22.9071 0.08942419289372122 0.08942419289372122 0.08942419289372122 -15.088999999999999 30.2851 22.9071 0.08031649549656529 0.08031649549656529 0.08031649549656529 -16.089 29.2851 21.9071 0.1096960742182612 0.1096960742182612 0.1096960742182612 -16.089 29.2851 22.9071 0.11218993095619441 0.11218993095619441 0.11218993095619441 -16.089 30.2851 22.9071 0.10201958798292252 0.10201958798292252 0.10201958798292252 -13.088999999999999 27.2851 24.9071 0.09469675561881143 0.09469675561881143 0.09469675561881143 -13.088999999999999 28.2851 24.9071 0.1074857647920117 0.1074857647920117 0.1074857647920117 -14.088999999999999 27.2851 24.9071 0.06319470880969612 0.06319470880969612 0.06319470880969612 -14.088999999999999 28.2851 23.9071 0.08823639216320082 0.08823639216320082 0.08823639216320082 -14.088999999999999 28.2851 24.9071 0.08822915922277 0.08822915922277 0.08822915922277 -13.088999999999999 27.2851 25.9071 0.04426908016336333 0.04426908016336333 0.04426908016336333 -13.088999999999999 27.2851 26.9071 0.04106966615897905 0.04106966615897905 0.04106966615897905 -13.088999999999999 28.2851 25.9071 0.05331131219332672 0.05331131219332672 0.05331131219332672 -13.088999999999999 28.2851 26.9071 0.04416607497403048 0.04416607497403048 0.04416607497403048 -14.088999999999999 27.2851 25.9071 0.054118935136411236 0.054118935136411236 0.054118935136411236 -14.088999999999999 28.2851 25.9071 0.06716359593197167 0.06716359593197167 0.06716359593197167 -13.088999999999999 29.2851 23.9071 0.12056435326039949 0.12056435326039949 0.12056435326039949 -13.088999999999999 29.2851 24.9071 0.1279466829849087 0.1279466829849087 0.1279466829849087 -13.088999999999999 30.2851 23.9071 0.06569193667987241 0.06569193667987241 0.06569193667987241 -13.088999999999999 30.2851 24.9071 0.07718916614035039 0.07718916614035039 0.07718916614035039 -14.088999999999999 29.2851 23.9071 0.08260896795208014 0.08260896795208014 0.08260896795208014 -14.088999999999999 29.2851 24.9071 0.0844012351755051 0.0844012351755051 0.0844012351755051 -13.088999999999999 29.2851 26.9071 0.11793498779562499 0.11793498779562499 0.11793498779562499 -13.088999999999999 30.2851 25.9071 0.06644059152215445 0.06644059152215445 0.06644059152215445 -14.088999999999999 29.2851 25.9071 0.03543017611055168 0.03543017611055168 0.03543017611055168 -14.088999999999999 29.2851 26.9071 0.145092923747501 0.145092923747501 0.145092923747501 -14.088999999999999 30.2851 25.9071 0.08980753214696448 0.08980753214696448 0.08980753214696448 -15.088999999999999 27.2851 23.9071 0.04449511216579947 0.04449511216579947 0.04449511216579947 -15.088999999999999 27.2851 24.9071 0.054158572370298766 0.054158572370298766 0.054158572370298766 -15.088999999999999 28.2851 23.9071 0.08633491010328559 0.08633491010328559 0.08633491010328559 -15.088999999999999 28.2851 24.9071 0.05205093788101572 0.05205093788101572 0.05205093788101572 -16.089 27.2851 23.9071 0.06258469944198106 0.06258469944198106 0.06258469944198106 -16.089 27.2851 24.9071 0.06310555511978674 0.06310555511978674 0.06310555511978674 -16.089 28.2851 23.9071 0.07023408163059536 0.07023408163059536 0.07023408163059536 -16.089 28.2851 24.9071 0.05984997092303936 0.05984997092303936 0.05984997092303936 -15.088999999999999 28.2851 25.9071 0.03640034226516214 0.03640034226516214 0.03640034226516214 -16.089 27.2851 25.9071 0.05880925918144063 0.05880925918144063 0.05880925918144063 -16.089 27.2851 26.9071 0.06378767078363218 0.06378767078363218 0.06378767078363218 -16.089 28.2851 25.9071 0.0443619535816728 0.0443619535816728 0.0443619535816728 -16.089 28.2851 26.9071 0.06820090378608408 0.06820090378608408 0.06820090378608408 -15.088999999999999 29.2851 23.9071 0.09381520654496898 0.09381520654496898 0.09381520654496898 -15.088999999999999 29.2851 24.9071 0.08231319983681501 0.08231319983681501 0.08231319983681501 -16.089 29.2851 23.9071 0.036560775610586266 0.036560775610586266 0.036560775610586266 -16.089 29.2851 24.9071 0.06889921408770702 0.06889921408770702 0.06889921408770702 -16.089 30.2851 23.9071 0.07299353615799133 0.07299353615799133 0.07299353615799133 -15.088999999999999 29.2851 25.9071 0.05874277215690847 0.05874277215690847 0.05874277215690847 -15.088999999999999 29.2851 26.9071 0.09834097859671317 0.09834097859671317 0.09834097859671317 -15.088999999999999 30.2851 25.9071 0.07774979402109684 0.07774979402109684 0.07774979402109684 -15.088999999999999 30.2851 26.9071 0.08052410104566558 0.08052410104566558 0.08052410104566558 -16.089 29.2851 25.9071 0.08659369432729844 0.08659369432729844 0.08659369432729844 -16.089 30.2851 25.9071 0.10855758363495417 0.10855758363495417 0.10855758363495417 -16.089 30.2851 26.9071 0.10798310979384507 0.10798310979384507 0.10798310979384507 -14.088999999999999 31.2851 19.9071 0.08275042188371041 0.08275042188371041 0.08275042188371041 -13.088999999999999 31.2851 21.9071 0.10238036870626581 0.10238036870626581 0.10238036870626581 -13.088999999999999 31.2851 22.9071 0.06221650493897432 0.06221650493897432 0.06221650493897432 -14.088999999999999 31.2851 22.9071 0.07293783194710547 0.07293783194710547 0.07293783194710547 -14.088999999999999 32.2851 22.9071 0.03597211635552994 0.03597211635552994 0.03597211635552994 -15.088999999999999 31.2851 19.9071 0.08838105083544323 0.08838105083544323 0.08838105083544323 -15.088999999999999 31.2851 20.9071 0.09238076010403826 0.09238076010403826 0.09238076010403826 -15.088999999999999 32.2851 20.9071 0.0678882015711434 0.0678882015711434 0.0678882015711434 -16.089 31.2851 19.9071 0.0852338623297739 0.0852338623297739 0.0852338623297739 -16.089 31.2851 20.9071 0.10111963792478033 0.10111963792478033 0.10111963792478033 -16.089 32.2851 20.9071 0.08175541679108779 0.08175541679108779 0.08175541679108779 -15.088999999999999 31.2851 21.9071 0.08896852310355279 0.08896852310355279 0.08896852310355279 -15.088999999999999 31.2851 22.9071 0.08892834045854199 0.08892834045854199 0.08892834045854199 -15.088999999999999 32.2851 21.9071 0.08457483382600439 0.08457483382600439 0.08457483382600439 -15.088999999999999 32.2851 22.9071 0.09021578242503404 0.09021578242503404 0.09021578242503404 -16.089 31.2851 21.9071 0.11208066565652218 0.11208066565652218 0.11208066565652218 -16.089 31.2851 22.9071 0.11034043507298955 0.11034043507298955 0.11034043507298955 -16.089 32.2851 21.9071 0.1023594772163063 0.1023594772163063 0.1023594772163063 -15.088999999999999 33.2851 20.9071 0.04920738501037885 0.04920738501037885 0.04920738501037885 -16.089 33.2851 20.9071 0.0649785657537652 0.0649785657537652 0.0649785657537652 -15.088999999999999 33.2851 21.9071 0.07349985592533888 0.07349985592533888 0.07349985592533888 -15.088999999999999 33.2851 22.9071 0.073194569360197 0.073194569360197 0.073194569360197 -15.088999999999999 34.2851 21.9071 0.04011684533826013 0.04011684533826013 0.04011684533826013 -15.088999999999999 34.2851 22.9071 0.059843700162590954 0.059843700162590954 0.059843700162590954 -16.089 33.2851 21.9071 0.093441529683434 0.093441529683434 0.093441529683434 -16.089 34.2851 21.9071 0.0722318400276955 0.0722318400276955 0.0722318400276955 -16.089 34.2851 22.9071 0.08988709289516932 0.08988709289516932 0.08988709289516932 -13.088999999999999 31.2851 23.9071 0.06997243133117098 0.06997243133117098 0.06997243133117098 -13.088999999999999 31.2851 24.9071 0.061336127364840884 0.061336127364840884 0.061336127364840884 -13.088999999999999 32.2851 23.9071 0.05815258686193913 0.05815258686193913 0.05815258686193913 -13.088999999999999 32.2851 24.9071 0.04888865897113594 0.04888865897113594 0.04888865897113594 -14.088999999999999 32.2851 23.9071 0.054968437987171326 0.054968437987171326 0.054968437987171326 -14.088999999999999 32.2851 24.9071 0.06387272381032133 0.06387272381032133 0.06387272381032133 -13.088999999999999 31.2851 25.9071 0.05562200075150647 0.05562200075150647 0.05562200075150647 -14.088999999999999 31.2851 25.9071 0.08540585180713034 0.08540585180713034 0.08540585180713034 -14.088999999999999 32.2851 25.9071 0.07161265517710032 0.07161265517710032 0.07161265517710032 -15.088999999999999 32.2851 23.9071 0.07740031633983784 0.07740031633983784 0.07740031633983784 -15.088999999999999 32.2851 24.9071 0.07107055303905055 0.07107055303905055 0.07107055303905055 -15.088999999999999 31.2851 25.9071 0.08048873660748583 0.08048873660748583 0.08048873660748583 -15.088999999999999 31.2851 26.9071 0.07269387437874732 0.07269387437874732 0.07269387437874732 -15.088999999999999 32.2851 25.9071 0.10808675642650718 0.10808675642650718 0.10808675642650718 -15.088999999999999 32.2851 26.9071 0.0832157714152837 0.0832157714152837 0.0832157714152837 -16.089 31.2851 26.9071 0.1047860678475336 0.1047860678475336 0.1047860678475336 -16.089 32.2851 25.9071 0.10111642379937308 0.10111642379937308 0.10111642379937308 -16.089 32.2851 26.9071 0.07156466674552531 0.07156466674552531 0.07156466674552531 -15.088999999999999 33.2851 23.9071 0.09031945194928702 0.09031945194928702 0.09031945194928702 -15.088999999999999 33.2851 24.9071 0.09920881772673001 0.09920881772673001 0.09920881772673001 -15.088999999999999 34.2851 23.9071 0.060311272447272364 0.060311272447272364 0.060311272447272364 -15.088999999999999 34.2851 24.9071 0.08408538111453086 0.08408538111453086 0.08408538111453086 -16.089 34.2851 23.9071 0.10529467839405197 0.10529467839405197 0.10529467839405197 -16.089 34.2851 24.9071 0.09359582227533789 0.09359582227533789 0.09359582227533789 -15.088999999999999 33.2851 25.9071 0.0867174604010561 0.0867174604010561 0.0867174604010561 -15.088999999999999 33.2851 26.9071 0.06127350128963878 0.06127350128963878 0.06127350128963878 -15.088999999999999 34.2851 25.9071 0.07234831344670055 0.07234831344670055 0.07234831344670055 -15.088999999999999 34.2851 26.9071 0.05765855157043766 0.05765855157043766 0.05765855157043766 -16.089 33.2851 25.9071 0.0734959172698288 0.0734959172698288 0.0734959172698288 -16.089 33.2851 26.9071 0.0858181428422442 0.0858181428422442 0.0858181428422442 -16.089 34.2851 25.9071 0.08400742203335287 0.08400742203335287 0.08400742203335287 -16.089 34.2851 26.9071 0.07808134630577465 0.07808134630577465 0.07808134630577465 -16.089 35.2851 25.9071 0.07034669951596069 0.07034669951596069 0.07034669951596069 -16.089 35.2851 26.9071 0.08497266265394965 0.08497266265394965 0.08497266265394965 -20.089 27.2851 14.9071 0.15217427974509598 0.15217427974509598 0.15217427974509598 -20.089 30.2851 14.9071 0.07649349987628133 0.07649349987628133 0.07649349987628133 -17.089 28.2851 15.9071 0.05739203656114436 0.05739203656114436 0.05739203656114436 -17.089 28.2851 16.9071 0.08572250436927985 0.08572250436927985 0.08572250436927985 -18.089 28.2851 15.9071 0.07369381437613794 0.07369381437613794 0.07369381437613794 -18.089 28.2851 16.9071 0.10490016401606571 0.10490016401606571 0.10490016401606571 -17.089 27.2851 17.9071 0.081525551183079 0.081525551183079 0.081525551183079 -17.089 27.2851 18.9071 0.10840814048501997 0.10840814048501997 0.10840814048501997 -17.089 28.2851 17.9071 0.09405789467378133 0.09405789467378133 0.09405789467378133 -18.089 27.2851 17.9071 0.13861010175560542 0.13861010175560542 0.13861010175560542 -18.089 27.2851 18.9071 0.10326182393580291 0.10326182393580291 0.10326182393580291 -18.089 28.2851 17.9071 0.11573374194744343 0.11573374194744343 0.11573374194744343 -18.089 28.2851 18.9071 0.11951358140344774 0.11951358140344774 0.11951358140344774 -17.089 29.2851 15.9071 0.05491135450677582 0.05491135450677582 0.05491135450677582 -17.089 30.2851 15.9071 0.0472923564067449 0.0472923564067449 0.0472923564067449 -17.089 30.2851 16.9071 0.0952239125282391 0.0952239125282391 0.0952239125282391 -18.089 29.2851 15.9071 0.0761300309505073 0.0761300309505073 0.0761300309505073 -18.089 29.2851 16.9071 0.10051779070621053 0.10051779070621053 0.10051779070621053 -18.089 30.2851 15.9071 0.06303923242796623 0.06303923242796623 0.06303923242796623 -18.089 30.2851 16.9071 0.1065039212068658 0.1065039212068658 0.1065039212068658 -17.089 30.2851 18.9071 0.0830228807443518 0.0830228807443518 0.0830228807443518 -18.089 29.2851 18.9071 0.08592422908260929 0.08592422908260929 0.08592422908260929 -18.089 30.2851 17.9071 0.10264954703398922 0.10264954703398922 0.10264954703398922 -18.089 30.2851 18.9071 0.10190629125269757 0.10190629125269757 0.10190629125269757 -19.089 27.2851 15.9071 0.2147655346015572 0.2147655346015572 0.2147655346015572 -19.089 27.2851 16.9071 0.1979920820049363 0.1979920820049363 0.1979920820049363 -20.089 27.2851 15.9071 0.1957047409323028 0.1957047409323028 0.1957047409323028 -20.089 27.2851 16.9071 0.22151662055651042 0.22151662055651042 0.22151662055651042 -20.089 28.2851 16.9071 0.20657505049243627 0.20657505049243627 0.20657505049243627 -19.089 27.2851 17.9071 0.19476169541735902 0.19476169541735902 0.19476169541735902 -19.089 27.2851 18.9071 0.17411144454463504 0.17411144454463504 0.17411144454463504 -19.089 28.2851 17.9071 0.18976056037172126 0.18976056037172126 0.18976056037172126 -19.089 28.2851 18.9071 0.12341534629900953 0.12341534629900953 0.12341534629900953 -20.089 27.2851 18.9071 0.046400075969334265 0.046400075969334265 0.046400075969334265 -20.089 28.2851 17.9071 0.20102732333462078 0.20102732333462078 0.20102732333462078 -20.089 28.2851 18.9071 0.09608535662909183 0.09608535662909183 0.09608535662909183 -19.089 29.2851 15.9071 0.08087372590479942 0.08087372590479942 0.08087372590479942 -19.089 29.2851 16.9071 0.11151907181174574 0.11151907181174574 0.11151907181174574 -19.089 30.2851 15.9071 0.07689201168528405 0.07689201168528405 0.07689201168528405 -19.089 30.2851 16.9071 0.0939590515838587 0.0939590515838587 0.0939590515838587 -20.089 29.2851 15.9071 0.08581251705286293 0.08581251705286293 0.08581251705286293 -20.089 29.2851 16.9071 0.10076367275733947 0.10076367275733947 0.10076367275733947 -20.089 30.2851 15.9071 0.08098383732745008 0.08098383732745008 0.08098383732745008 -19.089 29.2851 17.9071 0.11070117848515326 0.11070117848515326 0.11070117848515326 -19.089 29.2851 18.9071 0.12250358577459215 0.12250358577459215 0.12250358577459215 -19.089 30.2851 17.9071 0.09874034647019302 0.09874034647019302 0.09874034647019302 -19.089 30.2851 18.9071 0.1003273521306274 0.1003273521306274 0.1003273521306274 -20.089 29.2851 17.9071 0.10643964297652088 0.10643964297652088 0.10643964297652088 -20.089 29.2851 18.9071 0.10813657103965196 0.10813657103965196 0.10813657103965196 -20.089 30.2851 17.9071 0.08443016830993709 0.08443016830993709 0.08443016830993709 -20.089 30.2851 18.9071 0.10024699816602217 0.10024699816602217 0.10024699816602217 -19.089 31.2851 14.9071 0.056257549067615535 0.056257549067615535 0.056257549067615535 -20.089 31.2851 14.9071 0.08192419881239285 0.08192419881239285 0.08192419881239285 -20.089 32.2851 14.9071 0.050820936308760424 0.050820936308760424 0.050820936308760424 -17.089 31.2851 16.9071 0.08056026920499311 0.08056026920499311 0.08056026920499311 -18.089 31.2851 16.9071 0.08032469363526061 0.08032469363526061 0.08032469363526061 -17.089 31.2851 17.9071 0.09371073791974771 0.09371073791974771 0.09371073791974771 -17.089 31.2851 18.9071 0.06513017971182454 0.06513017971182454 0.06513017971182454 -18.089 31.2851 17.9071 0.0841054736489833 0.0841054736489833 0.0841054736489833 -19.089 31.2851 15.9071 0.06107903053489445 0.06107903053489445 0.06107903053489445 -19.089 31.2851 16.9071 0.08426782114325936 0.08426782114325936 0.08426782114325936 -19.089 32.2851 15.9071 0.060460322600949856 0.060460322600949856 0.060460322600949856 -19.089 32.2851 16.9071 0.08891789296756329 0.08891789296756329 0.08891789296756329 -20.089 32.2851 15.9071 0.08971430935198904 0.08971430935198904 0.08971430935198904 -20.089 32.2851 16.9071 0.09801634007184236 0.09801634007184236 0.09801634007184236 -19.089 31.2851 17.9071 0.08283641932285282 0.08283641932285282 0.08283641932285282 -19.089 31.2851 18.9071 0.07071276684232826 0.07071276684232826 0.07071276684232826 -19.089 32.2851 17.9071 0.08326560143010793 0.08326560143010793 0.08326560143010793 -19.089 32.2851 18.9071 0.08075798818863324 0.08075798818863324 0.08075798818863324 -20.089 32.2851 17.9071 0.09554133003782711 0.09554133003782711 0.09554133003782711 -20.089 32.2851 18.9071 0.09493461952998712 0.09493461952998712 0.09493461952998712 -20.089 33.2851 16.9071 0.10571088494832326 0.10571088494832326 0.10571088494832326 -20.089 33.2851 17.9071 0.12385314834144676 0.12385314834144676 0.12385314834144676 -20.089 33.2851 18.9071 0.11379193603275159 0.11379193603275159 0.11379193603275159 -21.089 27.2851 14.9071 0.17919543316245024 0.17919543316245024 0.17919543316245024 -22.089 27.2851 13.9071 0.14311247383166953 0.14311247383166953 0.14311247383166953 -22.089 27.2851 14.9071 0.20013971569163264 0.20013971569163264 0.20013971569163264 -22.089 28.2851 14.9071 0.16745593520599425 0.16745593520599425 0.16745593520599425 -21.089 30.2851 14.9071 0.08096535147868825 0.08096535147868825 0.08096535147868825 -23.089 27.2851 13.9071 0.11705047982244375 0.11705047982244375 0.11705047982244375 -23.089 28.2851 13.9071 0.0571764924041073 0.0571764924041073 0.0571764924041073 -23.089 28.2851 14.9071 0.10686307487378388 0.10686307487378388 0.10686307487378388 -24.089 27.2851 13.9071 0.06675169161427963 0.06675169161427963 0.06675169161427963 -24.089 28.2851 13.9071 0.07957407823793647 0.07957407823793647 0.07957407823793647 -23.089 29.2851 14.9071 0.09137944507810708 0.09137944507810708 0.09137944507810708 -24.089 29.2851 13.9071 0.07402554413631471 0.07402554413631471 0.07402554413631471 -24.089 29.2851 14.9071 0.09609178528173462 0.09609178528173462 0.09609178528173462 -21.089 27.2851 15.9071 0.21329713450572538 0.21329713450572538 0.21329713450572538 -21.089 28.2851 15.9071 0.20286430298437086 0.20286430298437086 0.20286430298437086 -21.089 28.2851 16.9071 0.19267010140818158 0.19267010140818158 0.19267010140818158 -22.089 28.2851 15.9071 0.2091477563655868 0.2091477563655868 0.2091477563655868 -22.089 28.2851 16.9071 0.10651034902707224 0.10651034902707224 0.10651034902707224 -21.089 28.2851 17.9071 0.10651677684676511 0.10651677684676511 0.10651677684676511 -21.089 28.2851 18.9071 0.08132863781477952 0.08132863781477952 0.08132863781477952 -22.089 28.2851 17.9071 0.04134845799801276 0.04134845799801276 0.04134845799801276 -22.089 28.2851 18.9071 0.06444059918146686 0.06444059918146686 0.06444059918146686 -21.089 29.2851 15.9071 0.07925233785244777 0.07925233785244777 0.07925233785244777 -21.089 29.2851 16.9071 0.09339893844710814 0.09339893844710814 0.09339893844710814 -21.089 30.2851 15.9071 0.09775759258669248 0.09775759258669248 0.09775759258669248 -21.089 30.2851 16.9071 0.08556578561739464 0.08556578561739464 0.08556578561739464 -22.089 29.2851 15.9071 0.14775191831734413 0.14775191831734413 0.14775191831734413 -22.089 29.2851 16.9071 0.06199446193730555 0.06199446193730555 0.06199446193730555 -22.089 30.2851 15.9071 0.07534216100300078 0.07534216100300078 0.07534216100300078 -22.089 30.2851 16.9071 0.07429256671027636 0.07429256671027636 0.07429256671027636 -21.089 29.2851 17.9071 0.09111344356607391 0.09111344356607391 0.09111344356607391 -21.089 29.2851 18.9071 0.0727958784734276 0.0727958784734276 0.0727958784734276 -21.089 30.2851 17.9071 0.08732182187058786 0.08732182187058786 0.08732182187058786 -22.089 29.2851 17.9071 0.05053992598951371 0.05053992598951371 0.05053992598951371 -22.089 29.2851 18.9071 0.040460775633745866 0.040460775633745866 0.040460775633745866 -22.089 30.2851 17.9071 0.0850827684668317 0.0850827684668317 0.0850827684668317 -22.089 30.2851 18.9071 0.057194742528546 0.057194742528546 0.057194742528546 -23.089 28.2851 15.9071 0.06010811680392199 0.06010811680392199 0.06010811680392199 -24.089 27.2851 16.9071 0.059230771167418525 0.059230771167418525 0.059230771167418525 -24.089 28.2851 16.9071 0.04279531342436471 0.04279531342436471 0.04279531342436471 -23.089 27.2851 18.9071 0.07410994329973132 0.07410994329973132 0.07410994329973132 -23.089 28.2851 18.9071 0.04669710184381005 0.04669710184381005 0.04669710184381005 -24.089 27.2851 17.9071 0.04677389097514179 0.04677389097514179 0.04677389097514179 -24.089 28.2851 17.9071 0.039647949457121946 0.039647949457121946 0.039647949457121946 -24.089 28.2851 18.9071 0.03193606565246299 0.03193606565246299 0.03193606565246299 -23.089 29.2851 15.9071 0.052507781629738084 0.052507781629738084 0.052507781629738084 -23.089 29.2851 16.9071 0.060599162490312206 0.060599162490312206 0.060599162490312206 -23.089 30.2851 15.9071 0.06768643163052475 0.06768643163052475 0.06768643163052475 -23.089 30.2851 16.9071 0.08496864419078165 0.08496864419078165 0.08496864419078165 -24.089 29.2851 15.9071 0.04839263705087821 0.04839263705087821 0.04839263705087821 -24.089 29.2851 16.9071 0.0500263057365094 0.0500263057365094 0.0500263057365094 -24.089 30.2851 15.9071 0.039647547384367834 0.039647547384367834 0.039647547384367834 -24.089 30.2851 16.9071 0.05542807912711654 0.05542807912711654 0.05542807912711654 -23.089 29.2851 17.9071 0.05147372873837512 0.05147372873837512 0.05147372873837512 -23.089 29.2851 18.9071 0.049135583316048635 0.049135583316048635 0.049135583316048635 -23.089 30.2851 17.9071 0.07415825173342241 0.07415825173342241 0.07415825173342241 -23.089 30.2851 18.9071 0.062307187060305816 0.062307187060305816 0.062307187060305816 -24.089 29.2851 17.9071 0.05256317838102438 0.05256317838102438 0.05256317838102438 -24.089 29.2851 18.9071 0.07579895289489283 0.07579895289489283 0.07579895289489283 -24.089 30.2851 17.9071 0.07079692833073983 0.07079692833073983 0.07079692833073983 -24.089 30.2851 18.9071 0.10400346018945782 0.10400346018945782 0.10400346018945782 -21.089 31.2851 14.9071 0.0853439677851912 0.0853439677851912 0.0853439677851912 -21.089 32.2851 14.9071 0.07005587013657519 0.07005587013657519 0.07005587013657519 -23.089 34.2851 14.9071 0.05929701660392751 0.05929701660392751 0.05929701660392751 -24.089 34.2851 14.9071 0.09155785043332446 0.09155785043332446 0.09155785043332446 -21.089 31.2851 15.9071 0.0887081392075816 0.0887081392075816 0.0887081392075816 -21.089 32.2851 15.9071 0.10280623251154838 0.10280623251154838 0.10280623251154838 -21.089 32.2851 16.9071 0.07962961710507026 0.07962961710507026 0.07962961710507026 -22.089 31.2851 15.9071 0.0719856296159974 0.0719856296159974 0.0719856296159974 -22.089 32.2851 15.9071 0.07898581399066254 0.07898581399066254 0.07898581399066254 -22.089 32.2851 18.9071 0.08617015573818794 0.08617015573818794 0.08617015573818794 -21.089 33.2851 16.9071 0.12891300310355347 0.12891300310355347 0.12891300310355347 -22.089 33.2851 15.9071 0.06396155508910982 0.06396155508910982 0.06396155508910982 -22.089 33.2851 16.9071 0.08953670355573244 0.08953670355573244 0.08953670355573244 -21.089 33.2851 17.9071 0.13475565905463724 0.13475565905463724 0.13475565905463724 -21.089 33.2851 18.9071 0.12210112255555562 0.12210112255555562 0.12210112255555562 -22.089 33.2851 17.9071 0.0972714343469149 0.0972714343469149 0.0972714343469149 -22.089 33.2851 18.9071 0.0916205333020432 0.0916205333020432 0.0916205333020432 -23.089 31.2851 15.9071 0.06789398938667225 0.06789398938667225 0.06789398938667225 -23.089 32.2851 15.9071 0.0705567423028024 0.0705567423028024 0.0705567423028024 -24.089 31.2851 15.9071 0.03817144433579901 0.03817144433579901 0.03817144433579901 -24.089 31.2851 16.9071 0.07026784289756238 0.07026784289756238 0.07026784289756238 -24.089 32.2851 15.9071 0.03779461395124789 0.03779461395124789 0.03779461395124789 -24.089 32.2851 16.9071 0.06517680536788664 0.06517680536788664 0.06517680536788664 -23.089 31.2851 18.9071 0.052662474349202196 0.052662474349202196 0.052662474349202196 -23.089 32.2851 18.9071 0.06630417335042595 0.06630417335042595 0.06630417335042595 -24.089 31.2851 17.9071 0.07376888975539875 0.07376888975539875 0.07376888975539875 -24.089 31.2851 18.9071 0.09359180424283181 0.09359180424283181 0.09359180424283181 -24.089 32.2851 17.9071 0.07861898054879245 0.07861898054879245 0.07861898054879245 -24.089 32.2851 18.9071 0.08224649111707938 0.08224649111707938 0.08224649111707938 -23.089 33.2851 15.9071 0.0704654264092644 0.0704654264092644 0.0704654264092644 -23.089 33.2851 16.9071 0.09388351288041409 0.09388351288041409 0.09388351288041409 -23.089 34.2851 15.9071 0.06294766682781426 0.06294766682781426 0.06294766682781426 -23.089 34.2851 16.9071 0.06796231773301964 0.06796231773301964 0.06796231773301964 -24.089 33.2851 15.9071 0.08729208610660442 0.08729208610660442 0.08729208610660442 -24.089 33.2851 16.9071 0.08621275080149342 0.08621275080149342 0.08621275080149342 -24.089 34.2851 15.9071 0.089583315069619 0.089583315069619 0.089583315069619 -24.089 34.2851 16.9071 0.08153358845318533 0.08153358845318533 0.08153358845318533 -23.089 33.2851 17.9071 0.08329132013534743 0.08329132013534743 0.08329132013534743 -23.089 33.2851 18.9071 0.06810894212974689 0.06810894212974689 0.06810894212974689 -23.089 34.2851 17.9071 0.06813241487019675 0.06813241487019675 0.06813241487019675 -23.089 34.2851 18.9071 0.1321267573500292 0.1321267573500292 0.1321267573500292 -24.089 33.2851 17.9071 0.07186328776000386 0.07186328776000386 0.07186328776000386 -24.089 33.2851 18.9071 0.09206413374649869 0.09206413374649869 0.09206413374649869 -24.089 34.2851 17.9071 0.09082413578720681 0.09082413578720681 0.09082413578720681 -24.089 34.2851 18.9071 0.13222314389745546 0.13222314389745546 0.13222314389745546 -17.089 27.2851 19.9071 0.11424585845174547 0.11424585845174547 0.11424585845174547 -18.089 27.2851 19.9071 0.10357599570777455 0.10357599570777455 0.10357599570777455 -17.089 27.2851 22.9071 0.05203702830697561 0.05203702830697561 0.05203702830697561 -17.089 28.2851 22.9071 0.07270970953824311 0.07270970953824311 0.07270970953824311 -17.089 30.2851 19.9071 0.09066421242961552 0.09066421242961552 0.09066421242961552 -17.089 30.2851 20.9071 0.04478603395784331 0.04478603395784331 0.04478603395784331 -18.089 30.2851 19.9071 0.11183562161405065 0.11183562161405065 0.11183562161405065 -18.089 30.2851 20.9071 0.09415593404141151 0.09415593404141151 0.09415593404141151 -17.089 29.2851 21.9071 0.10449680923040205 0.10449680923040205 0.10449680923040205 -17.089 29.2851 22.9071 0.11446116942931576 0.11446116942931576 0.11446116942931576 -17.089 30.2851 21.9071 0.11858651288063252 0.11858651288063252 0.11858651288063252 -18.089 29.2851 21.9071 0.143225712549662 0.143225712549662 0.143225712549662 -18.089 29.2851 22.9071 0.08057634393726484 0.08057634393726484 0.08057634393726484 -18.089 30.2851 21.9071 0.07011889129640213 0.07011889129640213 0.07011889129640213 -19.089 27.2851 19.9071 0.06930403353859117 0.06930403353859117 0.06930403353859117 -19.089 27.2851 20.9071 0.047467080434249694 0.047467080434249694 0.047467080434249694 -19.089 28.2851 19.9071 0.08653502592711554 0.08653502592711554 0.08653502592711554 -19.089 28.2851 20.9071 0.045178752585750076 0.045178752585750076 0.045178752585750076 -20.089 28.2851 19.9071 0.07153637204547897 0.07153637204547897 0.07153637204547897 -20.089 28.2851 20.9071 0.055273874118725086 0.055273874118725086 0.055273874118725086 -19.089 27.2851 21.9071 0.04407778470680202 0.04407778470680202 0.04407778470680202 -20.089 27.2851 21.9071 0.06415400912495865 0.06415400912495865 0.06415400912495865 -20.089 27.2851 22.9071 0.06377102996354053 0.06377102996354053 0.06377102996354053 -20.089 28.2851 21.9071 0.06961801640427465 0.06961801640427465 0.06961801640427465 -20.089 28.2851 22.9071 0.06061974325258276 0.06061974325258276 0.06061974325258276 -19.089 29.2851 19.9071 0.10101517878383535 0.10101517878383535 0.10101517878383535 -19.089 29.2851 20.9071 0.060632284652018725 0.060632284652018725 0.060632284652018725 -19.089 30.2851 19.9071 0.10811166373692611 0.10811166373692611 0.10811166373692611 -19.089 30.2851 20.9071 0.23757124202737046 0.23757124202737046 0.23757124202737046 -20.089 29.2851 19.9071 0.09550999013691504 0.09550999013691504 0.09550999013691504 -20.089 29.2851 20.9071 0.07923087773100966 0.07923087773100966 0.07923087773100966 -20.089 30.2851 19.9071 0.09362475210337928 0.09362475210337928 0.09362475210337928 -20.089 30.2851 20.9071 0.08162601700163637 0.08162601700163637 0.08162601700163637 -19.089 29.2851 21.9071 0.06462107402278965 0.06462107402278965 0.06462107402278965 -19.089 29.2851 22.9071 0.07289442604175696 0.07289442604175696 0.07289442604175696 -19.089 30.2851 21.9071 0.07918651072019207 0.07918651072019207 0.07918651072019207 -19.089 30.2851 22.9071 0.08326560143010793 0.08326560143010793 0.08326560143010793 -20.089 29.2851 22.9071 0.08418825483798777 0.08418825483798777 0.08418825483798777 -20.089 30.2851 22.9071 0.11078312887893914 0.11078312887893914 0.11078312887893914 -17.089 28.2851 24.9071 0.05662705720373439 0.05662705720373439 0.05662705720373439 -18.089 27.2851 24.9071 0.06623013604900745 0.06623013604900745 0.06623013604900745 -18.089 28.2851 24.9071 0.0587624690441524 0.0587624690441524 0.0587624690441524 -17.089 27.2851 25.9071 0.02531342212249038 0.02531342212249038 0.02531342212249038 -17.089 27.2851 26.9071 0.08581010600014798 0.08581010600014798 0.08581010600014798 -17.089 28.2851 25.9071 0.07569373746642113 0.07569373746642113 0.07569373746642113 -17.089 28.2851 26.9071 0.07461746173541636 0.07461746173541636 0.07461746173541636 -18.089 27.2851 25.9071 0.0776505290106965 0.0776505290106965 0.0776505290106965 -18.089 27.2851 26.9071 0.03191089348128861 0.03191089348128861 0.03191089348128861 -18.089 28.2851 25.9071 0.09623482267025121 0.09623482267025121 0.09623482267025121 -17.089 29.2851 23.9071 0.0871056345792068 0.0871056345792068 0.0871056345792068 -17.089 29.2851 24.9071 0.07216303301494803 0.07216303301494803 0.07216303301494803 -17.089 30.2851 23.9071 0.06581404675541366 0.06581404675541366 0.06581404675541366 -17.089 30.2851 24.9071 0.08462707408732921 0.08462707408732921 0.08462707408732921 -18.089 29.2851 23.9071 0.16594251276514263 0.16594251276514263 0.16594251276514263 -18.089 29.2851 24.9071 0.11331310536023467 0.11331310536023467 0.11331310536023467 -18.089 30.2851 24.9071 0.052304445476921 0.052304445476921 0.052304445476921 -17.089 29.2851 25.9071 0.10732587455030747 0.10732587455030747 0.10732587455030747 -17.089 29.2851 26.9071 0.1060443307308063 0.1060443307308063 0.1060443307308063 -17.089 30.2851 25.9071 0.1285732260307535 0.1285732260307535 0.1285732260307535 -17.089 30.2851 26.9071 0.1019914646959744 0.1019914646959744 0.1019914646959744 -18.089 29.2851 25.9071 0.1255344467035036 0.1255344467035036 0.1255344467035036 -18.089 29.2851 26.9071 0.14489536280622928 0.14489536280622928 0.14489536280622928 -18.089 30.2851 25.9071 0.08147572009052727 0.08147572009052727 0.08147572009052727 -18.089 30.2851 26.9071 0.08602067099792249 0.08602067099792249 0.08602067099792249 -19.089 27.2851 26.9071 0.028018280311749428 0.028018280311749428 0.028018280311749428 -20.089 27.2851 25.9071 0.024828917091388642 0.024828917091388642 0.024828917091388642 -20.089 27.2851 26.9071 0.07476640500825353 0.07476640500825353 0.07476640500825353 -20.089 28.2851 26.9071 0.2855058501994595 0.2855058501994595 0.2855058501994595 -19.089 29.2851 23.9071 0.0 0.0 0.0 -19.089 29.2851 24.9071 0.08315870797329339 0.08315870797329339 0.08315870797329339 -19.089 30.2851 24.9071 0.04944602668739983 0.04944602668739983 0.04944602668739983 -20.089 29.2851 23.9071 0.12497375005566666 0.12497375005566666 0.12497375005566666 -20.089 29.2851 24.9071 0.10645008819243619 0.10645008819243619 0.10645008819243619 -20.089 30.2851 23.9071 0.12105920742432491 0.12105920742432491 0.12105920742432491 -20.089 30.2851 24.9071 0.0819386658263153 0.0819386658263153 0.0819386658263153 -20.089 29.2851 25.9071 0.20103695374358818 0.20103695374358818 0.20103695374358818 -20.089 30.2851 26.9071 0.16028599488891376 0.16028599488891376 0.16028599488891376 -17.089 32.2851 20.9071 0.07413662949297231 0.07413662949297231 0.07413662949297231 -17.089 31.2851 21.9071 0.10022048134009502 0.10022048134009502 0.10022048134009502 -17.089 31.2851 22.9071 0.09354037340918472 0.09354037340918472 0.09354037340918472 -17.089 32.2851 21.9071 0.10343618540321578 0.10343618540321578 0.10343618540321578 -18.089 32.2851 21.9071 0.07230973013817284 0.07230973013817284 0.07230973013817284 -18.089 32.2851 22.9071 0.06897855435899776 0.06897855435899776 0.06897855435899776 -17.089 33.2851 20.9071 0.06500445108390111 0.06500445108390111 0.06500445108390111 -17.089 33.2851 21.9071 0.09650964660189439 0.09650964660189439 0.09650964660189439 -17.089 34.2851 21.9071 0.05830654516514749 0.05830654516514749 0.05830654516514749 -17.089 34.2851 22.9071 0.07538612823965453 0.07538612823965453 0.07538612823965453 -18.089 33.2851 21.9071 0.06546435644608381 0.06546435644608381 0.06546435644608381 -18.089 33.2851 22.9071 0.0893245404616816 0.0893245404616816 0.0893245404616816 -18.089 34.2851 22.9071 0.07279547656629737 0.07279547656629737 0.07279547656629737 -19.089 31.2851 19.9071 0.0639216011233683 0.0639216011233683 0.0639216011233683 -19.089 31.2851 20.9071 0.14567275427790066 0.14567275427790066 0.14567275427790066 -19.089 32.2851 19.9071 0.0682988138955586 0.0682988138955586 0.0682988138955586 -20.089 31.2851 20.9071 0.10740943531927478 0.10740943531927478 0.10740943531927478 -20.089 32.2851 19.9071 0.08659369432729844 0.08659369432729844 0.08659369432729844 -20.089 32.2851 20.9071 0.1636542603174414 0.1636542603174414 0.1636542603174414 -19.089 31.2851 21.9071 0.10632394203247916 0.10632394203247916 0.10632394203247916 -19.089 31.2851 22.9071 0.13622388696613996 0.13622388696613996 0.13622388696613996 -19.089 32.2851 22.9071 0.1651091146720085 0.1651091146720085 0.1651091146720085 -20.089 31.2851 21.9071 0.1962898248910145 0.1962898248910145 0.1962898248910145 -20.089 31.2851 22.9071 0.14637143648465972 0.14637143648465972 0.14637143648465972 -20.089 32.2851 21.9071 0.13682225444193 0.13682225444193 0.13682225444193 -20.089 32.2851 22.9071 0.09189537299610712 0.09189537299610712 0.09189537299610712 -19.089 34.2851 20.9071 0.04273701513435625 0.04273701513435625 0.04273701513435625 -20.089 33.2851 19.9071 0.0778452008427945 0.0778452008427945 0.0778452008427945 -20.089 34.2851 20.9071 0.07375225099965435 0.07375225099965435 0.07375225099965435 -19.089 33.2851 21.9071 0.05712166160883979 0.05712166160883979 0.05712166160883979 -19.089 33.2851 22.9071 0.1696702176436406 0.1696702176436406 0.1696702176436406 -19.089 34.2851 21.9071 0.054459267991433864 0.054459267991433864 0.054459267991433864 -20.089 33.2851 21.9071 0.11375015897345905 0.11375015897345905 0.11375015897345905 -20.089 34.2851 21.9071 0.07331875795261278 0.07331875795261278 0.07331875795261278 -17.089 31.2851 23.9071 0.06369530213009776 0.06369530213009776 0.06369530213009776 -17.089 32.2851 23.9071 0.050908817159902454 0.050908817159902454 0.050908817159902454 -18.089 31.2851 23.9071 0.053120842246104145 0.053120842246104145 0.053120842246104145 -18.089 31.2851 24.9071 0.045303949337478916 0.045303949337478916 0.045303949337478916 -18.089 32.2851 23.9071 0.05699037305716579 0.05699037305716579 0.05699037305716579 -17.089 31.2851 25.9071 0.10069537226296511 0.10069537226296511 0.10069537226296511 -17.089 31.2851 26.9071 0.10846438256326711 0.10846438256326711 0.10846438256326711 -17.089 32.2851 25.9071 0.08586073809191712 0.08586073809191712 0.08586073809191712 -17.089 32.2851 26.9071 0.08329051642593761 0.08329051642593761 0.08329051642593761 -18.089 31.2851 25.9071 0.06948031746427537 0.06948031746427537 0.06948031746427537 -18.089 31.2851 26.9071 0.09420816808192105 0.09420816808192105 0.09420816808192105 -18.089 32.2851 25.9071 0.07554133962701562 0.07554133962701562 0.07554133962701562 -18.089 32.2851 26.9071 0.06550398809083664 0.06550398809083664 0.06550398809083664 -17.089 34.2851 23.9071 0.11620934469108626 0.11620934469108626 0.11620934469108626 -18.089 33.2851 23.9071 0.0536094381619853 0.0536094381619853 0.0536094381619853 -18.089 34.2851 23.9071 0.0928131057574866 0.0928131057574866 0.0928131057574866 -18.089 34.2851 26.9071 0.05315726392980602 0.05315726392980602 0.05315726392980602 -19.089 31.2851 23.9071 0.12032335175375701 0.12032335175375701 0.12032335175375701 -19.089 31.2851 24.9071 0.053979923263202646 0.053979923263202646 0.053979923263202646 -20.089 31.2851 23.9071 0.14919902974759136 0.14919902974759136 0.14919902974759136 -20.089 31.2851 24.9071 0.10363063415158587 0.10363063415158587 0.10363063415158587 -19.089 31.2851 25.9071 0.05867130055414279 0.05867130055414279 0.05867130055414279 -19.089 31.2851 26.9071 0.07022845475138717 0.07022845475138717 0.07022845475138717 -19.089 32.2851 25.9071 0.06468635034676025 0.06468635034676025 0.06468635034676025 -19.089 32.2851 26.9071 0.06403318277278512 0.06403318277278512 0.06403318277278512 -20.089 31.2851 25.9071 0.11431495084316376 0.11431495084316376 0.11431495084316376 -20.089 31.2851 26.9071 0.07284362502650901 0.07284362502650901 0.07284362502650901 -20.089 32.2851 25.9071 0.05547278083654823 0.05547278083654823 0.05547278083654823 -19.089 34.2851 24.9071 0.06420947824782748 0.06420947824782748 0.06420947824782748 -20.089 34.2851 24.9071 0.07573022931129017 0.07573022931129017 0.07573022931129017 -19.089 33.2851 25.9071 0.06972002439878096 0.06972002439878096 0.06972002439878096 -19.089 33.2851 26.9071 0.049912935764909905 0.049912935764909905 0.049912935764909905 -19.089 34.2851 25.9071 0.07852076149500681 0.07852076149500681 0.07852076149500681 -19.089 34.2851 26.9071 0.06321593203602358 0.06321593203602358 0.06321593203602358 -20.089 33.2851 25.9071 0.09861981311563896 0.09861981311563896 0.09861981311563896 -20.089 33.2851 26.9071 0.09008961080830981 0.09008961080830981 0.09008961080830981 -20.089 34.2851 25.9071 0.11335729287386832 0.11335729287386832 0.11335729287386832 -20.089 34.2851 26.9071 0.0937195775779037 0.0937195775779037 0.0937195775779037 -21.089 28.2851 19.9071 0.07243110673379868 0.07243110673379868 0.07243110673379868 -21.089 28.2851 20.9071 0.058083848203217554 0.058083848203217554 0.058083848203217554 -22.089 27.2851 19.9071 0.08773731774740734 0.08773731774740734 0.08773731774740734 -22.089 27.2851 20.9071 0.0902559644270226 0.0902559644270226 0.0902559644270226 -22.089 28.2851 19.9071 0.08312575582639577 0.08312575582639577 0.08312575582639577 -22.089 28.2851 20.9071 0.094880778773818 0.094880778773818 0.094880778773818 -21.089 27.2851 21.9071 0.0962203582267896 0.0962203582267896 0.0962203582267896 -21.089 27.2851 22.9071 0.10061823281135923 0.10061823281135923 0.10061823281135923 -21.089 28.2851 21.9071 0.09038695761420071 0.09038695761420071 0.09038695761420071 -21.089 28.2851 22.9071 0.10421638807819761 0.10421638807819761 0.10421638807819761 -22.089 27.2851 21.9071 0.16644190517391 0.16644190517391 0.16644190517391 -22.089 27.2851 22.9071 0.09994406299790545 0.09994406299790545 0.09994406299790545 -22.089 28.2851 22.9071 0.12988975378929724 0.12988975378929724 0.12988975378929724 -21.089 29.2851 19.9071 0.06394169869412986 0.06394169869412986 0.06394169869412986 -21.089 29.2851 20.9071 0.05765702403596308 0.05765702403596308 0.05765702403596308 -21.089 30.2851 20.9071 0.07488134755053306 0.07488134755053306 0.07488134755053306 -22.089 29.2851 19.9071 0.056574718360733425 0.056574718360733425 0.056574718360733425 -22.089 29.2851 20.9071 0.06067979724368297 0.06067979724368297 0.06067979724368297 -21.089 29.2851 22.9071 0.09042231770178769 0.09042231770178769 0.09042231770178769 -21.089 30.2851 22.9071 0.08233168537588621 0.08233168537588621 0.08233168537588621 -22.089 29.2851 21.9071 0.09237192029878256 0.09237192029878256 0.09237192029878256 -22.089 29.2851 22.9071 0.10159050590725564 0.10159050590725564 0.10159050590725564 -22.089 30.2851 21.9071 0.17874428531136324 0.17874428531136324 0.17874428531136324 -22.089 30.2851 22.9071 0.12597223721476078 0.12597223721476078 0.12597223721476078 -23.089 27.2851 19.9071 0.0782096265322319 0.0782096265322319 0.0782096265322319 -23.089 28.2851 19.9071 0.10142899689272035 0.10142899689272035 0.10142899689272035 -23.089 28.2851 20.9071 0.11933282798042014 0.11933282798042014 0.11933282798042014 -23.089 27.2851 21.9071 0.0688017066359811 0.0688017066359811 0.0688017066359811 -23.089 27.2851 22.9071 0.078165660838559 0.078165660838559 0.078165660838559 -23.089 28.2851 21.9071 0.12487092846989399 0.12487092846989399 0.12487092846989399 -23.089 28.2851 22.9071 0.09517971505416058 0.09517971505416058 0.09517971505416058 -24.089 28.2851 21.9071 0.04727064653788053 0.04727064653788053 0.04727064653788053 -24.089 28.2851 22.9071 0.0 0.0 0.0 -23.089 29.2851 20.9071 0.07981423734729971 0.07981423734729971 0.07981423734729971 -24.089 29.2851 20.9071 0.134063301585407 0.134063301585407 0.134063301585407 -23.089 29.2851 21.9071 0.085603558882955 0.085603558882955 0.085603558882955 -23.089 29.2851 22.9071 0.132220734235174 0.132220734235174 0.132220734235174 -23.089 30.2851 21.9071 0.10058769842465347 0.10058769842465347 0.10058769842465347 -23.089 30.2851 22.9071 0.08675041107690898 0.08675041107690898 0.08675041107690898 -24.089 29.2851 21.9071 0.13347696171418763 0.13347696171418763 0.13347696171418763 -24.089 29.2851 22.9071 0.11358706755356698 0.11358706755356698 0.11358706755356698 -24.089 30.2851 21.9071 0.11727060351484299 0.11727060351484299 0.11727060351484299 -24.089 30.2851 22.9071 0.09704482735367914 0.09704482735367914 0.09704482735367914 -21.089 28.2851 23.9071 0.09324785991750607 0.09324785991750607 0.09324785991750607 -21.089 28.2851 24.9071 0.08146125299335916 0.08146125299335916 0.08146125299335916 -22.089 27.2851 23.9071 0.08526199147504251 0.08526199147504251 0.08526199147504251 -22.089 27.2851 24.9071 0.1382960667615025 0.1382960667615025 0.1382960667615025 -22.089 28.2851 23.9071 0.11361840041357704 0.11361840041357704 0.11361840041357704 -22.089 28.2851 24.9071 0.13110585607985809 0.13110585607985809 0.13110585607985809 -21.089 27.2851 25.9071 0.09480443734138357 0.09480443734138357 0.09480443734138357 -21.089 27.2851 26.9071 0.13144883537092686 0.13144883537092686 0.13144883537092686 -21.089 28.2851 25.9071 0.0 0.0 0.0 -21.089 28.2851 26.9071 0.3089358922636845 0.3089358922636845 0.3089358922636845 -22.089 27.2851 25.9071 0.2223863413299899 0.2223863413299899 0.2223863413299899 -22.089 27.2851 26.9071 0.7723970469871176 0.7723970469871176 0.7723970469871176 -22.089 28.2851 25.9071 0.12629595967545493 0.12629595967545493 0.12629595967545493 -22.089 28.2851 26.9071 0.40625821491190134 0.40625821491190134 0.40625821491190134 -21.089 29.2851 23.9071 0.0994056873378185 0.0994056873378185 0.0994056873378185 -21.089 29.2851 24.9071 0.06438513021794413 0.06438513021794413 0.06438513021794413 -21.089 30.2851 23.9071 0.10262624506510573 0.10262624506510573 0.10262624506510573 -21.089 30.2851 24.9071 0.08784340145721367 0.08784340145721367 0.08784340145721367 -22.089 29.2851 23.9071 0.11891990530389485 0.11891990530389485 0.11891990530389485 -22.089 30.2851 23.9071 0.10876246492161419 0.10876246492161419 0.10876246492161419 -21.089 29.2851 25.9071 0.0741183832112052 0.0741183832112052 0.0741183832112052 -21.089 29.2851 26.9071 0.2610368981046823 0.2610368981046823 0.2610368981046823 -21.089 30.2851 25.9071 0.057817414999154985 0.057817414999154985 0.057817414999154985 -21.089 30.2851 26.9071 0.10640911079910706 0.10640911079910706 0.10640911079910706 -22.089 29.2851 26.9071 0.1905800582984352 0.1905800582984352 0.1905800582984352 -22.089 30.2851 26.9071 0.1838536677712333 0.1838536677712333 0.1838536677712333 -23.089 27.2851 23.9071 0.10495158758842983 0.10495158758842983 0.10495158758842983 -23.089 27.2851 24.9071 0.14128296380280303 0.14128296380280303 0.14128296380280303 -23.089 28.2851 23.9071 0.1118966818387184 0.1118966818387184 0.1118966818387184 -23.089 28.2851 24.9071 0.1523870801845698 0.1523870801845698 0.1523870801845698 -24.089 27.2851 23.9071 0.046726772207965284 0.046726772207965284 0.046726772207965284 -24.089 27.2851 24.9071 0.09411816479098135 0.09411816479098135 0.09411816479098135 -24.089 28.2851 23.9071 0.024259636037494182 0.024259636037494182 0.024259636037494182 -24.089 28.2851 24.9071 0.08747532253149196 0.08747532253149196 0.08747532253149196 -23.089 27.2851 25.9071 0.651997853670246 0.651997853670246 0.651997853670246 -23.089 28.2851 25.9071 0.2160445454148298 0.2160445454148298 0.2160445454148298 -23.089 28.2851 26.9071 0.38542838156261616 0.38542838156261616 0.38542838156261616 -24.089 27.2851 25.9071 0.23040273437625672 0.23040273437625672 0.23040273437625672 -24.089 28.2851 25.9071 0.10217707820812559 0.10217707820812559 0.10217707820812559 -23.089 29.2851 23.9071 0.11141623302925609 0.11141623302925609 0.11141623302925609 -23.089 30.2851 23.9071 0.09907783890227397 0.09907783890227397 0.09907783890227397 -24.089 29.2851 23.9071 0.12106563408177198 0.12106563408177198 0.12106563408177198 -24.089 29.2851 24.9071 0.0577953059881491 0.0577953059881491 0.0577953059881491 -24.089 30.2851 24.9071 0.15641492499146542 0.15641492499146542 0.15641492499146542 -23.089 29.2851 26.9071 0.3348741194257312 0.3348741194257312 0.3348741194257312 -23.089 30.2851 26.9071 0.14537882408807312 0.14537882408807312 0.14537882408807312 -24.089 29.2851 25.9071 0.09021497878477636 0.09021497878477636 0.09021497878477636 -24.089 29.2851 26.9071 0.4078831922893133 0.4078831922893133 0.4078831922893133 -24.089 30.2851 25.9071 0.18928780018042174 0.18928780018042174 0.18928780018042174 -24.089 30.2851 26.9071 0.6486332118430508 0.6486332118430508 0.6486332118430508 -21.089 32.2851 19.9071 0.09582579934943689 0.09582579934943689 0.09582579934943689 -21.089 32.2851 20.9071 0.10168933962191938 0.10168933962191938 0.10168933962191938 -22.089 32.2851 19.9071 0.11364009238645498 0.11364009238645498 0.11364009238645498 -22.089 31.2851 22.9071 0.11403777751918297 0.11403777751918297 0.11403777751918297 -21.089 33.2851 19.9071 0.10749219253377504 0.10749219253377504 0.10749219253377504 -21.089 33.2851 20.9071 0.06878972920794814 0.06878972920794814 0.06878972920794814 -21.089 34.2851 19.9071 0.04703232003688402 0.04703232003688402 0.04703232003688402 -21.089 34.2851 20.9071 0.07423549693900477 0.07423549693900477 0.07423549693900477 -22.089 33.2851 19.9071 0.09305901135656962 0.09305901135656962 0.09305901135656962 -22.089 33.2851 20.9071 0.058566062724273366 0.058566062724273366 0.058566062724273366 -22.089 34.2851 19.9071 0.06374731477920603 0.06374731477920603 0.06374731477920603 -21.089 33.2851 21.9071 0.07531081323275346 0.07531081323275346 0.07531081323275346 -21.089 33.2851 22.9071 0.06531676256283506 0.06531676256283506 0.06531676256283506 -21.089 34.2851 21.9071 0.06184613815707573 0.06184613815707573 0.06184613815707573 -21.089 34.2851 22.9071 0.06634083023014219 0.06634083023014219 0.06634083023014219 -22.089 33.2851 22.9071 0.03887902184498132 0.03887902184498132 0.03887902184498132 -22.089 34.2851 22.9071 0.05039913904851443 0.05039913904851443 0.05039913904851443 -23.089 31.2851 20.9071 0.07153195099768948 0.07153195099768948 0.07153195099768948 -23.089 32.2851 19.9071 0.09708902380317118 0.09708902380317118 0.09708902380317118 -23.089 32.2851 20.9071 0.09380074166649051 0.09380074166649051 0.09380074166649051 -24.089 32.2851 19.9071 0.09297382845635271 0.09297382845635271 0.09297382845635271 -24.089 32.2851 20.9071 0.08254708177878631 0.08254708177878631 0.08254708177878631 -23.089 31.2851 21.9071 0.057186783223681835 0.057186783223681835 0.057186783223681835 -23.089 32.2851 21.9071 0.05890308056030701 0.05890308056030701 0.05890308056030701 -23.089 32.2851 22.9071 0.05435008505895311 0.05435008505895311 0.05435008505895311 -24.089 31.2851 21.9071 0.07551465389970492 0.07551465389970492 0.07551465389970492 -24.089 32.2851 21.9071 0.08145241198825454 0.08145241198825454 0.08145241198825454 -24.089 32.2851 22.9071 0.09552606188249523 0.09552606188249523 0.09552606188249523 -23.089 33.2851 19.9071 0.07568706604806041 0.07568706604806041 0.07568706604806041 -23.089 33.2851 20.9071 0.09762259356844132 0.09762259356844132 0.09762259356844132 -23.089 34.2851 19.9071 0.09178125838331719 0.09178125838331719 0.09178125838331719 -24.089 33.2851 19.9071 0.09067465969384379 0.09067465969384379 0.09067465969384379 -24.089 33.2851 20.9071 0.11228714481128961 0.11228714481128961 0.11228714481128961 -24.089 34.2851 19.9071 0.1238941168510431 0.1238941168510431 0.1238941168510431 -24.089 34.2851 20.9071 0.12599231929116306 0.12599231929116306 0.12599231929116306 -23.089 33.2851 21.9071 0.06982814147790298 0.06982814147790298 0.06982814147790298 -23.089 33.2851 22.9071 0.048138232662001394 0.048138232662001394 0.048138232662001394 -23.089 34.2851 21.9071 0.07780854920437497 0.07780854920437497 0.07780854920437497 -23.089 34.2851 22.9071 0.057944682388050645 0.057944682388050645 0.057944682388050645 -24.089 33.2851 21.9071 0.0863831308292393 0.0863831308292393 0.0863831308292393 -24.089 33.2851 22.9071 0.08553846026530319 0.08553846026530319 0.08553846026530319 -24.089 34.2851 21.9071 0.10463902818044954 0.10463902818044954 0.10463902818044954 -24.089 34.2851 22.9071 0.09352590848129383 0.09352590848129383 0.09352590848129383 -21.089 31.2851 24.9071 0.08209298047959894 0.08209298047959894 0.08209298047959894 -22.089 31.2851 23.9071 0.09911480227310927 0.09911480227310927 0.09911480227310927 -21.089 31.2851 25.9071 0.11097997017001754 0.11097997017001754 0.11097997017001754 -21.089 32.2851 25.9071 0.07741719547157236 0.07741719547157236 0.07741719547157236 -21.089 32.2851 26.9071 0.10523120268785244 0.10523120268785244 0.10523120268785244 -22.089 31.2851 25.9071 0.11153273007766289 0.11153273007766289 0.11153273007766289 -22.089 31.2851 26.9071 0.17235248468638414 0.17235248468638414 0.17235248468638414 -22.089 32.2851 26.9071 0.14292374228084867 0.14292374228084867 0.14292374228084867 -21.089 33.2851 23.9071 0.0771592658769847 0.0771592658769847 0.0771592658769847 -21.089 33.2851 24.9071 0.07129851932981315 0.07129851932981315 0.07129851932981315 -21.089 34.2851 23.9071 0.06866408668436869 0.06866408668436869 0.06866408668436869 -21.089 34.2851 24.9071 0.07696362785801344 0.07696362785801344 0.07696362785801344 -22.089 33.2851 23.9071 0.10388936274925653 0.10388936274925653 0.10388936274925653 -22.089 34.2851 23.9071 0.07382234273968795 0.07382234273968795 0.07382234273968795 -22.089 34.2851 24.9071 0.08612273856571148 0.08612273856571148 0.08612273856571148 -21.089 33.2851 25.9071 0.08738852638225719 0.08738852638225719 0.08738852638225719 -21.089 33.2851 26.9071 0.10236911944311143 0.10236911944311143 0.10236911944311143 -21.089 34.2851 25.9071 0.09068269605001797 0.09068269605001797 0.09068269605001797 -21.089 34.2851 26.9071 0.07873938312055052 0.07873938312055052 0.07873938312055052 -22.089 33.2851 25.9071 0.09398637407614205 0.09398637407614205 0.09398637407614205 -22.089 33.2851 26.9071 0.09387226242914978 0.09387226242914978 0.09387226242914978 -22.089 34.2851 25.9071 0.10821289982253535 0.10821289982253535 0.10821289982253535 -22.089 34.2851 26.9071 0.09550999013691504 0.09550999013691504 0.09550999013691504 -24.089 32.2851 24.9071 0.09892837814271983 0.09892837814271983 0.09892837814271983 -23.089 31.2851 26.9071 0.25454015425922966 0.25454015425922966 0.25454015425922966 -23.089 32.2851 25.9071 0.16012380071844254 0.16012380071844254 0.16012380071844254 -23.089 32.2851 26.9071 0.27936465591193477 0.27936465591193477 0.27936465591193477 -24.089 31.2851 25.9071 0.22780583782560596 0.22780583782560596 0.22780583782560596 -24.089 31.2851 26.9071 0.6071094836895196 0.6071094836895196 0.6071094836895196 -24.089 32.2851 25.9071 0.23577115311755 0.23577115311755 0.23577115311755 -24.089 32.2851 26.9071 0.4130188655963226 0.4130188655963226 0.4130188655963226 -23.089 33.2851 23.9071 0.06466544906652358 0.06466544906652358 0.06466544906652358 -23.089 33.2851 24.9071 0.0788200800704615 0.0788200800704615 0.0788200800704615 -23.089 34.2851 24.9071 0.07674082177795274 0.07674082177795274 0.07674082177795274 -24.089 33.2851 23.9071 0.06547617359169138 0.06547617359169138 0.06547617359169138 -24.089 34.2851 23.9071 0.0882396068032034 0.0882396068032034 0.0882396068032034 -24.089 34.2851 24.9071 0.09691304143287548 0.09691304143287548 0.09691304143287548 -23.089 33.2851 25.9071 0.14327309607938932 0.14327309607938932 0.14327309607938932 -23.089 33.2851 26.9071 0.14558361162885156 0.14558361162885156 0.14558361162885156 -23.089 34.2851 25.9071 0.1252589186098435 0.1252589186098435 0.1252589186098435 -23.089 34.2851 26.9071 0.10841135431912026 0.10841135431912026 0.10841135431912026 -24.089 33.2851 26.9071 0.38554208043166094 0.38554208043166094 0.38554208043166094 -24.089 34.2851 25.9071 0.0946019312959912 0.0946019312959912 0.0946019312959912 -24.089 34.2851 26.9071 0.12287873430752486 0.12287873430752486 0.12287873430752486 -23.089 35.2851 14.9071 0.06303296191609031 0.06303296191609031 0.06303296191609031 -23.089 36.2851 14.9071 0.06262103645004001 0.06262103645004001 0.06262103645004001 -24.089 35.2851 14.9071 0.09553891927666563 0.09553891927666563 0.09553891927666563 -24.089 36.2851 14.9071 0.10200512457943672 0.10200512457943672 0.10200512457943672 -24.089 37.2851 14.9071 0.1077669780140769 0.1077669780140769 0.1077669780140769 -24.089 38.2851 14.9071 0.06658352086115567 0.06658352086115567 0.06658352086115567 -22.089 35.2851 18.9071 0.1659674021708003 0.1659674021708003 0.1659674021708003 -22.089 36.2851 18.9071 0.11316768809856863 0.11316768809856863 0.11316768809856863 -22.089 37.2851 18.9071 0.06595794186659112 0.06595794186659112 0.06595794186659112 -23.089 35.2851 15.9071 0.05857080606716107 0.05857080606716107 0.05857080606716107 -23.089 35.2851 16.9071 0.05258665565743296 0.05258665565743296 0.05258665565743296 -23.089 36.2851 15.9071 0.06924342328977758 0.06924342328977758 0.06924342328977758 -23.089 36.2851 16.9071 0.0648425470498632 0.0648425470498632 0.0648425470498632 -24.089 36.2851 15.9071 0.0847492357967887 0.0847492357967887 0.0847492357967887 -23.089 35.2851 17.9071 0.07672972968424278 0.07672972968424278 0.07672972968424278 -23.089 35.2851 18.9071 0.10369973565971859 0.10369973565971859 0.10369973565971859 -23.089 36.2851 17.9071 0.09388110206955878 0.09388110206955878 0.09388110206955878 -23.089 36.2851 18.9071 0.06872823433129009 0.06872823433129009 0.06872823433129009 -24.089 35.2851 17.9071 0.051119553924246004 0.051119553924246004 0.051119553924246004 -23.089 37.2851 15.9071 0.07803054856557019 0.07803054856557019 0.07803054856557019 -23.089 37.2851 16.9071 0.10559759341613728 0.10559759341613728 0.10559759341613728 -24.089 37.2851 15.9071 0.09862543800953656 0.09862543800953656 0.09862543800953656 -24.089 38.2851 15.9071 0.07935899537487631 0.07935899537487631 0.07935899537487631 -24.089 38.2851 16.9071 0.08825728732083245 0.08825728732083245 0.08825728732083245 -23.089 37.2851 17.9071 0.12702854763084748 0.12702854763084748 0.12702854763084748 -23.089 37.2851 18.9071 0.05344485797014276 0.05344485797014276 0.05344485797014276 -23.089 38.2851 18.9071 0.03674042841065321 0.03674042841065321 0.03674042841065321 -24.089 37.2851 17.9071 0.12714582534639016 0.12714582534639016 0.12714582534639016 -24.089 37.2851 18.9071 0.035953298488625496 0.035953298488625496 0.035953298488625496 -24.089 38.2851 17.9071 0.09171214663771197 0.09171214663771197 0.09171214663771197 -24.089 38.2851 18.9071 0.037455416846036836 0.037455416846036836 0.037455416846036836 -24.089 39.2851 15.9071 0.051236701135220455 0.051236701135220455 0.051236701135220455 -24.089 39.2851 16.9071 0.08839873132198874 0.08839873132198874 0.08839873132198874 -18.089 35.2851 22.9071 0.054743560999656715 0.054743560999656715 0.054743560999656715 -19.089 35.2851 20.9071 0.05195718891345711 0.05195718891345711 0.05195718891345711 -19.089 36.2851 19.9071 0.04467756158291937 0.04467756158291937 0.04467756158291937 -19.089 36.2851 20.9071 0.08271505842411878 0.08271505842411878 0.08271505842411878 -20.089 35.2851 19.9071 0.03670013925448882 0.03670013925448882 0.03670013925448882 -20.089 35.2851 20.9071 0.07760752753093755 0.07760752753093755 0.07760752753093755 -20.089 36.2851 19.9071 0.07447719919996114 0.07447719919996114 0.07447719919996114 -19.089 35.2851 21.9071 0.05120060019407895 0.05120060019407895 0.05120060019407895 -19.089 35.2851 22.9071 0.05858037314773446 0.05858037314773446 0.05858037314773446 -19.089 36.2851 21.9071 0.08373175168687709 0.08373175168687709 0.08373175168687709 -19.089 36.2851 22.9071 0.07533018454862306 0.07533018454862306 0.07533018454862306 -20.089 35.2851 22.9071 0.04510340929571119 0.04510340929571119 0.04510340929571119 -20.089 36.2851 22.9071 0.06004452504282986 0.06004452504282986 0.06004452504282986 -19.089 37.2851 20.9071 0.08517760400971451 0.08517760400971451 0.08517760400971451 -20.089 37.2851 19.9071 0.05086338928451967 0.05086338928451967 0.05086338928451967 -20.089 37.2851 20.9071 0.11841539767868997 0.11841539767868997 0.11841539767868997 -20.089 38.2851 20.9071 0.08771963711551002 0.08771963711551002 0.08771963711551002 -19.089 37.2851 21.9071 0.08639840071978282 0.08639840071978282 0.08639840071978282 -19.089 37.2851 22.9071 0.08217013769526539 0.08217013769526539 0.08217013769526539 -20.089 37.2851 21.9071 0.08282195247037848 0.08282195247037848 0.08282195247037848 -20.089 37.2851 22.9071 0.06711431865294226 0.06711431865294226 0.06711431865294226 -20.089 38.2851 21.9071 0.0958764251384597 0.0958764251384597 0.0958764251384597 -20.089 38.2851 22.9071 0.07214864462515755 0.07214864462515755 0.07214864462515755 -17.089 35.2851 23.9071 0.0993735453934017 0.0993735453934017 0.0993735453934017 -17.089 35.2851 24.9071 0.10962215718178074 0.10962215718178074 0.10962215718178074 -18.089 35.2851 23.9071 0.053155173502495254 0.053155173502495254 0.053155173502495254 -18.089 35.2851 24.9071 0.11437761598405417 0.11437761598405417 0.11437761598405417 -17.089 35.2851 25.9071 0.07909014098743718 0.07909014098743718 0.07909014098743718 -17.089 35.2851 26.9071 0.07730675765975455 0.07730675765975455 0.07730675765975455 -18.089 35.2851 25.9071 0.06177081047400766 0.06177081047400766 0.06177081047400766 -18.089 35.2851 26.9071 0.05723687055331434 0.05723687055331434 0.05723687055331434 -19.089 35.2851 23.9071 0.0646527475166513 0.0646527475166513 0.0646527475166513 -19.089 35.2851 24.9071 0.053179293814377616 0.053179293814377616 0.053179293814377616 -20.089 35.2851 23.9071 0.054220882384096725 0.054220882384096725 0.054220882384096725 -20.089 35.2851 24.9071 0.059381511614309865 0.059381511614309865 0.059381511614309865 -20.089 36.2851 24.9071 0.07526282700696513 0.07526282700696513 0.07526282700696513 -19.089 35.2851 25.9071 0.06509617512147511 0.06509617512147511 0.06509617512147511 -19.089 35.2851 26.9071 0.06208498352465621 0.06208498352465621 0.06208498352465621 -19.089 36.2851 25.9071 0.0641245863573175 0.0641245863573175 0.0641245863573175 -19.089 36.2851 26.9071 0.06856899051720129 0.06856899051720129 0.06856899051720129 -20.089 35.2851 25.9071 0.08772687010176557 0.08772687010176557 0.08772687010176557 -20.089 36.2851 25.9071 0.09220798191618437 0.09220798191618437 0.09220798191618437 -20.089 37.2851 23.9071 0.06750515979819134 0.06750515979819134 0.06750515979819134 -20.089 37.2851 24.9071 0.0840829700100565 0.0840829700100565 0.0840829700100565 -20.089 38.2851 23.9071 0.05215923951115679 0.05215923951115679 0.05215923951115679 -20.089 38.2851 24.9071 0.04929840341543866 0.04929840341543866 0.04929840341543866 -19.089 37.2851 25.9071 0.045100836204518706 0.045100836204518706 0.045100836204518706 -19.089 37.2851 26.9071 0.06073350010538163 0.06073350010538163 0.06073350010538163 -20.089 37.2851 25.9071 0.08804512085282604 0.08804512085282604 0.08804512085282604 -20.089 37.2851 26.9071 0.07791118982513778 0.07791118982513778 0.07791118982513778 -20.089 38.2851 25.9071 0.04944482061600344 0.04944482061600344 0.04944482061600344 -20.089 39.2851 22.9071 0.09917828280511103 0.09917828280511103 0.09917828280511103 -20.089 39.2851 23.9071 0.09364644946757467 0.09364644946757467 0.09364644946757467 -20.089 39.2851 24.9071 0.05921670204464701 0.05921670204464701 0.05921670204464701 -20.089 40.2851 23.9071 0.07480337955026754 0.07480337955026754 0.07480337955026754 -20.089 40.2851 24.9071 0.08267567637128619 0.08267567637128619 0.08267567637128619 -20.089 39.2851 25.9071 0.06788988968404676 0.06788988968404676 0.06788988968404676 -20.089 39.2851 26.9071 0.06071991360633324 0.06071991360633324 0.06071991360633324 -20.089 40.2851 25.9071 0.0649483393950071 0.0649483393950071 0.0649483393950071 -20.089 40.2851 26.9071 0.04853865387151652 0.04853865387151652 0.04853865387151652 -20.089 41.2851 24.9071 0.0847749540277787 0.0847749540277787 0.0847749540277787 -20.089 41.2851 25.9071 0.06891472845288668 0.06891472845288668 0.06891472845288668 -21.089 35.2851 19.9071 0.08416173271874429 0.08416173271874429 0.08416173271874429 -21.089 35.2851 20.9071 0.056474623243568015 0.056474623243568015 0.056474623243568015 -21.089 36.2851 19.9071 0.053771927605871114 0.053771927605871114 0.053771927605871114 -22.089 35.2851 19.9071 0.14487769473093812 0.14487769473093812 0.14487769473093812 -22.089 36.2851 19.9071 0.13991843384653965 0.13991843384653965 0.13991843384653965 -21.089 35.2851 21.9071 0.050724773803534906 0.050724773803534906 0.050724773803534906 -21.089 35.2851 22.9071 0.05052633776894192 0.05052633776894192 0.05052633776894192 -21.089 36.2851 22.9071 0.061271893430850155 0.061271893430850155 0.061271893430850155 -22.089 35.2851 21.9071 0.05935377539327673 0.05935377539327673 0.05935377539327673 -22.089 35.2851 22.9071 0.07601412565365502 0.07601412565365502 0.07601412565365502 -21.089 37.2851 19.9071 0.11319821771120848 0.11319821771120848 0.11319821771120848 -21.089 38.2851 20.9071 0.09992076024541859 0.09992076024541859 0.09992076024541859 -22.089 37.2851 19.9071 0.10481981461846618 0.10481981461846618 0.10481981461846618 -22.089 38.2851 19.9071 0.07490915879832662 0.07490915879832662 0.07490915879832662 -22.089 38.2851 20.9071 0.11496409506490307 0.11496409506490307 0.11496409506490307 -21.089 38.2851 21.9071 0.10423808258618388 0.10423808258618388 0.10423808258618388 -22.089 38.2851 21.9071 0.10010557499341892 0.10010557499341892 0.10010557499341892 -24.089 35.2851 20.9071 0.1531965197328007 0.1531965197328007 0.1531965197328007 -24.089 36.2851 20.9071 0.08723422188571982 0.08723422188571982 0.08723422188571982 -23.089 35.2851 21.9071 0.12836839518720589 0.12836839518720589 0.12836839518720589 -23.089 35.2851 22.9071 0.07394315439139378 0.07394315439139378 0.07394315439139378 -24.089 35.2851 21.9071 0.12703256399380713 0.12703256399380713 0.12703256399380713 -24.089 35.2851 22.9071 0.06751352001584665 0.06751352001584665 0.06751352001584665 -24.089 36.2851 21.9071 0.1242531928953755 0.1242531928953755 0.1242531928953755 -24.089 36.2851 22.9071 0.08985253621621529 0.08985253621621529 0.08985253621621529 -23.089 37.2851 19.9071 0.05392316068258242 0.05392316068258242 0.05392316068258242 -23.089 37.2851 20.9071 0.08128764762444685 0.08128764762444685 0.08128764762444685 -23.089 38.2851 19.9071 0.03378093113469997 0.03378093113469997 0.03378093113469997 -23.089 38.2851 20.9071 0.08155287789814322 0.08155287789814322 0.08155287789814322 -24.089 37.2851 20.9071 0.07188788475781926 0.07188788475781926 0.07188788475781926 -24.089 38.2851 19.9071 0.03173653777908134 0.03173653777908134 0.03173653777908134 -24.089 38.2851 20.9071 0.03534485175362211 0.03534485175362211 0.03534485175362211 -23.089 37.2851 21.9071 0.11637162741635435 0.11637162741635435 0.11637162741635435 -23.089 38.2851 21.9071 0.10982783920182644 0.10982783920182644 0.10982783920182644 -23.089 38.2851 22.9071 0.09933095729726285 0.09933095729726285 0.09933095729726285 -24.089 37.2851 21.9071 0.09216619364758952 0.09216619364758952 0.09216619364758952 -24.089 37.2851 22.9071 0.09666714761324523 0.09666714761324523 0.09666714761324523 -24.089 38.2851 21.9071 0.08064385777769482 0.08064385777769482 0.08064385777769482 -24.089 38.2851 22.9071 0.676636214881962 0.676636214881962 0.676636214881962 -21.089 35.2851 23.9071 0.05178826361123129 0.05178826361123129 0.05178826361123129 -21.089 35.2851 24.9071 0.08678898746077952 0.08678898746077952 0.08678898746077952 -21.089 36.2851 23.9071 0.07570708030148295 0.07570708030148295 0.07570708030148295 -21.089 36.2851 24.9071 0.0986045455445136 0.0986045455445136 0.0986045455445136 -22.089 35.2851 23.9071 0.0896845744722529 0.0896845744722529 0.0896845744722529 -22.089 36.2851 23.9071 0.08646349864162733 0.08646349864162733 0.08646349864162733 -22.089 36.2851 24.9071 0.10874237854402698 0.10874237854402698 0.10874237854402698 -21.089 35.2851 25.9071 0.08516554865029924 0.08516554865029924 0.08516554865029924 -21.089 36.2851 25.9071 0.08907781979642927 0.08907781979642927 0.08907781979642927 -22.089 35.2851 25.9071 0.09222967966248392 0.09222967966248392 0.09222967966248392 -22.089 36.2851 25.9071 0.09673946940292 0.09673946940292 0.09673946940292 -22.089 36.2851 26.9071 0.06411276901318656 0.06411276901318656 0.06411276901318656 -21.089 37.2851 24.9071 0.09663179027019167 0.09663179027019167 0.09663179027019167 -21.089 38.2851 24.9071 0.05328212666291202 0.05328212666291202 0.05328212666291202 -22.089 37.2851 24.9071 0.08851526170428738 0.08851526170428738 0.08851526170428738 -21.089 37.2851 25.9071 0.09341742143922499 0.09341742143922499 0.09341742143922499 -21.089 37.2851 26.9071 0.08965805416483665 0.08965805416483665 0.08965805416483665 -21.089 38.2851 25.9071 0.07153733663768032 0.07153733663768032 0.07153733663768032 -21.089 38.2851 26.9071 0.06358814149663149 0.06358814149663149 0.06358814149663149 -22.089 37.2851 25.9071 0.09660125437049301 0.09660125437049301 0.09660125437049301 -22.089 37.2851 26.9071 0.0781488622399354 0.0781488622399354 0.0781488622399354 -22.089 38.2851 25.9071 0.07245473897680864 0.07245473897680864 0.07245473897680864 -22.089 38.2851 26.9071 0.08416816232420898 0.08416816232420898 0.08416816232420898 -23.089 35.2851 23.9071 0.10603790287336762 0.10603790287336762 0.10603790287336762 -23.089 35.2851 24.9071 0.1030898726255308 0.1030898726255308 0.1030898726255308 -23.089 36.2851 23.9071 0.08640241911153909 0.08640241911153909 0.08640241911153909 -23.089 36.2851 24.9071 0.11014760942314604 0.11014760942314604 0.11014760942314604 -24.089 35.2851 23.9071 0.07523099693184297 0.07523099693184297 0.07523099693184297 -24.089 35.2851 24.9071 0.09846954794741046 0.09846954794741046 0.09846954794741046 -24.089 36.2851 23.9071 0.06503684792945198 0.06503684792945198 0.06503684792945198 -24.089 36.2851 24.9071 0.0991766757036625 0.0991766757036625 0.0991766757036625 -23.089 35.2851 25.9071 0.1146941545395397 0.1146941545395397 0.1146941545395397 -23.089 36.2851 25.9071 0.10234742443117034 0.10234742443117034 0.10234742443117034 -24.089 35.2851 25.9071 0.10707519172264472 0.10707519172264472 0.10707519172264472 -24.089 35.2851 26.9071 0.10622993489293699 0.10622993489293699 0.10622993489293699 -24.089 36.2851 25.9071 0.10235787017838416 0.10235787017838416 0.10235787017838416 -24.089 36.2851 26.9071 0.10478124687911473 0.10478124687911473 0.10478124687911473 -23.089 37.2851 23.9071 0.06462002895804368 0.06462002895804368 0.06462002895804368 -23.089 37.2851 24.9071 0.0871771612938285 0.0871771612938285 0.0871771612938285 -24.089 37.2851 23.9071 0.09490167220587441 0.09490167220587441 0.09490167220587441 -24.089 37.2851 24.9071 0.07902318846960822 0.07902318846960822 0.07902318846960822 -24.089 38.2851 23.9071 0.10723106511116676 0.10723106511116676 0.10723106511116676 -24.089 38.2851 24.9071 0.09533159354527303 0.09533159354527303 0.09533159354527303 -23.089 37.2851 25.9071 0.09760732580807516 0.09760732580807516 0.09760732580807516 -23.089 37.2851 26.9071 0.07462742880599875 0.07462742880599875 0.07462742880599875 -23.089 38.2851 25.9071 0.06233580657382506 0.06233580657382506 0.06233580657382506 -23.089 38.2851 26.9071 0.039035590320024995 0.039035590320024995 0.039035590320024995 -24.089 37.2851 26.9071 0.06819366904419352 0.06819366904419352 0.06819366904419352 -24.089 38.2851 25.9071 0.05391455785171576 0.05391455785171576 0.05391455785171576 -24.089 38.2851 26.9071 0.06347109265964429 0.06347109265964429 0.06347109265964429 -21.089 39.2851 21.9071 0.060213754586722325 0.060213754586722325 0.060213754586722325 -21.089 39.2851 22.9071 0.12821818557051 0.12821818557051 0.12821818557051 -22.089 39.2851 21.9071 0.08373416280187701 0.08373416280187701 0.08373416280187701 -22.089 39.2851 22.9071 0.12709843231754492 0.12709843231754492 0.12709843231754492 -22.089 40.2851 22.9071 0.08487782686950919 0.08487782686950919 0.08487782686950919 -23.089 39.2851 22.9071 0.1285531445985581 0.1285531445985581 0.1285531445985581 -23.089 40.2851 22.9071 0.08005206488866541 0.08005206488866541 0.08005206488866541 -24.089 39.2851 22.9071 0.11030026310071216 0.11030026310071216 0.11030026310071216 -21.089 39.2851 23.9071 0.08444865336259212 0.08444865336259212 0.08444865336259212 -21.089 40.2851 23.9071 0.09365850355626791 0.09365850355626791 0.09365850355626791 -22.089 40.2851 23.9071 0.08801618901838323 0.08801618901838323 0.08801618901838323 -21.089 39.2851 26.9071 0.07243392009642746 0.07243392009642746 0.07243392009642746 -21.089 40.2851 26.9071 0.038636086797513756 0.038636086797513756 0.038636086797513756 -22.089 39.2851 26.9071 0.04346071505205312 0.04346071505205312 0.04346071505205312 -21.089 41.2851 23.9071 0.059485542456652746 0.059485542456652746 0.059485542456652746 -21.089 41.2851 24.9071 0.08996022442260991 0.08996022442260991 0.08996022442260991 -22.089 41.2851 23.9071 0.06587683007300059 0.06587683007300059 0.06587683007300059 -22.089 41.2851 24.9071 0.055722740117335294 0.055722740117335294 0.055722740117335294 -22.089 42.2851 24.9071 0.025553743256545587 0.025553743256545587 0.025553743256545587 -21.089 41.2851 25.9071 0.056867927999313096 0.056867927999313096 0.056867927999313096 -21.089 41.2851 26.9071 0.03821173275520069 0.03821173275520069 0.03821173275520069 -21.089 42.2851 25.9071 0.03274108844315039 0.03274108844315039 0.03274108844315039 -21.089 42.2851 26.9071 0.030959170534739806 0.030959170534739806 0.030959170534739806 -22.089 41.2851 25.9071 0.056277246563303976 0.056277246563303976 0.056277246563303976 -22.089 42.2851 25.9071 0.03104835985409798 0.03104835985409798 0.03104835985409798 -22.089 42.2851 26.9071 0.03414603899241122 0.03414603899241122 0.03414603899241122 -23.089 39.2851 23.9071 0.09733893417897231 0.09733893417897231 0.09733893417897231 -23.089 40.2851 23.9071 0.09333786418206964 0.09333786418206964 0.09333786418206964 -23.089 40.2851 24.9071 0.038491258239131264 0.038491258239131264 0.038491258239131264 -24.089 39.2851 23.9071 0.11835514576037472 0.11835514576037472 0.11835514576037472 -24.089 39.2851 24.9071 0.09827267604559357 0.09827267604559357 0.09827267604559357 -24.089 40.2851 23.9071 0.07525977260636137 0.07525977260636137 0.07525977260636137 -24.089 40.2851 24.9071 0.05528416518166459 0.05528416518166459 0.05528416518166459 -23.089 39.2851 25.9071 0.03635635371808155 0.03635635371808155 0.03635635371808155 -23.089 39.2851 26.9071 0.047822477423334044 0.047822477423334044 0.047822477423334044 -24.089 39.2851 25.9071 0.07711610338041917 0.07711610338041917 0.07711610338041917 -24.089 40.2851 25.9071 0.054944961405760814 0.054944961405760814 0.054944961405760814 -24.089 40.2851 26.9071 0.05674741229419776 0.05674741229419776 0.05674741229419776 -23.089 41.2851 24.9071 0.049832772646005476 0.049832772646005476 0.049832772646005476 -23.089 42.2851 24.9071 0.03014142291448628 0.03014142291448628 0.03014142291448628 -24.089 41.2851 24.9071 0.04657456071174522 0.04657456071174522 0.04657456071174522 -24.089 42.2851 24.9071 0.019767981462302676 0.019767981462302676 0.019767981462302676 -23.089 41.2851 26.9071 0.039701585944842216 0.039701585944842216 0.039701585944842216 -23.089 42.2851 25.9071 0.03222059910366188 0.03222059910366188 0.03222059910366188 -23.089 42.2851 26.9071 0.02890376763537211 0.02890376763537211 0.02890376763537211 -24.089 41.2851 25.9071 0.051594171940797004 0.051594171940797004 0.051594171940797004 -24.089 41.2851 26.9071 0.056222495553157927 0.056222495553157927 0.056222495553157927 -24.089 42.2851 25.9071 0.023772148734796918 0.023772148734796918 0.023772148734796918 -24.089 42.2851 26.9071 0.025072858983199834 0.025072858983199834 0.025072858983199834 -11.088999999999999 28.2851 30.9071 0.019684892659678446 0.019684892659678446 0.019684892659678446 -12.088999999999999 27.2851 30.9071 0.07701691796537868 0.07701691796537868 0.07701691796537868 -12.088999999999999 28.2851 30.9071 0.05592783639329359 0.05592783639329359 0.05592783639329359 -11.088999999999999 29.2851 30.9071 0.03726635686206787 0.03726635686206787 0.03726635686206787 -12.088999999999999 29.2851 30.9071 0.04979490217791391 0.04979490217791391 0.04979490217791391 -11.088999999999999 27.2851 31.9071 0.05738407727579838 0.05738407727579838 0.05738407727579838 -11.088999999999999 27.2851 32.9071 0.08749139588219682 0.08749139588219682 0.08749139588219682 -11.088999999999999 28.2851 31.9071 0.03156073409159455 0.03156073409159455 0.03156073409159455 -11.088999999999999 28.2851 32.9071 0.026916192875209115 0.026916192875209115 0.026916192875209115 -12.088999999999999 27.2851 31.9071 0.08745040883157654 0.08745040883157654 0.08745040883157654 -11.088999999999999 27.2851 33.9071 0.07707912990125466 0.07707912990125466 0.07707912990125466 -11.088999999999999 27.2851 34.9071 0.0920898496392928 0.0920898496392928 0.0920898496392928 -11.088999999999999 28.2851 33.9071 0.05712343034475772 0.05712343034475772 0.05712343034475772 -11.088999999999999 28.2851 34.9071 0.07456706370641224 0.07456706370641224 0.07456706370641224 -12.088999999999999 27.2851 33.9071 0.04974907165127018 0.04974907165127018 0.04974907165127018 -11.088999999999999 29.2851 31.9071 0.04500603381846923 0.04500603381846923 0.04500603381846923 -11.088999999999999 29.2851 32.9071 0.035766165017164495 0.035766165017164495 0.035766165017164495 -11.088999999999999 30.2851 31.9071 0.019767418421323676 0.019767418421323676 0.019767418421323676 -11.088999999999999 30.2851 32.9071 0.03253006226883949 0.03253006226883949 0.03253006226883949 -12.088999999999999 29.2851 31.9071 0.06146588136293081 0.06146588136293081 0.06146588136293081 -12.088999999999999 29.2851 32.9071 0.05525280959516155 0.05525280959516155 0.05525280959516155 -12.088999999999999 30.2851 31.9071 0.05108425696175045 0.05108425696175045 0.05108425696175045 -12.088999999999999 30.2851 32.9071 0.0464209819952899 0.0464209819952899 0.0464209819952899 -11.088999999999999 29.2851 34.9071 0.06923514363685217 0.06923514363685217 0.06923514363685217 -12.088999999999999 29.2851 33.9071 0.03708131728976181 0.03708131728976181 0.03708131728976181 -12.088999999999999 29.2851 34.9071 0.06526298237140096 0.06526298237140096 0.06526298237140096 -12.088999999999999 30.2851 33.9071 0.03151907515601032 0.03151907515601032 0.03151907515601032 -12.088999999999999 30.2851 34.9071 0.041245931547077556 0.041245931547077556 0.041245931547077556 -13.088999999999999 27.2851 27.9071 0.03174667100827777 0.03174667100827777 0.03174667100827777 -13.088999999999999 27.2851 28.9071 0.05713645467164597 0.05713645467164597 0.05713645467164597 -13.088999999999999 28.2851 27.9071 0.03948977387960268 0.03948977387960268 0.03948977387960268 -13.088999999999999 28.2851 28.9071 0.06644332470650824 0.06644332470650824 0.06644332470650824 -14.088999999999999 27.2851 27.9071 0.03981995599807417 0.03981995599807417 0.03981995599807417 -14.088999999999999 27.2851 28.9071 0.07817418070064516 0.07817418070064516 0.07817418070064516 -13.088999999999999 27.2851 29.9071 0.04511989315920854 0.04511989315920854 0.04511989315920854 -13.088999999999999 27.2851 30.9071 0.06828161130694213 0.06828161130694213 0.06828161130694213 -13.088999999999999 28.2851 29.9071 0.06252319982234564 0.06252319982234564 0.06252319982234564 -13.088999999999999 28.2851 30.9071 0.08937677763903387 0.08937677763903387 0.08937677763903387 -14.088999999999999 27.2851 29.9071 0.07330758500619428 0.07330758500619428 0.07330758500619428 -14.088999999999999 28.2851 29.9071 0.08504499495677707 0.08504499495677707 0.08504499495677707 -14.088999999999999 28.2851 30.9071 0.07988143032988063 0.07988143032988063 0.07988143032988063 -13.088999999999999 29.2851 27.9071 0.04719852148706928 0.04719852148706928 0.04719852148706928 -13.088999999999999 29.2851 28.9071 0.04313135198555867 0.04313135198555867 0.04313135198555867 -14.088999999999999 29.2851 27.9071 0.08520251841344373 0.08520251841344373 0.08520251841344373 -14.088999999999999 30.2851 27.9071 0.10903081844509091 0.10903081844509091 0.10903081844509091 -14.088999999999999 30.2851 28.9071 0.043917125119473224 0.043917125119473224 0.043917125119473224 -13.088999999999999 29.2851 29.9071 0.057770865474351306 0.057770865474351306 0.057770865474351306 -13.088999999999999 29.2851 30.9071 0.04299409017283437 0.04299409017283437 0.04299409017283437 -13.088999999999999 30.2851 30.9071 0.10137114283848792 0.10137114283848792 0.10137114283848792 -14.088999999999999 29.2851 29.9071 0.062148493280900115 0.062148493280900115 0.062148493280900115 -14.088999999999999 29.2851 30.9071 0.08385873697840684 0.08385873697840684 0.08385873697840684 -14.088999999999999 30.2851 30.9071 0.08197483334973135 0.08197483334973135 0.08197483334973135 -15.088999999999999 27.2851 28.9071 0.11038141046404328 0.11038141046404328 0.11038141046404328 -16.089 27.2851 27.9071 0.09551079372426584 0.09551079372426584 0.09551079372426584 -16.089 27.2851 28.9071 0.11990561409873171 0.11990561409873171 0.11990561409873171 -16.089 28.2851 28.9071 0.09949648826141765 0.09949648826141765 0.09949648826141765 -15.088999999999999 27.2851 29.9071 0.06918546570145978 0.06918546570145978 0.06918546570145978 -15.088999999999999 27.2851 30.9071 0.06771086913234066 0.06771086913234066 0.06771086913234066 -15.088999999999999 28.2851 29.9071 0.08064948392850814 0.08064948392850814 0.08064948392850814 -15.088999999999999 28.2851 30.9071 0.09274319128326701 0.09274319128326701 0.09274319128326701 -16.089 28.2851 29.9071 0.10479329929964701 0.10479329929964701 0.10479329929964701 -16.089 28.2851 30.9071 0.10541921919105242 0.10541921919105242 0.10541921919105242 -15.088999999999999 29.2851 28.9071 0.19889094911871988 0.19889094911871988 0.19889094911871988 -15.088999999999999 30.2851 27.9071 0.05456668198365614 0.05456668198365614 0.05456668198365614 -15.088999999999999 30.2851 28.9071 0.04016525460131614 0.04016525460131614 0.04016525460131614 -16.089 30.2851 27.9071 0.06605545276491183 0.06605545276491183 0.06605545276491183 -16.089 30.2851 28.9071 0.05913992478836863 0.05913992478836863 0.05913992478836863 -15.088999999999999 29.2851 29.9071 0.050696873790974935 0.050696873790974935 0.050696873790974935 -15.088999999999999 30.2851 29.9071 0.06933859904466223 0.06933859904466223 0.06933859904466223 -16.089 29.2851 29.9071 0.1000887006209915 0.1000887006209915 0.1000887006209915 -16.089 29.2851 30.9071 0.10369089709803402 0.10369089709803402 0.10369089709803402 -16.089 30.2851 29.9071 0.1040725613773739 0.1040725613773739 0.1040725613773739 -16.089 30.2851 30.9071 0.11092051611654091 0.11092051611654091 0.11092051611654091 -13.088999999999999 27.2851 31.9071 0.09672500505018597 0.09672500505018597 0.09672500505018597 -13.088999999999999 28.2851 31.9071 0.0818293594344721 0.0818293594344721 0.0818293594344721 -14.088999999999999 27.2851 31.9071 0.09407878831951863 0.09407878831951863 0.09407878831951863 -14.088999999999999 27.2851 32.9071 0.1223790714209181 0.1223790714209181 0.1223790714209181 -14.088999999999999 28.2851 31.9071 0.09216780088908105 0.09216780088908105 0.09216780088908105 -14.088999999999999 28.2851 32.9071 0.1125980676749016 0.1125980676749016 0.1125980676749016 -14.088999999999999 27.2851 34.9071 0.11720392377379261 0.11720392377379261 0.11720392377379261 -14.088999999999999 28.2851 34.9071 0.1213178799804801 0.1213178799804801 0.1213178799804801 -13.088999999999999 29.2851 31.9071 0.04843131223675808 0.04843131223675808 0.04843131223675808 -13.088999999999999 29.2851 32.9071 0.02678573972517324 0.02678573972517324 0.02678573972517324 -13.088999999999999 30.2851 31.9071 0.09218628416405095 0.09218628416405095 0.09218628416405095 -13.088999999999999 30.2851 32.9071 0.06913032154952567 0.06913032154952567 0.06913032154952567 -14.088999999999999 29.2851 31.9071 0.07030690948881163 0.07030690948881163 0.07030690948881163 -13.088999999999999 29.2851 34.9071 0.027700435436784306 0.027700435436784306 0.027700435436784306 -13.088999999999999 30.2851 34.9071 0.0585687157805047 0.0585687157805047 0.0585687157805047 -14.088999999999999 30.2851 34.9071 0.07338515255185965 0.07338515255185965 0.07338515255185965 -15.088999999999999 27.2851 32.9071 0.11828284339883824 0.11828284339883824 0.11828284339883824 -15.088999999999999 28.2851 31.9071 0.09532596842108405 0.09532596842108405 0.09532596842108405 -15.088999999999999 28.2851 32.9071 0.11909824959928016 0.11909824959928016 0.11909824959928016 -16.089 27.2851 31.9071 0.14947768806096978 0.14947768806096978 0.14947768806096978 -16.089 27.2851 32.9071 0.174080135234755 0.174080135234755 0.174080135234755 -16.089 28.2851 31.9071 0.125838088815844 0.125838088815844 0.125838088815844 -16.089 28.2851 32.9071 0.15882944740407134 0.15882944740407134 0.15882944740407134 -15.088999999999999 27.2851 33.9071 0.13571065279368028 0.13571065279368028 0.13571065279368028 -15.088999999999999 27.2851 34.9071 0.11639974567707281 0.11639974567707281 0.11639974567707281 -15.088999999999999 28.2851 33.9071 0.14013287298860824 0.14013287298860824 0.14013287298860824 -15.088999999999999 28.2851 34.9071 0.14806671946748354 0.14806671946748354 0.14806671946748354 -16.089 27.2851 33.9071 0.2009334267867274 0.2009334267867274 0.2009334267867274 -16.089 27.2851 34.9071 0.1990185553324575 0.1990185553324575 0.1990185553324575 -16.089 28.2851 33.9071 0.1769011354260685 0.1769011354260685 0.1769011354260685 -16.089 28.2851 34.9071 0.16139645411467293 0.16139645411467293 0.16139645411467293 -15.088999999999999 29.2851 32.9071 0.09393976511311943 0.09393976511311943 0.09393976511311943 -16.089 29.2851 32.9071 0.12377281786992538 0.12377281786992538 0.12377281786992538 -16.089 30.2851 32.9071 0.10331967663047605 0.10331967663047605 0.10331967663047605 -15.088999999999999 29.2851 33.9071 0.1361596324759481 0.1361596324759481 0.1361596324759481 -15.088999999999999 29.2851 34.9071 0.12004539578630029 0.12004539578630029 0.12004539578630029 -15.088999999999999 30.2851 33.9071 0.10383713499376736 0.10383713499376736 0.10383713499376736 -15.088999999999999 30.2851 34.9071 0.0873989740718358 0.0873989740718358 0.0873989740718358 -16.089 29.2851 33.9071 0.12350531682149027 0.12350531682149027 0.12350531682149027 -16.089 29.2851 34.9071 0.11567188124882481 0.11567188124882481 0.11567188124882481 -16.089 30.2851 33.9071 0.12367802781036534 0.12367802781036534 0.12367802781036534 -14.088999999999999 31.2851 30.9071 0.09258246812367554 0.09258246812367554 0.09258246812367554 -16.089 32.2851 27.9071 0.0851687634129854 0.0851687634129854 0.0851687634129854 -16.089 32.2851 28.9071 0.06534819461621218 0.06534819461621218 0.06534819461621218 -15.088999999999999 31.2851 30.9071 0.0926330959535868 0.0926330959535868 0.0926330959535868 -16.089 31.2851 30.9071 0.12097164416565512 0.12097164416565512 0.12097164416565512 -16.089 32.2851 30.9071 0.08815441880016496 0.08815441880016496 0.08815441880016496 -16.089 33.2851 27.9071 0.05813345259791538 0.05813345259791538 0.05813345259791538 -16.089 33.2851 28.9071 0.0669421292941616 0.0669421292941616 0.0669421292941616 -16.089 34.2851 27.9071 0.06836440877909779 0.06836440877909779 0.06836440877909779 -16.089 34.2851 28.9071 0.051047110711173606 0.051047110711173606 0.051047110711173606 -13.088999999999999 31.2851 31.9071 0.0851735855567649 0.0851735855567649 0.0851735855567649 -13.088999999999999 31.2851 32.9071 0.08499034388953298 0.08499034388953298 0.08499034388953298 -13.088999999999999 32.2851 31.9071 0.044683592297002285 0.044683592297002285 0.044683592297002285 -13.088999999999999 32.2851 32.9071 0.0418945398189935 0.0418945398189935 0.0418945398189935 -14.088999999999999 31.2851 31.9071 0.10356153258408447 0.10356153258408447 0.10356153258408447 -14.088999999999999 32.2851 31.9071 0.062028226662086586 0.062028226662086586 0.062028226662086586 -13.088999999999999 31.2851 33.9071 0.05618937157593648 0.05618937157593648 0.05618937157593648 -13.088999999999999 31.2851 34.9071 0.04367428569484772 0.04367428569484772 0.04367428569484772 -13.088999999999999 32.2851 33.9071 0.056092331107838025 0.056092331107838025 0.056092331107838025 -14.088999999999999 31.2851 33.9071 0.05434839666191192 0.05434839666191192 0.05434839666191192 -14.088999999999999 31.2851 34.9071 0.0667875444158106 0.0667875444158106 0.0667875444158106 -14.088999999999999 32.2851 33.9071 0.07250007428072072 0.07250007428072072 0.07250007428072072 -14.088999999999999 32.2851 34.9071 0.045285374879873656 0.045285374879873656 0.045285374879873656 -14.088999999999999 33.2851 31.9071 0.050853258462793746 0.050853258462793746 0.050853258462793746 -14.088999999999999 33.2851 32.9071 0.09424915168997458 0.09424915168997458 0.09424915168997458 -14.088999999999999 33.2851 33.9071 0.08937115209848598 0.08937115209848598 0.08937115209848598 -15.088999999999999 32.2851 31.9071 0.0758310238804821 0.0758310238804821 0.0758310238804821 -16.089 31.2851 31.9071 0.08415530311276576 0.08415530311276576 0.08415530311276576 -16.089 31.2851 32.9071 0.08431684680733449 0.08431684680733449 0.08431684680733449 -16.089 32.2851 31.9071 0.10386847165113293 0.10386847165113293 0.10386847165113293 -16.089 32.2851 32.9071 0.09307910165008347 0.09307910165008347 0.09307910165008347 -15.088999999999999 31.2851 34.9071 0.07233730112927692 0.07233730112927692 0.07233730112927692 -15.088999999999999 32.2851 34.9071 0.05355323812456717 0.05355323812456717 0.05355323812456717 -16.089 31.2851 33.9071 0.11329784057716082 0.11329784057716082 0.11329784057716082 -16.089 31.2851 34.9071 0.07779745725786993 0.07779745725786993 0.07779745725786993 -16.089 32.2851 33.9071 0.08490675983254864 0.08490675983254864 0.08490675983254864 -16.089 32.2851 34.9071 0.06352519561164134 0.06352519561164134 0.06352519561164134 -15.088999999999999 33.2851 31.9071 0.06460756856982623 0.06460756856982623 0.06460756856982623 -15.088999999999999 33.2851 32.9071 0.08867840395597494 0.08867840395597494 0.08867840395597494 -16.089 33.2851 31.9071 0.07495947623378292 0.07495947623378292 0.07495947623378292 -16.089 33.2851 32.9071 0.07270335939852086 0.07270335939852086 0.07270335939852086 -15.088999999999999 33.2851 33.9071 0.08138972119692114 0.08138972119692114 0.08138972119692114 -16.089 33.2851 33.9071 0.059957860083934854 0.059957860083934854 0.059957860083934854 -10.088999999999999 28.2851 35.9071 0.06142214769674531 0.06142214769674531 0.06142214769674531 -11.088999999999999 27.2851 35.9071 0.06960965640530054 0.06960965640530054 0.06960965640530054 -11.088999999999999 27.2851 36.9071 0.07626450339151705 0.07626450339151705 0.07626450339151705 -11.088999999999999 28.2851 35.9071 0.08061653075385718 0.08061653075385718 0.08061653075385718 -11.088999999999999 28.2851 36.9071 0.06596389059748359 0.06596389059748359 0.06596389059748359 -12.088999999999999 27.2851 36.9071 0.0918720679122806 0.0918720679122806 0.0918720679122806 -12.088999999999999 28.2851 36.9071 0.0811027896438779 0.0811027896438779 0.0811027896438779 -11.088999999999999 29.2851 35.9071 0.07154529452297592 0.07154529452297592 0.07154529452297592 -11.088999999999999 29.2851 36.9071 0.05585161878690449 0.05585161878690449 0.05585161878690449 -11.088999999999999 30.2851 35.9071 0.04318337793070398 0.04318337793070398 0.04318337793070398 -12.088999999999999 29.2851 36.9071 0.06571886683095779 0.06571886683095779 0.06571886683095779 -12.088999999999999 30.2851 35.9071 0.05451611059349794 0.05451611059349794 0.05451611059349794 -12.088999999999999 30.2851 36.9071 0.04767557483109243 0.04767557483109243 0.04767557483109243 -13.088999999999999 27.2851 36.9071 0.08779839626407072 0.08779839626407072 0.08779839626407072 -13.088999999999999 28.2851 36.9071 0.06442259186997501 0.06442259186997501 0.06442259186997501 -14.088999999999999 27.2851 35.9071 0.11312028683492521 0.11312028683492521 0.11312028683492521 -14.088999999999999 27.2851 36.9071 0.07787132316262042 0.07787132316262042 0.07787132316262042 -14.088999999999999 28.2851 35.9071 0.1378382641905075 0.1378382641905075 0.1378382641905075 -13.088999999999999 29.2851 35.9071 0.049753091873960854 0.049753091873960854 0.049753091873960854 -13.088999999999999 29.2851 36.9071 0.057510862969979 0.057510862969979 0.057510862969979 -13.088999999999999 30.2851 35.9071 0.05113072995241643 0.05113072995241643 0.05113072995241643 -14.088999999999999 29.2851 35.9071 0.06591059316846513 0.06591059316846513 0.06591059316846513 -14.088999999999999 30.2851 35.9071 0.04715582535629415 0.04715582535629415 0.04715582535629415 -15.088999999999999 27.2851 35.9071 0.10347073624819747 0.10347073624819747 0.10347073624819747 -16.089 35.2851 27.9071 0.06579668285866562 0.06579668285866562 0.06579668285866562 -17.089 27.2851 28.9071 0.11625192385364139 0.11625192385364139 0.11625192385364139 -18.089 27.2851 28.9071 0.05946528298321881 0.05946528298321881 0.05946528298321881 -17.089 27.2851 29.9071 0.10221645071624727 0.10221645071624727 0.10221645071624727 -17.089 27.2851 30.9071 0.1375161945050292 0.1375161945050292 0.1375161945050292 -17.089 28.2851 29.9071 0.08352921776918953 0.08352921776918953 0.08352921776918953 -17.089 28.2851 30.9071 0.08098785598965304 0.08098785598965304 0.08098785598965304 -18.089 27.2851 29.9071 0.07658939045359332 0.07658939045359332 0.07658939045359332 -18.089 27.2851 30.9071 0.14216800852872497 0.14216800852872497 0.14216800852872497 -17.089 29.2851 28.9071 0.05204892782712317 0.05204892782712317 0.05204892782712317 -17.089 30.2851 27.9071 0.07462879525913298 0.07462879525913298 0.07462879525913298 -17.089 30.2851 28.9071 0.05873666210110591 0.05873666210110591 0.05873666210110591 -18.089 30.2851 27.9071 0.0416139807953752 0.0416139807953752 0.0416139807953752 -17.089 29.2851 29.9071 0.08068886697316731 0.08068886697316731 0.08068886697316731 -17.089 29.2851 30.9071 0.06657909954119307 0.06657909954119307 0.06657909954119307 -17.089 30.2851 29.9071 0.12566779232254113 0.12566779232254113 0.12566779232254113 -17.089 30.2851 30.9071 0.09549552556313895 0.09549552556313895 0.09549552556313895 -19.089 27.2851 27.9071 0.053459571308279746 0.053459571308279746 0.053459571308279746 -19.089 27.2851 28.9071 0.15478807255629162 0.15478807255629162 0.15478807255629162 -20.089 27.2851 27.9071 0.17621797114954238 0.17621797114954238 0.17621797114954238 -20.089 27.2851 28.9071 0.2793919155124049 0.2793919155124049 0.2793919155124049 -20.089 28.2851 27.9071 0.3626757663835322 0.3626757663835322 0.3626757663835322 -20.089 28.2851 28.9071 0.41128433180184654 0.41128433180184654 0.41128433180184654 -19.089 27.2851 29.9071 0.359137209439797 0.359137209439797 0.359137209439797 -19.089 27.2851 30.9071 0.1331886094429072 0.1331886094429072 0.1331886094429072 -19.089 28.2851 29.9071 0.11721918781577319 0.11721918781577319 0.11721918781577319 -20.089 27.2851 29.9071 0.20815752310744987 0.20815752310744987 0.20815752310744987 -20.089 27.2851 30.9071 0.0030454874208863305 0.0030454874208863305 0.0030454874208863305 -20.089 28.2851 29.9071 0.2031877162038939 0.2031877162038939 0.2031877162038939 -20.089 28.2851 30.9071 0.04092162545025353 0.04092162545025353 0.04092162545025353 -20.089 29.2851 27.9071 0.33835205393430706 0.33835205393430706 0.33835205393430706 -20.089 29.2851 28.9071 0.26173056954155255 0.26173056954155255 0.26173056954155255 -20.089 30.2851 27.9071 0.1644194270628419 0.1644194270628419 0.1644194270628419 -20.089 30.2851 28.9071 0.19906349835324352 0.19906349835324352 0.19906349835324352 -20.089 29.2851 29.9071 0.4588187969690511 0.4588187969690511 0.4588187969690511 -20.089 29.2851 30.9071 1.0 1.0 1.0 -20.089 30.2851 29.9071 0.16732346169955148 0.16732346169955148 0.16732346169955148 -20.089 30.2851 30.9071 0.19991741097819837 0.19991741097819837 0.19991741097819837 -17.089 27.2851 31.9071 0.17398540442811736 0.17398540442811736 0.17398540442811736 -17.089 27.2851 32.9071 0.17284461197172168 0.17284461197172168 0.17284461197172168 -17.089 28.2851 31.9071 0.12675061482783026 0.12675061482783026 0.12675061482783026 -18.089 27.2851 31.9071 0.18440753262894857 0.18440753262894857 0.18440753262894857 -18.089 27.2851 32.9071 0.19160582356777478 0.19160582356777478 0.19160582356777478 -18.089 28.2851 31.9071 0.11320303817531063 0.11320303817531063 0.11320303817531063 -18.089 28.2851 32.9071 0.17329177885230798 0.17329177885230798 0.17329177885230798 -17.089 27.2851 34.9071 0.1886665457221596 0.1886665457221596 0.1886665457221596 -17.089 28.2851 34.9071 0.164076588298154 0.164076588298154 0.164076588298154 -18.089 27.2851 33.9071 0.22088117286648465 0.22088117286648465 0.22088117286648465 -18.089 27.2851 34.9071 0.1952432519550339 0.1952432519550339 0.1952432519550339 -18.089 28.2851 33.9071 0.21547725768251974 0.21547725768251974 0.21547725768251974 -18.089 28.2851 34.9071 0.16641139575874803 0.16641139575874803 0.16641139575874803 -17.089 29.2851 31.9071 0.0836481663223273 0.0836481663223273 0.0836481663223273 -17.089 29.2851 32.9071 0.10806827680411564 0.10806827680411564 0.10806827680411564 -17.089 30.2851 31.9071 0.09085065571024764 0.09085065571024764 0.09085065571024764 -17.089 30.2851 32.9071 0.09100254237381296 0.09100254237381296 0.09100254237381296 -18.089 29.2851 31.9071 0.06357648485497715 0.06357648485497715 0.06357648485497715 -18.089 29.2851 32.9071 0.10240768833879389 0.10240768833879389 0.10240768833879389 -18.089 30.2851 32.9071 0.06837333160837662 0.06837333160837662 0.06837333160837662 -17.089 29.2851 33.9071 0.11333319059671629 0.11333319059671629 0.11333319059671629 -17.089 29.2851 34.9071 0.0949466734256812 0.0949466734256812 0.0949466734256812 -17.089 30.2851 33.9071 0.10321682736675064 0.10321682736675064 0.10321682736675064 -17.089 30.2851 34.9071 0.09325428879688165 0.09325428879688165 0.09325428879688165 -18.089 29.2851 33.9071 0.10669514863848453 0.10669514863848453 0.10669514863848453 -18.089 29.2851 34.9071 0.11365134007377235 0.11365134007377235 0.11365134007377235 -19.089 27.2851 31.9071 0.12425801269713944 0.12425801269713944 0.12425801269713944 -19.089 28.2851 31.9071 0.11223974302885277 0.11223974302885277 0.11223974302885277 -19.089 28.2851 32.9071 0.15509722522989902 0.15509722522989902 0.15509722522989902 -20.089 28.2851 31.9071 0.05679122889899581 0.05679122889899581 0.05679122889899581 -19.089 27.2851 33.9071 0.17831079566910848 0.17831079566910848 0.17831079566910848 -19.089 27.2851 34.9071 0.17605661187776425 0.17605661187776425 0.17605661187776425 -19.089 28.2851 33.9071 0.19382024406042783 0.19382024406042783 0.19382024406042783 -19.089 28.2851 34.9071 0.1683045633426434 0.1683045633426434 0.1683045633426434 -20.089 27.2851 33.9071 0.15977371713697275 0.15977371713697275 0.15977371713697275 -20.089 28.2851 33.9071 0.18551364552795566 0.18551364552795566 0.18551364552795566 -20.089 28.2851 34.9071 0.2104862370549646 0.2104862370549646 0.2104862370549646 -19.089 29.2851 31.9071 0.0719018712826319 0.0719018712826319 0.0719018712826319 -19.089 29.2851 32.9071 0.14316949476633162 0.14316949476633162 0.14316949476633162 -19.089 30.2851 31.9071 0.12523321331682746 0.12523321331682746 0.12523321331682746 -19.089 30.2851 32.9071 0.1283997222911622 0.1283997222911622 0.1283997222911622 -20.089 29.2851 31.9071 0.16943257458701524 0.16943257458701524 0.16943257458701524 -20.089 30.2851 31.9071 0.256687080988617 0.256687080988617 0.256687080988617 -20.089 30.2851 32.9071 0.1491934083883973 0.1491934083883973 0.1491934083883973 -19.089 29.2851 33.9071 0.137800515441203 0.137800515441203 0.137800515441203 -19.089 29.2851 34.9071 0.12566056274644344 0.12566056274644344 0.12566056274644344 -20.089 29.2851 33.9071 0.16877985541773907 0.16877985541773907 0.16877985541773907 -20.089 29.2851 34.9071 0.12460503766615334 0.12460503766615334 0.12460503766615334 -20.089 30.2851 33.9071 0.15014100339066644 0.15014100339066644 0.15014100339066644 -20.089 30.2851 34.9071 0.18616221553981413 0.18616221553981413 0.18616221553981413 -17.089 31.2851 27.9071 0.08844775446889488 0.08844775446889488 0.08844775446889488 -17.089 32.2851 27.9071 0.12403308830662735 0.12403308830662735 0.12403308830662735 -17.089 32.2851 28.9071 0.10443815388399107 0.10443815388399107 0.10443815388399107 -18.089 31.2851 27.9071 0.05685273290033539 0.05685273290033539 0.05685273290033539 -18.089 31.2851 28.9071 0.04081041380983019 0.04081041380983019 0.04081041380983019 -18.089 32.2851 27.9071 0.07907961184367203 0.07907961184367203 0.07907961184367203 -18.089 32.2851 28.9071 0.06132832925543622 0.06132832925543622 0.06132832925543622 -17.089 31.2851 29.9071 0.08553604920437528 0.08553604920437528 0.08553604920437528 -17.089 31.2851 30.9071 0.10617931561845965 0.10617931561845965 0.10617931561845965 -17.089 32.2851 30.9071 0.10192798638361134 0.10192798638361134 0.10192798638361134 -18.089 31.2851 29.9071 0.07874091025481754 0.07874091025481754 0.07874091025481754 -18.089 32.2851 29.9071 0.04588055947944495 0.04588055947944495 0.04588055947944495 -18.089 32.2851 30.9071 0.039325968950194655 0.039325968950194655 0.039325968950194655 -17.089 33.2851 28.9071 0.09891311063014992 0.09891311063014992 0.09891311063014992 -17.089 34.2851 27.9071 0.05063094288707364 0.05063094288707364 0.05063094288707364 -17.089 34.2851 28.9071 0.08997951184732994 0.08997951184732994 0.08997951184732994 -18.089 33.2851 28.9071 0.08116226573613981 0.08116226573613981 0.08116226573613981 -18.089 34.2851 27.9071 0.06732396794431465 0.06732396794431465 0.06732396794431465 -18.089 34.2851 28.9071 0.08885038607000861 0.08885038607000861 0.08885038607000861 -17.089 33.2851 30.9071 0.06248155691595196 0.06248155691595196 0.06248155691595196 -17.089 34.2851 29.9071 0.1003699396993143 0.1003699396993143 0.1003699396993143 -17.089 34.2851 30.9071 0.09933336794481872 0.09933336794481872 0.09933336794481872 -18.089 33.2851 29.9071 0.04904633364028583 0.04904633364028583 0.04904633364028583 -18.089 33.2851 30.9071 0.030967212857932264 0.030967212857932264 0.030967212857932264 -18.089 34.2851 29.9071 0.10019878574875143 0.10019878574875143 0.10019878574875143 -19.089 31.2851 27.9071 0.046885576816503335 0.046885576816503335 0.046885576816503335 -19.089 32.2851 27.9071 0.0630762123598413 0.0630762123598413 0.0630762123598413 -19.089 32.2851 28.9071 0.04726220380951985 0.04726220380951985 0.04726220380951985 -20.089 31.2851 27.9071 0.078751600193875 0.078751600193875 0.078751600193875 -20.089 31.2851 28.9071 0.1443187390732082 0.1443187390732082 0.1443187390732082 -20.089 32.2851 27.9071 0.1222015377188733 0.1222015377188733 0.1222015377188733 -20.089 32.2851 28.9071 0.17338891890530975 0.17338891890530975 0.17338891890530975 -19.089 33.2851 27.9071 0.06606405429767107 0.06606405429767107 0.06606405429767107 -19.089 33.2851 28.9071 0.057547604253027684 0.057547604253027684 0.057547604253027684 -19.089 34.2851 27.9071 0.051514734121258614 0.051514734121258614 0.051514734121258614 -19.089 34.2851 28.9071 0.05512803031953624 0.05512803031953624 0.05512803031953624 -20.089 33.2851 27.9071 0.09421861488596418 0.09421861488596418 0.09421861488596418 -20.089 33.2851 28.9071 0.08893235872393905 0.08893235872393905 0.08893235872393905 -20.089 34.2851 27.9071 0.07728168005690696 0.07728168005690696 0.07728168005690696 -20.089 34.2851 28.9071 0.09852499341649164 0.09852499341649164 0.09852499341649164 -19.089 33.2851 30.9071 0.1274004619895316 0.1274004619895316 0.1274004619895316 -19.089 34.2851 29.9071 0.07203715461267922 0.07203715461267922 0.07203715461267922 -19.089 34.2851 30.9071 0.1538533803645529 0.1538533803645529 0.1538533803645529 -20.089 33.2851 29.9071 0.06224198919793735 0.06224198919793735 0.06224198919793735 -20.089 33.2851 30.9071 0.10438512298604517 0.10438512298604517 0.10438512298604517 -20.089 34.2851 29.9071 0.15674896367148353 0.15674896367148353 0.15674896367148353 -20.089 34.2851 30.9071 0.1396903406486395 0.1396903406486395 0.1396903406486395 -17.089 31.2851 32.9071 0.1451001515776267 0.1451001515776267 0.1451001515776267 -17.089 32.2851 31.9071 0.10956993314766916 0.10956993314766916 0.10956993314766916 -17.089 32.2851 32.9071 0.10730659128359596 0.10730659128359596 0.10730659128359596 -17.089 31.2851 33.9071 0.14753027187067225 0.14753027187067225 0.14753027187067225 -17.089 31.2851 34.9071 0.10343618540321578 0.10343618540321578 0.10343618540321578 -17.089 32.2851 33.9071 0.12643492698229614 0.12643492698229614 0.12643492698229614 -17.089 32.2851 34.9071 0.11014118189352894 0.11014118189352894 0.11014118189352894 -17.089 33.2851 31.9071 0.09168562699864087 0.09168562699864087 0.09168562699864087 -17.089 33.2851 32.9071 0.03342571337548801 0.03342571337548801 0.03342571337548801 -17.089 34.2851 31.9071 0.09150400741733918 0.09150400741733918 0.09150400741733918 -17.089 34.2851 32.9071 0.0855754298570903 0.0855754298570903 0.0855754298570903 -18.089 33.2851 31.9071 0.052727679975005076 0.052727679975005076 0.052727679975005076 -18.089 33.2851 32.9071 0.10334378190763932 0.10334378190763932 0.10334378190763932 -18.089 34.2851 32.9071 0.08505303187528536 0.08505303187528536 0.08505303187528536 -17.089 33.2851 33.9071 0.10166684090079477 0.10166684090079477 0.10166684090079477 -17.089 33.2851 34.9071 0.08907299788663245 0.08907299788663245 0.08907299788663245 -17.089 34.2851 33.9071 0.06618736962886794 0.06618736962886794 0.06618736962886794 -18.089 34.2851 33.9071 0.08145080453268633 0.08145080453268633 0.08145080453268633 -18.089 34.2851 34.9071 0.08886485183854004 0.08886485183854004 0.08886485183854004 -19.089 32.2851 31.9071 0.0 0.0 0.0 -20.089 31.2851 31.9071 0.23473070903046453 0.23473070903046453 0.23473070903046453 -20.089 31.2851 32.9071 0.23587864618852003 0.23587864618852003 0.23587864618852003 -20.089 32.2851 31.9071 0.18110515734480198 0.18110515734480198 0.18110515734480198 -20.089 32.2851 32.9071 0.2583150821155041 0.2583150821155041 0.2583150821155041 -20.089 31.2851 33.9071 0.140761730547679 0.140761730547679 0.140761730547679 -20.089 31.2851 34.9071 0.22063966933477352 0.22063966933477352 0.22063966933477352 -20.089 32.2851 33.9071 0.20115893882413516 0.20115893882413516 0.20115893882413516 -20.089 32.2851 34.9071 0.2571241584177101 0.2571241584177101 0.2571241584177101 -19.089 33.2851 31.9071 0.11550477678619835 0.11550477678619835 0.11550477678619835 -19.089 33.2851 32.9071 0.12079089401839453 0.12079089401839453 0.12079089401839453 -19.089 34.2851 31.9071 0.1756640499099677 0.1756640499099677 0.1756640499099677 -19.089 34.2851 32.9071 0.11387388327836324 0.11387388327836324 0.11387388327836324 -20.089 33.2851 31.9071 0.12808404091639494 0.12808404091639494 0.12808404091639494 -20.089 33.2851 32.9071 0.16736119659936485 0.16736119659936485 0.16736119659936485 -20.089 34.2851 31.9071 0.19177357266881154 0.19177357266881154 0.19177357266881154 -20.089 34.2851 32.9071 0.11814145192629733 0.11814145192629733 0.11814145192629733 -19.089 34.2851 33.9071 0.07467846983357289 0.07467846983357289 0.07467846983357289 -19.089 34.2851 34.9071 0.12332617898550902 0.12332617898550902 0.12332617898550902 -20.089 33.2851 33.9071 0.18543739004692375 0.18543739004692375 0.18543739004692375 -20.089 33.2851 34.9071 0.2376506567869524 0.2376506567869524 0.2376506567869524 -20.089 34.2851 33.9071 0.11662147790294597 0.11662147790294597 0.11662147790294597 -20.089 34.2851 34.9071 0.14424244453711538 0.14424244453711538 0.14424244453711538 -21.089 27.2851 27.9071 0.4768992139274428 0.4768992139274428 0.4768992139274428 -21.089 27.2851 28.9071 0.8273939031658848 0.8273939031658848 0.8273939031658848 -21.089 28.2851 27.9071 0.7377128379402728 0.7377128379402728 0.7377128379402728 -21.089 28.2851 28.9071 0.8210390955818051 0.8210390955818051 0.8210390955818051 -22.089 27.2851 27.9071 0.5116888241746158 0.5116888241746158 0.5116888241746158 -22.089 28.2851 27.9071 0.5689140568571965 0.5689140568571965 0.5689140568571965 -21.089 27.2851 29.9071 0.7568417329025248 0.7568417329025248 0.7568417329025248 -21.089 27.2851 30.9071 0.11208709303121255 0.11208709303121255 0.11208709303121255 -21.089 28.2851 29.9071 0.3182434923821847 0.3182434923821847 0.3182434923821847 -21.089 28.2851 30.9071 0.07195058295354058 0.07195058295354058 0.07195058295354058 -22.089 27.2851 30.9071 0.17161228104510498 0.17161228104510498 0.17161228104510498 -21.089 29.2851 27.9071 0.3952667426006039 0.3952667426006039 0.3952667426006039 -21.089 29.2851 28.9071 0.6954270890856941 0.6954270890856941 0.6954270890856941 -21.089 30.2851 28.9071 0.08856910672049192 0.08856910672049192 0.08856910672049192 -22.089 29.2851 27.9071 0.6314438895481661 0.6314438895481661 0.6314438895481661 -22.089 29.2851 28.9071 0.4809612295925724 0.4809612295925724 0.4809612295925724 -22.089 30.2851 27.9071 0.22012536870033553 0.22012536870033553 0.22012536870033553 -22.089 30.2851 28.9071 0.10516933391337004 0.10516933391337004 0.10516933391337004 -21.089 29.2851 29.9071 0.14221539268139144 0.14221539268139144 0.14221539268139144 -21.089 29.2851 30.9071 0.07931792380611104 0.07931792380611104 0.07931792380611104 -21.089 30.2851 29.9071 0.0568504013769625 0.0568504013769625 0.0568504013769625 -21.089 30.2851 30.9071 0.04592108526342738 0.04592108526342738 0.04592108526342738 -22.089 29.2851 29.9071 0.07440517891481682 0.07440517891481682 0.07440517891481682 -22.089 29.2851 30.9071 0.09798982251070422 0.09798982251070422 0.09798982251070422 -22.089 30.2851 29.9071 0.06017677333912458 0.06017677333912458 0.06017677333912458 -22.089 30.2851 30.9071 0.05081715734959561 0.05081715734959561 0.05081715734959561 -24.089 27.2851 28.9071 0.555550201359903 0.555550201359903 0.555550201359903 -23.089 27.2851 30.9071 0.6921472186966834 0.6921472186966834 0.6921472186966834 -23.089 28.2851 30.9071 0.19957953873930467 0.19957953873930467 0.19957953873930467 -24.089 27.2851 29.9071 0.5016016416963863 0.5016016416963863 0.5016016416963863 -24.089 27.2851 30.9071 0.2142544060242834 0.2142544060242834 0.2142544060242834 -24.089 28.2851 29.9071 0.5724441983994137 0.5724441983994137 0.5724441983994137 -24.089 28.2851 30.9071 0.3024790838406294 0.3024790838406294 0.3024790838406294 -23.089 29.2851 27.9071 0.6761886456466827 0.6761886456466827 0.6761886456466827 -23.089 30.2851 27.9071 0.23588345930772978 0.23588345930772978 0.23588345930772978 -23.089 29.2851 30.9071 0.16756271672210582 0.16756271672210582 0.16756271672210582 -23.089 30.2851 29.9071 0.0 0.0 0.0 -23.089 30.2851 30.9071 0.15063005441098307 0.15063005441098307 0.15063005441098307 -24.089 29.2851 29.9071 0.4337431313104634 0.4337431313104634 0.4337431313104634 -24.089 29.2851 30.9071 0.19256255059168265 0.19256255059168265 0.19256255059168265 -24.089 30.2851 29.9071 0.3021119855694297 0.3021119855694297 0.3021119855694297 -24.089 30.2851 30.9071 0.2516352559568322 0.2516352559568322 0.2516352559568322 -21.089 27.2851 32.9071 0.1419816841323607 0.1419816841323607 0.1419816841323607 -21.089 28.2851 31.9071 0.0818518637037594 0.0818518637037594 0.0818518637037594 -21.089 28.2851 32.9071 0.07567894781532022 0.07567894781532022 0.07567894781532022 -22.089 27.2851 32.9071 0.09289507437402568 0.09289507437402568 0.09289507437402568 -22.089 28.2851 31.9071 0.07753237535689557 0.07753237535689557 0.07753237535689557 -22.089 28.2851 32.9071 0.05570304248588727 0.05570304248588727 0.05570304248588727 -21.089 27.2851 33.9071 0.24552355925317512 0.24552355925317512 0.24552355925317512 -21.089 27.2851 34.9071 0.2071239441138651 0.2071239441138651 0.2071239441138651 -21.089 28.2851 33.9071 0.09292882613304164 0.09292882613304164 0.09292882613304164 -21.089 28.2851 34.9071 0.18316895710420975 0.18316895710420975 0.18316895710420975 -22.089 27.2851 33.9071 0.1530897191476724 0.1530897191476724 0.1530897191476724 -22.089 27.2851 34.9071 0.16774416468763442 0.16774416468763442 0.16774416468763442 -22.089 28.2851 33.9071 0.0858735970307968 0.0858735970307968 0.0858735970307968 -22.089 28.2851 34.9071 0.12190511179570965 0.12190511179570965 0.12190511179570965 -21.089 29.2851 31.9071 0.13119581800257332 0.13119581800257332 0.13119581800257332 -21.089 29.2851 32.9071 0.16490919419241645 0.16490919419241645 0.16490919419241645 -21.089 30.2851 31.9071 0.12428773480170514 0.12428773480170514 0.12428773480170514 -21.089 30.2851 32.9071 0.1445725182726918 0.1445725182726918 0.1445725182726918 -22.089 29.2851 31.9071 0.07344053492989712 0.07344053492989712 0.07344053492989712 -22.089 30.2851 31.9071 0.09215253209352582 0.09215253209352582 0.09215253209352582 -21.089 29.2851 33.9071 0.14455485012650243 0.14455485012650243 0.14455485012650243 -21.089 29.2851 34.9071 0.09285810814554413 0.09285810814554413 0.09285810814554413 -21.089 30.2851 34.9071 0.18218883943195377 0.18218883943195377 0.18218883943195377 -22.089 29.2851 34.9071 0.10871104378497591 0.10871104378497591 0.10871104378497591 -22.089 30.2851 34.9071 0.15508839231285315 0.15508839231285315 0.15508839231285315 -23.089 27.2851 32.9071 0.12475605732413148 0.12475605732413148 0.12475605732413148 -23.089 28.2851 31.9071 0.047045989254732704 0.047045989254732704 0.047045989254732704 -23.089 28.2851 32.9071 0.0375399347980999 0.0375399347980999 0.0375399347980999 -24.089 27.2851 31.9071 0.18628181513191422 0.18628181513191422 0.18628181513191422 -24.089 27.2851 32.9071 0.16397863409704005 0.16397863409704005 0.16397863409704005 -24.089 28.2851 31.9071 0.14023005308576214 0.14023005308576214 0.14023005308576214 -24.089 28.2851 32.9071 0.1564181369084522 0.1564181369084522 0.1564181369084522 -23.089 27.2851 33.9071 0.13329784607952075 0.13329784607952075 0.13329784607952075 -23.089 27.2851 34.9071 0.11191917769926965 0.11191917769926965 0.11191917769926965 -23.089 28.2851 33.9071 0.11280293867248692 0.11280293867248692 0.11280293867248692 -23.089 28.2851 34.9071 0.15350166348055422 0.15350166348055422 0.15350166348055422 -24.089 27.2851 33.9071 0.13441831625242906 0.13441831625242906 0.13441831625242906 -24.089 27.2851 34.9071 0.1359154649452029 0.1359154649452029 0.1359154649452029 -24.089 28.2851 33.9071 0.1641954178246359 0.1641954178246359 0.1641954178246359 -24.089 28.2851 34.9071 0.1855361208138259 0.1855361208138259 0.1855361208138259 -23.089 29.2851 31.9071 0.05746752913756257 0.05746752913756257 0.05746752913756257 -23.089 30.2851 31.9071 0.15316439927097492 0.15316439927097492 0.15316439927097492 -23.089 29.2851 33.9071 0.17229387878950067 0.17229387878950067 0.17229387878950067 -23.089 29.2851 34.9071 0.15141622379442038 0.15141622379442038 0.15141622379442038 -23.089 30.2851 33.9071 0.19738052560301414 0.19738052560301414 0.19738052560301414 -23.089 30.2851 34.9071 0.22240960863853215 0.22240960863853215 0.22240960863853215 -24.089 29.2851 33.9071 0.2408255786187819 0.2408255786187819 0.2408255786187819 -24.089 29.2851 34.9071 0.193986383335702 0.193986383335702 0.193986383335702 -24.089 30.2851 33.9071 0.2611387438809912 0.2611387438809912 0.2611387438809912 -24.089 30.2851 34.9071 0.30064197265217857 0.30064197265217857 0.30064197265217857 -21.089 31.2851 28.9071 0.18925007556331822 0.18925007556331822 0.18925007556331822 -21.089 32.2851 27.9071 0.12548142970923465 0.12548142970923465 0.12548142970923465 -21.089 32.2851 28.9071 0.21059296147513262 0.21059296147513262 0.21059296147513262 -22.089 31.2851 28.9071 0.11773977025087602 0.11773977025087602 0.11773977025087602 -22.089 32.2851 27.9071 0.14459821738750026 0.14459821738750026 0.14459821738750026 -22.089 32.2851 28.9071 0.18710295383944628 0.18710295383944628 0.18710295383944628 -22.089 31.2851 29.9071 0.11253058064381478 0.11253058064381478 0.11253058064381478 -22.089 31.2851 30.9071 0.10798712710768675 0.10798712710768675 0.10798712710768675 -22.089 32.2851 30.9071 0.10076126215263942 0.10076126215263942 0.10076126215263942 -21.089 33.2851 30.9071 0.17050196281406593 0.17050196281406593 0.17050196281406593 -21.089 34.2851 30.9071 0.1130801162506455 0.1130801162506455 0.1130801162506455 -22.089 33.2851 30.9071 0.11053245682335011 0.11053245682335011 0.11053245682335011 -23.089 31.2851 27.9071 0.4997099043131931 0.4997099043131931 0.4997099043131931 -23.089 31.2851 28.9071 0.2308295255421767 0.2308295255421767 0.2308295255421767 -23.089 32.2851 27.9071 0.2753694210624826 0.2753694210624826 0.2753694210624826 -23.089 32.2851 28.9071 0.10023655214474027 0.10023655214474027 0.10023655214474027 -24.089 31.2851 27.9071 0.68630581490071 0.68630581490071 0.68630581490071 -24.089 32.2851 27.9071 0.3834402267770045 0.3834402267770045 0.3834402267770045 -24.089 32.2851 28.9071 0.02032378141051079 0.02032378141051079 0.02032378141051079 -23.089 31.2851 29.9071 0.1066630096061211 0.1066630096061211 0.1066630096061211 -23.089 31.2851 30.9071 0.11415186056815978 0.11415186056815978 0.11415186056815978 -23.089 32.2851 29.9071 0.03526314615828671 0.03526314615828671 0.03526314615828671 -23.089 32.2851 30.9071 0.06689478117524376 0.06689478117524376 0.06689478117524376 -24.089 31.2851 29.9071 0.23022463664128903 0.23022463664128903 0.23022463664128903 -24.089 31.2851 30.9071 0.22625423837647307 0.22625423837647307 0.22625423837647307 -24.089 32.2851 29.9071 0.08704777022424026 0.08704777022424026 0.08704777022424026 -24.089 32.2851 30.9071 0.1177494106345869 0.1177494106345869 0.1177494106345869 -23.089 33.2851 27.9071 0.14255832461546858 0.14255832461546858 0.14255832461546858 -23.089 33.2851 28.9071 0.08183820039817241 0.08183820039817241 0.08183820039817241 -23.089 34.2851 27.9071 0.11334765196387754 0.11334765196387754 0.11334765196387754 -23.089 34.2851 28.9071 0.08387882956944336 0.08387882956944336 0.08387882956944336 -24.089 33.2851 27.9071 0.3212733992059282 0.3212733992059282 0.3212733992059282 -24.089 33.2851 28.9071 0.19658998976990644 0.19658998976990644 0.19658998976990644 -24.089 34.2851 27.9071 0.13180064867499033 0.13180064867499033 0.13180064867499033 -24.089 34.2851 28.9071 0.1084804517212694 0.1084804517212694 0.1084804517212694 -24.089 33.2851 29.9071 0.09641080652406092 0.09641080652406092 0.09641080652406092 -24.089 33.2851 30.9071 0.0920858315315928 0.0920858315315928 0.0920858315315928 -24.089 34.2851 29.9071 0.21878062950841937 0.21878062950841937 0.21878062950841937 -21.089 31.2851 31.9071 0.26255414624476076 0.26255414624476076 0.26255414624476076 -21.089 31.2851 32.9071 0.18410571688939656 0.18410571688939656 0.18410571688939656 -21.089 32.2851 31.9071 0.2541584011090033 0.2541584011090033 0.2541584011090033 -21.089 32.2851 32.9071 0.23020137159273923 0.23020137159273923 0.23020137159273923 -22.089 31.2851 31.9071 0.01946989093570619 0.01946989093570619 0.01946989093570619 -22.089 32.2851 31.9071 0.12952989965313205 0.12952989965313205 0.12952989965313205 -22.089 32.2851 32.9071 0.1528817386539609 0.1528817386539609 0.1528817386539609 -21.089 31.2851 34.9071 0.20698270868605376 0.20698270868605376 0.20698270868605376 -21.089 32.2851 33.9071 0.22941998295124533 0.22941998295124533 0.22941998295124533 -21.089 32.2851 34.9071 0.2055566984603114 0.2055566984603114 0.2055566984603114 -22.089 31.2851 34.9071 0.19614375494593717 0.19614375494593717 0.19614375494593717 -22.089 32.2851 34.9071 0.19229608078515784 0.19229608078515784 0.19229608078515784 -21.089 33.2851 31.9071 0.19477212917289882 0.19477212917289882 0.19477212917289882 -21.089 33.2851 32.9071 0.18027512726715766 0.18027512726715766 0.18027512726715766 -21.089 34.2851 31.9071 0.1308166920754832 0.1308166920754832 0.1308166920754832 -22.089 33.2851 31.9071 0.21063067608598007 0.21063067608598007 0.21063067608598007 -22.089 33.2851 32.9071 0.18626335346151926 0.18626335346151926 0.18626335346151926 -22.089 34.2851 31.9071 0.1373274498258373 0.1373274498258373 0.1373274498258373 -22.089 34.2851 32.9071 0.1193063174442299 0.1193063174442299 0.1193063174442299 -21.089 33.2851 33.9071 0.18734696607276244 0.18734696607276244 0.18734696607276244 -21.089 33.2851 34.9071 0.20257539677574088 0.20257539677574088 0.20257539677574088 -22.089 33.2851 33.9071 0.19702498608288602 0.19702498608288602 0.19702498608288602 -22.089 33.2851 34.9071 0.19538611317349844 0.19538611317349844 0.19538611317349844 -23.089 31.2851 31.9071 0.10442529791194777 0.10442529791194777 0.10442529791194777 -23.089 32.2851 31.9071 0.2041731956157592 0.2041731956157592 0.2041731956157592 -24.089 32.2851 31.9071 0.15642054584611256 0.15642054584611256 0.15642054584611256 -23.089 31.2851 34.9071 0.2347788408964617 0.2347788408964617 0.2347788408964617 -23.089 32.2851 34.9071 0.2102093948540386 0.2102093948540386 0.2102093948540386 -24.089 31.2851 33.9071 0.28393291532705145 0.28393291532705145 0.28393291532705145 -24.089 31.2851 34.9071 0.3237494879988546 0.3237494879988546 0.3237494879988546 -24.089 32.2851 34.9071 0.2984769810566222 0.2984769810566222 0.2984769810566222 -23.089 33.2851 31.9071 0.1908112178105149 0.1908112178105149 0.1908112178105149 -23.089 33.2851 32.9071 0.18545825997522977 0.18545825997522977 0.18545825997522977 -23.089 34.2851 32.9071 0.15445563173235366 0.15445563173235366 0.15445563173235366 -24.089 34.2851 32.9071 0.14629353773454598 0.14629353773454598 0.14629353773454598 -23.089 33.2851 33.9071 0.15143710254972914 0.15143710254972914 0.15143710254972914 -23.089 33.2851 34.9071 0.1815249855447024 0.1815249855447024 0.1815249855447024 -23.089 34.2851 33.9071 0.10610298490624179 0.10610298490624179 0.10610298490624179 -24.089 33.2851 34.9071 0.12094031416923334 0.12094031416923334 0.12094031416923334 -24.089 34.2851 33.9071 0.12121103706897599 0.12121103706897599 0.12121103706897599 -24.089 34.2851 34.9071 0.09319803608490047 0.09319803608490047 0.09319803608490047 -17.089 30.2851 35.9071 0.0903009682454502 0.0903009682454502 0.0903009682454502 -18.089 29.2851 35.9071 0.110658596384848 0.110658596384848 0.110658596384848 -18.089 30.2851 35.9071 0.13256772486018312 0.13256772486018312 0.13256772486018312 -19.089 27.2851 35.9071 0.14753268107446538 0.14753268107446538 0.14753268107446538 -19.089 27.2851 36.9071 0.0775787526961176 0.0775787526961176 0.0775787526961176 -19.089 28.2851 35.9071 0.1347002385485159 0.1347002385485159 0.1347002385485159 -20.089 27.2851 36.9071 0.0654145154046776 0.0654145154046776 0.0654145154046776 -20.089 28.2851 35.9071 0.16430461236992822 0.16430461236992822 0.16430461236992822 -20.089 28.2851 36.9071 0.044208049001535805 0.044208049001535805 0.044208049001535805 -20.089 27.2851 37.9071 0.02939524508576056 0.02939524508576056 0.02939524508576056 -20.089 28.2851 37.9071 0.04182924500029421 0.04182924500029421 0.04182924500029421 -19.089 29.2851 35.9071 0.13947590032705937 0.13947590032705937 0.13947590032705937 -19.089 30.2851 35.9071 0.17972605044018017 0.17972605044018017 0.17972605044018017 -19.089 30.2851 36.9071 0.12442268908433189 0.12442268908433189 0.12442268908433189 -20.089 29.2851 35.9071 0.09409646755398274 0.09409646755398274 0.09409646755398274 -20.089 29.2851 36.9071 0.02829221140046839 0.02829221140046839 0.02829221140046839 -20.089 30.2851 35.9071 0.16816727406179957 0.16816727406179957 0.16816727406179957 -20.089 30.2851 36.9071 0.0476902892243269 0.0476902892243269 0.0476902892243269 -20.089 29.2851 37.9071 0.03526990134845367 0.03526990134845367 0.03526990134845367 -20.089 30.2851 37.9071 0.04918358512775593 0.04918358512775593 0.04918358512775593 -17.089 31.2851 35.9071 0.09025676806687087 0.09025676806687087 0.09025676806687087 -17.089 32.2851 35.9071 0.10878496165856116 0.10878496165856116 0.10878496165856116 -18.089 31.2851 35.9071 0.13652347284923533 0.13652347284923533 0.13652347284923533 -18.089 31.2851 36.9071 0.0991453372188033 0.0991453372188033 0.0991453372188033 -18.089 32.2851 35.9071 0.1537168694277609 0.1537168694277609 0.1537168694277609 -18.089 32.2851 36.9071 0.14547840711417825 0.14547840711417825 0.14547840711417825 -17.089 33.2851 35.9071 0.08085443629699163 0.08085443629699163 0.08085443629699163 -18.089 33.2851 35.9071 0.15313308180834298 0.15313308180834298 0.15313308180834298 -18.089 33.2851 36.9071 0.12438734393695353 0.12438734393695353 0.12438734393695353 -18.089 34.2851 35.9071 0.10898502164964625 0.10898502164964625 0.10898502164964625 -19.089 31.2851 36.9071 0.11444992185521387 0.11444992185521387 0.11444992185521387 -19.089 32.2851 36.9071 0.13510986747464185 0.13510986747464185 0.13510986747464185 -20.089 31.2851 35.9071 0.21908712932098318 0.21908712932098318 0.21908712932098318 -20.089 31.2851 36.9071 0.15413844657390502 0.15413844657390502 0.15413844657390502 -20.089 32.2851 35.9071 0.2481904656306952 0.2481904656306952 0.2481904656306952 -20.089 32.2851 36.9071 0.1615578427915767 0.1615578427915767 0.1615578427915767 -19.089 33.2851 36.9071 0.1517896314847889 0.1517896314847889 0.1517896314847889 -19.089 34.2851 35.9071 0.13515725578443932 0.13515725578443932 0.13515725578443932 -19.089 34.2851 36.9071 0.10300228980753033 0.10300228980753033 0.10300228980753033 -20.089 33.2851 35.9071 0.24900295217017884 0.24900295217017884 0.24900295217017884 -20.089 33.2851 36.9071 0.18017879827030445 0.18017879827030445 0.18017879827030445 -20.089 34.2851 35.9071 0.14876538088491206 0.14876538088491206 0.14876538088491206 -21.089 27.2851 35.9071 0.17891928602368742 0.17891928602368742 0.17891928602368742 -21.089 27.2851 36.9071 0.06721544556492037 0.06721544556492037 0.06721544556492037 -21.089 28.2851 35.9071 0.08327363852636951 0.08327363852636951 0.08327363852636951 -22.089 27.2851 35.9071 0.06126385413637153 0.06126385413637153 0.06126385413637153 -22.089 27.2851 36.9071 0.07813367115968155 0.07813367115968155 0.07813367115968155 -22.089 28.2851 35.9071 0.06204422470530754 0.06204422470530754 0.06204422470530754 -21.089 27.2851 37.9071 0.0867431780028852 0.0867431780028852 0.0867431780028852 -21.089 27.2851 38.9071 0.06346289280341706 0.06346289280341706 0.06346289280341706 -21.089 28.2851 37.9071 0.09143891357379692 0.09143891357379692 0.09143891357379692 -21.089 28.2851 38.9071 0.05902970307039601 0.05902970307039601 0.05902970307039601 -22.089 27.2851 37.9071 0.09214128140020418 0.09214128140020418 0.09214128140020418 -22.089 27.2851 38.9071 0.07437857319048594 0.07437857319048594 0.07437857319048594 -22.089 28.2851 38.9071 0.08123942384438548 0.08123942384438548 0.08123942384438548 -21.089 29.2851 35.9071 0.08610264653504215 0.08610264653504215 0.08610264653504215 -21.089 30.2851 35.9071 0.05252603281325172 0.05252603281325172 0.05252603281325172 -21.089 30.2851 36.9071 0.060664683258176734 0.060664683258176734 0.060664683258176734 -22.089 29.2851 35.9071 0.10333735383443766 0.10333735383443766 0.10333735383443766 -22.089 30.2851 35.9071 0.14187968740502901 0.14187968740502901 0.14187968740502901 -22.089 30.2851 36.9071 0.08669415381730039 0.08669415381730039 0.08669415381730039 -21.089 29.2851 38.9071 0.04274344805118562 0.04274344805118562 0.04274344805118562 -21.089 30.2851 37.9071 0.05787610434438027 0.05787610434438027 0.05787610434438027 -21.089 30.2851 38.9071 0.06393800074148463 0.06393800074148463 0.06393800074148463 -22.089 29.2851 38.9071 0.056279819297076594 0.056279819297076594 0.056279819297076594 -22.089 30.2851 37.9071 0.062269965599104644 0.062269965599104644 0.062269965599104644 -22.089 30.2851 38.9071 0.04405615438064766 0.04405615438064766 0.04405615438064766 -23.089 27.2851 35.9071 0.1211548039006664 0.1211548039006664 0.1211548039006664 -23.089 27.2851 36.9071 0.13038856679387867 0.13038856679387867 0.13038856679387867 -23.089 28.2851 35.9071 0.09708902380317118 0.09708902380317118 0.09708902380317118 -24.089 27.2851 35.9071 0.09942095475691412 0.09942095475691412 0.09942095475691412 -23.089 27.2851 37.9071 0.14592492303848933 0.14592492303848933 0.14592492303848933 -23.089 28.2851 37.9071 0.08117753661761516 0.08117753661761516 0.08117753661761516 -23.089 28.2851 38.9071 0.05639792376830184 0.05639792376830184 0.05639792376830184 -24.089 27.2851 37.9071 0.15704204935182076 0.15704204935182076 0.15704204935182076 -24.089 28.2851 37.9071 0.13405848237101667 0.13405848237101667 0.13405848237101667 -24.089 28.2851 38.9071 0.0399243337945634 0.0399243337945634 0.0399243337945634 -23.089 30.2851 35.9071 0.16193441511204337 0.16193441511204337 0.16193441511204337 -23.089 30.2851 36.9071 0.13252033502510138 0.13252033502510138 0.13252033502510138 -24.089 29.2851 35.9071 0.12117729717271386 0.12117729717271386 0.12117729717271386 -24.089 30.2851 35.9071 0.16620585834451523 0.16620585834451523 0.16620585834451523 -24.089 30.2851 36.9071 0.13148257095993035 0.13148257095993035 0.13148257095993035 -23.089 29.2851 37.9071 0.07551561844422834 0.07551561844422834 0.07551561844422834 -23.089 29.2851 38.9071 0.03352768684789154 0.03352768684789154 0.03352768684789154 -23.089 30.2851 37.9071 0.09163339132035388 0.09163339132035388 0.09163339132035388 -24.089 29.2851 37.9071 0.07037571808899332 0.07037571808899332 0.07037571808899332 -24.089 30.2851 37.9071 0.09546900717113159 0.09546900717113159 0.09546900717113159 -21.089 28.2851 39.9071 0.046438269666499686 0.046438269666499686 0.046438269666499686 -22.089 28.2851 39.9071 0.05887429903498896 0.05887429903498896 0.05887429903498896 -22.089 29.2851 39.9071 0.051809891858669514 0.051809891858669514 0.051809891858669514 -21.089 31.2851 36.9071 0.4173578378121691 0.4173578378121691 0.4173578378121691 -21.089 32.2851 35.9071 0.15614271456075646 0.15614271456075646 0.15614271456075646 -22.089 31.2851 35.9071 0.13208258014386948 0.13208258014386948 0.13208258014386948 -22.089 31.2851 36.9071 0.09484381345769557 0.09484381345769557 0.09484381345769557 -21.089 31.2851 37.9071 0.04439484119932251 0.04439484119932251 0.04439484119932251 -21.089 33.2851 35.9071 0.2063222692758021 0.2063222692758021 0.2063222692758021 -23.089 31.2851 35.9071 0.10027110436382326 0.10027110436382326 0.10027110436382326 -23.089 31.2851 36.9071 0.08664914798129396 0.08664914798129396 0.08664914798129396 -17.089 35.2851 27.9071 0.07298718604065323 0.07298718604065323 0.07298718604065323 -18.089 35.2851 27.9071 0.05157760900109475 0.05157760900109475 0.05157760900109475 -17.089 35.2851 29.9071 0.12085837412087788 0.12085837412087788 0.12085837412087788 -17.089 35.2851 30.9071 0.13079902090818638 0.13079902090818638 0.13079902090818638 -17.089 36.2851 30.9071 0.09402735779717825 0.09402735779717825 0.09402735779717825 -18.089 35.2851 29.9071 0.16835193210447683 0.16835193210447683 0.16835193210447683 -18.089 36.2851 29.9071 0.11645276865624586 0.11645276865624586 0.11645276865624586 -18.089 36.2851 30.9071 0.1346287540712076 0.1346287540712076 0.1346287540712076 -19.089 35.2851 27.9071 0.07275030219178125 0.07275030219178125 0.07275030219178125 -19.089 36.2851 27.9071 0.06809463340103651 0.06809463340103651 0.06809463340103651 -20.089 35.2851 27.9071 0.0754670696892821 0.0754670696892821 0.0754670696892821 -20.089 35.2851 28.9071 0.10361617103771804 0.10361617103771804 0.10361617103771804 -20.089 36.2851 27.9071 0.07489509241696925 0.07489509241696925 0.07489509241696925 -20.089 36.2851 28.9071 0.05687371660768664 0.05687371660768664 0.05687371660768664 -19.089 35.2851 29.9071 0.14965676767800343 0.14965676767800343 0.14965676767800343 -19.089 35.2851 30.9071 0.20290121870295397 0.20290121870295397 0.20290121870295397 -19.089 36.2851 29.9071 0.10886209328031114 0.10886209328031114 0.10886209328031114 -19.089 36.2851 30.9071 0.13441751305359792 0.13441751305359792 0.13441751305359792 -20.089 35.2851 29.9071 0.1383273900000796 0.1383273900000796 0.1383273900000796 -20.089 35.2851 30.9071 0.19254409036246006 0.19254409036246006 0.19254409036246006 -19.089 37.2851 27.9071 0.0635754397766802 0.0635754397766802 0.0635754397766802 -20.089 37.2851 27.9071 0.0821580818851812 0.0821580818851812 0.0821580818851812 -17.089 35.2851 31.9071 0.10092357604094028 0.10092357604094028 0.10092357604094028 -17.089 36.2851 31.9071 0.07564615336191625 0.07564615336191625 0.07564615336191625 -18.089 35.2851 32.9071 0.07388463752620957 0.07388463752620957 0.07388463752620957 -18.089 36.2851 31.9071 0.11126036774895037 0.11126036774895037 0.11126036774895037 -19.089 35.2851 31.9071 0.19637570105362814 0.19637570105362814 0.19637570105362814 -19.089 35.2851 32.9071 0.10676023013969344 0.10676023013969344 0.10676023013969344 -19.089 36.2851 31.9071 0.1146234556808499 0.1146234556808499 0.1146234556808499 -20.089 35.2851 31.9071 0.19526171156496164 0.19526171156496164 0.19526171156496164 -21.089 36.2851 28.9071 0.10236349481094441 0.10236349481094441 0.10236349481094441 -22.089 36.2851 28.9071 0.09945550732628682 0.09945550732628682 0.09945550732628682 -21.089 35.2851 29.9071 0.14691190717897903 0.14691190717897903 0.14691190717897903 -21.089 35.2851 30.9071 0.11761283842445436 0.11761283842445436 0.11761283842445436 -21.089 36.2851 29.9071 0.09446371259137953 0.09446371259137953 0.09446371259137953 -21.089 36.2851 30.9071 0.09057179426397798 0.09057179426397798 0.09057179426397798 -22.089 35.2851 29.9071 0.0821146809539914 0.0821146809539914 0.0821146809539914 -22.089 35.2851 30.9071 0.0841689660248515 0.0841689660248515 0.0841689660248515 -22.089 36.2851 29.9071 0.09180858161519576 0.09180858161519576 0.09180858161519576 -22.089 36.2851 30.9071 0.11172474898237168 0.11172474898237168 0.11172474898237168 -21.089 37.2851 27.9071 0.07613597892934747 0.07613597892934747 0.07613597892934747 -21.089 37.2851 28.9071 0.0730642716082883 0.0730642716082883 0.0730642716082883 -22.089 37.2851 27.9071 0.0792354591057182 0.0792354591057182 0.0792354591057182 -22.089 37.2851 28.9071 0.10186691859279035 0.10186691859279035 0.10186691859279035 -22.089 37.2851 30.9071 0.05363749796569352 0.05363749796569352 0.05363749796569352 -23.089 35.2851 28.9071 0.06308650242483378 0.06308650242483378 0.06308650242483378 -23.089 36.2851 28.9071 0.06457822635768093 0.06457822635768093 0.06457822635768093 -24.089 35.2851 27.9071 0.11598038088336039 0.11598038088336039 0.11598038088336039 -24.089 35.2851 28.9071 0.10299746873220504 0.10299746873220504 0.10299746873220504 -24.089 36.2851 27.9071 0.08569116064333561 0.08569116064333561 0.08569116064333561 -24.089 36.2851 28.9071 0.0914188228707059 0.0914188228707059 0.0914188228707059 -23.089 35.2851 29.9071 0.125535249991022 0.125535249991022 0.125535249991022 -23.089 36.2851 29.9071 0.05641191298621925 0.05641191298621925 0.05641191298621925 -23.089 36.2851 30.9071 0.11772048948002449 0.11772048948002449 0.11772048948002449 -24.089 35.2851 29.9071 0.2709041124570505 0.2709041124570505 0.2709041124570505 -24.089 35.2851 30.9071 0.25391779945349324 0.25391779945349324 0.25391779945349324 -24.089 36.2851 30.9071 0.11125795745873653 0.11125795745873653 0.11125795745873653 -23.089 37.2851 27.9071 0.0835549363901771 0.0835549363901771 0.0835549363901771 -23.089 37.2851 28.9071 0.07368915230531521 0.07368915230531521 0.07368915230531521 -23.089 38.2851 27.9071 0.082845260175872 0.082845260175872 0.082845260175872 -23.089 38.2851 28.9071 0.10646615775275954 0.10646615775275954 0.10646615775275954 -24.089 37.2851 27.9071 0.0884083752220983 0.0884083752220983 0.0884083752220983 -24.089 37.2851 28.9071 0.09468711247243156 0.09468711247243156 0.09468711247243156 -24.089 38.2851 27.9071 0.1537618377619434 0.1537618377619434 0.1537618377619434 -24.089 38.2851 28.9071 0.16433110808283583 0.16433110808283583 0.16433110808283583 -23.089 37.2851 30.9071 0.09423066888893275 0.09423066888893275 0.09423066888893275 -23.089 38.2851 29.9071 0.057441159001768924 0.057441159001768924 0.057441159001768924 -24.089 37.2851 29.9071 0.08354850673570542 0.08354850673570542 0.08354850673570542 -24.089 38.2851 29.9071 0.08597968319804052 0.08597968319804052 0.08597968319804052 -24.089 38.2851 30.9071 0.06261629334593599 0.06261629334593599 0.06261629334593599 -21.089 35.2851 31.9071 0.11597556058566162 0.11597556058566162 0.11597556058566162 -21.089 35.2851 32.9071 0.07348177026063445 0.07348177026063445 0.07348177026063445 -21.089 36.2851 31.9071 0.08199010407695749 0.08199010407695749 0.08199010407695749 -22.089 35.2851 32.9071 0.0826162013977914 0.0826162013977914 0.0826162013977914 -22.089 36.2851 31.9071 0.0981722310121349 0.0981722310121349 0.0981722310121349 -22.089 36.2851 32.9071 0.06682950664305463 0.06682950664305463 0.06682950664305463 -22.089 37.2851 31.9071 0.0910716547289669 0.0910716547289669 0.0910716547289669 -23.089 35.2851 32.9071 0.08584627178323198 0.08584627178323198 0.08584627178323198 -23.089 36.2851 31.9071 0.09708339880185529 0.09708339880185529 0.09708339880185529 -23.089 36.2851 32.9071 0.07438299408183527 0.07438299408183527 0.07438299408183527 -24.089 35.2851 32.9071 0.09055411425497499 0.09055411425497499 0.09055411425497499 -24.089 36.2851 31.9071 0.08283481189493651 0.08283481189493651 0.08283481189493651 -24.089 36.2851 32.9071 0.062495384292667516 0.062495384292667516 0.062495384292667516 -24.089 35.2851 33.9071 0.09202234540318838 0.09202234540318838 0.09202234540318838 -24.089 36.2851 33.9071 0.1776653734296611 0.1776653734296611 0.1776653734296611 -24.089 36.2851 34.9071 0.1479510783717827 0.1479510783717827 0.1479510783717827 -23.089 37.2851 31.9071 0.09046169596284909 0.09046169596284909 0.09046169596284909 -24.089 37.2851 32.9071 0.13758767641686048 0.13758767641686048 0.13758767641686048 -24.089 37.2851 33.9071 0.18580662644065282 0.18580662644065282 0.18580662644065282 -24.089 37.2851 34.9071 0.12574571104580431 0.12574571104580431 0.12574571104580431 -24.089 38.2851 33.9071 0.11685124326043543 0.11685124326043543 0.11685124326043543 -21.089 40.2851 27.9071 0.032783229274466905 0.032783229274466905 0.032783229274466905 -22.089 39.2851 27.9071 0.03917446718694663 0.03917446718694663 0.03917446718694663 -22.089 40.2851 27.9071 0.03956737403657376 0.03956737403657376 0.03956737403657376 -21.089 41.2851 27.9071 0.03076832596917738 0.03076832596917738 0.03076832596917738 -21.089 42.2851 27.9071 0.021308768529431664 0.021308768529431664 0.021308768529431664 -22.089 41.2851 27.9071 0.04273878418654007 0.04273878418654007 0.04273878418654007 -22.089 42.2851 27.9071 0.02870945989836223 0.02870945989836223 0.02870945989836223 -23.089 39.2851 27.9071 0.0636317132042713 0.0636317132042713 0.0636317132042713 -23.089 39.2851 28.9071 0.06796794477070339 0.06796794477070339 0.06796794477070339 -23.089 40.2851 27.9071 0.05022570785217275 0.05022570785217275 0.05022570785217275 -23.089 40.2851 28.9071 0.07374276610353744 0.07374276610353744 0.07374276610353744 -24.089 40.2851 27.9071 0.047808165086233013 0.047808165086233013 0.047808165086233013 -23.089 39.2851 29.9071 0.0809340058993746 0.0809340058993746 0.0809340058993746 -23.089 39.2851 30.9071 0.0719097487495703 0.0719097487495703 0.0719097487495703 -23.089 40.2851 29.9071 0.0678639248959126 0.0678639248959126 0.0678639248959126 -23.089 40.2851 30.9071 0.056176749085870226 0.056176749085870226 0.056176749085870226 -24.089 39.2851 30.9071 0.08615488580434219 0.08615488580434219 0.08615488580434219 -24.089 40.2851 30.9071 0.06167707283181964 0.06167707283181964 0.06167707283181964 -23.089 41.2851 27.9071 0.04624376304923974 0.04624376304923974 0.04624376304923974 -23.089 41.2851 28.9071 0.02729058098133161 0.02729058098133161 0.02729058098133161 -23.089 42.2851 27.9071 0.027720783337102758 0.027720783337102758 0.027720783337102758 -24.089 41.2851 27.9071 0.06341039762560707 0.06341039762560707 0.06341039762560707 -24.089 41.2851 28.9071 0.08272711415072422 0.08272711415072422 0.08272711415072422 -23.089 41.2851 29.9071 0.06027493439599693 0.06027493439599693 0.06027493439599693 -24.089 41.2851 29.9071 0.09060876154296521 0.09060876154296521 0.09060876154296521 -28.089 18.2851 22.9071 0.12665743482924458 0.12665743482924458 0.12665743482924458 -25.089 17.2851 25.9071 0.10126588049422632 0.10126588049422632 0.10126588049422632 -25.089 17.2851 26.9071 0.16412556535397044 0.16412556535397044 0.16412556535397044 -25.089 18.2851 25.9071 0.13116208229334783 0.13116208229334783 0.13116208229334783 -25.089 18.2851 26.9071 0.18176018470690372 0.18176018470690372 0.18176018470690372 -28.089 18.2851 23.9071 0.1324480453923855 0.1324480453923855 0.1324480453923855 -29.089 18.2851 22.9071 0.1308383794118544 0.1308383794118544 0.1308383794118544 -29.089 18.2851 23.9071 0.14948732464243264 0.14948732464243264 0.14948732464243264 -30.089 18.2851 23.9071 0.08159386795334536 0.08159386795334536 0.08159386795334536 -28.089 22.2851 14.9071 0.07157648299515072 0.07157648299515072 0.07157648299515072 -26.089 22.2851 15.9071 0.002122417881421699 0.002122417881421699 0.002122417881421699 -26.089 22.2851 16.9071 0.08897254136694292 0.08897254136694292 0.08897254136694292 -26.089 22.2851 17.9071 0.1158928120969128 0.1158928120969128 0.1158928120969128 -26.089 22.2851 18.9071 0.10506809399794505 0.10506809399794505 0.10506809399794505 -27.089 22.2851 15.9071 0.05105611586440242 0.05105611586440242 0.05105611586440242 -27.089 22.2851 16.9071 0.06751159073492638 0.06751159073492638 0.06751159073492638 -28.089 21.2851 15.9071 0.06310016891533904 0.06310016891533904 0.06310016891533904 -28.089 21.2851 16.9071 0.05516477269077692 0.05516477269077692 0.05516477269077692 -28.089 22.2851 15.9071 0.08321416399492877 0.08321416399492877 0.08321416399492877 -28.089 22.2851 16.9071 0.09104674214267841 0.09104674214267841 0.09104674214267841 -27.089 22.2851 17.9071 0.0815110840948714 0.0815110840948714 0.0815110840948714 -27.089 22.2851 18.9071 0.07551762791191856 0.07551762791191856 0.07551762791191856 -28.089 22.2851 17.9071 0.07970123084096695 0.07970123084096695 0.07970123084096695 -28.089 22.2851 18.9071 0.04902583032240747 0.04902583032240747 0.04902583032240747 -25.089 23.2851 14.9071 0.07507015840517539 0.07507015840517539 0.07507015840517539 -25.089 24.2851 13.9071 0.055214861279241946 0.055214861279241946 0.055214861279241946 -25.089 24.2851 14.9071 0.10684941581510195 0.10684941581510195 0.10684941581510195 -26.089 23.2851 14.9071 0.08208012093646946 0.08208012093646946 0.08208012093646946 -26.089 24.2851 14.9071 0.08585350493790861 0.08585350493790861 0.08585350493790861 -25.089 25.2851 13.9071 0.05579027481709844 0.05579027481709844 0.05579027481709844 -25.089 25.2851 14.9071 0.09005826878366001 0.09005826878366001 0.09005826878366001 -25.089 26.2851 13.9071 0.06830781711802944 0.06830781711802944 0.06830781711802944 -25.089 26.2851 14.9071 0.11264466582999667 0.11264466582999667 0.11264466582999667 -26.089 25.2851 14.9071 0.10849973470661418 0.10849973470661418 0.10849973470661418 -26.089 26.2851 14.9071 0.10501667050006566 0.10501667050006566 0.10501667050006566 -27.089 23.2851 14.9071 0.061753606489544824 0.061753606489544824 0.061753606489544824 -27.089 24.2851 14.9071 0.07536482784464486 0.07536482784464486 0.07536482784464486 -28.089 23.2851 14.9071 0.06057592873280422 0.06057592873280422 0.06057592873280422 -27.089 25.2851 14.9071 0.09184072658200367 0.09184072658200367 0.09184072658200367 -25.089 23.2851 15.9071 0.08157055988530082 0.08157055988530082 0.08157055988530082 -25.089 23.2851 16.9071 0.10326262744573109 0.10326262744573109 0.10326262744573109 -25.089 24.2851 16.9071 0.0774599559227771 0.0774599559227771 0.0774599559227771 -26.089 23.2851 15.9071 0.08624570168405489 0.08624570168405489 0.08624570168405489 -26.089 23.2851 16.9071 0.09171455751356095 0.09171455751356095 0.09171455751356095 -25.089 23.2851 17.9071 0.12144480596164918 0.12144480596164918 0.12144480596164918 -25.089 23.2851 18.9071 0.12834751044445233 0.12834751044445233 0.12834751044445233 -25.089 24.2851 17.9071 0.11278044305904346 0.11278044305904346 0.11278044305904346 -25.089 24.2851 18.9071 0.1183021240349405 0.1183021240349405 0.1183021240349405 -26.089 23.2851 17.9071 0.11119850361068671 0.11119850361068671 0.11119850361068671 -26.089 23.2851 18.9071 0.1192219656800471 0.1192219656800471 0.1192219656800471 -26.089 24.2851 18.9071 0.10804336948024698 0.10804336948024698 0.10804336948024698 -26.089 26.2851 15.9071 0.09640518147532691 0.09640518147532691 0.09640518147532691 -26.089 26.2851 16.9071 0.06467517620146561 0.06467517620146561 0.06467517620146561 -25.089 25.2851 17.9071 0.09623000118938034 0.09623000118938034 0.09623000118938034 -25.089 25.2851 18.9071 0.11169421881059562 0.11169421881059562 0.11169421881059562 -25.089 26.2851 17.9071 0.07705308770139345 0.07705308770139345 0.07705308770139345 -25.089 26.2851 18.9071 0.07632133058980983 0.07632133058980983 0.07632133058980983 -26.089 25.2851 17.9071 0.09566990386256082 0.09566990386256082 0.09566990386256082 -26.089 25.2851 18.9071 0.11390360921937358 0.11390360921937358 0.11390360921937358 -26.089 26.2851 17.9071 0.07772077810765714 0.07772077810765714 0.07772077810765714 -26.089 26.2851 18.9071 0.16690837663351396 0.16690837663351396 0.16690837663351396 -27.089 23.2851 15.9071 0.023030818132224566 0.023030818132224566 0.023030818132224566 -28.089 23.2851 15.9071 0.05998503333711813 0.05998503333711813 0.05998503333711813 -28.089 24.2851 15.9071 0.041138017290547044 0.041138017290547044 0.041138017290547044 -27.089 23.2851 18.9071 0.08218781954676396 0.08218781954676396 0.08218781954676396 -27.089 24.2851 18.9071 0.10511951746297424 0.10511951746297424 0.10511951746297424 -28.089 23.2851 18.9071 0.06598567581094347 0.06598567581094347 0.06598567581094347 -28.089 24.2851 18.9071 0.07119739754994642 0.07119739754994642 0.07119739754994642 -27.089 25.2851 15.9071 0.09624526921112307 0.09624526921112307 0.09624526921112307 -27.089 25.2851 16.9071 0.08433613558499868 0.08433613558499868 0.08433613558499868 -27.089 26.2851 15.9071 0.0731387849074104 0.0731387849074104 0.0731387849074104 -27.089 26.2851 16.9071 0.05032878568756097 0.05032878568756097 0.05032878568756097 -28.089 25.2851 15.9071 0.04503707176207452 0.04503707176207452 0.04503707176207452 -28.089 25.2851 16.9071 0.06222623237000498 0.06222623237000498 0.06222623237000498 -28.089 26.2851 16.9071 0.06696841592879067 0.06696841592879067 0.06696841592879067 -27.089 25.2851 17.9071 0.09565383214571486 0.09565383214571486 0.09565383214571486 -27.089 25.2851 18.9071 0.10437146350666403 0.10437146350666403 0.10437146350666403 -27.089 26.2851 17.9071 0.05444037404831943 0.05444037404831943 0.05444037404831943 -27.089 26.2851 18.9071 0.06900106222312083 0.06900106222312083 0.06900106222312083 -28.089 25.2851 17.9071 0.0664997569036324 0.0664997569036324 0.0664997569036324 -28.089 25.2851 18.9071 0.09174027351809172 0.09174027351809172 0.09174027351809172 -28.089 26.2851 17.9071 0.06435876234940678 0.06435876234940678 0.06435876234940678 -28.089 26.2851 18.9071 0.055374131527447475 0.055374131527447475 0.055374131527447475 -29.089 22.2851 14.9071 0.08691918261972705 0.08691918261972705 0.08691918261972705 -29.089 21.2851 15.9071 0.07295945450973741 0.07295945450973741 0.07295945450973741 -29.089 21.2851 16.9071 0.07267064411373565 0.07267064411373565 0.07267064411373565 -29.089 22.2851 15.9071 0.09662375450823485 0.09662375450823485 0.09662375450823485 -29.089 22.2851 16.9071 0.10862507399877336 0.10862507399877336 0.10862507399877336 -29.089 22.2851 17.9071 0.0900534469326247 0.0900534469326247 0.0900534469326247 -29.089 22.2851 18.9071 0.059273541285582945 0.059273541285582945 0.059273541285582945 -30.089 22.2851 17.9071 0.06544779636154445 0.06544779636154445 0.06544779636154445 -30.089 22.2851 18.9071 0.05808778761331953 0.05808778761331953 0.05808778761331953 -32.089 20.2851 17.9071 0.08069529685617675 0.08069529685617675 0.08069529685617675 -32.089 20.2851 18.9071 0.09271988644502592 0.09271988644502592 0.09271988644502592 -32.089 21.2851 16.9071 0.0620546756865866 0.0620546756865866 0.0620546756865866 -32.089 22.2851 16.9071 0.05626607125000426 0.05626607125000426 0.05626607125000426 -31.089 21.2851 17.9071 0.0634718161763364 0.0634718161763364 0.0634718161763364 -31.089 21.2851 18.9071 0.05536898600189615 0.05536898600189615 0.05536898600189615 -31.089 22.2851 17.9071 0.051234369449092 0.051234369449092 0.051234369449092 -31.089 22.2851 18.9071 0.055202721030322116 0.055202721030322116 0.055202721030322116 -32.089 21.2851 17.9071 0.0664803834615042 0.0664803834615042 0.0664803834615042 -32.089 21.2851 18.9071 0.07512312825031146 0.07512312825031146 0.07512312825031146 -29.089 23.2851 14.9071 0.06429187796119386 0.06429187796119386 0.06429187796119386 -29.089 23.2851 15.9071 0.06633464036347263 0.06633464036347263 0.06633464036347263 -29.089 24.2851 15.9071 0.053788570494265074 0.053788570494265074 0.053788570494265074 -30.089 23.2851 15.9071 0.07964754063866744 0.07964754063866744 0.07964754063866744 -30.089 23.2851 16.9071 0.05627322666660617 0.05627322666660617 0.05627322666660617 -30.089 24.2851 15.9071 0.041921960410550796 0.041921960410550796 0.041921960410550796 -30.089 24.2851 16.9071 0.05557070643694678 0.05557070643694678 0.05557070643694678 -29.089 23.2851 18.9071 0.06653729795871725 0.06653729795871725 0.06653729795871725 -29.089 24.2851 17.9071 0.06138991018127313 0.06138991018127313 0.06138991018127313 -29.089 24.2851 18.9071 0.07059251302509471 0.07059251302509471 0.07059251302509471 -30.089 23.2851 17.9071 0.04836650515799101 0.04836650515799101 0.04836650515799101 -30.089 23.2851 18.9071 0.05582492652794003 0.05582492652794003 0.05582492652794003 -30.089 24.2851 17.9071 0.05187751024536186 0.05187751024536186 0.05187751024536186 -30.089 24.2851 18.9071 0.0484695853753962 0.0484695853753962 0.0484695853753962 -29.089 25.2851 15.9071 0.05433424628544761 0.05433424628544761 0.05433424628544761 -29.089 25.2851 16.9071 0.08177309873373204 0.08177309873373204 0.08177309873373204 -29.089 26.2851 16.9071 0.07901892858364032 0.07901892858364032 0.07901892858364032 -30.089 25.2851 15.9071 0.03507231180189805 0.03507231180189805 0.03507231180189805 -30.089 25.2851 16.9071 0.058418858164449666 0.058418858164449666 0.058418858164449666 -29.089 25.2851 17.9071 0.0745115213444202 0.0745115213444202 0.0745115213444202 -29.089 26.2851 17.9071 0.09004942872321973 0.09004942872321973 0.09004942872321973 -29.089 26.2851 18.9071 0.06964896446986418 0.06964896446986418 0.06964896446986418 -30.089 26.2851 17.9071 0.04934061598000166 0.04934061598000166 0.04934061598000166 -30.089 26.2851 18.9071 0.06242166505331673 0.06242166505331673 0.06242166505331673 -31.089 23.2851 18.9071 0.07324102958095863 0.07324102958095863 0.07324102958095863 -31.089 24.2851 17.9071 0.08557703723026944 0.08557703723026944 0.08557703723026944 -31.089 24.2851 18.9071 0.11515128543312049 0.11515128543312049 0.11515128543312049 -32.089 23.2851 17.9071 0.06494062202497587 0.06494062202497587 0.06494062202497587 -32.089 23.2851 18.9071 0.058745184020914255 0.058745184020914255 0.058745184020914255 -32.089 24.2851 17.9071 0.10195852026163062 0.10195852026163062 0.10195852026163062 -31.089 25.2851 18.9071 0.12857563580226514 0.12857563580226514 0.12857563580226514 -31.089 26.2851 18.9071 0.11951840148915786 0.11951840148915786 0.11951840148915786 -32.089 25.2851 17.9071 0.08653743695810616 0.08653743695810616 0.08653743695810616 -32.089 25.2851 18.9071 0.11812377797475818 0.11812377797475818 0.11812377797475818 -32.089 26.2851 18.9071 0.052167601323619035 0.052167601323619035 0.052167601323619035 -25.089 22.2851 19.9071 0.11571928100916745 0.11571928100916745 0.11571928100916745 -26.089 21.2851 22.9071 0.11990481075500276 0.11990481075500276 0.11990481075500276 -26.089 22.2851 22.9071 0.15001492571625766 0.15001492571625766 0.15001492571625766 -28.089 19.2851 20.9071 0.07452285488304272 0.07452285488304272 0.07452285488304272 -28.089 20.2851 20.9071 0.0851896593673234 0.0851896593673234 0.0851896593673234 -27.089 19.2851 22.9071 0.07375562697937015 0.07375562697937015 0.07375562697937015 -27.089 20.2851 22.9071 0.10247036275485884 0.10247036275485884 0.10247036275485884 -28.089 19.2851 21.9071 0.08580528389451916 0.08580528389451916 0.08580528389451916 -28.089 19.2851 22.9071 0.12894754300933353 0.12894754300933353 0.12894754300933353 -28.089 20.2851 21.9071 0.11599082486071102 0.11599082486071102 0.11599082486071102 -28.089 20.2851 22.9071 0.11261574284035487 0.11261574284035487 0.11261574284035487 -28.089 21.2851 19.9071 0.05160912682518106 0.05160912682518106 0.05160912682518106 -28.089 21.2851 20.9071 0.096168929073417 0.096168929073417 0.096168929073417 -28.089 22.2851 20.9071 0.11324963598001506 0.11324963598001506 0.11324963598001506 -27.089 21.2851 22.9071 0.15056340231225718 0.15056340231225718 0.15056340231225718 -27.089 22.2851 21.9071 0.12934033298768718 0.12934033298768718 0.12934033298768718 -27.089 22.2851 22.9071 0.1785989862655871 0.1785989862655871 0.1785989862655871 -28.089 21.2851 21.9071 0.1040926489208721 0.1040926489208721 0.1040926489208721 -28.089 21.2851 22.9071 0.08216451165079018 0.08216451165079018 0.08216451165079018 -28.089 22.2851 21.9071 0.1732387933194176 0.1732387933194176 0.1732387933194176 -28.089 22.2851 22.9071 0.16763818627960203 0.16763818627960203 0.16763818627960203 -25.089 19.2851 25.9071 0.12904152360812446 0.12904152360812446 0.12904152360812446 -25.089 19.2851 26.9071 0.19218531897941857 0.19218531897941857 0.19218531897941857 -25.089 20.2851 25.9071 0.09615205387530154 0.09615205387530154 0.09615205387530154 -25.089 20.2851 26.9071 0.15468609206312492 0.15468609206312492 0.15468609206312492 -26.089 21.2851 23.9071 0.14589039042052576 0.14589039042052576 0.14589039042052576 -26.089 21.2851 24.9071 0.10774046366653792 0.10774046366653792 0.10774046366653792 -26.089 22.2851 23.9071 0.18088681370566717 0.18088681370566717 0.18088681370566717 -26.089 22.2851 24.9071 0.15237021677404639 0.15237021677404639 0.15237021677404639 -25.089 22.2851 26.9071 0.07930490306955755 0.07930490306955755 0.07930490306955755 -26.089 22.2851 26.9071 0.07495682371799803 0.07495682371799803 0.07495682371799803 -27.089 19.2851 23.9071 0.0864233147454685 0.0864233147454685 0.0864233147454685 -27.089 20.2851 23.9071 0.11083535212555318 0.11083535212555318 0.11083535212555318 -28.089 19.2851 23.9071 0.15045499215419303 0.15045499215419303 0.15045499215419303 -28.089 19.2851 24.9071 0.09221119639748356 0.09221119639748356 0.09221119639748356 -28.089 20.2851 23.9071 0.13984936343937343 0.13984936343937343 0.13984936343937343 -28.089 20.2851 24.9071 0.1086588191594611 0.1086588191594611 0.1086588191594611 -27.089 21.2851 23.9071 0.16138681895954737 0.16138681895954737 0.16138681895954737 -27.089 21.2851 24.9071 0.145731379569827 0.145731379569827 0.145731379569827 -27.089 22.2851 24.9071 0.145557912828819 0.145557912828819 0.145557912828819 -28.089 21.2851 23.9071 0.13547290940703796 0.13547290940703796 0.13547290940703796 -28.089 21.2851 24.9071 0.08505785402601924 0.08505785402601924 0.08505785402601924 -28.089 22.2851 24.9071 0.04494966695243429 0.04494966695243429 0.04494966695243429 -27.089 21.2851 25.9071 0.07742989500644205 0.07742989500644205 0.07742989500644205 -27.089 21.2851 26.9071 0.09858284951738819 0.09858284951738819 0.09858284951738819 -27.089 22.2851 25.9071 0.07794735915911766 0.07794735915911766 0.07794735915911766 -27.089 22.2851 26.9071 0.11065538264051508 0.11065538264051508 0.11065538264051508 -28.089 21.2851 25.9071 0.09057500881065039 0.09057500881065039 0.09057500881065039 -28.089 21.2851 26.9071 0.4439500408144469 0.4439500408144469 0.4439500408144469 -28.089 22.2851 25.9071 0.06584797065395774 0.06584797065395774 0.06584797065395774 -25.089 23.2851 19.9071 0.11625433399424795 0.11625433399424795 0.11625433399424795 -25.089 23.2851 20.9071 0.11901630767481772 0.11901630767481772 0.11901630767481772 -25.089 24.2851 19.9071 0.10927265723090326 0.10927265723090326 0.10927265723090326 -25.089 24.2851 20.9071 0.12140945950600221 0.12140945950600221 0.12140945950600221 -26.089 24.2851 20.9071 0.09378145515780115 0.09378145515780115 0.09378145515780115 -25.089 23.2851 21.9071 0.10283355199946735 0.10283355199946735 0.10283355199946735 -25.089 24.2851 21.9071 0.12702774435823866 0.12702774435823866 0.12702774435823866 -26.089 23.2851 22.9071 0.13618051519088656 0.13618051519088656 0.13618051519088656 -26.089 24.2851 21.9071 0.1375507307175588 0.1375507307175588 0.1375507307175588 -25.089 25.2851 19.9071 0.11101933837045236 0.11101933837045236 0.11101933837045236 -25.089 25.2851 20.9071 0.12123272699481434 0.12123272699481434 0.12123272699481434 -25.089 26.2851 19.9071 0.13438699149189456 0.13438699149189456 0.13438699149189456 -25.089 26.2851 20.9071 0.1874874333056398 0.1874874333056398 0.1874874333056398 -26.089 25.2851 19.9071 0.11708984505252482 0.11708984505252482 0.11708984505252482 -26.089 25.2851 20.9071 0.1351709100380216 0.1351709100380216 0.1351709100380216 -26.089 26.2851 19.9071 0.0956144564258426 0.0956144564258426 0.0956144564258426 -26.089 26.2851 20.9071 0.13623111559306678 0.13623111559306678 0.13623111559306678 -25.089 25.2851 21.9071 0.13015643036970953 0.13015643036970953 0.13015643036970953 -25.089 25.2851 22.9071 0.17030125289404807 0.17030125289404807 0.17030125289404807 -25.089 26.2851 21.9071 0.12180228628807899 0.12180228628807899 0.12180228628807899 -25.089 26.2851 22.9071 0.1163804645850651 0.1163804645850651 0.1163804645850651 -26.089 25.2851 21.9071 0.1653612225203775 0.1653612225203775 0.1653612225203775 -26.089 26.2851 21.9071 0.13344724300417707 0.13344724300417707 0.13344724300417707 -26.089 26.2851 22.9071 0.0989042715425991 0.0989042715425991 0.0989042715425991 -27.089 24.2851 19.9071 0.09153293799756787 0.09153293799756787 0.09153293799756787 -27.089 24.2851 20.9071 0.14487528544764 0.14487528544764 0.14487528544764 -28.089 24.2851 19.9071 0.09250692812774054 0.09250692812774054 0.09250692812774054 -28.089 24.2851 20.9071 0.14350921020135754 0.14350921020135754 0.14350921020135754 -27.089 23.2851 21.9071 0.15013297297143158 0.15013297297143158 0.15013297297143158 -27.089 23.2851 22.9071 0.187756327038763 0.187756327038763 0.187756327038763 -27.089 24.2851 21.9071 0.18199136956141854 0.18199136956141854 0.18199136956141854 -27.089 24.2851 22.9071 0.19389408378067716 0.19389408378067716 0.19389408378067716 -28.089 23.2851 21.9071 0.16913712548373067 0.16913712548373067 0.16913712548373067 -28.089 23.2851 22.9071 0.15788998437579216 0.15788998437579216 0.15788998437579216 -28.089 24.2851 21.9071 0.1922904624363618 0.1922904624363618 0.1922904624363618 -28.089 24.2851 22.9071 0.13981804079332308 0.13981804079332308 0.13981804079332308 -27.089 25.2851 19.9071 0.13090906402317443 0.13090906402317443 0.13090906402317443 -27.089 26.2851 19.9071 0.10493792820522249 0.10493792820522249 0.10493792820522249 -27.089 26.2851 20.9071 0.1312399956956546 0.1312399956956546 0.1312399956956546 -28.089 25.2851 19.9071 0.1349026436903222 0.1349026436903222 0.1349026436903222 -28.089 26.2851 19.9071 0.11936335525370823 0.11936335525370823 0.11936335525370823 -28.089 26.2851 20.9071 0.1582818301177229 0.1582818301177229 0.1582818301177229 -27.089 25.2851 21.9071 0.18683807130110214 0.18683807130110214 0.18683807130110214 -27.089 25.2851 22.9071 0.1700451463090015 0.1700451463090015 0.1700451463090015 -27.089 26.2851 21.9071 0.14719378569931926 0.14719378569931926 0.14719378569931926 -27.089 26.2851 22.9071 0.09877248866757762 0.09877248866757762 0.09877248866757762 -28.089 25.2851 21.9071 0.20450623356747644 0.20450623356747644 0.20450623356747644 -28.089 25.2851 22.9071 0.18806374772811718 0.18806374772811718 0.18806374772811718 -28.089 26.2851 21.9071 0.17589444949750171 0.17589444949750171 0.17589444949750171 -28.089 26.2851 22.9071 0.06619243407455276 0.06619243407455276 0.06619243407455276 -25.089 24.2851 23.9071 0.17242634411206006 0.17242634411206006 0.17242634411206006 -25.089 24.2851 24.9071 0.1558520345589008 0.1558520345589008 0.1558520345589008 -26.089 23.2851 23.9071 0.19211067506778473 0.19211067506778473 0.19211067506778473 -26.089 23.2851 24.9071 0.16706573988931947 0.16706573988931947 0.16706573988931947 -25.089 23.2851 26.9071 0.08415369571118192 0.08415369571118192 0.08415369571118192 -25.089 24.2851 26.9071 0.09294088032925361 0.09294088032925361 0.09294088032925361 -26.089 23.2851 25.9071 0.07836547547954602 0.07836547547954602 0.07836547547954602 -26.089 23.2851 26.9071 0.08206163533961534 0.08206163533961534 0.08206163533961534 -26.089 24.2851 26.9071 0.06571701789548944 0.06571701789548944 0.06571701789548944 -25.089 25.2851 23.9071 0.15926384497570198 0.15926384497570198 0.15926384497570198 -25.089 25.2851 24.9071 0.16866745551834283 0.16866745551834283 0.16866745551834283 -25.089 26.2851 23.9071 0.10310674636848971 0.10310674636848971 0.10310674636848971 -25.089 26.2851 24.9071 0.08063260547488789 0.08063260547488789 0.08063260547488789 -26.089 26.2851 24.9071 0.06438239696368646 0.06438239696368646 0.06438239696368646 -25.089 25.2851 25.9071 0.10191914762728321 0.10191914762728321 0.10191914762728321 -25.089 25.2851 26.9071 0.17400708013099694 0.17400708013099694 0.17400708013099694 -25.089 26.2851 25.9071 0.12343141247112561 0.12343141247112561 0.12343141247112561 -25.089 26.2851 26.9071 0.17807960023820146 0.17807960023820146 0.17807960023820146 -26.089 25.2851 26.9071 0.01805157298537484 0.01805157298537484 0.01805157298537484 -26.089 26.2851 25.9071 0.12677310653544532 0.12677310653544532 0.12677310653544532 -26.089 26.2851 26.9071 0.14405532184225747 0.14405532184225747 0.14405532184225747 -27.089 23.2851 23.9071 0.20036844011667834 0.20036844011667834 0.20036844011667834 -27.089 23.2851 24.9071 0.16998814441897622 0.16998814441897622 0.16998814441897622 -27.089 24.2851 23.9071 0.196122085206228 0.196122085206228 0.196122085206228 -27.089 24.2851 24.9071 0.15127489053907198 0.15127489053907198 0.15127489053907198 -28.089 23.2851 23.9071 0.1417415498988763 0.1417415498988763 0.1417415498988763 -28.089 23.2851 24.9071 0.05770421679868198 0.05770421679868198 0.05770421679868198 -28.089 24.2851 23.9071 0.1414749117162501 0.1414749117162501 0.1414749117162501 -28.089 24.2851 24.9071 0.10805863526029781 0.10805863526029781 0.10805863526029781 -27.089 23.2851 25.9071 0.11061842457143302 0.11061842457143302 0.11061842457143302 -27.089 24.2851 25.9071 0.13017972436638314 0.13017972436638314 0.13017972436638314 -27.089 24.2851 26.9071 0.1680018843246564 0.1680018843246564 0.1680018843246564 -28.089 23.2851 25.9071 0.06469856955422441 0.06469856955422441 0.06469856955422441 -28.089 24.2851 25.9071 0.15223852144651717 0.15223852144651717 0.15223852144651717 -28.089 24.2851 26.9071 0.16964211799447632 0.16964211799447632 0.16964211799447632 -27.089 25.2851 23.9071 0.07994468491648662 0.07994468491648662 0.07994468491648662 -27.089 26.2851 23.9071 0.11378229517484442 0.11378229517484442 0.11378229517484442 -27.089 26.2851 24.9071 0.08236463784801798 0.08236463784801798 0.08236463784801798 -28.089 25.2851 23.9071 0.08561802523528192 0.08561802523528192 0.08561802523528192 -28.089 25.2851 24.9071 0.09574624447377553 0.09574624447377553 0.09574624447377553 -28.089 26.2851 24.9071 0.08525234719777415 0.08525234719777415 0.08525234719777415 -27.089 25.2851 25.9071 0.10718124993735886 0.10718124993735886 0.10718124993735886 -27.089 25.2851 26.9071 0.11886608059655207 0.11886608059655207 0.11886608059655207 -27.089 26.2851 25.9071 0.11868291565103574 0.11868291565103574 0.11868291565103574 -28.089 25.2851 25.9071 0.09619223291260946 0.09619223291260946 0.09619223291260946 -28.089 25.2851 26.9071 0.1545664454929622 0.1545664454929622 0.1545664454929622 -28.089 26.2851 25.9071 0.15017954939181136 0.15017954939181136 0.15017954939181136 -28.089 26.2851 26.9071 0.19621759253375054 0.19621759253375054 0.19621759253375054 -29.089 19.2851 20.9071 0.07577990320566216 0.07577990320566216 0.07577990320566216 -29.089 20.2851 19.9071 0.0583275284933253 0.0583275284933253 0.0583275284933253 -29.089 20.2851 20.9071 0.0854122813131882 0.0854122813131882 0.0854122813131882 -30.089 19.2851 20.9071 0.07173893615595123 0.07173893615595123 0.07173893615595123 -30.089 20.2851 19.9071 0.07422327917990268 0.07422327917990268 0.07422327917990268 -30.089 20.2851 20.9071 0.09595678346829194 0.09595678346829194 0.09595678346829194 -29.089 19.2851 21.9071 0.08648278690464171 0.08648278690464171 0.08648278690464171 -29.089 19.2851 22.9071 0.10166764442665246 0.10166764442665246 0.10166764442665246 -30.089 19.2851 21.9071 0.11009056507980972 0.11009056507980972 0.11009056507980972 -30.089 19.2851 22.9071 0.11658050568984177 0.11658050568984177 0.11658050568984177 -29.089 21.2851 19.9071 0.02026876462593806 0.02026876462593806 0.02026876462593806 -29.089 22.2851 20.9071 0.1077059146551136 0.1077059146551136 0.1077059146551136 -30.089 21.2851 19.9071 0.05938022529702526 0.05938022529702526 0.05938022529702526 -30.089 21.2851 20.9071 0.10785535910943234 0.10785535910943234 0.10785535910943234 -30.089 22.2851 20.9071 0.09574142296364274 0.09574142296364274 0.09574142296364274 -29.089 22.2851 21.9071 0.12131065001350855 0.12131065001350855 0.12131065001350855 -29.089 22.2851 22.9071 0.07203482352930198 0.07203482352930198 0.07203482352930198 -30.089 21.2851 21.9071 0.08354931044253802 0.08354931044253802 0.08354931044253802 -30.089 22.2851 21.9071 0.09872990025328841 0.09872990025328841 0.09872990025328841 -30.089 22.2851 22.9071 0.07970219533529989 0.07970219533529989 0.07970219533529989 -31.089 20.2851 20.9071 0.07405150693601854 0.07405150693601854 0.07405150693601854 -32.089 20.2851 19.9071 0.07495433196067887 0.07495433196067887 0.07495433196067887 -31.089 19.2851 21.9071 0.07325967796653385 0.07325967796653385 0.07325967796653385 -31.089 19.2851 22.9071 0.09822365888492482 0.09822365888492482 0.09822365888492482 -31.089 20.2851 21.9071 0.08849034832640079 0.08849034832640079 0.08849034832640079 -32.089 19.2851 21.9071 0.07171136495977373 0.07171136495977373 0.07171136495977373 -32.089 19.2851 22.9071 0.0686580577675565 0.0686580577675565 0.0686580577675565 -32.089 20.2851 21.9071 0.08684122628441947 0.08684122628441947 0.08684122628441947 -32.089 20.2851 22.9071 0.11899301044576217 0.11899301044576217 0.11899301044576217 -31.089 21.2851 20.9071 0.06809125718378634 0.06809125718378634 0.06809125718378634 -31.089 22.2851 20.9071 0.07041454347644266 0.07041454347644266 0.07041454347644266 -32.089 21.2851 19.9071 0.0725182405478168 0.0725182405478168 0.0725182405478168 -32.089 22.2851 19.9071 0.05371363726913922 0.05371363726913922 0.05371363726913922 -32.089 22.2851 20.9071 0.07160855566396244 0.07160855566396244 0.07160855566396244 -31.089 21.2851 21.9071 0.08686855119406273 0.08686855119406273 0.08686855119406273 -31.089 22.2851 21.9071 0.0635858101684393 0.0635858101684393 0.0635858101684393 -31.089 22.2851 22.9071 0.04102455438034192 0.04102455438034192 0.04102455438034192 -32.089 21.2851 21.9071 0.09091012459679843 0.09091012459679843 0.09091012459679843 -32.089 21.2851 22.9071 0.1324817805623908 0.1324817805623908 0.1324817805623908 -32.089 22.2851 21.9071 0.06192862068325744 0.06192862068325744 0.06192862068325744 -32.089 22.2851 22.9071 0.09309678110422294 0.09309678110422294 0.09309678110422294 -29.089 19.2851 24.9071 0.11602537031455684 0.11602537031455684 0.11602537031455684 -29.089 20.2851 24.9071 0.10626528801812969 0.10626528801812969 0.10626528801812969 -30.089 19.2851 23.9071 0.10536618893976614 0.10536618893976614 0.10536618893976614 -30.089 19.2851 24.9071 0.10893360065525173 0.10893360065525173 0.10893360065525173 -30.089 20.2851 24.9071 0.10270820368440294 0.10270820368440294 0.10270820368440294 -30.089 20.2851 25.9071 0.12603730312410205 0.12603730312410205 0.12603730312410205 -29.089 21.2851 23.9071 0.04949820935871141 0.04949820935871141 0.04949820935871141 -29.089 21.2851 24.9071 0.07086493267828675 0.07086493267828675 0.07086493267828675 -29.089 22.2851 23.9071 0.043295712043737895 0.043295712043737895 0.043295712043737895 -30.089 21.2851 23.9071 0.08374219985134893 0.08374219985134893 0.08374219985134893 -30.089 21.2851 24.9071 0.07496285216282424 0.07496285216282424 0.07496285216282424 -30.089 22.2851 23.9071 0.07668150317211334 0.07668150317211334 0.07668150317211334 -29.089 21.2851 25.9071 0.11423380744716846 0.11423380744716846 0.11423380744716846 -29.089 21.2851 26.9071 0.1771363481059488 0.1771363481059488 0.1771363481059488 -30.089 21.2851 25.9071 0.054707622431055404 0.054707622431055404 0.054707622431055404 -30.089 21.2851 26.9071 0.10649026208720865 0.10649026208720865 0.10649026208720865 -31.089 19.2851 23.9071 0.10480936919087551 0.10480936919087551 0.10480936919087551 -31.089 19.2851 24.9071 0.11705369331133451 0.11705369331133451 0.11705369331133451 -32.089 19.2851 23.9071 0.09393574709780832 0.09393574709780832 0.09393574709780832 -32.089 19.2851 24.9071 0.08668611706271141 0.08668611706271141 0.08668611706271141 -32.089 20.2851 23.9071 0.1265441727890974 0.1265441727890974 0.1265441727890974 -32.089 20.2851 24.9071 0.11931033419269253 0.11931033419269253 0.11931033419269253 -31.089 19.2851 25.9071 0.07636039424174446 0.07636039424174446 0.07636039424174446 -31.089 20.2851 25.9071 0.12839329621955115 0.12839329621955115 0.12839329621955115 -32.089 20.2851 25.9071 0.12785752069334635 0.12785752069334635 0.12785752069334635 -32.089 21.2851 23.9071 0.12745428098758727 0.12745428098758727 0.12745428098758727 -32.089 22.2851 23.9071 0.14395573705469678 0.14395573705469678 0.14395573705469678 -32.089 22.2851 24.9071 0.18582990433043284 0.18582990433043284 0.18582990433043284 -31.089 21.2851 25.9071 0.05396247641195204 0.05396247641195204 0.05396247641195204 -31.089 21.2851 26.9071 0.1140401877261189 0.1140401877261189 0.1140401877261189 -31.089 22.2851 26.9071 0.11792936425157803 0.11792936425157803 0.11792936425157803 -32.089 21.2851 25.9071 0.1252645416415965 0.1252645416415965 0.1252645416415965 -32.089 22.2851 25.9071 0.15590422855924782 0.15590422855924782 0.15590422855924782 -32.089 22.2851 26.9071 0.15281187635976276 0.15281187635976276 0.15281187635976276 -29.089 24.2851 20.9071 0.1153344584190603 0.1153344584190603 0.1153344584190603 -29.089 23.2851 21.9071 0.11609365779600012 0.11609365779600012 0.11609365779600012 -29.089 23.2851 22.9071 0.09574865522874247 0.09574865522874247 0.09574865522874247 -29.089 24.2851 21.9071 0.14354535005685082 0.14354535005685082 0.14354535005685082 -29.089 24.2851 22.9071 0.10830208388763508 0.10830208388763508 0.10830208388763508 -30.089 23.2851 21.9071 0.08973038225537162 0.08973038225537162 0.08973038225537162 -30.089 24.2851 21.9071 0.09565061780196041 0.09565061780196041 0.09565061780196041 -29.089 25.2851 19.9071 0.11949189101411607 0.11949189101411607 0.11949189101411607 -29.089 25.2851 20.9071 0.15286808740583496 0.15286808740583496 0.15286808740583496 -29.089 26.2851 19.9071 0.11438404317522914 0.11438404317522914 0.11438404317522914 -29.089 26.2851 20.9071 0.13945823106159141 0.13945823106159141 0.13945823106159141 -30.089 26.2851 19.9071 0.12054908985306194 0.12054908985306194 0.12054908985306194 -30.089 26.2851 20.9071 0.1063046585256407 0.1063046585256407 0.1063046585256407 -29.089 25.2851 21.9071 0.1711915982833375 0.1711915982833375 0.1711915982833375 -29.089 25.2851 22.9071 0.0946139852415476 0.0946139852415476 0.0946139852415476 -29.089 26.2851 21.9071 0.14936606424149623 0.14936606424149623 0.14936606424149623 -29.089 26.2851 22.9071 0.06138669446829872 0.06138669446829872 0.06138669446829872 -30.089 25.2851 21.9071 0.11293710880782515 0.11293710880782515 0.11293710880782515 -30.089 25.2851 22.9071 0.09878052421492181 0.09878052421492181 0.09878052421492181 -30.089 26.2851 21.9071 0.04538588596292632 0.04538588596292632 0.04538588596292632 -30.089 26.2851 22.9071 0.07660884183924026 0.07660884183924026 0.07660884183924026 -31.089 23.2851 20.9071 0.06206649333303794 0.06206649333303794 0.06206649333303794 -31.089 24.2851 19.9071 0.0897207385137274 0.0897207385137274 0.0897207385137274 -31.089 24.2851 20.9071 0.15199922084837753 0.15199922084837753 0.15199922084837753 -32.089 23.2851 19.9071 0.0682142478638443 0.0682142478638443 0.0682142478638443 -32.089 23.2851 20.9071 0.08027437955521066 0.08027437955521066 0.08027437955521066 -32.089 24.2851 19.9071 0.08025862625849851 0.08025862625849851 0.08025862625849851 -32.089 24.2851 20.9071 0.08651011193602312 0.08651011193602312 0.08651011193602312 -31.089 23.2851 21.9071 0.06746070593392808 0.06746070593392808 0.06746070593392808 -31.089 24.2851 21.9071 0.06717653824657965 0.06717653824657965 0.06717653824657965 -32.089 23.2851 22.9071 0.05075484469963011 0.05075484469963011 0.05075484469963011 -31.089 26.2851 19.9071 0.1143486936173951 0.1143486936173951 0.1143486936173951 -31.089 26.2851 20.9071 0.10043100862640936 0.10043100862640936 0.10043100862640936 -32.089 25.2851 19.9071 0.06118531018709646 0.06118531018709646 0.06118531018709646 -32.089 25.2851 20.9071 0.139761017483326 0.139761017483326 0.139761017483326 -32.089 26.2851 19.9071 0.07031076791654547 0.07031076791654547 0.07031076791654547 -32.089 26.2851 20.9071 0.11630334017086219 0.11630334017086219 0.11630334017086219 -31.089 25.2851 21.9071 0.1082362001734109 0.1082362001734109 0.1082362001734109 -31.089 25.2851 22.9071 0.10864837423027941 0.10864837423027941 0.10864837423027941 -31.089 26.2851 21.9071 0.11004235856096728 0.11004235856096728 0.11004235856096728 -31.089 26.2851 22.9071 0.09192671430507843 0.09192671430507843 0.09192671430507843 -32.089 26.2851 21.9071 0.0882588946404145 0.0882588946404145 0.0882588946404145 -29.089 23.2851 23.9071 0.06143034776096704 0.06143034776096704 0.06143034776096704 -29.089 23.2851 24.9071 0.06317766591177948 0.06317766591177948 0.06317766591177948 -29.089 24.2851 23.9071 0.07534891282882626 0.07534891282882626 0.07534891282882626 -29.089 24.2851 24.9071 0.0655931391230119 0.0655931391230119 0.0655931391230119 -30.089 24.2851 24.9071 0.1658124454231845 0.1658124454231845 0.1658124454231845 -29.089 24.2851 25.9071 0.14738170416422156 0.14738170416422156 0.14738170416422156 -29.089 24.2851 26.9071 0.24279800990824701 0.24279800990824701 0.24279800990824701 -30.089 24.2851 25.9071 0.15889207788257095 0.15889207788257095 0.15889207788257095 -30.089 24.2851 26.9071 0.2539137894198119 0.2539137894198119 0.2539137894198119 -29.089 25.2851 23.9071 0.05735617957244766 0.05735617957244766 0.05735617957244766 -29.089 25.2851 24.9071 0.060403966561298414 0.060403966561298414 0.060403966561298414 -30.089 25.2851 23.9071 0.08579563968235877 0.08579563968235877 0.08579563968235877 -30.089 25.2851 24.9071 0.12786715986476122 0.12786715986476122 0.12786715986476122 -30.089 26.2851 23.9071 0.12621482836220957 0.12621482836220957 0.12621482836220957 -30.089 26.2851 24.9071 0.14211982122621086 0.14211982122621086 0.14211982122621086 -29.089 25.2851 25.9071 0.11408357143856535 0.11408357143856535 0.11408357143856535 -29.089 26.2851 25.9071 0.0418590779843778 0.0418590779843778 0.0418590779843778 -29.089 26.2851 26.9071 0.10638500644034475 0.10638500644034475 0.10638500644034475 -30.089 25.2851 25.9071 0.11256271733234573 0.11256271733234573 0.11256271733234573 -30.089 25.2851 26.9071 0.12294862259895387 0.12294862259895387 0.12294862259895387 -30.089 26.2851 25.9071 0.12648151712393044 0.12648151712393044 0.12648151712393044 -32.089 23.2851 23.9071 0.18789679355692795 0.18789679355692795 0.18789679355692795 -32.089 23.2851 24.9071 0.19382827012026446 0.19382827012026446 0.19382827012026446 -31.089 23.2851 25.9071 0.13845910810068449 0.13845910810068449 0.13845910810068449 -31.089 23.2851 26.9071 0.10551483425278049 0.10551483425278049 0.10551483425278049 -31.089 24.2851 25.9071 0.1573977656062585 0.1573977656062585 0.1573977656062585 -31.089 24.2851 26.9071 0.10364349025061105 0.10364349025061105 0.10364349025061105 -32.089 23.2851 25.9071 0.16879912395616287 0.16879912395616287 0.16879912395616287 -32.089 23.2851 26.9071 0.11753089498709823 0.11753089498709823 0.11753089498709823 -32.089 24.2851 25.9071 0.0903837430600147 0.0903837430600147 0.0903837430600147 -32.089 24.2851 26.9071 0.11544853962937568 0.11544853962937568 0.11544853962937568 -31.089 25.2851 23.9071 0.07292191645120213 0.07292191645120213 0.07292191645120213 -31.089 25.2851 24.9071 0.07621499055234385 0.07621499055234385 0.07621499055234385 -31.089 26.2851 23.9071 0.14120827264993893 0.14120827264993893 0.14120827264993893 -31.089 26.2851 24.9071 0.10038761755139695 0.10038761755139695 0.10038761755139695 -32.089 25.2851 24.9071 0.0333936254816575 0.0333936254816575 0.0333936254816575 -32.089 26.2851 23.9071 0.07591276866564342 0.07591276866564342 0.07591276866564342 -32.089 26.2851 24.9071 0.08022446731370027 0.08022446731370027 0.08022446731370027 -31.089 25.2851 25.9071 0.12350130028244266 0.12350130028244266 0.12350130028244266 -31.089 25.2851 26.9071 0.11623826638887028 0.11623826638887028 0.11623826638887028 -31.089 26.2851 25.9071 0.1500823813118542 0.1500823813118542 0.1500823813118542 -32.089 25.2851 25.9071 0.06043805352866656 0.06043805352866656 0.06043805352866656 -32.089 25.2851 26.9071 0.10544091337467937 0.10544091337467937 0.10544091337467937 -32.089 26.2851 25.9071 0.11513923456416408 0.11513923456416408 0.11513923456416408 -32.089 26.2851 26.9071 0.11011065112080846 0.11011065112080846 0.11011065112080846 -33.089 20.2851 16.9071 0.07878399150425648 0.07878399150425648 0.07878399150425648 -33.089 20.2851 17.9071 0.09459871691021043 0.09459871691021043 0.09459871691021043 -33.089 20.2851 18.9071 0.11077348766047863 0.11077348766047863 0.11077348766047863 -34.089 20.2851 17.9071 0.057961324413284034 0.057961324413284034 0.057961324413284034 -34.089 20.2851 18.9071 0.0865872649156705 0.0865872649156705 0.0865872649156705 -33.089 21.2851 16.9071 0.0712842111683738 0.0712842111683738 0.0712842111683738 -33.089 22.2851 16.9071 0.08216451165079018 0.08216451165079018 0.08216451165079018 -34.089 21.2851 16.9071 0.0668378669309192 0.0668378669309192 0.0668378669309192 -34.089 22.2851 16.9071 0.06508315208308262 0.06508315208308262 0.06508315208308262 -34.089 21.2851 17.9071 0.07708081782132234 0.07708081782132234 0.07708081782132234 -34.089 21.2851 18.9071 0.07403993219044529 0.07403993219044529 0.07403993219044529 -34.089 22.2851 17.9071 0.0851703707942714 0.0851703707942714 0.0851703707942714 -35.089 22.2851 17.9071 0.15125240568009587 0.15125240568009587 0.15125240568009587 -35.089 22.2851 18.9071 0.18707245225825422 0.18707245225825422 0.18707245225825422 -36.089 21.2851 18.9071 0.0778439148206771 0.0778439148206771 0.0778439148206771 -36.089 22.2851 18.9071 0.11363366513583037 0.11363366513583037 0.11363366513583037 -33.089 23.2851 16.9071 0.06856087156619747 0.06856087156619747 0.06856087156619747 -34.089 23.2851 16.9071 0.09642125304208227 0.09642125304208227 0.09642125304208227 -33.089 23.2851 17.9071 0.09937434894216371 0.09937434894216371 0.09937434894216371 -33.089 24.2851 17.9071 0.08928435799448245 0.08928435799448245 0.08928435799448245 -34.089 23.2851 17.9071 0.15959466003744327 0.15959466003744327 0.15959466003744327 -34.089 24.2851 17.9071 0.10879219275123368 0.10879219275123368 0.10879219275123368 -34.089 24.2851 18.9071 0.13452273203284087 0.13452273203284087 0.13452273203284087 -33.089 25.2851 17.9071 0.0624505257014227 0.0624505257014227 0.0624505257014227 -33.089 26.2851 18.9071 0.04228880038760182 0.04228880038760182 0.04228880038760182 -34.089 25.2851 17.9071 0.03986900875443005 0.03986900875443005 0.03986900875443005 -34.089 25.2851 18.9071 0.06994807490054263 0.06994807490054263 0.06994807490054263 -34.089 26.2851 18.9071 0.07314939520976775 0.07314939520976775 0.07314939520976775 -35.089 23.2851 17.9071 0.16092593602478422 0.16092593602478422 0.16092593602478422 -35.089 23.2851 18.9071 0.23153869984136324 0.23153869984136324 0.23153869984136324 -35.089 24.2851 17.9071 0.15535337940238858 0.15535337940238858 0.15535337940238858 -35.089 24.2851 18.9071 0.230675495908805 0.230675495908805 0.230675495908805 -36.089 23.2851 18.9071 0.207537216810841 0.207537216810841 0.207537216810841 -36.089 26.2851 16.9071 0.11024241542539684 0.11024241542539684 0.11024241542539684 -35.089 26.2851 17.9071 0.1494399447724377 0.1494399447724377 0.1494399447724377 -35.089 26.2851 18.9071 0.1807391103196584 0.1807391103196584 0.1807391103196584 -36.089 25.2851 17.9071 0.11555298003218265 0.11555298003218265 0.11555298003218265 -36.089 25.2851 18.9071 0.05197302815491574 0.05197302815491574 0.05197302815491574 -36.089 26.2851 17.9071 0.15166596547388517 0.15166596547388517 0.15166596547388517 -36.089 26.2851 18.9071 0.1625847810669866 0.1625847810669866 0.1625847810669866 -37.089 22.2851 18.9071 0.08586957861260987 0.08586957861260987 0.08586957861260987 -37.089 26.2851 16.9071 0.12040368566951226 0.12040368566951226 0.12040368566951226 -38.089 26.2851 16.9071 0.09701750590001859 0.09701750590001859 0.09701750590001859 -37.089 25.2851 17.9071 0.09435603041277235 0.09435603041277235 0.09435603041277235 -37.089 25.2851 18.9071 0.10181870714625235 0.10181870714625235 0.10181870714625235 -37.089 26.2851 17.9071 0.13628010960295775 0.13628010960295775 0.13628010960295775 -38.089 25.2851 17.9071 0.07698918782340759 0.07698918782340759 0.07698918782340759 -38.089 25.2851 18.9071 0.09989183268121628 0.09989183268121628 0.09989183268121628 -38.089 26.2851 17.9071 0.1275522796677259 0.1275522796677259 0.1275522796677259 -39.089 25.2851 18.9071 0.09374529294156725 0.09374529294156725 0.09374529294156725 -39.089 26.2851 17.9071 0.09207538445060863 0.09207538445060863 0.09207538445060863 -39.089 26.2851 18.9071 0.1181767998177279 0.1181767998177279 0.1181767998177279 -33.089 20.2851 19.9071 0.10588042020561007 0.10588042020561007 0.10588042020561007 -34.089 20.2851 19.9071 0.09767723605550452 0.09767723605550452 0.09767723605550452 -33.089 20.2851 22.9071 0.11381684157702031 0.11381684157702031 0.11381684157702031 -33.089 21.2851 19.9071 0.10199869639927905 0.10199869639927905 0.10199869639927905 -33.089 21.2851 20.9071 0.14504795056774977 0.14504795056774977 0.14504795056774977 -33.089 22.2851 20.9071 0.11565179659618449 0.11565179659618449 0.11565179659618449 -34.089 21.2851 19.9071 0.13476690379035353 0.13476690379035353 0.13476690379035353 -34.089 21.2851 20.9071 0.1812351999659801 0.1812351999659801 0.1812351999659801 -33.089 21.2851 21.9071 0.15469331903145475 0.15469331903145475 0.15469331903145475 -33.089 21.2851 22.9071 0.11414945036456926 0.11414945036456926 0.11414945036456926 -33.089 22.2851 21.9071 0.08561320311812268 0.08561320311812268 0.08561320311812268 -33.089 22.2851 22.9071 0.08673514125319336 0.08673514125319336 0.08673514125319336 -34.089 21.2851 21.9071 0.18254926083218076 0.18254926083218076 0.18254926083218076 -34.089 22.2851 21.9071 0.1933033641211226 0.1933033641211226 0.1933033641211226 -34.089 22.2851 22.9071 0.11204933219763594 0.11204933219763594 0.11204933219763594 -35.089 20.2851 19.9071 0.08549023903307021 0.08549023903307021 0.08549023903307021 -35.089 20.2851 20.9071 0.11162833787410613 0.11162833787410613 0.11162833787410613 -36.089 20.2851 19.9071 0.10391748537278993 0.10391748537278993 0.10391748537278993 -36.089 20.2851 20.9071 0.14321446899613496 0.14321446899613496 0.14321446899613496 -35.089 20.2851 21.9071 0.09602508798554382 0.09602508798554382 0.09602508798554382 -36.089 20.2851 21.9071 0.12836678866871676 0.12836678866871676 0.12836678866871676 -35.089 21.2851 19.9071 0.10715553886785531 0.10715553886785531 0.10715553886785531 -35.089 21.2851 20.9071 0.09746429085967717 0.09746429085967717 0.09746429085967717 -35.089 22.2851 19.9071 0.1641841772012645 0.1641841772012645 0.1641841772012645 -36.089 21.2851 19.9071 0.14504232891851102 0.14504232891851102 0.14504232891851102 -35.089 21.2851 21.9071 0.11759114752269555 0.11759114752269555 0.11759114752269555 -35.089 22.2851 21.9071 0.2308784619785547 0.2308784619785547 0.2308784619785547 -35.089 22.2851 22.9071 0.24535672427702562 0.24535672427702562 0.24535672427702562 -36.089 21.2851 21.9071 0.13048575866182294 0.13048575866182294 0.13048575866182294 -36.089 22.2851 21.9071 0.09734777343850033 0.09734777343850033 0.09734777343850033 -36.089 22.2851 22.9071 0.1433509977540431 0.1433509977540431 0.1433509977540431 -33.089 20.2851 23.9071 0.1016451456994787 0.1016451456994787 0.1016451456994787 -33.089 20.2851 24.9071 0.12561477541612523 0.12561477541612523 0.12561477541612523 -33.089 20.2851 25.9071 0.11213610174621963 0.11213610174621963 0.11213610174621963 -33.089 21.2851 23.9071 0.10896975604537162 0.10896975604537162 0.10896975604537162 -33.089 21.2851 24.9071 0.10809800489023876 0.10809800489023876 0.10809800489023876 -33.089 22.2851 23.9071 0.08025340195023058 0.08025340195023058 0.08025340195023058 -33.089 22.2851 24.9071 0.08135998324035974 0.08135998324035974 0.08135998324035974 -34.089 22.2851 23.9071 0.0974056303859635 0.0974056303859635 0.0974056303859635 -34.089 22.2851 24.9071 0.09062001245059606 0.09062001245059606 0.09062001245059606 -33.089 21.2851 25.9071 0.11514084134680422 0.11514084134680422 0.11514084134680422 -33.089 22.2851 25.9071 0.09054607788595713 0.09054607788595713 0.09054607788595713 -33.089 22.2851 26.9071 0.1407328176642559 0.1407328176642559 0.1407328176642559 -34.089 22.2851 25.9071 0.08359512171901017 0.08359512171901017 0.08359512171901017 -34.089 22.2851 26.9071 0.05037477669161167 0.05037477669161167 0.05037477669161167 -35.089 22.2851 23.9071 0.10388614873451506 0.10388614873451506 0.10388614873451506 -35.089 22.2851 24.9071 0.08752836457659947 0.08752836457659947 0.08752836457659947 -36.089 21.2851 23.9071 0.09787973436040351 0.09787973436040351 0.09787973436040351 -36.089 22.2851 23.9071 0.1314624902538968 0.1314624902538968 0.1314624902538968 -36.089 22.2851 24.9071 0.11813020486667294 0.11813020486667294 0.11813020486667294 -35.089 22.2851 25.9071 0.12298637831734231 0.12298637831734231 0.12298637831734231 -35.089 22.2851 26.9071 0.06272152587805178 0.06272152587805178 0.06272152587805178 -36.089 22.2851 25.9071 0.17709942056349653 0.17709942056349653 0.17709942056349653 -36.089 22.2851 26.9071 0.06935314870671849 0.06935314870671849 0.06935314870671849 -34.089 24.2851 19.9071 0.07673607950619492 0.07673607950619492 0.07673607950619492 -33.089 23.2851 22.9071 0.10818477870041686 0.10818477870041686 0.10818477870041686 -34.089 23.2851 21.9071 0.14412920725017597 0.14412920725017597 0.14412920725017597 -34.089 23.2851 22.9071 0.1317564712897647 0.1317564712897647 0.1317564712897647 -34.089 24.2851 22.9071 0.17175357857846243 0.17175357857846243 0.17175357857846243 -33.089 25.2851 19.9071 0.03653938451634608 0.03653938451634608 0.03653938451634608 -33.089 26.2851 19.9071 0.056618293866808875 0.056618293866808875 0.056618293866808875 -33.089 26.2851 20.9071 0.08665879209112523 0.08665879209112523 0.08665879209112523 -34.089 25.2851 19.9071 0.07493592510576871 0.07493592510576871 0.07493592510576871 -34.089 26.2851 19.9071 0.07007299196165537 0.07007299196165537 0.07007299196165537 -33.089 26.2851 21.9071 0.05298826074607146 0.05298826074607146 0.05298826074607146 -33.089 26.2851 22.9071 0.055515150959074784 0.055515150959074784 0.055515150959074784 -34.089 25.2851 22.9071 0.14233345138107636 0.14233345138107636 0.14233345138107636 -34.089 26.2851 21.9071 0.05987947564834088 0.05987947564834088 0.05987947564834088 -34.089 26.2851 22.9071 0.08562043629375317 0.08562043629375317 0.08562043629375317 -35.089 23.2851 19.9071 0.2301588526935172 0.2301588526935172 0.2301588526935172 -35.089 24.2851 19.9071 0.11721276085108356 0.11721276085108356 0.11721276085108356 -36.089 23.2851 19.9071 0.16176660378395671 0.16176660378395671 0.16176660378395671 -36.089 24.2851 19.9071 0.09345679823436208 0.09345679823436208 0.09345679823436208 -35.089 23.2851 21.9071 0.1936661435563971 0.1936661435563971 0.1936661435563971 -35.089 23.2851 22.9071 0.17908144230725095 0.17908144230725095 0.17908144230725095 -35.089 24.2851 21.9071 0.0970030415972709 0.0970030415972709 0.0970030415972709 -35.089 24.2851 22.9071 0.0897834228137789 0.0897834228137789 0.0897834228137789 -36.089 23.2851 22.9071 0.1612174006266393 0.1612174006266393 0.1612174006266393 -35.089 25.2851 19.9071 0.0649372456753667 0.0649372456753667 0.0649372456753667 -35.089 26.2851 19.9071 0.12056194324890337 0.12056194324890337 0.12056194324890337 -36.089 25.2851 19.9071 0.04436002374550111 0.04436002374550111 0.04436002374550111 -35.089 25.2851 21.9071 0.04904376067519313 0.04904376067519313 0.04904376067519313 -35.089 25.2851 22.9071 0.08610264653504215 0.08610264653504215 0.08610264653504215 -35.089 26.2851 21.9071 0.07438862067048697 0.07438862067048697 0.07438862067048697 -35.089 26.2851 22.9071 0.07892649704002593 0.07892649704002593 0.07892649704002593 -36.089 25.2851 21.9071 0.06168438855224802 0.06168438855224802 0.06168438855224802 -36.089 25.2851 22.9071 0.054738254634824034 0.054738254634824034 0.054738254634824034 -36.089 26.2851 21.9071 0.09077189954958496 0.09077189954958496 0.09077189954958496 -36.089 26.2851 22.9071 0.05851131327171796 0.05851131327171796 0.05851131327171796 -33.089 23.2851 23.9071 0.08619667719535325 0.08619667719535325 0.08619667719535325 -33.089 23.2851 24.9071 0.08172648269473887 0.08172648269473887 0.08172648269473887 -33.089 24.2851 23.9071 0.06196343053490295 0.06196343053490295 0.06196343053490295 -34.089 23.2851 23.9071 0.09082654668966592 0.09082654668966592 0.09082654668966592 -34.089 24.2851 23.9071 0.06681326838912957 0.06681326838912957 0.06681326838912957 -34.089 24.2851 24.9071 0.07250554023762842 0.07250554023762842 0.07250554023762842 -33.089 23.2851 25.9071 0.0737745163869982 0.0737745163869982 0.0737745163869982 -33.089 23.2851 26.9071 0.10628617849389446 0.10628617849389446 0.10628617849389446 -33.089 24.2851 25.9071 0.07062016498828799 0.07062016498828799 0.07062016498828799 -33.089 24.2851 26.9071 0.18161810201878462 0.18161810201878462 0.18161810201878462 -34.089 24.2851 26.9071 0.08665155900886462 0.08665155900886462 0.08665155900886462 -33.089 25.2851 23.9071 0.07490755121202045 0.07490755121202045 0.07490755121202045 -33.089 25.2851 24.9071 0.0746896425896136 0.0746896425896136 0.0746896425896136 -33.089 26.2851 23.9071 0.09738714831004776 0.09738714831004776 0.09738714831004776 -34.089 25.2851 23.9071 0.10202440911684593 0.10202440911684593 0.10202440911684593 -34.089 25.2851 24.9071 0.12005905260482706 0.12005905260482706 0.12005905260482706 -34.089 26.2851 23.9071 0.12308839899968216 0.12308839899968216 0.12308839899968216 -34.089 26.2851 24.9071 0.10958359174448486 0.10958359174448486 0.10958359174448486 -33.089 25.2851 25.9071 0.08483924956927714 0.08483924956927714 0.08483924956927714 -33.089 25.2851 26.9071 0.24668096737492307 0.24668096737492307 0.24668096737492307 -33.089 26.2851 26.9071 0.10207583452730888 0.10207583452730888 0.10207583452730888 -34.089 25.2851 25.9071 0.19422876948905113 0.19422876948905113 0.19422876948905113 -34.089 25.2851 26.9071 0.2426576392105591 0.2426576392105591 0.2426576392105591 -35.089 23.2851 23.9071 0.11996184814016453 0.11996184814016453 0.11996184814016453 -35.089 23.2851 24.9071 0.10702296603523255 0.10702296603523255 0.10702296603523255 -35.089 24.2851 23.9071 0.08640402646817827 0.08640402646817827 0.08640402646817827 -36.089 23.2851 23.9071 0.13092432546520877 0.13092432546520877 0.13092432546520877 -36.089 23.2851 24.9071 0.13121268585189028 0.13121268585189028 0.13121268585189028 -36.089 23.2851 25.9071 0.1801627434262913 0.1801627434262913 0.1801627434262913 -36.089 23.2851 26.9071 0.08299314339144255 0.08299314339144255 0.08299314339144255 -36.089 24.2851 26.9071 0.05660502826320578 0.05660502826320578 0.05660502826320578 -35.089 25.2851 23.9071 0.08929641273674586 0.08929641273674586 0.08929641273674586 -35.089 25.2851 24.9071 0.11572088778022328 0.11572088778022328 0.11572088778022328 -35.089 26.2851 23.9071 0.08242411300746104 0.08242411300746104 0.08242411300746104 -35.089 26.2851 24.9071 0.09503587219769556 0.09503587219769556 0.09503587219769556 -36.089 26.2851 23.9071 0.06335291818031395 0.06335291818031395 0.06335291818031395 -36.089 26.2851 24.9071 0.06096270158670458 0.06096270158670458 0.06096270158670458 -35.089 25.2851 25.9071 0.11711796306223164 0.11711796306223164 0.11711796306223164 -35.089 25.2851 26.9071 0.1257657931787496 0.1257657931787496 0.1257657931787496 -35.089 26.2851 25.9071 0.11533927875516994 0.11533927875516994 0.11533927875516994 -36.089 25.2851 26.9071 0.08559230727378928 0.08559230727378928 0.08559230727378928 -36.089 26.2851 25.9071 0.10465590159852338 0.10465590159852338 0.10465590159852338 -36.089 26.2851 26.9071 0.09626294796952492 0.09626294796952492 0.09626294796952492 -37.089 20.2851 19.9071 0.10822495172900068 0.10822495172900068 0.10822495172900068 -37.089 20.2851 20.9071 0.14708617407305055 0.14708617407305055 0.14708617407305055 -37.089 20.2851 21.9071 0.1291877154324855 0.1291877154324855 0.1291877154324855 -37.089 21.2851 19.9071 0.13935462483597305 0.13935462483597305 0.13935462483597305 -37.089 21.2851 20.9071 0.16515809109927143 0.16515809109927143 0.16515809109927143 -37.089 22.2851 19.9071 0.11175045859173385 0.11175045859173385 0.11175045859173385 -37.089 22.2851 20.9071 0.11787875233748504 0.11787875233748504 0.11787875233748504 -38.089 21.2851 20.9071 0.09769170023704397 0.09769170023704397 0.09769170023704397 -38.089 22.2851 20.9071 0.10677308573863761 0.10677308573863761 0.10677308573863761 -37.089 21.2851 21.9071 0.1452977120160264 0.1452977120160264 0.1452977120160264 -37.089 21.2851 22.9071 0.11498659006778894 0.11498659006778894 0.11498659006778894 -37.089 22.2851 21.9071 0.10528182255885629 0.10528182255885629 0.10528182255885629 -37.089 22.2851 22.9071 0.11046818181149215 0.11046818181149215 0.11046818181149215 -38.089 21.2851 22.9071 0.09682866618730226 0.09682866618730226 0.09682866618730226 -38.089 22.2851 21.9071 0.13556688238369485 0.13556688238369485 0.13556688238369485 -38.089 22.2851 22.9071 0.12030166158273778 0.12030166158273778 0.12030166158273778 -39.089 22.2851 22.9071 0.10215136553935089 0.10215136553935089 0.10215136553935089 -37.089 21.2851 23.9071 0.11771968611447654 0.11771968611447654 0.11771968611447654 -37.089 21.2851 24.9071 0.0685589423103924 0.0685589423103924 0.0685589423103924 -37.089 22.2851 24.9071 0.10952815389597945 0.10952815389597945 0.10952815389597945 -38.089 21.2851 23.9071 0.10938433669061176 0.10938433669061176 0.10938433669061176 -38.089 21.2851 24.9071 0.054198611584719364 0.054198611584719364 0.054198611584719364 -38.089 22.2851 24.9071 0.0909310190600155 0.0909310190600155 0.0909310190600155 -39.089 21.2851 23.9071 0.08221594975703848 0.08221594975703848 0.08221594975703848 -39.089 22.2851 23.9071 0.11316527786549463 0.11316527786549463 0.11316527786549463 -39.089 22.2851 24.9071 0.10198423299203754 0.10198423299203754 0.10198423299203754 -37.089 23.2851 19.9071 0.10742630815632943 0.10742630815632943 0.10742630815632943 -37.089 23.2851 20.9071 0.08849436661367333 0.08849436661367333 0.08849436661367333 -37.089 24.2851 19.9071 0.0680468036433621 0.0680468036433621 0.0680468036433621 -38.089 23.2851 19.9071 0.09628544820187905 0.09628544820187905 0.09628544820187905 -38.089 23.2851 20.9071 0.16958672151453397 0.16958672151453397 0.16958672151453397 -38.089 24.2851 19.9071 0.07260400777996609 0.07260400777996609 0.07260400777996609 -38.089 24.2851 20.9071 0.09735259485236768 0.09735259485236768 0.09735259485236768 -38.089 23.2851 21.9071 0.17610959555492833 0.17610959555492833 0.17610959555492833 -38.089 23.2851 22.9071 0.15796626597105579 0.15796626597105579 0.15796626597105579 -38.089 24.2851 22.9071 0.1824545399969805 0.1824545399969805 0.1824545399969805 -37.089 25.2851 19.9071 0.07230201347423262 0.07230201347423262 0.07230201347423262 -38.089 25.2851 19.9071 0.075915501528228 0.075915501528228 0.075915501528228 -37.089 25.2851 22.9071 0.06504609268447129 0.06504609268447129 0.06504609268447129 -37.089 26.2851 22.9071 0.0736317605836578 0.0736317605836578 0.0736317605836578 -38.089 25.2851 22.9071 0.0974417909570197 0.0974417909570197 0.0974417909570197 -38.089 26.2851 22.9071 0.0938208317747692 0.0938208317747692 0.0938208317747692 -39.089 23.2851 20.9071 0.12163599788438549 0.12163599788438549 0.12163599788438549 -39.089 24.2851 20.9071 0.10885084492340781 0.10885084492340781 0.10885084492340781 -39.089 23.2851 21.9071 0.14470422614929415 0.14470422614929415 0.14470422614929415 -39.089 23.2851 22.9071 0.09716214878447164 0.09716214878447164 0.09716214878447164 -39.089 24.2851 21.9071 0.13095806127412957 0.13095806127412957 0.13095806127412957 -39.089 24.2851 22.9071 0.1677923366451302 0.1677923366451302 0.1677923366451302 -39.089 25.2851 19.9071 0.09883596946969239 0.09883596946969239 0.09883596946969239 -39.089 25.2851 20.9071 0.08975770618377954 0.08975770618377954 0.08975770618377954 -39.089 26.2851 19.9071 0.12391419944616922 0.12391419944616922 0.12391419944616922 -39.089 26.2851 20.9071 0.0759352745899524 0.0759352745899524 0.0759352745899524 -39.089 25.2851 21.9071 0.10916740522409756 0.10916740522409756 0.10916740522409756 -39.089 25.2851 22.9071 0.10186691859279035 0.10186691859279035 0.10186691859279035 -39.089 26.2851 21.9071 0.09637544906835249 0.09637544906835249 0.09637544906835249 -39.089 26.2851 22.9071 0.10601861929795245 0.10601861929795245 0.10601861929795245 -40.089 26.2851 22.9071 0.09279622985547528 0.09279622985547528 0.09279622985547528 -37.089 23.2851 24.9071 0.08347376196471626 0.08347376196471626 0.08347376196471626 -38.089 23.2851 24.9071 0.08158583068927872 0.08158583068927872 0.08158583068927872 -38.089 24.2851 23.9071 0.18809826224914258 0.18809826224914258 0.18809826224914258 -38.089 24.2851 24.9071 0.12995561977389702 0.12995561977389702 0.12995561977389702 -37.089 23.2851 25.9071 0.11533927875516994 0.11533927875516994 0.11533927875516994 -37.089 23.2851 26.9071 0.062496027426409986 0.062496027426409986 0.062496027426409986 -37.089 24.2851 25.9071 0.12673454931852343 0.12673454931852343 0.12673454931852343 -37.089 24.2851 26.9071 0.0956120456668723 0.0956120456668723 0.0956120456668723 -38.089 23.2851 25.9071 0.09942979378769978 0.09942979378769978 0.09942979378769978 -38.089 24.2851 25.9071 0.1488456864061905 0.1488456864061905 0.1488456864061905 -38.089 24.2851 26.9071 0.10286247850598447 0.10286247850598447 0.10286247850598447 -37.089 25.2851 23.9071 0.08411994027068126 0.08411994027068126 0.08411994027068126 -37.089 25.2851 24.9071 0.08156011143882351 0.08156011143882351 0.08156011143882351 -37.089 26.2851 23.9071 0.07444086754630827 0.07444086754630827 0.07444086754630827 -37.089 26.2851 24.9071 0.1020951190477692 0.1020951190477692 0.1020951190477692 -38.089 25.2851 23.9071 0.13804628357638551 0.13804628357638551 0.13804628357638551 -38.089 25.2851 24.9071 0.12820693991947027 0.12820693991947027 0.12820693991947027 -38.089 26.2851 24.9071 0.16004109762446958 0.16004109762446958 0.16004109762446958 -37.089 25.2851 25.9071 0.13046487446869914 0.13046487446869914 0.13046487446869914 -37.089 25.2851 26.9071 0.09376136503967193 0.09376136503967193 0.09376136503967193 -37.089 26.2851 25.9071 0.11784420767941835 0.11784420767941835 0.11784420767941835 -37.089 26.2851 26.9071 0.09846151236900673 0.09846151236900673 0.09846151236900673 -38.089 25.2851 25.9071 0.14313255163017355 0.14313255163017355 0.14313255163017355 -38.089 25.2851 26.9071 0.10277891301435267 0.10277891301435267 0.10277891301435267 -38.089 26.2851 25.9071 0.18328775843495837 0.18328775843495837 0.18328775843495837 -38.089 26.2851 26.9071 0.127179562739755 0.127179562739755 0.127179562739755 -39.089 23.2851 23.9071 0.08421316954809249 0.08421316954809249 0.08421316954809249 -39.089 23.2851 24.9071 0.08100151943967018 0.08100151943967018 0.08100151943967018 -39.089 24.2851 23.9071 0.1716058584240594 0.1716058584240594 0.1716058584240594 -40.089 24.2851 24.9071 0.13623834421936196 0.13623834421936196 0.13623834421936196 -39.089 24.2851 25.9071 0.11432298483830095 0.11432298483830095 0.11432298483830095 -39.089 24.2851 26.9071 0.11157129458065759 0.11157129458065759 0.11157129458065759 -40.089 24.2851 25.9071 0.11001343463579016 0.11001343463579016 0.11001343463579016 -40.089 24.2851 26.9071 0.1123474012740657 0.1123474012740657 0.1123474012740657 -39.089 25.2851 24.9071 0.13186811954379382 0.13186811954379382 0.13186811954379382 -39.089 26.2851 23.9071 0.08849275929879553 0.08849275929879553 0.08849275929879553 -39.089 26.2851 24.9071 0.13538134588829256 0.13538134588829256 0.13538134588829256 -40.089 25.2851 24.9071 0.09421379328426394 0.09421379328426394 0.09421379328426394 -40.089 26.2851 23.9071 0.09432227925248517 0.09432227925248517 0.09432227925248517 -40.089 26.2851 24.9071 0.07331256862277755 0.07331256862277755 0.07331256862277755 -39.089 25.2851 25.9071 0.13884382009881843 0.13884382009881843 0.13884382009881843 -39.089 25.2851 26.9071 0.09307186914498786 0.09307186914498786 0.09307186914498786 -41.089 26.2851 22.9071 0.09716777378026384 0.09716777378026384 0.09716777378026384 -41.089 24.2851 24.9071 0.09194037589748726 0.09194037589748726 0.09194037589748726 -41.089 24.2851 25.9071 0.09332018478090705 0.09332018478090705 0.09332018478090705 -41.089 24.2851 26.9071 0.09036686664841763 0.09036686664841763 0.09036686664841763 -42.089 24.2851 25.9071 0.05689453951493999 0.05689453951493999 0.05689453951493999 -42.089 24.2851 26.9071 0.09322857327629706 0.09322857327629706 0.09322857327629706 -41.089 25.2851 24.9071 0.076379363415676 0.076379363415676 0.076379363415676 -41.089 26.2851 23.9071 0.09959773518811997 0.09959773518811997 0.09959773518811997 -41.089 26.2851 24.9071 0.06854688446055805 0.06854688446055805 0.06854688446055805 -42.089 25.2851 24.9071 0.059925059221711166 0.059925059221711166 0.059925059221711166 -42.089 26.2851 23.9071 0.04218313906636217 0.04218313906636217 0.04218313906636217 -42.089 26.2851 24.9071 0.05531334998582975 0.05531334998582975 0.05531334998582975 -42.089 25.2851 25.9071 0.06703200221741083 0.06703200221741083 0.06703200221741083 -42.089 26.2851 25.9071 0.0707058538603777 0.0707058538603777 0.0707058538603777 -43.089 25.2851 25.9071 0.05914249743060123 0.05914249743060123 0.05914249743060123 -43.089 25.2851 26.9071 0.08570401960930092 0.08570401960930092 0.08570401960930092 -43.089 26.2851 25.9071 0.07382161931608898 0.07382161931608898 0.07382161931608898 -43.089 26.2851 26.9071 0.12421784767353392 0.12421784767353392 0.12421784767353392 -25.089 17.2851 27.9071 0.1962224080262417 0.1962224080262417 0.1962224080262417 -25.089 18.2851 27.9071 0.2649109564585937 0.2649109564585937 0.2649109564585937 -25.089 18.2851 28.9071 0.18162452384060718 0.18162452384060718 0.18162452384060718 -28.089 18.2851 30.9071 0.07095327393755346 0.07095327393755346 0.07095327393755346 -29.089 16.2851 28.9071 0.05651417891919826 0.05651417891919826 0.05651417891919826 -30.089 16.2851 27.9071 0.06886722072415151 0.06886722072415151 0.06886722072415151 -30.089 16.2851 28.9071 1.0 1.0 1.0 -30.089 16.2851 29.9071 0.0918519773173549 0.0918519773173549 0.0918519773173549 -30.089 16.2851 30.9071 0.07415447387027774 0.07415447387027774 0.07415447387027774 -29.089 17.2851 28.9071 0.08189124615986529 0.08189124615986529 0.08189124615986529 -29.089 18.2851 28.9071 0.07783860997921212 0.07783860997921212 0.07783860997921212 -30.089 17.2851 27.9071 0.07319706117201859 0.07319706117201859 0.07319706117201859 -30.089 18.2851 27.9071 0.07054058518482285 0.07054058518482285 0.07054058518482285 -30.089 18.2851 28.9071 0.07879170754651088 0.07879170754651088 0.07879170754651088 -29.089 17.2851 29.9071 0.07612014444418494 0.07612014444418494 0.07612014444418494 -29.089 17.2851 30.9071 0.0 0.0 0.0 -29.089 18.2851 29.9071 0.06112083495341769 0.06112083495341769 0.06112083495341769 -29.089 18.2851 30.9071 0.09857722462053087 0.09857722462053087 0.09857722462053087 -30.089 17.2851 29.9071 0.10882111711546029 0.10882111711546029 0.10882111711546029 -30.089 17.2851 30.9071 0.09331214868818036 0.09331214868818036 0.09331214868818036 -30.089 18.2851 29.9071 0.06133114300633931 0.06133114300633931 0.06133114300633931 -31.089 16.2851 27.9071 0.05867620468190841 0.05867620468190841 0.05867620468190841 -31.089 16.2851 28.9071 0.08443981268576292 0.08443981268576292 0.08443981268576292 -32.089 16.2851 27.9071 0.06234320262623178 0.06234320262623178 0.06234320262623178 -32.089 16.2851 28.9071 0.09713322022838448 0.09713322022838448 0.09713322022838448 -31.089 16.2851 29.9071 0.07988464530371484 0.07988464530371484 0.07988464530371484 -31.089 16.2851 30.9071 0.10559598644289384 0.10559598644289384 0.10559598644289384 -32.089 16.2851 29.9071 0.11040310330967458 0.11040310330967458 0.11040310330967458 -32.089 16.2851 30.9071 0.11533606519778371 0.11533606519778371 0.11533606519778371 -31.089 17.2851 27.9071 0.06139151803770321 0.06139151803770321 0.06139151803770321 -31.089 18.2851 27.9071 0.07163524268691213 0.07163524268691213 0.07163524268691213 -32.089 17.2851 27.9071 0.0617888183790506 0.0617888183790506 0.0617888183790506 -32.089 18.2851 27.9071 0.07030096107903053 0.07030096107903053 0.07030096107903053 -32.089 18.2851 28.9071 0.0800285152513612 0.0800285152513612 0.0800285152513612 -31.089 17.2851 30.9071 0.11853509802251169 0.11853509802251169 0.11853509802251169 -31.089 18.2851 30.9071 0.12393829855369635 0.12393829855369635 0.12393829855369635 -32.089 17.2851 30.9071 0.11533285164028696 0.11533285164028696 0.11533285164028696 -32.089 18.2851 30.9071 0.1294592138300913 0.1294592138300913 0.1294592138300913 -29.089 17.2851 31.9071 0.0942539732895558 0.0942539732895558 0.0942539732895558 -29.089 18.2851 31.9071 0.11615391140794275 0.11615391140794275 0.11615391140794275 -29.089 18.2851 32.9071 0.10097660922059248 0.10097660922059248 0.10097660922059248 -30.089 17.2851 31.9071 0.11038783797446841 0.11038783797446841 0.11038783797446841 -30.089 18.2851 31.9071 0.1462084111791121 0.1462084111791121 0.1462084111791121 -30.089 18.2851 32.9071 0.12537378903763183 0.12537378903763183 0.12537378903763183 -31.089 16.2851 31.9071 0.07675794218043695 0.07675794218043695 0.07675794218043695 -32.089 16.2851 31.9071 0.07606034311172816 0.07606034311172816 0.07606034311172816 -31.089 17.2851 31.9071 0.11670502901795914 0.11670502901795914 0.11670502901795914 -31.089 18.2851 31.9071 0.1600435064536547 0.1600435064536547 0.1600435064536547 -31.089 18.2851 32.9071 0.11491830164670552 0.11491830164670552 0.11491830164670552 -32.089 17.2851 31.9071 0.08965725051900791 0.08965725051900791 0.08965725051900791 -32.089 18.2851 31.9071 0.12042778582859535 0.12042778582859535 0.12042778582859535 -25.089 19.2851 27.9071 0.23244120334311788 0.23244120334311788 0.23244120334311788 -25.089 19.2851 28.9071 0.18583150970190151 0.18583150970190151 0.18583150970190151 -25.089 20.2851 27.9071 0.15850906765527337 0.15850906765527337 0.15850906765527337 -25.089 20.2851 30.9071 0.14461187003888945 0.14461187003888945 0.14461187003888945 -26.089 20.2851 30.9071 0.11636359362578794 0.11636359362578794 0.11636359362578794 -25.089 22.2851 27.9071 0.102655975162145 0.102655975162145 0.102655975162145 -25.089 22.2851 28.9071 0.15268419683775392 0.15268419683775392 0.15268419683775392 -26.089 22.2851 27.9071 0.11744814809802241 0.11744814809802241 0.11744814809802241 -26.089 22.2851 28.9071 0.17202011643174114 0.17202011643174114 0.17202011643174114 -25.089 21.2851 30.9071 0.10978043597039998 0.10978043597039998 0.10978043597039998 -25.089 22.2851 29.9071 0.20712956142689168 0.20712956142689168 0.20712956142689168 -25.089 22.2851 30.9071 0.11777592168379986 0.11777592168379986 0.11777592168379986 -26.089 21.2851 30.9071 0.10035145830435235 0.10035145830435235 0.10035145830435235 -26.089 22.2851 29.9071 0.19018034340831363 0.19018034340831363 0.19018034340831363 -26.089 22.2851 30.9071 0.1291459463669224 0.1291459463669224 0.1291459463669224 -27.089 20.2851 30.9071 0.11079277009626214 0.11079277009626214 0.11079277009626214 -28.089 19.2851 30.9071 0.05508726797557893 0.05508726797557893 0.05508726797557893 -28.089 20.2851 29.9071 0.11482591133768932 0.11482591133768932 0.11482591133768932 -28.089 20.2851 30.9071 0.09594231897484302 0.09594231897484302 0.09594231897484302 -27.089 21.2851 27.9071 0.07607561496162195 0.07607561496162195 0.07607561496162195 -27.089 21.2851 28.9071 0.08554328238692438 0.08554328238692438 0.08554328238692438 -27.089 22.2851 27.9071 0.10528503651784334 0.10528503651784334 0.10528503651784334 -28.089 21.2851 27.9071 0.11502675970018236 0.11502675970018236 0.11502675970018236 -28.089 21.2851 28.9071 0.12656746783165557 0.12656746783165557 0.12656746783165557 -28.089 22.2851 27.9071 0.10109874610742718 0.10109874610742718 0.10109874610742718 -27.089 21.2851 29.9071 0.09339893844710814 0.09339893844710814 0.09339893844710814 -27.089 21.2851 30.9071 0.18015070229117444 0.18015070229117444 0.18015070229117444 -27.089 22.2851 29.9071 0.11929266049792836 0.11929266049792836 0.11929266049792836 -27.089 22.2851 30.9071 0.1907140987908595 0.1907140987908595 0.1907140987908595 -28.089 21.2851 29.9071 0.09650402156007087 0.09650402156007087 0.09650402156007087 -28.089 21.2851 30.9071 0.10395203601107925 0.10395203601107925 0.10395203601107925 -28.089 22.2851 29.9071 0.08962671197206758 0.08962671197206758 0.08962671197206758 -28.089 22.2851 30.9071 0.1517342227112048 0.1517342227112048 0.1517342227112048 -25.089 20.2851 31.9071 0.1668120316311124 0.1668120316311124 0.1668120316311124 -25.089 20.2851 32.9071 0.1325323832909028 0.1325323832909028 0.1325323832909028 -26.089 20.2851 31.9071 0.12583648224682864 0.12583648224682864 0.12583648224682864 -26.089 20.2851 32.9071 0.11305521047831368 0.11305521047831368 0.11305521047831368 -25.089 21.2851 31.9071 0.1349219203439446 0.1349219203439446 0.1349219203439446 -25.089 21.2851 32.9071 0.15628082734276183 0.15628082734276183 0.15628082734276183 -25.089 22.2851 31.9071 0.13031788172526385 0.13031788172526385 0.13031788172526385 -25.089 22.2851 32.9071 0.13666081613850392 0.13666081613850392 0.13666081613850392 -26.089 22.2851 32.9071 0.12684218816956455 0.12684218816956455 0.12684218816956455 -25.089 21.2851 33.9071 0.10971455346676577 0.10971455346676577 0.10971455346676577 -25.089 21.2851 34.9071 0.1167516247944101 0.1167516247944101 0.1167516247944101 -25.089 22.2851 33.9071 0.12056836994605404 0.12056836994605404 0.12056836994605404 -25.089 22.2851 34.9071 0.1002703008240177 0.1002703008240177 0.1002703008240177 -26.089 21.2851 33.9071 0.1171999069201463 0.1171999069201463 0.1171999069201463 -26.089 21.2851 34.9071 0.05240141011211932 0.05240141011211932 0.05240141011211932 -26.089 22.2851 33.9071 0.11710591248783357 0.11710591248783357 0.11710591248783357 -26.089 22.2851 34.9071 0.04950407890206114 0.04950407890206114 0.04950407890206114 -27.089 19.2851 32.9071 0.06591959665819366 0.06591959665819366 0.06591959665819366 -27.089 20.2851 31.9071 0.09064572880498448 0.09064572880498448 0.09064572880498448 -27.089 20.2851 32.9071 0.0857602775612608 0.0857602775612608 0.0857602775612608 -28.089 19.2851 31.9071 0.07072281478014204 0.07072281478014204 0.07072281478014204 -28.089 19.2851 32.9071 0.08439159079505482 0.08439159079505482 0.08439159079505482 -28.089 20.2851 31.9071 0.05300739623378735 0.05300739623378735 0.05300739623378735 -27.089 20.2851 33.9071 0.0390031025875359 0.0390031025875359 0.0390031025875359 -27.089 20.2851 34.9071 0.03862177282611327 0.03862177282611327 0.03862177282611327 -28.089 19.2851 33.9071 0.07187550587751693 0.07187550587751693 0.07187550587751693 -28.089 20.2851 33.9071 0.06298705853864016 0.06298705853864016 0.06298705853864016 -28.089 20.2851 34.9071 0.04972430707513905 0.04972430707513905 0.04972430707513905 -27.089 21.2851 31.9071 0.18085630976771908 0.18085630976771908 0.18085630976771908 -27.089 21.2851 32.9071 0.0961030354226324 0.0961030354226324 0.0961030354226324 -27.089 21.2851 33.9071 0.11345209509397211 0.11345209509397211 0.11345209509397211 -26.089 24.2851 27.9071 0.07175002893773756 0.07175002893773756 0.07175002893773756 -25.089 23.2851 29.9071 0.1881921737778976 0.1881921737778976 0.1881921737778976 -25.089 23.2851 30.9071 0.16169353749823817 0.16169353749823817 0.16169353749823817 -25.089 24.2851 29.9071 0.11127241919891864 0.11127241919891864 0.11127241919891864 -25.089 25.2851 27.9071 0.0 0.0 0.0 -25.089 25.2851 28.9071 0.1257368749057218 0.1257368749057218 0.1257368749057218 -25.089 26.2851 27.9071 0.8080651292532584 0.8080651292532584 0.8080651292532584 -25.089 26.2851 28.9071 0.3765962107896212 0.3765962107896212 0.3765962107896212 -26.089 25.2851 27.9071 0.02380214927610704 0.02380214927610704 0.02380214927610704 -26.089 25.2851 28.9071 0.1437686136930043 0.1437686136930043 0.1437686136930043 -26.089 26.2851 27.9071 0.19900330680184544 0.19900330680184544 0.19900330680184544 -26.089 26.2851 28.9071 0.13572270058173116 0.13572270058173116 0.13572270058173116 -25.089 26.2851 29.9071 0.22243608522282435 0.22243608522282435 0.22243608522282435 -25.089 26.2851 30.9071 0.19347030707327834 0.19347030707327834 0.19347030707327834 -27.089 24.2851 27.9071 0.18378463507246762 0.18378463507246762 0.18378463507246762 -27.089 24.2851 28.9071 0.2905146652352935 0.2905146652352935 0.2905146652352935 -28.089 24.2851 27.9071 0.15543046639184369 0.15543046639184369 0.15543046639184369 -28.089 24.2851 28.9071 0.09922569228368623 0.09922569228368623 0.09922569228368623 -27.089 24.2851 29.9071 0.24904064877984633 0.24904064877984633 0.24904064877984633 -28.089 23.2851 29.9071 0.058930816936715584 0.058930816936715584 0.058930816936715584 -28.089 23.2851 30.9071 0.08885279703159626 0.08885279703159626 0.08885279703159626 -28.089 24.2851 29.9071 0.06291036527163232 0.06291036527163232 0.06291036527163232 -27.089 25.2851 27.9071 0.1721060185035248 0.1721060185035248 0.1721060185035248 -27.089 25.2851 28.9071 0.2322743412363207 0.2322743412363207 0.2322743412363207 -27.089 26.2851 27.9071 0.1015109567316618 0.1015109567316618 0.1015109567316618 -27.089 26.2851 28.9071 0.16597783966121546 0.16597783966121546 0.16597783966121546 -28.089 25.2851 28.9071 0.17175197292606012 0.17175197292606012 0.17175197292606012 -28.089 26.2851 27.9071 0.14573700117091934 0.14573700117091934 0.14573700117091934 -28.089 26.2851 28.9071 0.19253766941217393 0.19253766941217393 0.19253766941217393 -27.089 25.2851 29.9071 0.15344464986824213 0.15344464986824213 0.15344464986824213 -27.089 25.2851 30.9071 0.05182661555532443 0.05182661555532443 0.05182661555532443 -28.089 25.2851 29.9071 0.08471387321576053 0.08471387321576053 0.08471387321576053 -28.089 25.2851 30.9071 0.04918607768335213 0.04918607768335213 0.04918607768335213 -28.089 26.2851 29.9071 0.14673362452805716 0.14673362452805716 0.14673362452805716 -28.089 26.2851 30.9071 0.13705437163387751 0.13705437163387751 0.13705437163387751 -25.089 23.2851 31.9071 0.12171633048946827 0.12171633048946827 0.12171633048946827 -25.089 23.2851 32.9071 0.09683348763229632 0.09683348763229632 0.09683348763229632 -25.089 24.2851 31.9071 0.13351310607640832 0.13351310607640832 0.13351310607640832 -25.089 24.2851 32.9071 0.14222101452816277 0.14222101452816277 0.14222101452816277 -26.089 23.2851 31.9071 0.21136891597260696 0.21136891597260696 0.21136891597260696 -26.089 23.2851 32.9071 0.19303208108503805 0.19303208108503805 0.19303208108503805 -26.089 24.2851 31.9071 0.04378436763080692 0.04378436763080692 0.04378436763080692 -26.089 24.2851 32.9071 0.07918723409557077 0.07918723409557077 0.07918723409557077 -25.089 23.2851 33.9071 0.15580626440766782 0.15580626440766782 0.15580626440766782 -25.089 23.2851 34.9071 0.12877805635279935 0.12877805635279935 0.12877805635279935 -25.089 24.2851 33.9071 0.18944833026825017 0.18944833026825017 0.18944833026825017 -25.089 24.2851 34.9071 0.1611427279780167 0.1611427279780167 0.1611427279780167 -26.089 23.2851 33.9071 0.19268936422579494 0.19268936422579494 0.19268936422579494 -26.089 23.2851 34.9071 0.11718705298717323 0.11718705298717323 0.11718705298717323 -26.089 24.2851 33.9071 0.10621145484404484 0.10621145484404484 0.10621145484404484 -26.089 24.2851 34.9071 0.12063585023517728 0.12063585023517728 0.12063585023517728 -25.089 26.2851 32.9071 0.13974013569772328 0.13974013569772328 0.13974013569772328 -26.089 25.2851 32.9071 0.06774808807643878 0.06774808807643878 0.06774808807643878 -26.089 26.2851 32.9071 0.029320208712920907 0.029320208712920907 0.029320208712920907 -25.089 25.2851 33.9071 0.1667349555461286 0.1667349555461286 0.1667349555461286 -25.089 25.2851 34.9071 0.1906129664639597 0.1906129664639597 0.1906129664639597 -25.089 26.2851 33.9071 0.11039426548438006 0.11039426548438006 0.11039426548438006 -25.089 26.2851 34.9071 0.10487605920521333 0.10487605920521333 0.10487605920521333 -26.089 25.2851 33.9071 0.0628216132235922 0.0628216132235922 0.0628216132235922 -26.089 25.2851 34.9071 0.14568319440149705 0.14568319440149705 0.14568319440149705 -26.089 26.2851 33.9071 0.037459839766766596 0.037459839766766596 0.037459839766766596 -26.089 26.2851 34.9071 0.10619940263595716 0.10619940263595716 0.10619940263595716 -27.089 23.2851 32.9071 0.2815502051523235 0.2815502051523235 0.2815502051523235 -27.089 24.2851 32.9071 0.1479109251746921 0.1479109251746921 0.1479109251746921 -28.089 23.2851 31.9071 0.0867367486032031 0.0867367486032031 0.0867367486032031 -28.089 23.2851 32.9071 0.1488288222533652 0.1488288222533652 0.1488288222533652 -28.089 24.2851 31.9071 0.08253904460992603 0.08253904460992603 0.08253904460992603 -28.089 24.2851 32.9071 0.0460470045334268 0.0460470045334268 0.0460470045334268 -27.089 23.2851 33.9071 0.06889977678493506 0.06889977678493506 0.06889977678493506 -27.089 24.2851 33.9071 0.09320928663044678 0.09320928663044678 0.09320928663044678 -27.089 25.2851 31.9071 0.09039017216825827 0.09039017216825827 0.09039017216825827 -27.089 25.2851 32.9071 0.05234352079172946 0.05234352079172946 0.05234352079172946 -27.089 26.2851 31.9071 0.07047507245926454 0.07047507245926454 0.07047507245926454 -27.089 26.2851 32.9071 0.06568003917741354 0.06568003917741354 0.06568003917741354 -28.089 25.2851 31.9071 0.060386923072198576 0.060386923072198576 0.060386923072198576 -28.089 25.2851 32.9071 0.07183724387177279 0.07183724387177279 0.07183724387177279 -28.089 26.2851 31.9071 0.1661616998471522 0.1661616998471522 0.1661616998471522 -28.089 26.2851 32.9071 0.07479485933121596 0.07479485933121596 0.07479485933121596 -27.089 25.2851 33.9071 0.07060320404688356 0.07060320404688356 0.07060320404688356 -27.089 25.2851 34.9071 0.07985595165768548 0.07985595165768548 0.07985595165768548 -27.089 26.2851 34.9071 0.06251009597573359 0.06251009597573359 0.06251009597573359 -28.089 25.2851 34.9071 0.0814130293173558 0.0814130293173558 0.0814130293173558 -28.089 26.2851 34.9071 0.09413905842106675 0.09413905842106675 0.09413905842106675 -30.089 19.2851 28.9071 0.08862214804449173 0.08862214804449173 0.08862214804449173 -30.089 20.2851 28.9071 0.06420312743715806 0.06420312743715806 0.06420312743715806 -29.089 19.2851 29.9071 0.06818506773911304 0.06818506773911304 0.06818506773911304 -29.089 20.2851 29.9071 0.08252136283561794 0.08252136283561794 0.08252136283561794 -30.089 20.2851 29.9071 0.09831928249852953 0.09831928249852953 0.09831928249852953 -29.089 21.2851 27.9071 0.11043042021807857 0.11043042021807857 0.11043042021807857 -29.089 21.2851 28.9071 0.053393079862637825 0.053393079862637825 0.053393079862637825 -29.089 22.2851 28.9071 0.07410930025882134 0.07410930025882134 0.07410930025882134 -30.089 21.2851 27.9071 0.09161972967583502 0.09161972967583502 0.09161972967583502 -30.089 21.2851 28.9071 0.08204797206963539 0.08204797206963539 0.08204797206963539 -30.089 22.2851 28.9071 0.0973574162659639 0.0973574162659639 0.0973574162659639 -29.089 21.2851 29.9071 0.0 0.0 0.0 -29.089 21.2851 30.9071 0.10946548497774765 0.10946548497774765 0.10946548497774765 -29.089 22.2851 29.9071 0.08511089766494502 0.08511089766494502 0.08511089766494502 -29.089 22.2851 30.9071 0.09859731353611594 0.09859731353611594 0.09859731353611594 -30.089 21.2851 29.9071 0.10285283633830695 0.10285283633830695 0.10285283633830695 -30.089 21.2851 30.9071 0.1119248016634291 0.1119248016634291 0.1119248016634291 -30.089 22.2851 29.9071 0.09005907242546518 0.09005907242546518 0.09005907242546518 -30.089 22.2851 30.9071 0.13788243823634858 0.13788243823634858 0.13788243823634858 -31.089 19.2851 27.9071 0.07982211403955711 0.07982211403955711 0.07982211403955711 -31.089 19.2851 28.9071 0.1124422046841698 0.1124422046841698 0.1124422046841698 -31.089 20.2851 28.9071 0.11294996341983521 0.11294996341983521 0.11294996341983521 -32.089 19.2851 27.9071 0.09108612009811687 0.09108612009811687 0.09108612009811687 -32.089 19.2851 28.9071 0.12029121816499147 0.12029121816499147 0.12029121816499147 -32.089 20.2851 28.9071 0.10343538189500312 0.10343538189500312 0.10343538189500312 -31.089 20.2851 29.9071 0.1095442228414977 0.1095442228414977 0.1095442228414977 -31.089 20.2851 30.9071 0.09853945744562075 0.09853945744562075 0.09853945744562075 -32.089 19.2851 30.9071 0.13053234645772463 0.13053234645772463 0.13053234645772463 -32.089 20.2851 29.9071 0.10115740388849216 0.10115740388849216 0.10115740388849216 -32.089 20.2851 30.9071 0.11917778138732635 0.11917778138732635 0.11917778138732635 -31.089 21.2851 27.9071 0.10354305192225931 0.10354305192225931 0.10354305192225931 -31.089 21.2851 28.9071 0.1063898273126821 0.1063898273126821 0.1063898273126821 -31.089 22.2851 27.9071 0.10346993274034771 0.10346993274034771 0.10346993274034771 -31.089 22.2851 28.9071 0.10902840808809994 0.10902840808809994 0.10902840808809994 -32.089 21.2851 28.9071 0.07510890114813769 0.07510890114813769 0.07510890114813769 -32.089 22.2851 27.9071 0.08115262096741287 0.08115262096741287 0.08115262096741287 -32.089 22.2851 28.9071 0.05178142940542523 0.05178142940542523 0.05178142940542523 -31.089 21.2851 29.9071 0.11471745301345389 0.11471745301345389 0.11471745301345389 -31.089 21.2851 30.9071 0.12306911951056418 0.12306911951056418 0.12306911951056418 -31.089 22.2851 29.9071 0.09121550467316604 0.09121550467316604 0.09121550467316604 -31.089 22.2851 30.9071 0.12032254841418136 0.12032254841418136 0.12032254841418136 -32.089 21.2851 29.9071 0.09689295209671575 0.09689295209671575 0.09689295209671575 -32.089 21.2851 30.9071 0.10698279240647683 0.10698279240647683 0.10698279240647683 -32.089 22.2851 29.9071 0.07916617583207586 0.07916617583207586 0.07916617583207586 -32.089 22.2851 30.9071 0.11883715984340029 0.11883715984340029 0.11883715984340029 -29.089 19.2851 31.9071 0.08353404001125653 0.08353404001125653 0.08353404001125653 -29.089 19.2851 32.9071 0.13036928905406142 0.13036928905406142 0.13036928905406142 -30.089 19.2851 32.9071 0.16179791788609932 0.16179791788609932 0.16179791788609932 -30.089 20.2851 32.9071 0.12690082718453313 0.12690082718453313 0.12690082718453313 -29.089 19.2851 33.9071 0.09721920229514387 0.09721920229514387 0.09721920229514387 -29.089 20.2851 33.9071 0.1316167099476577 0.1316167099476577 0.1316167099476577 -29.089 20.2851 34.9071 0.04547867768331502 0.04547867768331502 0.04547867768331502 -30.089 19.2851 33.9071 0.10511308953164752 0.10511308953164752 0.10511308953164752 -30.089 20.2851 33.9071 0.1615353608062358 0.1615353608062358 0.1615353608062358 -29.089 22.2851 31.9071 0.16049475918148223 0.16049475918148223 0.16049475918148223 -30.089 21.2851 32.9071 0.10128757579783275 0.10128757579783275 0.10128757579783275 -30.089 22.2851 31.9071 0.12277430341410948 0.12277430341410948 0.12277430341410948 -30.089 22.2851 32.9071 0.15831876629825756 0.15831876629825756 0.15831876629825756 -29.089 21.2851 33.9071 0.14111992818608463 0.14111992818608463 0.14111992818608463 -29.089 21.2851 34.9071 0.0912709551416367 0.0912709551416367 0.0912709551416367 -29.089 22.2851 33.9071 0.19989493970945596 0.19989493970945596 0.19989493970945596 -29.089 22.2851 34.9071 0.14206360267012758 0.14206360267012758 0.14206360267012758 -30.089 21.2851 33.9071 0.1465368706934629 0.1465368706934629 0.1465368706934629 -30.089 22.2851 33.9071 0.1593593960677126 0.1593593960677126 0.1593593960677126 -30.089 22.2851 34.9071 0.1831537055693177 0.1831537055693177 0.1831537055693177 -31.089 19.2851 31.9071 0.13735154491591833 0.13735154491591833 0.13735154491591833 -31.089 19.2851 32.9071 0.1471239184658176 0.1471239184658176 0.1471239184658176 -31.089 20.2851 31.9071 0.1167492146687007 0.1167492146687007 0.1167492146687007 -31.089 20.2851 32.9071 0.1525243963957962 0.1525243963957962 0.1525243963957962 -32.089 19.2851 31.9071 0.12604212281900362 0.12604212281900362 0.12604212281900362 -32.089 20.2851 31.9071 0.12333581869983665 0.12333581869983665 0.12333581869983665 -32.089 20.2851 32.9071 0.06552239710377555 0.06552239710377555 0.06552239710377555 -31.089 20.2851 33.9071 0.010703798279541784 0.010703798279541784 0.010703798279541784 -31.089 20.2851 34.9071 0.13201109334070255 0.13201109334070255 0.13201109334070255 -32.089 20.2851 33.9071 0.08791974949512378 0.08791974949512378 0.08791974949512378 -32.089 20.2851 34.9071 0.11224456355036505 0.11224456355036505 0.11224456355036505 -31.089 21.2851 31.9071 0.1080465833289185 0.1080465833289185 0.1080465833289185 -31.089 21.2851 32.9071 0.169985735887519 0.169985735887519 0.169985735887519 -31.089 22.2851 31.9071 0.11996184814016453 0.11996184814016453 0.11996184814016453 -31.089 22.2851 32.9071 0.17912398820872405 0.17912398820872405 0.17912398820872405 -32.089 21.2851 31.9071 0.1258509413667405 0.1258509413667405 0.1258509413667405 -32.089 21.2851 32.9071 0.16015591840192359 0.16015591840192359 0.16015591840192359 -32.089 22.2851 31.9071 0.1378936825350569 0.1378936825350569 0.1378936825350569 -32.089 22.2851 32.9071 0.15083241948087472 0.15083241948087472 0.15083241948087472 -31.089 21.2851 33.9071 0.15961955140695758 0.15961955140695758 0.15961955140695758 -31.089 21.2851 34.9071 0.1751623063649763 0.1751623063649763 0.1751623063649763 -31.089 22.2851 33.9071 0.14367384718929457 0.14367384718929457 0.14367384718929457 -31.089 22.2851 34.9071 0.16843542951506887 0.16843542951506887 0.16843542951506887 -29.089 23.2851 28.9071 0.07158998727830931 0.07158998727830931 0.07158998727830931 -29.089 24.2851 27.9071 0.17695652686992472 0.17695652686992472 0.17695652686992472 -29.089 24.2851 28.9071 0.0723633448556346 0.0723633448556346 0.0723633448556346 -30.089 23.2851 28.9071 0.06533943222917042 0.06533943222917042 0.06533943222917042 -30.089 24.2851 27.9071 0.09220235657359725 0.09220235657359725 0.09220235657359725 -30.089 24.2851 28.9071 0.08406368117167828 0.08406368117167828 0.08406368117167828 -29.089 23.2851 29.9071 0.06826191675006583 0.06826191675006583 0.06826191675006583 -29.089 23.2851 30.9071 0.08101196795869113 0.08101196795869113 0.08101196795869113 -29.089 24.2851 29.9071 0.08072744626353372 0.08072744626353372 0.08072744626353372 -30.089 23.2851 29.9071 0.07937450772317774 0.07937450772317774 0.07937450772317774 -30.089 23.2851 30.9071 0.10449680923040205 0.10449680923040205 0.10449680923040205 -29.089 25.2851 27.9071 0.19146375826607762 0.19146375826607762 0.19146375826607762 -29.089 25.2851 28.9071 0.14410993280247408 0.14410993280247408 0.14410993280247408 -29.089 26.2851 27.9071 0.15650485861867822 0.15650485861867822 0.15650485861867822 -29.089 26.2851 28.9071 0.1591602642519888 0.1591602642519888 0.1591602642519888 -30.089 25.2851 27.9071 0.20152489295603557 0.20152489295603557 0.20152489295603557 -30.089 25.2851 28.9071 0.11118886244200248 0.11118886244200248 0.11118886244200248 -29.089 25.2851 29.9071 0.09581937067554058 0.09581937067554058 0.09581937067554058 -29.089 25.2851 30.9071 0.07903918313379579 0.07903918313379579 0.07903918313379579 -29.089 26.2851 29.9071 0.2304629024408808 0.2304629024408808 0.2304629024408808 -29.089 26.2851 30.9071 0.2455011007188388 0.2455011007188388 0.2455011007188388 -31.089 23.2851 27.9071 0.09951657694746958 0.09951657694746958 0.09951657694746958 -31.089 23.2851 28.9071 0.10325137830595303 0.10325137830595303 0.10325137830595303 -31.089 24.2851 27.9071 0.08627383047557491 0.08627383047557491 0.08627383047557491 -31.089 24.2851 28.9071 0.12047678946314744 0.12047678946314744 0.12047678946314744 -32.089 23.2851 27.9071 0.09792875173061058 0.09792875173061058 0.09792875173061058 -32.089 23.2851 28.9071 0.08221193115617796 0.08221193115617796 0.08221193115617796 -32.089 24.2851 27.9071 0.09384654710606916 0.09384654710606916 0.09384654710606916 -31.089 23.2851 29.9071 0.08601584890489625 0.08601584890489625 0.08601584890489625 -31.089 23.2851 30.9071 0.10237152999963663 0.10237152999963663 0.10237152999963663 -31.089 24.2851 29.9071 0.09941372282190292 0.09941372282190292 0.09941372282190292 -31.089 24.2851 30.9071 0.2275587391927091 0.2275587391927091 0.2275587391927091 -32.089 23.2851 29.9071 0.06512784842829786 0.06512784842829786 0.06512784842829786 -32.089 23.2851 30.9071 0.10599853223531866 0.10599853223531866 0.10599853223531866 -32.089 24.2851 29.9071 0.14158975899360907 0.14158975899360907 0.14158975899360907 -32.089 24.2851 30.9071 0.27301532265070083 0.27301532265070083 0.27301532265070083 -31.089 25.2851 27.9071 0.09803964337593195 0.09803964337593195 0.09803964337593195 -32.089 25.2851 27.9071 0.10906134962758918 0.10906134962758918 0.10906134962758918 -32.089 26.2851 27.9071 0.11426835365546908 0.11426835365546908 0.11426835365546908 -32.089 25.2851 30.9071 0.2523097599148679 0.2523097599148679 0.2523097599148679 -32.089 26.2851 30.9071 0.10739175900999871 0.10739175900999871 0.10739175900999871 -29.089 23.2851 31.9071 0.1407657462251035 0.1407657462251035 0.1407657462251035 -29.089 23.2851 32.9071 0.23463284081412802 0.23463284081412802 0.23463284081412802 -29.089 24.2851 31.9071 0.08198126312996744 0.08198126312996744 0.08198126312996744 -29.089 24.2851 32.9071 0.1157988161375111 0.1157988161375111 0.1157988161375111 -30.089 23.2851 31.9071 0.0907694886454883 0.0907694886454883 0.0907694886454883 -30.089 23.2851 32.9071 0.1476692025046779 0.1476692025046779 0.1476692025046779 -30.089 24.2851 31.9071 0.12526373835137525 0.12526373835137525 0.12526373835137525 -30.089 24.2851 32.9071 0.15301343292863184 0.15301343292863184 0.15301343292863184 -29.089 23.2851 33.9071 0.17012462775023854 0.17012462775023854 0.17012462775023854 -29.089 23.2851 34.9071 0.23811751772802991 0.23811751772802991 0.23811751772802991 -29.089 24.2851 33.9071 0.12781896399612044 0.12781896399612044 0.12781896399612044 -29.089 24.2851 34.9071 0.10229439215511427 0.10229439215511427 0.10229439215511427 -30.089 23.2851 33.9071 0.1280583365259961 0.1280583365259961 0.1280583365259961 -30.089 23.2851 34.9071 0.17271054170455413 0.17271054170455413 0.17271054170455413 -30.089 24.2851 33.9071 0.15203375084440363 0.15203375084440363 0.15203375084440363 -30.089 24.2851 34.9071 0.13335005471376027 0.13335005471376027 0.13335005471376027 -29.089 25.2851 31.9071 0.1061383380872188 0.1061383380872188 0.1061383380872188 -29.089 25.2851 32.9071 0.15314592999962412 0.15314592999962412 0.15314592999962412 -29.089 26.2851 31.9071 0.1754456915037587 0.1754456915037587 0.1754456915037587 -29.089 25.2851 33.9071 0.09941613346697889 0.09941613346697889 0.09941613346697889 -29.089 25.2851 34.9071 0.11052763619923568 0.11052763619923568 0.11052763619923568 -29.089 26.2851 34.9071 0.13810491442582362 0.13810491442582362 0.13810491442582362 -30.089 25.2851 34.9071 0.11518101090218227 0.11518101090218227 0.11518101090218227 -30.089 26.2851 34.9071 0.09758643307866559 0.09758643307866559 0.09758643307866559 -31.089 23.2851 32.9071 0.1672455832333394 0.1672455832333394 0.1672455832333394 -31.089 24.2851 31.9071 0.1956750451995432 0.1956750451995432 0.1956750451995432 -31.089 24.2851 32.9071 0.17454415401531762 0.17454415401531762 0.17454415401531762 -32.089 23.2851 31.9071 0.1591723085290384 0.1591723085290384 0.1591723085290384 -32.089 23.2851 32.9071 0.15964926045083877 0.15964926045083877 0.15964926045083877 -32.089 24.2851 31.9071 0.2062099218134777 0.2062099218134777 0.2062099218134777 -31.089 25.2851 31.9071 0.08364254038120754 0.08364254038120754 0.08364254038120754 -32.089 25.2851 31.9071 0.13910886069744882 0.13910886069744882 0.13910886069744882 -32.089 25.2851 32.9071 0.08247153235984069 0.08247153235984069 0.08247153235984069 -32.089 26.2851 31.9071 0.08490997460557544 0.08490997460557544 0.08490997460557544 -32.089 26.2851 32.9071 0.07968234282478932 0.07968234282478932 0.07968234282478932 -32.089 25.2851 34.9071 0.09766678970054632 0.09766678970054632 0.09766678970054632 -32.089 26.2851 33.9071 0.11826597283847853 0.11826597283847853 0.11826597283847853 -32.089 26.2851 34.9071 0.12315668048645313 0.12315668048645313 0.12315668048645313 -25.089 21.2851 35.9071 0.08859321641755083 0.08859321641755083 0.08859321641755083 -25.089 21.2851 36.9071 0.09306624386280327 0.09306624386280327 0.09306624386280327 -26.089 21.2851 35.9071 0.05842866645043968 0.05842866645043968 0.05842866645043968 -26.089 21.2851 36.9071 0.08700758661990252 0.08700758661990252 0.08700758661990252 -25.089 21.2851 37.9071 0.08684444098015015 0.08684444098015015 0.08684444098015015 -25.089 22.2851 37.9071 0.13446329537446047 0.13446329537446047 0.13446329537446047 -26.089 21.2851 37.9071 0.07951251122900357 0.07951251122900357 0.07951251122900357 -26.089 22.2851 37.9071 0.1317588809659512 0.1317588809659512 0.1317588809659512 -27.089 20.2851 35.9071 0.032732885454336016 0.032732885454336016 0.032732885454336016 -28.089 20.2851 35.9071 0.06809961734053885 0.06809961734053885 0.06809961734053885 -27.089 21.2851 35.9071 0.06243340225407564 0.06243340225407564 0.06243340225407564 -27.089 21.2851 36.9071 0.11909664289569089 0.11909664289569089 0.11909664289569089 -28.089 21.2851 35.9071 0.08137525408428888 0.08137525408428888 0.08137525408428888 -28.089 21.2851 36.9071 0.15618607557599354 0.15618607557599354 0.15618607557599354 -28.089 22.2851 35.9071 0.1049644434763763 0.1049644434763763 0.1049644434763763 -28.089 22.2851 36.9071 0.17921951571682318 0.17921951571682318 0.17921951571682318 -27.089 22.2851 37.9071 0.14278159099067067 0.14278159099067067 0.14278159099067067 -28.089 22.2851 37.9071 0.15684371477533515 0.15684371477533515 0.15684371477533515 -25.089 24.2851 36.9071 0.06046868355070357 0.06046868355070357 0.06046868355070357 -26.089 24.2851 35.9071 0.07916786370835811 0.07916786370835811 0.07916786370835811 -26.089 24.2851 36.9071 0.06034841442078733 0.06034841442078733 0.06034841442078733 -25.089 23.2851 37.9071 0.13412675454811435 0.13412675454811435 0.13412675454811435 -25.089 24.2851 37.9071 0.0839808998544969 0.0839808998544969 0.0839808998544969 -26.089 23.2851 37.9071 0.11671627627681713 0.11671627627681713 0.11671627627681713 -26.089 23.2851 38.9071 0.09600740917487526 0.09600740917487526 0.09600740917487526 -26.089 24.2851 37.9071 0.1363291035829951 0.1363291035829951 0.1363291035829951 -26.089 24.2851 38.9071 0.11076786361583867 0.11076786361583867 0.11076786361583867 -25.089 25.2851 35.9071 0.15533169867330698 0.15533169867330698 0.15533169867330698 -25.089 25.2851 36.9071 0.10299586170704432 0.10299586170704432 0.10299586170704432 -25.089 26.2851 35.9071 0.14250371260205355 0.14250371260205355 0.14250371260205355 -25.089 26.2851 36.9071 0.12897646012834924 0.12897646012834924 0.12897646012834924 -26.089 25.2851 35.9071 0.12678997531204367 0.12678997531204367 0.12678997531204367 -26.089 25.2851 36.9071 0.09484863502163901 0.09484863502163901 0.09484863502163901 -26.089 26.2851 35.9071 0.15829628340777613 0.15829628340777613 0.15829628340777613 -26.089 26.2851 36.9071 0.12200874049463448 0.12200874049463448 0.12200874049463448 -26.089 25.2851 37.9071 0.1057590940625838 0.1057590940625838 0.1057590940625838 -26.089 25.2851 38.9071 0.10428950658171163 0.10428950658171163 0.10428950658171163 -27.089 24.2851 35.9071 0.11048344713145393 0.11048344713145393 0.11048344713145393 -28.089 24.2851 35.9071 0.037602820600174 0.037602820600174 0.037602820600174 -27.089 23.2851 37.9071 0.10937308840672343 0.10937308840672343 0.10937308840672343 -27.089 23.2851 38.9071 0.1197240582109344 0.1197240582109344 0.1197240582109344 -27.089 24.2851 38.9071 0.11176652709340205 0.11176652709340205 0.11176652709340205 -28.089 23.2851 37.9071 0.14144760534646553 0.14144760534646553 0.14144760534646553 -28.089 23.2851 38.9071 0.10340324156043416 0.10340324156043416 0.10340324156043416 -28.089 24.2851 38.9071 0.11752527141480615 0.11752527141480615 0.11752527141480615 -27.089 25.2851 35.9071 0.07008577303998664 0.07008577303998664 0.07008577303998664 -27.089 25.2851 36.9071 0.07827545446377286 0.07827545446377286 0.07827545446377286 -27.089 26.2851 35.9071 0.09122595186580731 0.09122595186580731 0.09122595186580731 -27.089 26.2851 36.9071 0.03638554538912785 0.03638554538912785 0.03638554538912785 -28.089 25.2851 35.9071 0.04868105217870062 0.04868105217870062 0.04868105217870062 -28.089 26.2851 35.9071 0.08277694446820345 0.08277694446820345 0.08277694446820345 -27.089 25.2851 37.9071 0.10392632390958192 0.10392632390958192 0.10392632390958192 -27.089 25.2851 38.9071 0.055100453430324346 0.055100453430324346 0.055100453430324346 -27.089 26.2851 37.9071 0.04505114336469153 0.04505114336469153 0.04505114336469153 -28.089 25.2851 37.9071 0.05100682871873337 0.05100682871873337 0.05100682871873337 -28.089 25.2851 38.9071 0.08993932970725194 0.08993932970725194 0.08993932970725194 -28.089 26.2851 37.9071 0.0453969823787869 0.0453969823787869 0.0453969823787869 -29.089 21.2851 35.9071 0.07375860105660742 0.07375860105660742 0.07375860105660742 -29.089 22.2851 35.9071 0.23414349794663028 0.23414349794663028 0.23414349794663028 -29.089 22.2851 36.9071 0.1592228944729609 0.1592228944729609 0.1592228944729609 -30.089 22.2851 35.9071 0.19365249922670497 0.19365249922670497 0.19365249922670497 -31.089 21.2851 35.9071 0.13905504949502387 0.13905504949502387 0.13905504949502387 -31.089 22.2851 35.9071 0.19551131717885092 0.19551131717885092 0.19551131717885092 -32.089 21.2851 35.9071 0.14616986327532772 0.14616986327532772 0.14616986327532772 -32.089 22.2851 35.9071 0.21974826630208114 0.21974826630208114 0.21974826630208114 -29.089 23.2851 35.9071 0.3011365219806441 0.3011365219806441 0.3011365219806441 -29.089 23.2851 36.9071 0.1372125964639236 0.1372125964639236 0.1372125964639236 -29.089 24.2851 35.9071 0.12159181491739725 0.12159181491739725 0.12159181491739725 -29.089 24.2851 36.9071 0.09768045031829159 0.09768045031829159 0.09768045031829159 -30.089 23.2851 35.9071 0.19926012377401703 0.19926012377401703 0.19926012377401703 -30.089 24.2851 35.9071 0.17040481927530077 0.17040481927530077 0.17040481927530077 -29.089 23.2851 37.9071 0.12115078724428954 0.12115078724428954 0.12115078724428954 -29.089 24.2851 37.9071 0.13813784406224563 0.13813784406224563 0.13813784406224563 -29.089 24.2851 38.9071 0.09732929134927573 0.09732929134927573 0.09732929134927573 -29.089 25.2851 35.9071 0.07143573286126523 0.07143573286126523 0.07143573286126523 -29.089 25.2851 36.9071 0.04402672426211621 0.04402672426211621 0.04402672426211621 -29.089 26.2851 35.9071 0.12457210249033097 0.12457210249033097 0.12457210249033097 -29.089 26.2851 36.9071 0.10114776151646493 0.10114776151646493 0.10114776151646493 -30.089 25.2851 35.9071 0.12565092331065378 0.12565092331065378 0.12565092331065378 -30.089 26.2851 35.9071 0.0908916410286634 0.0908916410286634 0.0908916410286634 -30.089 26.2851 36.9071 0.08136962798422834 0.08136962798422834 0.08136962798422834 -29.089 25.2851 37.9071 0.07618959109705634 0.07618959109705634 0.07618959109705634 -29.089 26.2851 37.9071 0.09978335422283259 0.09978335422283259 0.09978335422283259 -30.089 26.2851 37.9071 0.06984108336388427 0.06984108336388427 0.06984108336388427 -31.089 23.2851 35.9071 0.17488453979284405 0.17488453979284405 0.17488453979284405 -31.089 24.2851 35.9071 0.14929138059237412 0.14929138059237412 0.14929138059237412 -32.089 23.2851 35.9071 0.19342937397764126 0.19342937397764126 0.19342937397764126 -32.089 24.2851 35.9071 0.18588769768283972 0.18588769768283972 0.18588769768283972 -31.089 25.2851 35.9071 0.11263341800192507 0.11263341800192507 0.11263341800192507 -31.089 26.2851 35.9071 0.08196599240106323 0.08196599240106323 0.08196599240106323 -32.089 25.2851 35.9071 0.15975123465307312 0.15975123465307312 0.15975123465307312 -32.089 26.2851 35.9071 0.09245951468981278 0.09245951468981278 0.09245951468981278 -33.089 16.2851 28.9071 0.09347206678241034 0.09347206678241034 0.09347206678241034 -33.089 16.2851 29.9071 0.09962666285806615 0.09962666285806615 0.09962666285806615 -33.089 16.2851 30.9071 0.07719688233554182 0.07719688233554182 0.07719688233554182 -33.089 17.2851 27.9071 0.06484230588174213 0.06484230588174213 0.06484230588174213 -33.089 17.2851 28.9071 0.1101733195364973 0.1101733195364973 0.1101733195364973 -33.089 18.2851 27.9071 0.04807760646578778 0.04807760646578778 0.04807760646578778 -33.089 18.2851 28.9071 0.08618381830811114 0.08618381830811114 0.08618381830811114 -33.089 17.2851 29.9071 0.07865000552778752 0.07865000552778752 0.07865000552778752 -33.089 17.2851 30.9071 0.08937115209848598 0.08937115209848598 0.08937115209848598 -33.089 18.2851 29.9071 0.10855035252119533 0.10855035252119533 0.10855035252119533 -33.089 18.2851 30.9071 0.12423311038486716 0.12423311038486716 0.12423311038486716 -33.089 19.2851 28.9071 0.1008416156036232 0.1008416156036232 0.1008416156036232 -33.089 20.2851 28.9071 0.07029830840965334 0.07029830840965334 0.07029830840965334 -34.089 20.2851 28.9071 0.1462766730467693 0.1462766730467693 0.1462766730467693 -33.089 19.2851 29.9071 0.115702409911224 0.115702409911224 0.115702409911224 -33.089 19.2851 30.9071 0.12231078927418666 0.12231078927418666 0.12231078927418666 -33.089 20.2851 29.9071 0.10092277250763343 0.10092277250763343 0.10092277250763343 -33.089 20.2851 30.9071 0.12507094846514158 0.12507094846514158 0.12507094846514158 -34.089 20.2851 29.9071 0.10694020833807237 0.10694020833807237 0.10694020833807237 -34.089 20.2851 30.9071 0.12368043772850289 0.12368043772850289 0.12368043772850289 -33.089 21.2851 27.9071 0.06637025218729578 0.06637025218729578 0.06637025218729578 -33.089 21.2851 28.9071 0.07390521489024074 0.07390521489024074 0.07390521489024074 -33.089 22.2851 27.9071 0.10684780886687974 0.10684780886687974 0.10684780886687974 -33.089 22.2851 28.9071 0.06605778402154205 0.06605778402154205 0.06605778402154205 -34.089 21.2851 27.9071 0.08514384899878535 0.08514384899878535 0.08514384899878535 -34.089 21.2851 28.9071 0.10753879364622813 0.10753879364622813 0.10753879364622813 -34.089 21.2851 30.9071 0.0989910552692332 0.0989910552692332 0.0989910552692332 -34.089 22.2851 30.9071 0.07480466562098739 0.07480466562098739 0.07480466562098739 -35.089 20.2851 28.9071 0.09860615265739069 0.09860615265739069 0.09860615265739069 -35.089 20.2851 29.9071 0.12725667672858162 0.12725667672858162 0.12725667672858162 -35.089 21.2851 27.9071 0.10097018095825731 0.10097018095825731 0.10097018095825731 -35.089 21.2851 28.9071 0.1245174782665643 0.1245174782665643 0.1245174782665643 -35.089 22.2851 27.9071 0.061069624537721585 0.061069624537721585 0.061069624537721585 -36.089 21.2851 28.9071 0.08550390171847384 0.08550390171847384 0.08550390171847384 -36.089 22.2851 27.9071 0.061617743118484385 0.061617743118484385 0.061617743118484385 -36.089 22.2851 28.9071 0.05072364815481397 0.05072364815481397 0.05072364815481397 -35.089 21.2851 29.9071 0.12124558028145592 0.12124558028145592 0.12124558028145592 -35.089 21.2851 30.9071 0.08442936461190388 0.08442936461190388 0.08442936461190388 -36.089 21.2851 29.9071 0.10011923519708003 0.10011923519708003 0.10011923519708003 -36.089 21.2851 30.9071 0.09091414276321697 0.09091414276321697 0.09091414276321697 -36.089 22.2851 30.9071 0.10816469217860263 0.10816469217860263 0.10816469217860263 -33.089 19.2851 32.9071 0.04308029094023118 0.04308029094023118 0.04308029094023118 -33.089 20.2851 31.9071 0.10421719157861027 0.10421719157861027 0.10421719157861027 -33.089 20.2851 32.9071 0.050445290819881305 0.050445290819881305 0.050445290819881305 -34.089 19.2851 32.9071 0.0466695220646181 0.0466695220646181 0.0466695220646181 -34.089 20.2851 31.9071 0.09960737774591842 0.09960737774591842 0.09960737774591842 -33.089 19.2851 33.9071 0.04351692213990573 0.04351692213990573 0.04351692213990573 -33.089 19.2851 34.9071 0.03334304078091654 0.03334304078091654 0.03334304078091654 -33.089 20.2851 33.9071 0.19604985269834807 0.19604985269834807 0.19604985269834807 -33.089 20.2851 34.9071 0.05822590803316205 0.05822590803316205 0.05822590803316205 -34.089 19.2851 33.9071 0.04720977846693028 0.04720977846693028 0.04720977846693028 -34.089 19.2851 34.9071 0.038656914425509115 0.038656914425509115 0.038656914425509115 -34.089 20.2851 34.9071 0.039011385352267315 0.039011385352267315 0.039011385352267315 -33.089 21.2851 31.9071 0.07775686715076283 0.07775686715076283 0.07775686715076283 -33.089 21.2851 32.9071 0.07334705202582405 0.07334705202582405 0.07334705202582405 -33.089 22.2851 31.9071 0.1022927851158921 0.1022927851158921 0.1022927851158921 -34.089 21.2851 31.9071 0.07610310428408981 0.07610310428408981 0.07610310428408981 -34.089 22.2851 31.9071 0.10829083545243617 0.10829083545243617 0.10829083545243617 -33.089 21.2851 34.9071 0.11240765769173039 0.11240765769173039 0.11240765769173039 -34.089 21.2851 34.9071 0.09514757142139715 0.09514757142139715 0.09514757142139715 -34.089 22.2851 34.9071 0.20882195973454087 0.20882195973454087 0.20882195973454087 -35.089 19.2851 32.9071 0.08827416417493172 0.08827416417493172 0.08827416417493172 -35.089 20.2851 31.9071 0.10205815704616701 0.10205815704616701 0.10205815704616701 -35.089 20.2851 32.9071 0.13499581414001124 0.13499581414001124 0.13499581414001124 -35.089 19.2851 33.9071 0.04894011835657839 0.04894011835657839 0.04894011835657839 -35.089 20.2851 33.9071 0.11537864482252902 0.11537864482252902 0.11537864482252902 -35.089 20.2851 34.9071 0.0948647068993338 0.0948647068993338 0.0948647068993338 -35.089 21.2851 31.9071 0.0902374807086 0.0902374807086 0.0902374807086 -35.089 21.2851 32.9071 0.12942788713867517 0.12942788713867517 0.12942788713867517 -35.089 22.2851 31.9071 0.08274720702439148 0.08274720702439148 0.08274720702439148 -35.089 22.2851 32.9071 0.05859725622831771 0.05859725622831771 0.05859725622831771 -36.089 21.2851 32.9071 0.06257971516083137 0.06257971516083137 0.06257971516083137 -36.089 22.2851 31.9071 0.08643858462836743 0.08643858462836743 0.08643858462836743 -36.089 22.2851 32.9071 0.06736866304466177 0.06736866304466177 0.06736866304466177 -35.089 21.2851 33.9071 0.10676585446448872 0.10676585446448872 0.10676585446448872 -35.089 21.2851 34.9071 0.1140658965955798 0.1140658965955798 0.1140658965955798 -35.089 22.2851 33.9071 0.09590294339617897 0.09590294339617897 0.09590294339617897 -35.089 22.2851 34.9071 0.0960186593275716 0.0960186593275716 0.0960186593275716 -36.089 21.2851 33.9071 0.10441645942997191 0.10441645942997191 0.10441645942997191 -36.089 21.2851 34.9071 0.09134408541118079 0.09134408541118079 0.09134408541118079 -36.089 22.2851 34.9071 0.08950295037365691 0.08950295037365691 0.08950295037365691 -33.089 23.2851 29.9071 0.14636983032561718 0.14636983032561718 0.14636983032561718 -33.089 23.2851 30.9071 0.09270783221570308 0.09270783221570308 0.09270783221570308 -33.089 24.2851 29.9071 0.20842233546432648 0.20842233546432648 0.20842233546432648 -33.089 24.2851 30.9071 0.1989776250595348 0.1989776250595348 0.1989776250595348 -34.089 23.2851 29.9071 0.15175188928083816 0.15175188928083816 0.15175188928083816 -34.089 23.2851 30.9071 0.0643373786448148 0.0643373786448148 0.0643373786448148 -34.089 24.2851 29.9071 0.07274306785899592 0.07274306785899592 0.07274306785899592 -34.089 24.2851 30.9071 0.06400625205743272 0.06400625205743272 0.06400625205743272 -33.089 25.2851 27.9071 0.2370570496164033 0.2370570496164033 0.2370570496164033 -33.089 26.2851 27.9071 0.1856605374613902 0.1856605374613902 0.1856605374613902 -33.089 26.2851 28.9071 0.11424264485070262 0.11424264485070262 0.11424264485070262 -34.089 25.2851 27.9071 0.16075651672135713 0.16075651672135713 0.16075651672135713 -34.089 26.2851 27.9071 0.09773107494027149 0.09773107494027149 0.09773107494027149 -34.089 26.2851 28.9071 0.06953505945288341 0.06953505945288341 0.06953505945288341 -33.089 25.2851 29.9071 0.13518215471570016 0.13518215471570016 0.13518215471570016 -33.089 25.2851 30.9071 0.06995522910040108 0.06995522910040108 0.06995522910040108 -33.089 26.2851 29.9071 0.08928837624211618 0.08928837624211618 0.08928837624211618 -33.089 26.2851 30.9071 0.09705848807701227 0.09705848807701227 0.09705848807701227 -34.089 25.2851 30.9071 0.08544523252359217 0.08544523252359217 0.08544523252359217 -34.089 26.2851 29.9071 0.05607255316873403 0.05607255316873403 0.05607255316873403 -34.089 26.2851 30.9071 0.04816404300486588 0.04816404300486588 0.04816404300486588 -35.089 24.2851 28.9071 0.038912152949869355 0.038912152949869355 0.038912152949869355 -36.089 23.2851 28.9071 0.045280791571507155 0.045280791571507155 0.045280791571507155 -36.089 24.2851 27.9071 0.04683218634004503 0.04683218634004503 0.04683218634004503 -36.089 24.2851 28.9071 0.03481513103029158 0.03481513103029158 0.03481513103029158 -35.089 24.2851 29.9071 0.0650626528516945 0.0650626528516945 0.0650626528516945 -35.089 24.2851 30.9071 0.0885723213471827 0.0885723213471827 0.0885723213471827 -36.089 24.2851 29.9071 0.07383777577517221 0.07383777577517221 0.07383777577517221 -36.089 24.2851 30.9071 0.09183429758967313 0.09183429758967313 0.09183429758967313 -35.089 25.2851 27.9071 0.08869528072175477 0.08869528072175477 0.08869528072175477 -35.089 25.2851 28.9071 0.11734933374033714 0.11734933374033714 0.11734933374033714 -35.089 26.2851 27.9071 0.1023876003745957 0.1023876003745957 0.1023876003745957 -35.089 26.2851 28.9071 0.0732090379439384 0.0732090379439384 0.0732090379439384 -36.089 25.2851 27.9071 0.08356699199093098 0.08356699199093098 0.08356699199093098 -36.089 25.2851 28.9071 0.06529891622525716 0.06529891622525716 0.06529891622525716 -36.089 26.2851 27.9071 0.0901659567146814 0.0901659567146814 0.0901659567146814 -36.089 26.2851 28.9071 0.07395175508092088 0.07395175508092088 0.07395175508092088 -35.089 25.2851 29.9071 0.06999630544906459 0.06999630544906459 0.06999630544906459 -35.089 25.2851 30.9071 0.08252940000624458 0.08252940000624458 0.08252940000624458 -35.089 26.2851 29.9071 0.07079741063128361 0.07079741063128361 0.07079741063128361 -35.089 26.2851 30.9071 0.04625863852024419 0.04625863852024419 0.04625863852024419 -36.089 25.2851 29.9071 0.0562388163427603 0.0562388163427603 0.0562388163427603 -36.089 25.2851 30.9071 0.08673996330310837 0.08673996330310837 0.08673996330310837 -36.089 26.2851 29.9071 0.048032418210269885 0.048032418210269885 0.048032418210269885 -33.089 23.2851 31.9071 0.17336162336507946 0.17336162336507946 0.17336162336507946 -33.089 24.2851 31.9071 0.1796040328586352 0.1796040328586352 0.1796040328586352 -34.089 24.2851 31.9071 0.13580944460244343 0.13580944460244343 0.13580944460244343 -33.089 23.2851 34.9071 0.16531144332628597 0.16531144332628597 0.16531144332628597 -33.089 24.2851 34.9071 0.17791583640600728 0.17791583640600728 0.17791583640600728 -34.089 23.2851 34.9071 0.18780769767957262 0.18780769767957262 0.18780769767957262 -34.089 24.2851 33.9071 0.1320641060322872 0.1320641060322872 0.1320641060322872 -34.089 24.2851 34.9071 0.17463005339221233 0.17463005339221233 0.17463005339221233 -33.089 25.2851 31.9071 0.14980051291180568 0.14980051291180568 0.14980051291180568 -33.089 26.2851 31.9071 0.07382169969647927 0.07382169969647927 0.07382169969647927 -33.089 26.2851 32.9071 0.12571197305118523 0.12571197305118523 0.12571197305118523 -34.089 25.2851 31.9071 0.1493050324473994 0.1493050324473994 0.1493050324473994 -34.089 25.2851 32.9071 0.14875815338405513 0.14875815338405513 0.14875815338405513 -34.089 26.2851 32.9071 0.04108277349813165 0.04108277349813165 0.04108277349813165 -33.089 25.2851 33.9071 0.15371285439670856 0.15371285439670856 0.15371285439670856 -33.089 25.2851 34.9071 0.23451973067807297 0.23451973067807297 0.23451973067807297 -33.089 26.2851 33.9071 0.1380157633912647 0.1380157633912647 0.1380157633912647 -33.089 26.2851 34.9071 0.14641239352920515 0.14641239352920515 0.14641239352920515 -34.089 25.2851 33.9071 0.17494956615727736 0.17494956615727736 0.17494956615727736 -34.089 25.2851 34.9071 0.1796891240863525 0.1796891240863525 0.1796891240863525 -34.089 26.2851 33.9071 0.1353371704691841 0.1353371704691841 0.1353371704691841 -35.089 23.2851 31.9071 0.06832445699977686 0.06832445699977686 0.06832445699977686 -35.089 23.2851 32.9071 0.05093342056489341 0.05093342056489341 0.05093342056489341 -35.089 24.2851 31.9071 0.09819312358942224 0.09819312358942224 0.09819312358942224 -35.089 24.2851 32.9071 0.06921512777336795 0.06921512777336795 0.06921512777336795 -36.089 23.2851 31.9071 0.09214851398895635 0.09214851398895635 0.09214851398895635 -36.089 23.2851 32.9071 0.04309178972965056 0.04309178972965056 0.04309178972965056 -36.089 24.2851 31.9071 0.0818992833934214 0.0818992833934214 0.0818992833934214 -35.089 23.2851 33.9071 0.05521301210236297 0.05521301210236297 0.05521301210236297 -35.089 23.2851 34.9071 0.0659241787909789 0.0659241787909789 0.0659241787909789 -35.089 24.2851 33.9071 0.07985056657451775 0.07985056657451775 0.07985056657451775 -35.089 24.2851 34.9071 0.07988319856549196 0.07988319856549196 0.07988319856549196 -36.089 24.2851 34.9071 0.06880138509430374 0.06880138509430374 0.06880138509430374 -35.089 25.2851 31.9071 0.11267921272064722 0.11267921272064722 0.11267921272064722 -35.089 25.2851 32.9071 0.086985887465225 0.086985887465225 0.086985887465225 -35.089 26.2851 31.9071 0.11045130961236664 0.11045130961236664 0.11045130961236664 -35.089 26.2851 32.9071 0.10183879525247558 0.10183879525247558 0.10183879525247558 -36.089 26.2851 32.9071 0.10131489580144032 0.10131489580144032 0.10131489580144032 -35.089 25.2851 33.9071 0.08967010885110795 0.08967010885110795 0.08967010885110795 -35.089 25.2851 34.9071 0.09619223291260946 0.09619223291260946 0.09619223291260946 -35.089 26.2851 33.9071 0.09058947426909573 0.09058947426909573 0.09058947426909573 -36.089 25.2851 34.9071 0.09747955864720488 0.09747955864720488 0.09747955864720488 -36.089 26.2851 33.9071 0.09475140009304872 0.09475140009304872 0.09475140009304872 -36.089 26.2851 34.9071 0.08947964459680935 0.08947964459680935 0.08947964459680935 -37.089 22.2851 27.9071 0.05551426657344199 0.05551426657344199 0.05551426657344199 -37.089 22.2851 28.9071 0.08737566768550539 0.08737566768550539 0.08737566768550539 -37.089 21.2851 29.9071 0.07695084787226233 0.07695084787226233 0.07695084787226233 -37.089 22.2851 29.9071 0.12847281881965303 0.12847281881965303 0.12847281881965303 -37.089 22.2851 30.9071 0.11348583823009009 0.11348583823009009 0.11348583823009009 -37.089 22.2851 32.9071 0.06494817861645932 0.06494817861645932 0.06494817861645932 -38.089 22.2851 32.9071 0.0570899047528476 0.0570899047528476 0.0570899047528476 -37.089 21.2851 33.9071 0.07808552586525551 0.07808552586525551 0.07808552586525551 -37.089 21.2851 34.9071 0.08797841688555455 0.08797841688555455 0.08797841688555455 -37.089 22.2851 33.9071 0.09317633859977392 0.09317633859977392 0.09317633859977392 -37.089 22.2851 34.9071 0.10544091337467937 0.10544091337467937 0.10544091337467937 -38.089 21.2851 33.9071 0.0516925846772786 0.0516925846772786 0.0516925846772786 -38.089 21.2851 34.9071 0.06949952941459545 0.06949952941459545 0.06949952941459545 -38.089 22.2851 33.9071 0.09336518688531094 0.09336518688531094 0.09336518688531094 -38.089 22.2851 34.9071 0.11594583541017914 0.11594583541017914 0.11594583541017914 -39.089 22.2851 33.9071 0.04687407856929231 0.04687407856929231 0.04687407856929231 -39.089 22.2851 34.9071 0.0715224658398136 0.0715224658398136 0.0715224658398136 -37.089 23.2851 27.9071 0.07708282724993752 0.07708282724993752 0.07708282724993752 -37.089 23.2851 28.9071 0.057850055927952816 0.057850055927952816 0.057850055927952816 -37.089 24.2851 27.9071 0.06833337983348658 0.06833337983348658 0.06833337983348658 -37.089 24.2851 28.9071 0.07434441174906455 0.07434441174906455 0.07434441174906455 -38.089 24.2851 27.9071 0.09761134364004358 0.09761134364004358 0.09761134364004358 -38.089 24.2851 28.9071 0.09652491457056811 0.09652491457056811 0.09652491457056811 -37.089 23.2851 29.9071 0.10747612317840384 0.10747612317840384 0.10747612317840384 -37.089 23.2851 30.9071 0.10748656825975575 0.10748656825975575 0.10748656825975575 -37.089 24.2851 29.9071 0.07103679210892594 0.07103679210892594 0.07103679210892594 -37.089 24.2851 30.9071 0.0908016340274619 0.0908016340274619 0.0908016340274619 -38.089 24.2851 30.9071 0.0747690575303164 0.0747690575303164 0.0747690575303164 -37.089 25.2851 28.9071 0.08735236129242346 0.08735236129242346 0.08735236129242346 -37.089 26.2851 27.9071 0.16628614645943918 0.16628614645943918 0.16628614645943918 -37.089 26.2851 28.9071 0.051904043009391915 0.051904043009391915 0.051904043009391915 -38.089 25.2851 28.9071 0.08686774752036955 0.08686774752036955 0.08686774752036955 -37.089 25.2851 29.9071 0.03695602732466201 0.03695602732466201 0.03695602732466201 -38.089 25.2851 29.9071 0.05450187984681883 0.05450187984681883 0.05450187984681883 -39.089 24.2851 27.9071 0.11814546873293519 0.11814546873293519 0.11814546873293519 -39.089 24.2851 28.9071 0.08037645441324236 0.08037645441324236 0.08037645441324236 -40.089 24.2851 27.9071 0.12037155211283226 0.12037155211283226 0.12037155211283226 -39.089 25.2851 27.9071 0.12392223248281961 0.12392223248281961 0.12392223248281961 -39.089 25.2851 28.9071 0.11854232823892867 0.11854232823892867 0.11854232823892867 -40.089 25.2851 27.9071 0.11770843899589141 0.11770843899589141 0.11770843899589141 -40.089 25.2851 28.9071 0.17197355265355774 0.17197355265355774 0.17197355265355774 -40.089 26.2851 27.9071 0.11885483363822641 0.11885483363822641 0.11885483363822641 -40.089 26.2851 28.9071 0.15665662138661723 0.15665662138661723 0.15665662138661723 -39.089 25.2851 29.9071 0.07728891398161573 0.07728891398161573 0.07728891398161573 -39.089 25.2851 30.9071 0.08685810343558592 0.08685810343558592 0.08685810343558592 -39.089 26.2851 29.9071 0.13097653563968661 0.13097653563968661 0.13097653563968661 -40.089 26.2851 30.9071 0.05432234710330369 0.05432234710330369 0.05432234710330369 -37.089 23.2851 31.9071 0.10586274356039618 0.10586274356039618 0.10586274356039618 -37.089 23.2851 32.9071 0.05782778613313903 0.05782778613313903 0.05782778613313903 -38.089 23.2851 31.9071 0.08459492623822187 0.08459492623822187 0.08459492623822187 -38.089 23.2851 32.9071 0.054715421182205626 0.054715421182205626 0.054715421182205626 -38.089 24.2851 31.9071 0.11017492641829892 0.11017492641829892 0.11017492641829892 -38.089 24.2851 32.9071 0.09874516780062556 0.09874516780062556 0.09874516780062556 -37.089 24.2851 34.9071 0.07899650389716187 0.07899650389716187 0.07899650389716187 -38.089 23.2851 33.9071 0.05925633676710624 0.05925633676710624 0.05925633676710624 -38.089 23.2851 34.9071 0.08274559959469274 0.08274559959469274 0.08274559959469274 -38.089 24.2851 33.9071 0.0637071999260616 0.0637071999260616 0.0637071999260616 -38.089 24.2851 34.9071 0.07234123984152559 0.07234123984152559 0.07234123984152559 -37.089 26.2851 32.9071 0.08173693111962772 0.08173693111962772 0.08173693111962772 -38.089 25.2851 31.9071 0.1110217486678149 0.1110217486678149 0.1110217486678149 -38.089 25.2851 32.9071 0.10504961368218012 0.10504961368218012 0.10504961368218012 -38.089 26.2851 32.9071 0.08109877098741584 0.08109877098741584 0.08109877098741584 -37.089 25.2851 34.9071 0.08735155762358099 0.08735155762358099 0.08735155762358099 -37.089 26.2851 33.9071 0.07708347026708164 0.07708347026708164 0.07708347026708164 -37.089 26.2851 34.9071 0.08225693947441814 0.08225693947441814 0.08225693947441814 -38.089 25.2851 33.9071 0.072338104948113 0.072338104948113 0.072338104948113 -38.089 25.2851 34.9071 0.06207171882239188 0.06207171882239188 0.06207171882239188 -38.089 26.2851 33.9071 0.07208699155155764 0.07208699155155764 0.07208699155155764 -39.089 24.2851 31.9071 0.10731864332582557 0.10731864332582557 0.10731864332582557 -39.089 24.2851 32.9071 0.04527564540036814 0.04527564540036814 0.04527564540036814 -39.089 23.2851 33.9071 0.04008837874802218 0.04008837874802218 0.04008837874802218 -39.089 23.2851 34.9071 0.05788904815311264 0.05788904815311264 0.05788904815311264 -39.089 25.2851 31.9071 0.11405063195533433 0.11405063195533433 0.11405063195533433 -39.089 25.2851 32.9071 0.08320130463100447 0.08320130463100447 0.08320130463100447 -39.089 26.2851 31.9071 0.09342626112960828 0.09342626112960828 0.09342626112960828 -33.089 21.2851 35.9071 0.139360246882648 0.139360246882648 0.139360246882648 -33.089 22.2851 35.9071 0.2103907466643042 0.2103907466643042 0.2103907466643042 -35.089 22.2851 35.9071 0.0726777980714823 0.0726777980714823 0.0726777980714823 -36.089 22.2851 35.9071 0.09294811284610677 0.09294811284610677 0.09294811284610677 -36.089 22.2851 36.9071 0.0 0.0 0.0 -33.089 23.2851 35.9071 0.20437703105590016 0.20437703105590016 0.20437703105590016 -33.089 24.2851 35.9071 0.25811218524988216 0.25811218524988216 0.25811218524988216 -33.089 25.2851 35.9071 0.28423435680790404 0.28423435680790404 0.28423435680790404 -35.089 23.2851 35.9071 0.06889149709664442 0.06889149709664442 0.06889149709664442 -35.089 24.2851 35.9071 0.04630897387741451 0.04630897387741451 0.04630897387741451 -36.089 23.2851 35.9071 0.09063849608115306 0.09063849608115306 0.09063849608115306 -36.089 23.2851 36.9071 0.06886931074325872 0.06886931074325872 0.06886931074325872 -36.089 24.2851 35.9071 0.09487515361812712 0.09487515361812712 0.09487515361812712 -36.089 24.2851 36.9071 0.06813844382639864 0.06813844382639864 0.06813844382639864 -36.089 25.2851 35.9071 0.11501631559770088 0.11501631559770088 0.11501631559770088 -37.089 22.2851 35.9071 0.10781518589630013 0.10781518589630013 0.10781518589630013 -37.089 22.2851 36.9071 0.07624770439593263 0.07624770439593263 0.07624770439593263 -38.089 22.2851 35.9071 0.08963796301703143 0.08963796301703143 0.08963796301703143 -37.089 23.2851 35.9071 0.10513558728904418 0.10513558728904418 0.10513558728904418 -37.089 23.2851 36.9071 0.0795178963347986 0.0795178963347986 0.0795178963347986 -37.089 24.2851 35.9071 0.09273113705743587 0.09273113705743587 0.09273113705743587 -37.089 24.2851 36.9071 0.06360872149433179 0.06360872149433179 0.06360872149433179 -38.089 23.2851 35.9071 0.08158824186857232 0.08158824186857232 0.08158824186857232 -38.089 24.2851 35.9071 0.08929319813898676 0.08929319813898676 0.08929319813898676 -37.089 25.2851 35.9071 0.09987576180773067 0.09987576180773067 0.09987576180773067 -41.089 24.2851 27.9071 0.11645517879083578 0.11645517879083578 0.11645517879083578 -42.089 24.2851 27.9071 0.11944529682468866 0.11944529682468866 0.11944529682468866 -41.089 25.2851 27.9071 0.14690307336323644 0.14690307336323644 0.14690307336323644 -41.089 25.2851 28.9071 0.0955782950334893 0.0955782950334893 0.0955782950334893 -41.089 26.2851 27.9071 0.1140891952514299 0.1140891952514299 0.1140891952514299 -41.089 26.2851 28.9071 0.10992264558089017 0.10992264558089017 0.10992264558089017 -42.089 25.2851 27.9071 0.15574122256898834 0.15574122256898834 0.15574122256898834 -42.089 25.2851 28.9071 0.09205609752831151 0.09205609752831151 0.09205609752831151 -42.089 26.2851 27.9071 0.15066137284795422 0.15066137284795422 0.15066137284795422 -42.089 26.2851 28.9071 0.1024767908973311 0.1024767908973311 0.1024767908973311 -43.089 25.2851 27.9071 0.08941053087404306 0.08941053087404306 0.08941053087404306 -43.089 26.2851 27.9071 0.11881064914388145 0.11881064914388145 0.11881064914388145 -25.089 27.2851 13.9071 0.06657411550749748 0.06657411550749748 0.06657411550749748 -25.089 27.2851 14.9071 0.09101298959409013 0.09101298959409013 0.09101298959409013 -25.089 28.2851 13.9071 0.06985378409470236 0.06985378409470236 0.06985378409470236 -26.089 27.2851 14.9071 0.07159625712329548 0.07159625712329548 0.07159625712329548 -26.089 28.2851 14.9071 0.06531386856241037 0.06531386856241037 0.06531386856241037 -25.089 29.2851 13.9071 0.07211399994424823 0.07211399994424823 0.07211399994424823 -25.089 29.2851 14.9071 0.07827215904967245 0.07827215904967245 0.07827215904967245 -26.089 29.2851 14.9071 0.0705118078223649 0.0705118078223649 0.0705118078223649 -25.089 27.2851 15.9071 0.08942338924557432 0.08942338924557432 0.08942338924557432 -25.089 27.2851 16.9071 0.05594238848082636 0.05594238848082636 0.05594238848082636 -25.089 28.2851 15.9071 0.06492856363284351 0.06492856363284351 0.06492856363284351 -25.089 28.2851 16.9071 0.059825933005347776 0.059825933005347776 0.059825933005347776 -26.089 27.2851 15.9071 0.07042523452188072 0.07042523452188072 0.07042523452188072 -26.089 27.2851 16.9071 0.044241579961796895 0.044241579961796895 0.044241579961796895 -26.089 28.2851 15.9071 0.04949282224320926 0.04949282224320926 0.04949282224320926 -26.089 28.2851 16.9071 0.048133086673632475 0.048133086673632475 0.048133086673632475 -25.089 27.2851 17.9071 0.029268817201748544 0.029268817201748544 0.029268817201748544 -25.089 27.2851 18.9071 0.06183190870687385 0.06183190870687385 0.06183190870687385 -25.089 28.2851 17.9071 0.06266549298847629 0.06266549298847629 0.06266549298847629 -26.089 27.2851 17.9071 0.083998581308039 0.083998581308039 0.083998581308039 -26.089 27.2851 18.9071 0.14929700194472287 0.14929700194472287 0.14929700194472287 -26.089 28.2851 17.9071 0.05919370907295976 0.05919370907295976 0.05919370907295976 -25.089 29.2851 15.9071 0.06216979717526353 0.06216979717526353 0.06216979717526353 -25.089 29.2851 16.9071 0.05968829769948133 0.05968829769948133 0.05968829769948133 -25.089 30.2851 15.9071 0.03910249570796254 0.03910249570796254 0.03910249570796254 -26.089 29.2851 15.9071 0.05320100208888541 0.05320100208888541 0.05320100208888541 -26.089 29.2851 16.9071 0.05525280959516155 0.05525280959516155 0.05525280959516155 -25.089 29.2851 17.9071 0.08857714328698695 0.08857714328698695 0.08857714328698695 -25.089 30.2851 17.9071 0.08505062079982788 0.08505062079982788 0.08505062079982788 -25.089 30.2851 18.9071 0.07844295777315918 0.07844295777315918 0.07844295777315918 -26.089 30.2851 17.9071 0.09409325314800712 0.09409325314800712 0.09409325314800712 -26.089 30.2851 18.9071 0.09613839299805949 0.09613839299805949 0.09613839299805949 -27.089 27.2851 15.9071 0.04225470572985831 0.04225470572985831 0.04225470572985831 -27.089 27.2851 16.9071 0.05603203249785198 0.05603203249785198 0.05603203249785198 -27.089 28.2851 15.9071 0.04898168786736683 0.04898168786736683 0.04898168786736683 -28.089 27.2851 15.9071 0.048870326557118066 0.048870326557118066 0.048870326557118066 -28.089 27.2851 16.9071 0.07586373788019767 0.07586373788019767 0.07586373788019767 -28.089 28.2851 15.9071 0.04456539021856276 0.04456539021856276 0.04456539021856276 -28.089 28.2851 16.9071 0.06496618581033223 0.06496618581033223 0.06496618581033223 -28.089 27.2851 18.9071 0.05404496702094296 0.05404496702094296 0.05404496702094296 -27.089 29.2851 15.9071 0.04735137505763899 0.04735137505763899 0.04735137505763899 -27.089 29.2851 16.9071 0.06042808470007769 0.06042808470007769 0.06042808470007769 -28.089 29.2851 15.9071 0.03750511437761376 0.03750511437761376 0.03750511437761376 -28.089 29.2851 16.9071 0.056465136310340135 0.056465136310340135 0.056465136310340135 -27.089 29.2851 17.9071 0.08115744335192977 0.08115744335192977 0.08115744335192977 -27.089 29.2851 18.9071 0.12599392585706654 0.12599392585706654 0.12599392585706654 -27.089 30.2851 17.9071 0.0730815535554441 0.0730815535554441 0.0730815535554441 -27.089 30.2851 18.9071 0.08822353360197742 0.08822353360197742 0.08822353360197742 -28.089 29.2851 17.9071 0.05460414820768279 0.05460414820768279 0.05460414820768279 -28.089 29.2851 18.9071 0.10691931803213021 0.10691931803213021 0.10691931803213021 -28.089 30.2851 18.9071 0.09451273204286922 0.09451273204286922 0.09451273204286922 -25.089 34.2851 14.9071 0.08974404422073556 0.08974404422073556 0.08974404422073556 -26.089 34.2851 14.9071 0.05709577374237059 0.05709577374237059 0.05709577374237059 -25.089 31.2851 17.9071 0.06607860455192129 0.06607860455192129 0.06607860455192129 -25.089 31.2851 18.9071 0.11584862597583007 0.11584862597583007 0.11584862597583007 -25.089 32.2851 18.9071 0.07800137200093811 0.07800137200093811 0.07800137200093811 -26.089 31.2851 18.9071 0.10924212612859305 0.10924212612859305 0.10924212612859305 -26.089 32.2851 18.9071 0.064719390436372 0.064719390436372 0.064719390436372 -25.089 33.2851 15.9071 0.07280656920241206 0.07280656920241206 0.07280656920241206 -25.089 33.2851 16.9071 0.06855725421152724 0.06855725421152724 0.06855725421152724 -25.089 34.2851 15.9071 0.09697330941123912 0.09697330941123912 0.09697330941123912 -25.089 34.2851 16.9071 0.08572491542462003 0.08572491542462003 0.08572491542462003 -26.089 34.2851 15.9071 0.060867033562698625 0.060867033562698625 0.060867033562698625 -26.089 34.2851 16.9071 0.06567489431094432 0.06567489431094432 0.06567489431094432 -25.089 33.2851 18.9071 0.06626655179860506 0.06626655179860506 0.06626655179860506 -25.089 34.2851 17.9071 0.07797026639556846 0.07797026639556846 0.07797026639556846 -25.089 34.2851 18.9071 0.11464836096769541 0.11464836096769541 0.11464836096769541 -26.089 33.2851 18.9071 0.06179758115280358 0.06179758115280358 0.06179758115280358 -26.089 34.2851 17.9071 0.08558266303611677 0.08558266303611677 0.08558266303611677 -26.089 34.2851 18.9071 0.08394232212419124 0.08394232212419124 0.08394232212419124 -27.089 31.2851 17.9071 0.08900066920510807 0.08900066920510807 0.08900066920510807 -27.089 31.2851 18.9071 0.13041989311125216 0.13041989311125216 0.13041989311125216 -27.089 32.2851 17.9071 0.08373175168687709 0.08373175168687709 0.08373175168687709 -27.089 32.2851 18.9071 0.09480524093579938 0.09480524093579938 0.09480524093579938 -28.089 31.2851 17.9071 0.09975523015420122 0.09975523015420122 0.09975523015420122 -28.089 32.2851 17.9071 0.08876921698722984 0.08876921698722984 0.08876921698722984 -27.089 33.2851 18.9071 0.08730414114738082 0.08730414114738082 0.08730414114738082 -27.089 34.2851 18.9071 0.1183471121678532 0.1183471121678532 0.1183471121678532 -28.089 33.2851 18.9071 0.08102161274427944 0.08102161274427944 0.08102161274427944 -28.089 34.2851 17.9071 0.13080785649231996 0.13080785649231996 0.13080785649231996 -28.089 34.2851 18.9071 0.13972246649028636 0.13972246649028636 0.13972246649028636 -29.089 27.2851 16.9071 0.07459246367393811 0.07459246367393811 0.07459246367393811 -29.089 28.2851 16.9071 0.06609612916406035 0.06609612916406035 0.06609612916406035 -29.089 27.2851 18.9071 0.06478104915611518 0.06478104915611518 0.06478104915611518 -29.089 28.2851 17.9071 0.06835138626970243 0.06835138626970243 0.06835138626970243 -29.089 28.2851 18.9071 0.051373064454913346 0.051373064454913346 0.051373064454913346 -30.089 27.2851 17.9071 0.050184460600237873 0.050184460600237873 0.050184460600237873 -30.089 27.2851 18.9071 0.07650788748906097 0.07650788748906097 0.07650788748906097 -30.089 28.2851 18.9071 0.07002942374229079 0.07002942374229079 0.07002942374229079 -30.089 30.2851 16.9071 0.10164675275161943 0.10164675275161943 0.10164675275161943 -29.089 29.2851 17.9071 0.06589628404877436 0.06589628404877436 0.06589628404877436 -29.089 29.2851 18.9071 0.11225099091194404 0.11225099091194404 0.11225099091194404 -29.089 30.2851 18.9071 0.277633652367012 0.277633652367012 0.277633652367012 -30.089 29.2851 17.9071 0.09762580783341142 0.09762580783341142 0.09762580783341142 -30.089 29.2851 18.9071 0.10081027776728417 0.10081027776728417 0.10081027776728417 -30.089 30.2851 17.9071 0.11270251177806927 0.11270251177806927 0.11270251177806927 -30.089 30.2851 18.9071 0.09512989241790414 0.09512989241790414 0.09512989241790414 -31.089 27.2851 18.9071 0.1088580760101767 0.1088580760101767 0.1088580760101767 -31.089 28.2851 18.9071 0.10131087815443857 0.10131087815443857 0.10131087815443857 -32.089 28.2851 18.9071 0.08794144839793254 0.08794144839793254 0.08794144839793254 -31.089 30.2851 16.9071 0.10949681944296545 0.10949681944296545 0.10949681944296545 -32.089 30.2851 16.9071 0.11251852938230843 0.11251852938230843 0.11251852938230843 -31.089 29.2851 17.9071 0.10170621365861608 0.10170621365861608 0.10170621365861608 -31.089 29.2851 18.9071 0.10121847221786398 0.10121847221786398 0.10121847221786398 -32.089 29.2851 17.9071 0.11541078037344721 0.11541078037344721 0.11541078037344721 -32.089 29.2851 18.9071 0.13197093218745243 0.13197093218745243 0.13197093218745243 -32.089 30.2851 17.9071 0.1288599883356099 0.1288599883356099 0.1288599883356099 -32.089 30.2851 18.9071 0.11239239273686259 0.11239239273686259 0.11239239273686259 -30.089 31.2851 16.9071 0.08653261489605266 0.08653261489605266 0.08653261489605266 -30.089 32.2851 15.9071 0.052505047971943795 0.052505047971943795 0.052505047971943795 -30.089 32.2851 16.9071 0.08701321232571875 0.08701321232571875 0.08701321232571875 -29.089 31.2851 17.9071 0.10759985713203353 0.10759985713203353 0.10759985713203353 -29.089 31.2851 18.9071 0.14402078842183036 0.14402078842183036 0.14402078842183036 -29.089 32.2851 17.9071 0.09320848302010788 0.09320848302010788 0.09320848302010788 -29.089 32.2851 18.9071 0.10824744861624847 0.10824744861624847 0.10824744861624847 -30.089 31.2851 17.9071 0.11437038539335523 0.11437038539335523 0.11437038539335523 -30.089 31.2851 18.9071 0.0863831308292393 0.0863831308292393 0.0863831308292393 -30.089 32.2851 17.9071 0.08697945808492083 0.08697945808492083 0.08697945808492083 -30.089 32.2851 18.9071 0.16261127734628653 0.16261127734628653 0.16261127734628653 -29.089 33.2851 16.9071 0.0775281153919914 0.0775281153919914 0.0775281153919914 -29.089 34.2851 16.9071 0.13464321161107057 0.13464321161107057 0.13464321161107057 -30.089 33.2851 15.9071 0.05527427611339363 0.05527427611339363 0.05527427611339363 -30.089 33.2851 16.9071 0.09775437832698736 0.09775437832698736 0.09775437832698736 -30.089 34.2851 15.9071 0.059208421359793366 0.059208421359793366 0.059208421359793366 -30.089 34.2851 16.9071 0.12026952798530913 0.12026952798530913 0.12026952798530913 -29.089 33.2851 17.9071 0.11076866705080621 0.11076866705080621 0.11076866705080621 -29.089 33.2851 18.9071 0.08780562924324567 0.08780562924324567 0.08780562924324567 -29.089 34.2851 17.9071 0.14119622568330906 0.14119622568330906 0.14119622568330906 -29.089 34.2851 18.9071 0.1480819776551932 0.1480819776551932 0.1480819776551932 -30.089 33.2851 17.9071 0.094971584804388 0.094971584804388 0.094971584804388 -30.089 33.2851 18.9071 0.08704375186469893 0.08704375186469893 0.08704375186469893 -30.089 34.2851 17.9071 0.08249725131893847 0.08249725131893847 0.08249725131893847 -30.089 34.2851 18.9071 0.12207139964318098 0.12207139964318098 0.12207139964318098 -31.089 31.2851 16.9071 0.09141962649893871 0.09141962649893871 0.09141962649893871 -31.089 32.2851 15.9071 0.05180273604511536 0.05180273604511536 0.05180273604511536 -31.089 32.2851 16.9071 0.10962456752100128 0.10962456752100128 0.10962456752100128 -32.089 31.2851 16.9071 0.08158824186857232 0.08158824186857232 0.08158824186857232 -32.089 32.2851 15.9071 0.05325237831523722 0.05325237831523722 0.05325237831523722 -32.089 32.2851 16.9071 0.09716938092185926 0.09716938092185926 0.09716938092185926 -31.089 31.2851 17.9071 0.08848874101142488 0.08848874101142488 0.08848874101142488 -31.089 32.2851 17.9071 0.05663397139550361 0.05663397139550361 0.05663397139550361 -32.089 31.2851 17.9071 0.1568284582492041 0.1568284582492041 0.1568284582492041 -32.089 31.2851 18.9071 0.0776529403079502 0.0776529403079502 0.0776529403079502 -31.089 33.2851 15.9071 0.04478000325143926 0.04478000325143926 0.04478000325143926 -31.089 34.2851 15.9071 0.05928608289486996 0.05928608289486996 0.05928608289486996 -32.089 33.2851 15.9071 0.054788745485922746 0.054788745485922746 0.054788745485922746 -32.089 34.2851 15.9071 0.0714853290244837 0.0714853290244837 0.0714853290244837 -32.089 34.2851 16.9071 0.13488818619707887 0.13488818619707887 0.13488818619707887 -31.089 34.2851 18.9071 0.07710251964766034 0.07710251964766034 0.07710251964766034 -32.089 34.2851 18.9071 0.07176248821981161 0.07176248821981161 0.07176248821981161 -25.089 27.2851 20.9071 0.11570803361093157 0.11570803361093157 0.11570803361093157 -26.089 27.2851 19.9071 0.0857602775612608 0.0857602775612608 0.0857602775612608 -26.089 27.2851 20.9071 0.12768481867636425 0.12768481867636425 0.12768481867636425 -26.089 28.2851 20.9071 0.14409788627032222 0.14409788627032222 0.14409788627032222 -25.089 27.2851 22.9071 0.035902956652129496 0.035902956652129496 0.035902956652129496 -25.089 28.2851 21.9071 0.084567600556387 0.084567600556387 0.084567600556387 -25.089 28.2851 22.9071 0.0002502491484266122 0.0002502491484266122 0.0002502491484266122 -26.089 27.2851 21.9071 0.1284495243287717 0.1284495243287717 0.1284495243287717 -26.089 27.2851 22.9071 0.11222287120124065 0.11222287120124065 0.11222287120124065 -26.089 28.2851 21.9071 0.1184828797736244 0.1184828797736244 0.1184828797736244 -26.089 28.2851 22.9071 0.08828139711133438 0.08828139711133438 0.08828139711133438 -25.089 30.2851 20.9071 0.18185009000703595 0.18185009000703595 0.18185009000703595 -26.089 29.2851 20.9071 0.15793976816195246 0.15793976816195246 0.15793976816195246 -26.089 30.2851 19.9071 0.07605222491667127 0.07605222491667127 0.07605222491667127 -26.089 30.2851 20.9071 0.16496619968099638 0.16496619968099638 0.16496619968099638 -25.089 29.2851 21.9071 0.12490948657995582 0.12490948657995582 0.12490948657995582 -25.089 30.2851 21.9071 0.15612264000875017 0.15612264000875017 0.15612264000875017 -25.089 30.2851 22.9071 0.09469273764128767 0.09469273764128767 0.09469273764128767 -26.089 29.2851 21.9071 0.14350198222832153 0.14350198222832153 0.14350198222832153 -27.089 27.2851 20.9071 0.1274092979469072 0.1274092979469072 0.1274092979469072 -27.089 28.2851 20.9071 0.09904248261863549 0.09904248261863549 0.09904248261863549 -28.089 27.2851 19.9071 0.09802035788338491 0.09802035788338491 0.09802035788338491 -28.089 27.2851 20.9071 0.12813384314941506 0.12813384314941506 0.12813384314941506 -28.089 28.2851 20.9071 0.08939124331291971 0.08939124331291971 0.08939124331291971 -27.089 27.2851 21.9071 0.11652426928494454 0.11652426928494454 0.11652426928494454 -27.089 27.2851 22.9071 0.07472492919742839 0.07472492919742839 0.07472492919742839 -27.089 28.2851 21.9071 0.07216874014089729 0.07216874014089729 0.07216874014089729 -28.089 27.2851 21.9071 0.104815797146486 0.104815797146486 0.104815797146486 -28.089 27.2851 22.9071 0.10659632107300479 0.10659632107300479 0.10659632107300479 -28.089 28.2851 21.9071 0.07476150186119443 0.07476150186119443 0.07476150186119443 -27.089 29.2851 19.9071 0.07114048634926322 0.07114048634926322 0.07114048634926322 -27.089 29.2851 20.9071 0.0766102886363264 0.0766102886363264 0.0766102886363264 -27.089 30.2851 19.9071 0.0779555575392273 0.0779555575392273 0.0779555575392273 -27.089 30.2851 20.9071 0.08510848659120385 0.08510848659120385 0.08510848659120385 -28.089 29.2851 19.9071 0.08013605585983599 0.08013605585983599 0.08013605585983599 -28.089 29.2851 20.9071 0.0638372716617381 0.0638372716617381 0.0638372716617381 -28.089 30.2851 19.9071 0.08556739299074861 0.08556739299074861 0.08556739299074861 -28.089 30.2851 20.9071 0.09491694047969998 0.09491694047969998 0.09491694047969998 -28.089 29.2851 21.9071 0.15755675340103362 0.15755675340103362 0.15755675340103362 -28.089 30.2851 21.9071 0.10231206958435038 0.10231206958435038 0.10231206958435038 -25.089 27.2851 23.9071 0.0 0.0 0.0 -25.089 27.2851 24.9071 0.048980240573336 0.048980240573336 0.048980240573336 -25.089 28.2851 24.9071 0.05951070600188348 0.05951070600188348 0.05951070600188348 -26.089 27.2851 23.9071 0.07446289160379668 0.07446289160379668 0.07446289160379668 -26.089 27.2851 24.9071 0.054995050131074516 0.054995050131074516 0.054995050131074516 -26.089 28.2851 24.9071 0.19184901951889066 0.19184901951889066 0.19184901951889066 -25.089 27.2851 25.9071 0.10124498871486629 0.10124498871486629 0.10124498871486629 -25.089 27.2851 26.9071 0.3014667541993163 0.3014667541993163 0.3014667541993163 -25.089 28.2851 25.9071 0.09911399872173714 0.09911399872173714 0.09911399872173714 -26.089 28.2851 25.9071 0.1869287736018128 0.1869287736018128 0.1869287736018128 -25.089 29.2851 23.9071 0.10292675959433871 0.10292675959433871 0.10292675959433871 -25.089 30.2851 23.9071 0.13178779707452404 0.13178779707452404 0.13178779707452404 -25.089 30.2851 24.9071 0.1641311856699469 0.1641311856699469 0.1641311856699469 -26.089 29.2851 24.9071 0.7369578874346804 0.7369578874346804 0.7369578874346804 -25.089 29.2851 25.9071 0.22831527579368743 0.22831527579368743 0.22831527579368743 -25.089 29.2851 26.9071 0.2083420893876253 0.2083420893876253 0.2083420893876253 -25.089 30.2851 25.9071 0.537803130361662 0.537803130361662 0.537803130361662 -25.089 30.2851 26.9071 0.6028757589804837 0.6028757589804837 0.6028757589804837 -26.089 29.2851 25.9071 0.09460434208524696 0.09460434208524696 0.09460434208524696 -26.089 30.2851 25.9071 0.5418916405465323 0.5418916405465323 0.5418916405465323 -27.089 27.2851 23.9071 0.09405307306246699 0.09405307306246699 0.09405307306246699 -27.089 27.2851 24.9071 0.08659851638569113 0.08659851638569113 0.08659851638569113 -27.089 28.2851 23.9071 0.549512689062383 0.549512689062383 0.549512689062383 -27.089 28.2851 24.9071 0.6873236839004849 0.6873236839004849 0.6873236839004849 -28.089 27.2851 23.9071 0.10218109581187207 0.10218109581187207 0.10218109581187207 -28.089 28.2851 23.9071 0.5124458914687406 0.5124458914687406 0.5124458914687406 -28.089 27.2851 25.9071 0.16306653023671902 0.16306653023671902 0.16306653023671902 -28.089 27.2851 26.9071 0.39145580148856385 0.39145580148856385 0.39145580148856385 -27.089 29.2851 23.9071 0.6621491851603438 0.6621491851603438 0.6621491851603438 -27.089 29.2851 24.9071 0.7101521550668429 0.7101521550668429 0.7101521550668429 -27.089 30.2851 24.9071 0.5163038660969173 0.5163038660969173 0.5163038660969173 -28.089 29.2851 23.9071 0.8883204224898459 0.8883204224898459 0.8883204224898459 -28.089 29.2851 24.9071 0.749493771737366 0.749493771737366 0.749493771737366 -28.089 30.2851 23.9071 0.7099934580577247 0.7099934580577247 0.7099934580577247 -28.089 30.2851 24.9071 0.5335689537863391 0.5335689537863391 0.5335689537863391 -25.089 31.2851 20.9071 0.07822039691787695 0.07822039691787695 0.07822039691787695 -25.089 32.2851 20.9071 0.060374944391368916 0.060374944391368916 0.060374944391368916 -26.089 31.2851 19.9071 0.10842019236223858 0.10842019236223858 0.10842019236223858 -26.089 31.2851 20.9071 0.09364323504361932 0.09364323504361932 0.09364323504361932 -26.089 32.2851 19.9071 0.06925411449082161 0.06925411449082161 0.06925411449082161 -26.089 32.2851 20.9071 0.10285685390830857 0.10285685390830857 0.10285685390830857 -25.089 31.2851 21.9071 0.07439288080164518 0.07439288080164518 0.07439288080164518 -25.089 31.2851 22.9071 0.0802115270978857 0.0802115270978857 0.0802115270978857 -25.089 32.2851 21.9071 0.09391003179501908 0.09391003179501908 0.09391003179501908 -25.089 32.2851 22.9071 0.100002721620836 0.100002721620836 0.100002721620836 -26.089 31.2851 21.9071 0.08043086749329102 0.08043086749329102 0.08043086749329102 -26.089 31.2851 22.9071 0.08478540205675833 0.08478540205675833 0.08478540205675833 -26.089 32.2851 21.9071 0.06367833972874827 0.06367833972874827 0.06367833972874827 -25.089 33.2851 19.9071 0.06049561545020676 0.06049561545020676 0.06049561545020676 -25.089 33.2851 20.9071 0.05579188278543969 0.05579188278543969 0.05579188278543969 -25.089 34.2851 19.9071 0.2040488075934249 0.2040488075934249 0.2040488075934249 -25.089 34.2851 20.9071 0.17650456368516027 0.17650456368516027 0.17650456368516027 -25.089 33.2851 21.9071 0.06175521433870653 0.06175521433870653 0.06175521433870653 -25.089 33.2851 22.9071 0.10055475341548942 0.10055475341548942 0.10055475341548942 -25.089 34.2851 21.9071 0.11594744217671041 0.11594744217671041 0.11594744217671041 -25.089 34.2851 22.9071 0.08356699199093098 0.08356699199093098 0.08356699199093098 -26.089 33.2851 22.9071 0.08468654757432512 0.08468654757432512 0.08468654757432512 -26.089 34.2851 21.9071 0.04166938504809593 0.04166938504809593 0.04166938504809593 -26.089 34.2851 22.9071 0.07692633279958815 0.07692633279958815 0.07692633279958815 -27.089 31.2851 19.9071 0.09838919212729302 0.09838919212729302 0.09838919212729302 -27.089 31.2851 20.9071 0.14051838012125026 0.14051838012125026 0.14051838012125026 -27.089 32.2851 19.9071 0.07466440341188246 0.07466440341188246 0.07466440341188246 -27.089 32.2851 20.9071 0.16060797343666972 0.16060797343666972 0.16060797343666972 -27.089 31.2851 21.9071 0.07547261582336048 0.07547261582336048 0.07547261582336048 -27.089 31.2851 22.9071 0.11825070899507845 0.11825070899507845 0.11825070899507845 -28.089 31.2851 21.9071 0.11524528214906347 0.11524528214906347 0.11524528214906347 -28.089 31.2851 22.9071 0.1380832290481231 0.1380832290481231 0.1380832290481231 -28.089 32.2851 21.9071 0.10052261193012843 0.10052261193012843 0.10052261193012843 -28.089 32.2851 22.9071 0.11734290678604405 0.11734290678604405 0.11734290678604405 -27.089 34.2851 19.9071 0.13823020760468266 0.13823020760468266 0.13823020760468266 -28.089 33.2851 19.9071 0.16212470791701183 0.16212470791701183 0.16212470791701183 -28.089 34.2851 19.9071 0.18007684995636025 0.18007684995636025 0.18007684995636025 -28.089 34.2851 20.9071 0.21329552968220836 0.21329552968220836 0.21329552968220836 -27.089 34.2851 21.9071 0.09873472158432914 0.09873472158432914 0.09873472158432914 -27.089 34.2851 22.9071 0.07302898427209593 0.07302898427209593 0.07302898427209593 -28.089 33.2851 22.9071 0.04623290797406198 0.04623290797406198 0.04623290797406198 -28.089 34.2851 21.9071 0.1553003820543032 0.1553003820543032 0.1553003820543032 -28.089 34.2851 22.9071 0.07295656078421331 0.07295656078421331 0.07295656078421331 -25.089 31.2851 23.9071 0.10847402405846077 0.10847402405846077 0.10847402405846077 -25.089 31.2851 24.9071 0.14397179912553815 0.14397179912553815 0.14397179912553815 -25.089 32.2851 23.9071 0.10458599741490862 0.10458599741490862 0.10458599741490862 -25.089 32.2851 24.9071 0.12849611330378968 0.12849611330378968 0.12849611330378968 -26.089 31.2851 23.9071 0.117090648424362 0.117090648424362 0.117090648424362 -26.089 32.2851 23.9071 0.11073010216308206 0.11073010216308206 0.11073010216308206 -25.089 31.2851 25.9071 0.3139063840763667 0.3139063840763667 0.3139063840763667 -25.089 31.2851 26.9071 0.7715412202931499 0.7715412202931499 0.7715412202931499 -25.089 32.2851 26.9071 0.5488534573326505 0.5488534573326505 0.5488534573326505 -26.089 31.2851 25.9071 0.6266773846558803 0.6266773846558803 0.6266773846558803 -26.089 32.2851 25.9071 0.710773383061305 0.710773383061305 0.710773383061305 -25.089 33.2851 23.9071 0.10633679770115491 0.10633679770115491 0.10633679770115491 -25.089 33.2851 24.9071 0.10790356693869796 0.10790356693869796 0.10790356693869796 -25.089 34.2851 23.9071 0.08984449977711823 0.08984449977711823 0.08984449977711823 -25.089 34.2851 24.9071 0.08365218485145004 0.08365218485145004 0.08365218485145004 -26.089 33.2851 23.9071 0.09415191603687839 0.09415191603687839 0.09415191603687839 -26.089 34.2851 23.9071 0.07961852540962688 0.07961852540962688 0.07961852540962688 -26.089 34.2851 24.9071 0.07787325219513166 0.07787325219513166 0.07787325219513166 -25.089 33.2851 26.9071 0.42424000351097113 0.42424000351097113 0.42424000351097113 -25.089 34.2851 25.9071 0.08039574413563305 0.08039574413563305 0.08039574413563305 -26.089 33.2851 26.9071 0.3443653772756072 0.3443653772756072 0.3443653772756072 -26.089 34.2851 25.9071 0.08111002322502518 0.08111002322502518 0.08111002322502518 -26.089 34.2851 26.9071 0.15264324298588972 0.15264324298588972 0.15264324298588972 -27.089 31.2851 23.9071 0.12692331885015504 0.12692331885015504 0.12692331885015504 -27.089 32.2851 23.9071 0.10134623344122544 0.10134623344122544 0.10134623344122544 -28.089 31.2851 23.9071 0.36456912677985537 0.36456912677985537 0.36456912677985537 -28.089 31.2851 24.9071 0.3458201718894182 0.3458201718894182 0.3458201718894182 -28.089 32.2851 23.9071 0.0899232568456122 0.0899232568456122 0.0899232568456122 -28.089 32.2851 24.9071 0.2765592729362295 0.2765592729362295 0.2765592729362295 -27.089 31.2851 25.9071 0.5104137052891141 0.5104137052891141 0.5104137052891141 -27.089 32.2851 25.9071 0.22716081252639242 0.22716081252639242 0.22716081252639242 -28.089 31.2851 25.9071 0.2663319056423266 0.2663319056423266 0.2663319056423266 -28.089 32.2851 25.9071 0.19860684399141015 0.19860684399141015 0.19860684399141015 -27.089 33.2851 23.9071 0.08535361205149458 0.08535361205149458 0.08535361205149458 -27.089 34.2851 23.9071 0.09030579008163302 0.09030579008163302 0.09030579008163302 -27.089 34.2851 24.9071 0.07034838757727993 0.07034838757727993 0.07034838757727993 -28.089 33.2851 23.9071 0.038565803565213636 0.038565803565213636 0.038565803565213636 -28.089 33.2851 24.9071 0.13227133712787478 0.13227133712787478 0.13227133712787478 -28.089 34.2851 23.9071 0.08493408539919078 0.08493408539919078 0.08493408539919078 -28.089 34.2851 24.9071 0.07515873618427524 0.07515873618427524 0.07515873618427524 -27.089 33.2851 25.9071 0.13410265849222677 0.13410265849222677 0.13410265849222677 -27.089 33.2851 26.9071 0.16503765720822694 0.16503765720822694 0.16503765720822694 -27.089 34.2851 25.9071 0.09620187587857121 0.09620187587857121 0.09620187587857121 -27.089 34.2851 26.9071 0.10418183755343277 0.10418183755343277 0.10418183755343277 -28.089 33.2851 25.9071 0.09642286019859014 0.09642286019859014 0.09642286019859014 -28.089 33.2851 26.9071 0.11684722638918073 0.11684722638918073 0.11684722638918073 -28.089 34.2851 25.9071 0.10112124498741797 0.10112124498741797 0.10112124498741797 -28.089 34.2851 26.9071 0.0837614887667844 0.0837614887667844 0.0837614887667844 -29.089 27.2851 19.9071 0.10354465893650812 0.10354465893650812 0.10354465893650812 -29.089 27.2851 20.9071 0.112913006404795 0.112913006404795 0.112913006404795 -29.089 28.2851 19.9071 0.059548411107620006 0.059548411107620006 0.059548411107620006 -29.089 28.2851 20.9071 0.08694088179239541 0.08694088179239541 0.08694088179239541 -29.089 27.2851 21.9071 0.09213726329507282 0.09213726329507282 0.09213726329507282 -29.089 27.2851 22.9071 0.14280407821714405 0.14280407821714405 0.14280407821714405 -29.089 28.2851 21.9071 0.1394244988167309 0.1394244988167309 0.1394244988167309 -29.089 28.2851 22.9071 0.24736353359031152 0.24736353359031152 0.24736353359031152 -30.089 27.2851 21.9071 0.09815214199039123 0.09815214199039123 0.09815214199039123 -30.089 27.2851 22.9071 0.07807523771845462 0.07807523771845462 0.07807523771845462 -30.089 28.2851 21.9071 0.11181633942820554 0.11181633942820554 0.11181633942820554 -30.089 28.2851 22.9071 0.1399087961188553 0.1399087961188553 0.1399087961188553 -29.089 29.2851 19.9071 0.06850331541475503 0.06850331541475503 0.06850331541475503 -29.089 30.2851 19.9071 0.06499657294083688 0.06499657294083688 0.06499657294083688 -30.089 29.2851 19.9071 0.11729872146135863 0.11729872146135863 0.11729872146135863 -29.089 29.2851 21.9071 0.12454238049081875 0.12454238049081875 0.12454238049081875 -29.089 29.2851 22.9071 0.49922936714951655 0.49922936714951655 0.49922936714951655 -29.089 30.2851 21.9071 0.13119099861641736 0.13119099861641736 0.13119099861641736 -29.089 30.2851 22.9071 0.19059290051098565 0.19059290051098565 0.19059290051098565 -30.089 29.2851 21.9071 0.10778786809992139 0.10778786809992139 0.10778786809992139 -30.089 29.2851 22.9071 0.12908007971945806 0.12908007971945806 0.12908007971945806 -30.089 30.2851 21.9071 0.1685614783265106 0.1685614783265106 0.1685614783265106 -30.089 30.2851 22.9071 0.14651117219790225 0.14651117219790225 0.14651117219790225 -31.089 27.2851 19.9071 0.1127941011108084 0.1127941011108084 0.1127941011108084 -31.089 27.2851 20.9071 0.105867564464028 0.105867564464028 0.105867564464028 -32.089 27.2851 19.9071 0.10288015581040086 0.10288015581040086 0.10288015581040086 -32.089 27.2851 20.9071 0.08534075302950576 0.08534075302950576 0.08534075302950576 -32.089 28.2851 19.9071 0.10139283811370929 0.10139283811370929 0.10139283811370929 -31.089 27.2851 21.9071 0.16641541015613523 0.16641541015613523 0.16641541015613523 -31.089 27.2851 22.9071 0.09760009371005492 0.09760009371005492 0.09760009371005492 -31.089 28.2851 21.9071 0.15002697136247456 0.15002697136247456 0.15002697136247456 -31.089 28.2851 22.9071 0.1172007102909023 0.1172007102909023 0.1172007102909023 -32.089 27.2851 21.9071 0.08071217529664503 0.08071217529664503 0.08071217529664503 -32.089 27.2851 22.9071 0.07312946070117012 0.07312946070117012 0.07312946070117012 -32.089 28.2851 21.9071 0.07645749064422398 0.07645749064422398 0.07645749064422398 -32.089 28.2851 22.9071 0.06450587565186543 0.06450587565186543 0.06450587565186543 -32.089 29.2851 19.9071 0.09129988580566893 0.09129988580566893 0.09129988580566893 -32.089 30.2851 19.9071 0.10497649586946489 0.10497649586946489 0.10497649586946489 -32.089 30.2851 20.9071 0.0982630333278099 0.0982630333278099 0.0982630333278099 -31.089 29.2851 21.9071 0.08748978854726369 0.08748978854726369 0.08748978854726369 -31.089 29.2851 22.9071 0.0814861685479822 0.0814861685479822 0.0814861685479822 -31.089 30.2851 21.9071 0.18906466282630371 0.18906466282630371 0.18906466282630371 -31.089 30.2851 22.9071 0.13110505284793914 0.13110505284793914 0.13110505284793914 -32.089 29.2851 21.9071 0.07022274748778164 0.07022274748778164 0.07022274748778164 -32.089 29.2851 22.9071 0.05308393813917419 0.05308393813917419 0.05308393813917419 -32.089 30.2851 21.9071 0.09452478600177197 0.09452478600177197 0.09452478600177197 -32.089 30.2851 22.9071 0.0688407739391388 0.0688407739391388 0.0688407739391388 -29.089 28.2851 23.9071 0.7151194524496898 0.7151194524496898 0.7151194524496898 -30.089 27.2851 24.9071 0.1867810813076471 0.1867810813076471 0.1867810813076471 -30.089 28.2851 23.9071 0.17870816126372208 0.17870816126372208 0.17870816126372208 -30.089 28.2851 24.9071 0.8104466340477191 0.8104466340477191 0.8104466340477191 -29.089 27.2851 25.9071 0.25684266478600715 0.25684266478600715 0.25684266478600715 -29.089 27.2851 26.9071 0.21069647600303765 0.21069647600303765 0.21069647600303765 -29.089 28.2851 26.9071 0.5692383985682428 0.5692383985682428 0.5692383985682428 -30.089 27.2851 25.9071 0.1916210735005006 0.1916210735005006 0.1916210735005006 -30.089 28.2851 25.9071 0.4249074598314681 0.4249074598314681 0.4249074598314681 -30.089 28.2851 26.9071 0.06612442577743426 0.06612442577743426 0.06612442577743426 -29.089 29.2851 23.9071 0.860314600012226 0.860314600012226 0.860314600012226 -29.089 30.2851 23.9071 0.7821419919825433 0.7821419919825433 0.7821419919825433 -30.089 30.2851 23.9071 0.5302648945160905 0.5302648945160905 0.5302648945160905 -29.089 29.2851 26.9071 0.6021027727415369 0.6021027727415369 0.6021027727415369 -30.089 29.2851 25.9071 0.8712347673256273 0.8712347673256273 0.8712347673256273 -30.089 29.2851 26.9071 0.5692368008290382 0.5692368008290382 0.5692368008290382 -30.089 30.2851 26.9071 0.4772343239855364 0.4772343239855364 0.4772343239855364 -31.089 27.2851 23.9071 0.15099623845036236 0.15099623845036236 0.15099623845036236 -31.089 27.2851 24.9071 0.17708737896988244 0.17708737896988244 0.17708737896988244 -31.089 28.2851 23.9071 0.11743931104658632 0.11743931104658632 0.11743931104658632 -31.089 28.2851 24.9071 0.23575751592663316 0.23575751592663316 0.23575751592663316 -32.089 27.2851 23.9071 0.10127391579254114 0.10127391579254114 0.10127391579254114 -32.089 28.2851 23.9071 0.09708420237349083 0.09708420237349083 0.09708420237349083 -32.089 28.2851 24.9071 0.10355269400721713 0.10355269400721713 0.10355269400721713 -31.089 27.2851 25.9071 0.12353664581907996 0.12353664581907996 0.12353664581907996 -31.089 28.2851 25.9071 0.25406937858033174 0.25406937858033174 0.25406937858033174 -31.089 28.2851 26.9071 0.13613232430206562 0.13613232430206562 0.13613232430206562 -32.089 27.2851 25.9071 0.146850070448412 0.146850070448412 0.146850070448412 -32.089 27.2851 26.9071 0.11824669219371273 0.11824669219371273 0.11824669219371273 -32.089 28.2851 25.9071 0.10012968123359417 0.10012968123359417 0.10012968123359417 -32.089 28.2851 26.9071 0.11986785693456746 0.11986785693456746 0.11986785693456746 -31.089 29.2851 23.9071 0.0670652021180486 0.0670652021180486 0.0670652021180486 -31.089 30.2851 23.9071 0.15889368379164323 0.15889368379164323 0.15889368379164323 -31.089 30.2851 24.9071 0.1540332532452247 0.1540332532452247 0.1540332532452247 -32.089 29.2851 23.9071 0.04072316523520677 0.04072316523520677 0.04072316523520677 -32.089 29.2851 24.9071 0.07780099382069443 0.07780099382069443 0.07780099382069443 -32.089 30.2851 23.9071 0.07281999289771056 0.07281999289771056 0.07281999289771056 -32.089 30.2851 24.9071 0.117111536089438 0.117111536089438 0.117111536089438 -31.089 29.2851 25.9071 0.3893332852209081 0.3893332852209081 0.3893332852209081 -31.089 30.2851 25.9071 0.4423721993144377 0.4423721993144377 0.4423721993144377 -31.089 30.2851 26.9071 0.5742415633001782 0.5742415633001782 0.5742415633001782 -32.089 29.2851 25.9071 0.10429432757961445 0.10429432757961445 0.10429432757961445 -29.089 31.2851 19.9071 0.07638121210612688 0.07638121210612688 0.07638121210612688 -29.089 32.2851 19.9071 0.21037229052529413 0.21037229052529413 0.21037229052529413 -30.089 32.2851 19.9071 0.14320804410770482 0.14320804410770482 0.14320804410770482 -29.089 31.2851 21.9071 0.09562651021968184 0.09562651021968184 0.09562651021968184 -29.089 31.2851 22.9071 0.17920506618506088 0.17920506618506088 0.17920506618506088 -29.089 32.2851 22.9071 0.09365127110327583 0.09365127110327583 0.09365127110327583 -30.089 31.2851 22.9071 0.19165558649548176 0.19165558649548176 0.19165558649548176 -30.089 32.2851 22.9071 0.06757308654152835 0.06757308654152835 0.06757308654152835 -29.089 33.2851 19.9071 0.2316550230832696 0.2316550230832696 0.2316550230832696 -29.089 33.2851 20.9071 0.14608232734188456 0.14608232734188456 0.14608232734188456 -29.089 34.2851 19.9071 0.13914018361958244 0.13914018361958244 0.13914018361958244 -29.089 34.2851 20.9071 0.1627381381990131 0.1627381381990131 0.1627381381990131 -30.089 33.2851 19.9071 0.10142658630795497 0.10142658630795497 0.10142658630795497 -30.089 33.2851 20.9071 0.08501766942778655 0.08501766942778655 0.08501766942778655 -30.089 34.2851 19.9071 0.12138937628564493 0.12138937628564493 0.12138937628564493 -30.089 34.2851 20.9071 0.056806745599191494 0.056806745599191494 0.056806745599191494 -29.089 33.2851 21.9071 0.05714192167243839 0.05714192167243839 0.05714192167243839 -29.089 33.2851 22.9071 0.047009323582762746 0.047009323582762746 0.047009323582762746 -29.089 34.2851 21.9071 0.05932547639849084 0.05932547639849084 0.05932547639849084 -29.089 34.2851 22.9071 0.13944779013016464 0.13944779013016464 0.13944779013016464 -30.089 34.2851 21.9071 0.06190795986347489 0.06190795986347489 0.06190795986347489 -30.089 34.2851 22.9071 0.13032430764315545 0.13032430764315545 0.13032430764315545 -31.089 32.2851 20.9071 0.055779823022025526 0.055779823022025526 0.055779823022025526 -32.089 31.2851 20.9071 0.17938086864519864 0.17938086864519864 0.17938086864519864 -32.089 32.2851 20.9071 0.10128837932747832 0.10128837932747832 0.10128837932747832 -31.089 31.2851 21.9071 0.186734526071759 0.186734526071759 0.186734526071759 -31.089 31.2851 22.9071 0.19383469096755018 0.19383469096755018 0.19383469096755018 -31.089 32.2851 21.9071 0.11576909089672727 0.11576909089672727 0.11576909089672727 -31.089 32.2851 22.9071 0.08609862812829547 0.08609862812829547 0.08609862812829547 -32.089 31.2851 21.9071 0.1792379790036426 0.1792379790036426 0.1792379790036426 -32.089 32.2851 21.9071 0.16143178300694563 0.16143178300694563 0.16143178300694563 -31.089 33.2851 19.9071 0.051196982058777686 0.051196982058777686 0.051196982058777686 -31.089 33.2851 20.9071 0.05678825419447488 0.05678825419447488 0.05678825419447488 -31.089 34.2851 19.9071 0.05503500853003216 0.05503500853003216 0.05503500853003216 -31.089 34.2851 20.9071 0.059628805730357254 0.059628805730357254 0.059628805730357254 -32.089 33.2851 20.9071 0.06055414205445514 0.06055414205445514 0.06055414205445514 -32.089 34.2851 19.9071 0.038630055630102696 0.038630055630102696 0.038630055630102696 -32.089 34.2851 20.9071 0.07526443458617241 0.07526443458617241 0.07526443458617241 -31.089 33.2851 21.9071 0.0540471378253015 0.0540471378253015 0.0540471378253015 -31.089 33.2851 22.9071 0.12537298574850134 0.12537298574850134 0.12537298574850134 -31.089 34.2851 22.9071 0.17032935231298424 0.17032935231298424 0.17032935231298424 -32.089 33.2851 21.9071 0.10248562959239634 0.10248562959239634 0.10248562959239634 -32.089 33.2851 22.9071 0.14342568691769567 0.14342568691769567 0.14342568691769567 -32.089 34.2851 22.9071 0.18575445183566258 0.18575445183566258 0.18575445183566258 -29.089 31.2851 23.9071 0.40619977915350053 0.40619977915350053 0.40619977915350053 -29.089 32.2851 23.9071 0.11682955215332742 0.11682955215332742 0.11682955215332742 -29.089 32.2851 24.9071 0.17641063851284353 0.17641063851284353 0.17641063851284353 -30.089 31.2851 23.9071 0.379175497063189 0.379175497063189 0.379175497063189 -30.089 31.2851 24.9071 0.35892976091448947 0.35892976091448947 0.35892976091448947 -30.089 32.2851 23.9071 0.13541427663949873 0.13541427663949873 0.13541427663949873 -30.089 32.2851 24.9071 0.15045418911542716 0.15045418911542716 0.15045418911542716 -29.089 31.2851 26.9071 0.3612124662119824 0.3612124662119824 0.3612124662119824 -29.089 32.2851 25.9071 0.18732850464676623 0.18732850464676623 0.18732850464676623 -29.089 32.2851 26.9071 0.19424000591553892 0.19424000591553892 0.19424000591553892 -30.089 31.2851 26.9071 0.37118512640002793 0.37118512640002793 0.37118512640002793 -30.089 32.2851 25.9071 0.29828139953161414 0.29828139953161414 0.29828139953161414 -30.089 32.2851 26.9071 0.2816768785998216 0.2816768785998216 0.2816768785998216 -29.089 33.2851 24.9071 0.11814145192629733 0.11814145192629733 0.11814145192629733 -29.089 34.2851 23.9071 0.11877289146584634 0.11877289146584634 0.11877289146584634 -29.089 34.2851 24.9071 0.10524004108032325 0.10524004108032325 0.10524004108032325 -30.089 33.2851 24.9071 0.14382001242797196 0.14382001242797196 0.14382001242797196 -30.089 34.2851 24.9071 0.056236565199557546 0.056236565199557546 0.056236565199557546 -29.089 33.2851 26.9071 0.10837278830142569 0.10837278830142569 0.10837278830142569 -29.089 34.2851 25.9071 0.12731370890193394 0.12731370890193394 0.12731370890193394 -29.089 34.2851 26.9071 0.1502140801688278 0.1502140801688278 0.1502140801688278 -30.089 33.2851 25.9071 0.18271542338381633 0.18271542338381633 0.18271542338381633 -30.089 33.2851 26.9071 0.23376164800227248 0.23376164800227248 0.23376164800227248 -30.089 34.2851 25.9071 0.11417114219426656 0.11417114219426656 0.11417114219426656 -31.089 31.2851 24.9071 0.340509563635426 0.340509563635426 0.340509563635426 -31.089 32.2851 23.9071 0.12496411053758773 0.12496411053758773 0.12496411053758773 -31.089 32.2851 24.9071 0.12755067313294044 0.12755067313294044 0.12755067313294044 -32.089 31.2851 24.9071 0.1812119207467716 0.1812119207467716 0.1812119207467716 -32.089 32.2851 23.9071 0.16166302628237164 0.16166302628237164 0.16166302628237164 -32.089 32.2851 24.9071 0.14350037601199322 0.14350037601199322 0.14350037601199322 -31.089 31.2851 25.9071 0.16417614818362442 0.16417614818362442 0.16417614818362442 -31.089 31.2851 26.9071 0.29858759662667783 0.29858759662667783 0.29858759662667783 -31.089 32.2851 25.9071 0.20636159085054656 0.20636159085054656 0.20636159085054656 -31.089 32.2851 26.9071 0.2116947022900025 0.2116947022900025 0.2116947022900025 -32.089 31.2851 25.9071 0.19183296700351415 0.19183296700351415 0.19183296700351415 -32.089 31.2851 26.9071 0.20744814268086947 0.20744814268086947 0.20744814268086947 -31.089 33.2851 23.9071 0.1099676383996751 0.1099676383996751 0.1099676383996751 -31.089 33.2851 24.9071 0.10127873697114838 0.10127873697114838 0.10127873697114838 -31.089 34.2851 23.9071 0.09931649341042866 0.09931649341042866 0.09931649341042866 -32.089 33.2851 23.9071 0.09063769244511775 0.09063769244511775 0.09063769244511775 -32.089 34.2851 23.9071 0.06648440284821554 0.06648440284821554 0.06648440284821554 -31.089 33.2851 25.9071 0.14422477631844002 0.14422477631844002 0.14422477631844002 -25.089 35.2851 14.9071 0.08656074358726083 0.08656074358726083 0.08656074358726083 -25.089 36.2851 14.9071 0.0807989786488202 0.0807989786488202 0.0807989786488202 -26.089 35.2851 14.9071 0.06781078949838021 0.06781078949838021 0.06781078949838021 -26.089 36.2851 14.9071 0.08012182964409484 0.08012182964409484 0.08012182964409484 -25.089 37.2851 14.9071 0.07567131185310567 0.07567131185310567 0.07567131185310567 -25.089 38.2851 14.9071 0.07807925652596172 0.07807925652596172 0.07807925652596172 -26.089 37.2851 14.9071 0.0642004745667205 0.0642004745667205 0.0642004745667205 -26.089 38.2851 14.9071 0.06888651320619685 0.06888651320619685 0.06888651320619685 -27.089 37.2851 14.9071 0.060761798604913014 0.060761798604913014 0.060761798604913014 -26.089 35.2851 15.9071 0.0856003441376422 0.0856003441376422 0.0856003441376422 -26.089 35.2851 16.9071 0.06814583934539548 0.06814583934539548 0.06814583934539548 -26.089 36.2851 15.9071 0.1040846139040711 0.1040846139040711 0.1040846139040711 -26.089 36.2851 16.9071 0.08699633520708998 0.08699633520708998 0.08699633520708998 -25.089 38.2851 16.9071 0.09338286627658456 0.09338286627658456 0.09338286627658456 -26.089 38.2851 15.9071 0.08262263112678835 0.08262263112678835 0.08262263112678835 -26.089 38.2851 16.9071 0.08248519555788898 0.08248519555788898 0.08248519555788898 -25.089 37.2851 17.9071 0.0943777275797532 0.0943777275797532 0.0943777275797532 -25.089 37.2851 18.9071 0.03905673950515857 0.03905673950515857 0.03905673950515857 -25.089 38.2851 17.9071 0.10844188573669693 0.10844188573669693 0.10844188573669693 -26.089 37.2851 17.9071 0.09197975341554306 0.09197975341554306 0.09197975341554306 -26.089 37.2851 18.9071 0.069997752365068 0.069997752365068 0.069997752365068 -26.089 38.2851 17.9071 0.07837327193778175 0.07837327193778175 0.07837327193778175 -27.089 35.2851 16.9071 0.06923425940202232 0.06923425940202232 0.06923425940202232 -27.089 36.2851 15.9071 0.09256478855651769 0.09256478855651769 0.09256478855651769 -27.089 36.2851 16.9071 0.11471664961790108 0.11471664961790108 0.11471664961790108 -28.089 36.2851 16.9071 0.12159422489804368 0.12159422489804368 0.12159422489804368 -27.089 35.2851 17.9071 0.07880561249575406 0.07880561249575406 0.07880561249575406 -27.089 35.2851 18.9071 0.10058287720465373 0.10058287720465373 0.10058287720465373 -27.089 36.2851 17.9071 0.1047941027942802 0.1047941027942802 0.1047941027942802 -27.089 36.2851 18.9071 0.0845828707914971 0.0845828707914971 0.0845828707914971 -28.089 35.2851 17.9071 0.13328820755873144 0.13328820755873144 0.13328820755873144 -28.089 35.2851 18.9071 0.14245311614475462 0.14245311614475462 0.14245311614475462 -28.089 36.2851 17.9071 0.1278213737902239 0.1278213737902239 0.1278213737902239 -28.089 36.2851 18.9071 0.12785270110719693 0.12785270110719693 0.12785270110719693 -27.089 37.2851 15.9071 0.08731941086310337 0.08731941086310337 0.08731941086310337 -27.089 37.2851 16.9071 0.09603071306085259 0.09603071306085259 0.09603071306085259 -27.089 38.2851 15.9071 0.058514609495324596 0.058514609495324596 0.058514609495324596 -27.089 38.2851 16.9071 0.06903257322233236 0.06903257322233236 0.06903257322233236 -28.089 37.2851 16.9071 0.05962382126609913 0.05962382126609913 0.05962382126609913 -28.089 38.2851 16.9071 0.10422683358277574 0.10422683358277574 0.10422683358277574 -27.089 37.2851 17.9071 0.10797909247982064 0.10797909247982064 0.10797909247982064 -27.089 37.2851 18.9071 0.09724491654025595 0.09724491654025595 0.09724491654025595 -28.089 37.2851 17.9071 0.14529289347451366 0.14529289347451366 0.14529289347451366 -28.089 37.2851 18.9071 0.14427938716363395 0.14427938716363395 0.14427938716363395 -28.089 38.2851 17.9071 0.12243128714108835 0.12243128714108835 0.12243128714108835 -28.089 38.2851 18.9071 0.11066743418110607 0.11066743418110607 0.11066743418110607 -25.089 39.2851 14.9071 0.05738110259317944 0.05738110259317944 0.05738110259317944 -26.089 39.2851 14.9071 0.04638487889320145 0.04638487889320145 0.04638487889320145 -25.089 39.2851 15.9071 0.07898412611056098 0.07898412611056098 0.07898412611056098 -25.089 39.2851 16.9071 0.09940729443469244 0.09940729443469244 0.09940729443469244 -26.089 39.2851 15.9071 0.06941809965225074 0.06941809965225074 0.06941809965225074 -26.089 39.2851 16.9071 0.0787854382622456 0.0787854382622456 0.0787854382622456 -25.089 39.2851 17.9071 0.08963635572498242 0.08963635572498242 0.08963635572498242 -26.089 39.2851 17.9071 0.08055625052143225 0.08055625052143225 0.08055625052143225 -30.089 35.2851 14.9071 0.08289348299343198 0.08289348299343198 0.08289348299343198 -30.089 36.2851 14.9071 0.10828280085491797 0.10828280085491797 0.10828280085491797 -30.089 37.2851 14.9071 0.08519608889064047 0.08519608889064047 0.08519608889064047 -31.089 35.2851 14.9071 0.08880377413149411 0.08880377413149411 0.08880377413149411 -31.089 36.2851 14.9071 0.10346671870885066 0.10346671870885066 0.10346671870885066 -32.089 35.2851 14.9071 0.078175547093524 0.078175547093524 0.078175547093524 -32.089 36.2851 14.9071 0.09132158379685708 0.09132158379685708 0.09132158379685708 -31.089 37.2851 14.9071 0.09987094054505007 0.09987094054505007 0.09987094054505007 -31.089 38.2851 14.9071 0.07389002300871278 0.07389002300871278 0.07389002300871278 -32.089 37.2851 14.9071 0.09592624731241525 0.09592624731241525 0.09592624731241525 -29.089 35.2851 16.9071 0.12428211170168162 0.12428211170168162 0.12428211170168162 -29.089 36.2851 15.9071 0.10749379946914456 0.10749379946914456 0.10749379946914456 -29.089 36.2851 16.9071 0.12536816601351422 0.12536816601351422 0.12536816601351422 -30.089 35.2851 15.9071 0.11127000890906584 0.11127000890906584 0.11127000890906584 -30.089 35.2851 16.9071 0.15301102388895446 0.15301102388895446 0.15301102388895446 -30.089 36.2851 15.9071 0.11027053582831967 0.11027053582831967 0.11027053582831967 -29.089 35.2851 17.9071 0.12024060773664828 0.12024060773664828 0.12024060773664828 -29.089 37.2851 15.9071 0.10799676866005621 0.10799676866005621 0.10799676866005621 -29.089 37.2851 16.9071 0.128291282263918 0.128291282263918 0.128291282263918 -29.089 38.2851 15.9071 0.09809267845662636 0.09809267845662636 0.09809267845662636 -29.089 38.2851 16.9071 0.13948312866180607 0.13948312866180607 0.13948312866180607 -30.089 38.2851 15.9071 0.1110064834499719 0.1110064834499719 0.1110064834499719 -30.089 38.2851 16.9071 0.10463983167664127 0.10463983167664127 0.10463983167664127 -29.089 38.2851 17.9071 0.15122510262861816 0.15122510262861816 0.15122510262861816 -29.089 38.2851 18.9071 0.13849123443397357 0.13849123443397357 0.13849123443397357 -30.089 38.2851 18.9071 0.13488095744949186 0.13488095744949186 0.13488095744949186 -31.089 35.2851 15.9071 0.09826544400736419 0.09826544400736419 0.09826544400736419 -32.089 35.2851 15.9071 0.11456802130501087 0.11456802130501087 0.11456802130501087 -32.089 35.2851 16.9071 0.14169818109801985 0.14169818109801985 0.14169818109801985 -32.089 36.2851 15.9071 0.12510629331220008 0.12510629331220008 0.12510629331220008 -31.089 36.2851 17.9071 0.14790851598222546 0.14790851598222546 0.14790851598222546 -31.089 36.2851 18.9071 0.14597872964622893 0.14597872964622893 0.14597872964622893 -32.089 35.2851 17.9071 0.13558937162677676 0.13558937162677676 0.13558937162677676 -32.089 35.2851 18.9071 0.06357624368307878 0.06357624368307878 0.06357624368307878 -32.089 36.2851 17.9071 0.17603012002609744 0.17603012002609744 0.17603012002609744 -32.089 36.2851 18.9071 0.0 0.0 0.0 -31.089 38.2851 15.9071 0.11128206035758995 0.11128206035758995 0.11128206035758995 -32.089 37.2851 15.9071 0.1167492146687007 0.1167492146687007 0.1167492146687007 -32.089 37.2851 16.9071 0.13257415059838107 0.13257415059838107 0.13257415059838107 -32.089 38.2851 15.9071 0.10117026038274865 0.10117026038274865 0.10117026038274865 -32.089 38.2851 16.9071 0.1097241948121422 0.1097241948121422 0.1097241948121422 -31.089 37.2851 17.9071 0.13434442192595272 0.13434442192595272 0.13434442192595272 -31.089 37.2851 18.9071 0.13019900215164013 0.13019900215164013 0.13019900215164013 -31.089 38.2851 17.9071 0.14797356415341295 0.14797356415341295 0.14797356415341295 -31.089 38.2851 18.9071 0.1298744921510304 0.1298744921510304 0.1298744921510304 -32.089 37.2851 17.9071 0.13424964432090555 0.13424964432090555 0.13424964432090555 -32.089 38.2851 17.9071 0.11397591551653419 0.11397591551653419 0.11397591551653419 -29.089 39.2851 16.9071 0.10554858071801324 0.10554858071801324 0.10554858071801324 -30.089 39.2851 16.9071 0.1284776383686546 0.1284776383686546 0.1284776383686546 -29.089 39.2851 17.9071 0.1346480307904535 0.1346480307904535 0.1346480307904535 -29.089 39.2851 18.9071 0.10671684247806446 0.10671684247806446 0.10671684247806446 -30.089 39.2851 17.9071 0.1451370938102912 0.1451370938102912 0.1451370938102912 -30.089 39.2851 18.9071 0.12292853976280353 0.12292853976280353 0.12292853976280353 -31.089 39.2851 15.9071 0.08248278440545873 0.08248278440545873 0.08248278440545873 -31.089 39.2851 16.9071 0.12932426799550042 0.12932426799550042 0.12932426799550042 -31.089 39.2851 17.9071 0.13019257622372246 0.13019257622372246 0.13019257622372246 -25.089 36.2851 20.9071 0.057466564376641 0.057466564376641 0.057466564376641 -26.089 36.2851 19.9071 0.054858612550882195 0.054858612550882195 0.054858612550882195 -25.089 35.2851 21.9071 0.1246733178657833 0.1246733178657833 0.1246733178657833 -25.089 35.2851 22.9071 0.04226620463727376 0.04226620463727376 0.04226620463727376 -25.089 36.2851 21.9071 0.033839638016560016 0.033839638016560016 0.033839638016560016 -25.089 36.2851 22.9071 0.04249545873499706 0.04249545873499706 0.04249545873499706 -26.089 35.2851 22.9071 0.045452946887687515 0.045452946887687515 0.045452946887687515 -26.089 36.2851 22.9071 0.021219809711270153 0.021219809711270153 0.021219809711270153 -25.089 37.2851 19.9071 0.04773797027248518 0.04773797027248518 0.04773797027248518 -25.089 37.2851 20.9071 0.07015032147372736 0.07015032147372736 0.07015032147372736 -26.089 37.2851 19.9071 0.20318611117871113 0.20318611117871113 0.20318611117871113 -26.089 37.2851 20.9071 0.04503248843954484 0.04503248843954484 0.04503248843954484 -25.089 37.2851 21.9071 0.03521087383430353 0.03521087383430353 0.03521087383430353 -25.089 37.2851 22.9071 0.07751525511918973 0.07751525511918973 0.07751525511918973 -25.089 38.2851 21.9071 0.08962590832594364 0.08962590832594364 0.08962590832594364 -25.089 38.2851 22.9071 0.10471294979532182 0.10471294979532182 0.10471294979532182 -26.089 38.2851 21.9071 0.08201100085688857 0.08201100085688857 0.08201100085688857 -27.089 35.2851 19.9071 0.21925803054187165 0.21925803054187165 0.21925803054187165 -27.089 35.2851 20.9071 0.19065550626775402 0.19065550626775402 0.19065550626775402 -27.089 36.2851 19.9071 0.08908023075121928 0.08908023075121928 0.08908023075121928 -27.089 36.2851 20.9071 0.09712357737403203 0.09712357737403203 0.09712357737403203 -28.089 35.2851 19.9071 0.1323685267213854 0.1323685267213854 0.1323685267213854 -28.089 35.2851 20.9071 0.09434156563152842 0.09434156563152842 0.09434156563152842 -28.089 36.2851 19.9071 0.11289533130464811 0.11289533130464811 0.11289533130464811 -28.089 36.2851 20.9071 0.10202440911684593 0.10202440911684593 0.10202440911684593 -27.089 35.2851 21.9071 0.08329292755416084 0.08329292755416084 0.08329292755416084 -27.089 35.2851 22.9071 0.09297704290705329 0.09297704290705329 0.09297704290705329 -27.089 36.2851 21.9071 0.08488827488512946 0.08488827488512946 0.08488827488512946 -27.089 36.2851 22.9071 0.06915877786587749 0.06915877786587749 0.06915877786587749 -28.089 35.2851 21.9071 0.09990549292116845 0.09990549292116845 0.09990549292116845 -28.089 36.2851 21.9071 0.09615044671340187 0.09615044671340187 0.09615044671340187 -27.089 37.2851 19.9071 0.06898683403831132 0.06898683403831132 0.06898683403831132 -27.089 37.2851 20.9071 0.07548202013679509 0.07548202013679509 0.07548202013679509 -28.089 37.2851 19.9071 0.1086572122473607 0.1086572122473607 0.1086572122473607 -27.089 37.2851 21.9071 0.04286776406796499 0.04286776406796499 0.04286776406796499 -27.089 37.2851 22.9071 0.08306547747395913 0.08306547747395913 0.08306547747395913 -27.089 38.2851 21.9071 0.08516715603164945 0.08516715603164945 0.08516715603164945 -27.089 38.2851 22.9071 0.07706257220725836 0.07706257220725836 0.07706257220725836 -28.089 37.2851 22.9071 0.09784277042213183 0.09784277042213183 0.09784277042213183 -28.089 38.2851 22.9071 0.0835171621627754 0.0835171621627754 0.0835171621627754 -25.089 35.2851 25.9071 0.08042604506524115 0.08042604506524115 0.08042604506524115 -25.089 35.2851 26.9071 0.12040609568574899 0.12040609568574899 0.12040609568574899 -25.089 36.2851 25.9071 0.058939338835940706 0.058939338835940706 0.058939338835940706 -25.089 36.2851 26.9071 0.12797961677932324 0.12797961677932324 0.12797961677932324 -26.089 35.2851 26.9071 0.10169335725002192 0.10169335725002192 0.10169335725002192 -26.089 36.2851 25.9071 0.04752400838334247 0.04752400838334247 0.04752400838334247 -26.089 36.2851 26.9071 0.07874002612445502 0.07874002612445502 0.07874002612445502 -25.089 37.2851 23.9071 0.05831410237975664 0.05831410237975664 0.05831410237975664 -25.089 37.2851 24.9071 0.0800732032944496 0.0800732032944496 0.0800732032944496 -25.089 38.2851 23.9071 0.0831571005518162 0.0831571005518162 0.0831571005518162 -25.089 38.2851 24.9071 0.11112780168013689 0.11112780168013689 0.11112780168013689 -25.089 37.2851 25.9071 0.10640589688502386 0.10640589688502386 0.10640589688502386 -25.089 37.2851 26.9071 0.0 0.0 0.0 -25.089 38.2851 25.9071 0.07995778592377592 0.07995778592377592 0.07995778592377592 -25.089 38.2851 26.9071 0.06997733477010074 0.06997733477010074 0.06997733477010074 -26.089 37.2851 25.9071 0.0656569676642591 0.0656569676642591 0.0656569676642591 -26.089 37.2851 26.9071 0.026057385821356777 0.026057385821356777 0.026057385821356777 -26.089 38.2851 25.9071 0.053468174187797486 0.053468174187797486 0.053468174187797486 -26.089 38.2851 26.9071 0.05426920276157683 0.05426920276157683 0.05426920276157683 -27.089 35.2851 23.9071 0.08361521437589976 0.08361521437589976 0.08361521437589976 -28.089 35.2851 23.9071 0.09809830338737831 0.09809830338737831 0.09809830338737831 -28.089 35.2851 24.9071 0.05400991254246022 0.05400991254246022 0.05400991254246022 -28.089 36.2851 23.9071 0.09606205275894224 0.09606205275894224 0.09606205275894224 -28.089 36.2851 24.9071 0.05606515653986975 0.05606515653986975 0.05606515653986975 -28.089 35.2851 26.9071 0.08767704284999188 0.08767704284999188 0.08767704284999188 -28.089 36.2851 26.9071 0.06917155908944304 0.06917155908944304 0.06917155908944304 -28.089 37.2851 23.9071 0.08560677362813934 0.08560677362813934 0.08560677362813934 -27.089 37.2851 25.9071 0.04414163031958765 0.04414163031958765 0.04414163031958765 -27.089 37.2851 26.9071 0.03246395563238455 0.03246395563238455 0.03246395563238455 -27.089 38.2851 26.9071 0.06069756421238131 0.06069756421238131 0.06069756421238131 -28.089 37.2851 25.9071 0.1276655402886694 0.1276655402886694 0.1276655402886694 -28.089 37.2851 26.9071 0.04348877839552842 0.04348877839552842 0.04348877839552842 -28.089 38.2851 26.9071 0.048513808517107536 0.048513808517107536 0.048513808517107536 -25.089 39.2851 21.9071 0.06479399185399873 0.06479399185399873 0.06479399185399873 -25.089 39.2851 22.9071 0.1024060813018526 0.1024060813018526 0.1024060813018526 -26.089 39.2851 21.9071 0.07754957596762424 0.07754957596762424 0.07754957596762424 -26.089 39.2851 22.9071 0.09722080943569412 0.09722080943569412 0.09722080943569412 -27.089 39.2851 21.9071 0.06952211751767491 0.06952211751767491 0.06952211751767491 -27.089 39.2851 22.9071 0.10278373410275668 0.10278373410275668 0.10278373410275668 -28.089 39.2851 22.9071 0.09003174859942523 0.09003174859942523 0.09003174859942523 -25.089 39.2851 23.9071 0.08340705420725604 0.08340705420725604 0.08340705420725604 -25.089 39.2851 24.9071 0.1255521190271629 0.1255521190271629 0.1255521190271629 -26.089 39.2851 23.9071 0.1623133944311481 0.1623133944311481 0.1623133944311481 -26.089 39.2851 24.9071 0.10593907450054266 0.10593907450054266 0.10593907450054266 -25.089 39.2851 25.9071 0.07047016905065245 0.07047016905065245 0.07047016905065245 -25.089 40.2851 25.9071 0.06300402108571733 0.06300402108571733 0.06300402108571733 -25.089 40.2851 26.9071 0.06167634929898741 0.06167634929898741 0.06167634929898741 -26.089 39.2851 25.9071 0.06148131676886134 0.06148131676886134 0.06148131676886134 -26.089 39.2851 26.9071 0.05700749766301768 0.05700749766301768 0.05700749766301768 -26.089 40.2851 25.9071 0.06366603997577777 0.06366603997577777 0.06366603997577777 -26.089 40.2851 26.9071 0.05213246562506428 0.05213246562506428 0.05213246562506428 -26.089 41.2851 26.9071 0.07434835036305441 0.07434835036305441 0.07434835036305441 -27.089 39.2851 23.9071 0.22117803667966174 0.22117803667966174 0.22117803667966174 -27.089 39.2851 24.9071 0.16141733028016209 0.16141733028016209 0.16141733028016209 -27.089 40.2851 24.9071 0.1011566003575385 0.1011566003575385 0.1011566003575385 -28.089 39.2851 23.9071 0.12375193193419226 0.12375193193419226 0.12375193193419226 -28.089 39.2851 24.9071 0.1414845492563111 0.1414845492563111 0.1414845492563111 -28.089 40.2851 24.9071 0.144712257110392 0.144712257110392 0.144712257110392 -27.089 40.2851 25.9071 0.07376479035212953 0.07376479035212953 0.07376479035212953 -27.089 40.2851 26.9071 0.04552555595542393 0.04552555595542393 0.04552555595542393 -28.089 41.2851 24.9071 0.14696892542088533 0.14696892542088533 0.14696892542088533 -27.089 41.2851 25.9071 0.09257443195726235 0.09257443195726235 0.09257443195726235 -27.089 41.2851 26.9071 0.08915738126624594 0.08915738126624594 0.08915738126624594 -27.089 42.2851 25.9071 0.08061733448999749 0.08061733448999749 0.08061733448999749 -27.089 42.2851 26.9071 0.10242134815158803 0.10242134815158803 0.10242134815158803 -28.089 41.2851 25.9071 0.13346812642317385 0.13346812642317385 0.13346812642317385 -28.089 42.2851 25.9071 0.11747465924650675 0.11747465924650675 0.11747465924650675 -28.089 42.2851 26.9071 0.13601907559974866 0.13601907559974866 0.13601907559974866 -29.089 35.2851 19.9071 0.13339262480584044 0.13339262480584044 0.13339262480584044 -29.089 36.2851 19.9071 0.12461307063382654 0.12461307063382654 0.12461307063382654 -29.089 36.2851 20.9071 0.0885699103771722 0.0885699103771722 0.0885699103771722 -30.089 35.2851 19.9071 0.12996766842377863 0.12996766842377863 0.12996766842377863 -30.089 36.2851 19.9071 0.13947590032705937 0.13947590032705937 0.13947590032705937 -29.089 35.2851 22.9071 0.14533626033768554 0.14533626033768554 0.14533626033768554 -30.089 35.2851 21.9071 0.1185945464492492 0.1185945464492492 0.1185945464492492 -30.089 35.2851 22.9071 0.18362008014464737 0.18362008014464737 0.18362008014464737 -30.089 36.2851 21.9071 0.14312612673520167 0.14312612673520167 0.14312612673520167 -30.089 36.2851 22.9071 0.17491103202172867 0.17491103202172867 0.17491103202172867 -29.089 37.2851 19.9071 0.11585585643367757 0.11585585643367757 0.11585585643367757 -29.089 38.2851 19.9071 0.11695487846917584 0.11695487846917584 0.11695487846917584 -30.089 37.2851 19.9071 0.11607116310263065 0.11607116310263065 0.11607116310263065 -30.089 38.2851 19.9071 0.10463420720321977 0.10463420720321977 0.10463420720321977 -29.089 37.2851 22.9071 0.11654033683322217 0.11654033683322217 0.11654033683322217 -29.089 38.2851 22.9071 0.1097989151995278 0.1097989151995278 0.1097989151995278 -30.089 37.2851 21.9071 0.13249302561592177 0.13249302561592177 0.13249302561592177 -30.089 37.2851 22.9071 0.15592028824484053 0.15592028824484053 0.15592028824484053 -30.089 38.2851 21.9071 0.12339124703483766 0.12339124703483766 0.12339124703483766 -30.089 38.2851 22.9071 0.13776597933589724 0.13776597933589724 0.13776597933589724 -31.089 35.2851 19.9071 0.1085551732637675 0.1085551732637675 0.1085551732637675 -31.089 35.2851 20.9071 0.1195200081843423 0.1195200081843423 0.1195200081843423 -31.089 36.2851 19.9071 0.13390346415377044 0.13390346415377044 0.13390346415377044 -31.089 36.2851 20.9071 0.1456052949850163 0.1456052949850163 0.1456052949850163 -32.089 35.2851 19.9071 0.07109651679235593 0.07109651679235593 0.07109651679235593 -32.089 35.2851 20.9071 0.12517778625083964 0.12517778625083964 0.12517778625083964 -32.089 36.2851 19.9071 0.07963090309864437 0.07963090309864437 0.07963090309864437 -32.089 36.2851 20.9071 0.16811829946634085 0.16811829946634085 0.16811829946634085 -31.089 35.2851 21.9071 0.1487107730846455 0.1487107730846455 0.1487107730846455 -31.089 35.2851 22.9071 0.18099518286533803 0.18099518286533803 0.18099518286533803 -31.089 36.2851 21.9071 0.16976334783923885 0.16976334783923885 0.16976334783923885 -31.089 36.2851 22.9071 0.1742800329268182 0.1742800329268182 0.1742800329268182 -32.089 35.2851 22.9071 0.17722063917198827 0.17722063917198827 0.17722063917198827 -32.089 36.2851 21.9071 0.1980001076486038 0.1980001076486038 0.1980001076486038 -32.089 36.2851 22.9071 0.18334876445553108 0.18334876445553108 0.18334876445553108 -31.089 37.2851 19.9071 0.11405063195533433 0.11405063195533433 0.11405063195533433 -31.089 37.2851 20.9071 0.13479180284242062 0.13479180284242062 0.13479180284242062 -31.089 38.2851 20.9071 0.07330380710308704 0.07330380710308704 0.07330380710308704 -32.089 37.2851 20.9071 0.1237607682922802 0.1237607682922802 0.1237607682922802 -31.089 37.2851 21.9071 0.11812056452860828 0.11812056452860828 0.11812056452860828 -31.089 38.2851 21.9071 0.12683495869899675 0.12683495869899675 0.12683495869899675 -32.089 37.2851 21.9071 0.18302206062161425 0.18302206062161425 0.18302206062161425 -32.089 37.2851 22.9071 0.1689452435556337 0.1689452435556337 0.1689452435556337 -32.089 38.2851 21.9071 0.12801174729747197 0.12801174729747197 0.12801174729747197 -32.089 38.2851 22.9071 0.15533812259364263 0.15533812259364263 0.15533812259364263 -29.089 35.2851 23.9071 0.12220475100202789 0.12220475100202789 0.12220475100202789 -29.089 35.2851 24.9071 0.0503417307105946 0.0503417307105946 0.0503417307105946 -29.089 36.2851 23.9071 0.11088677190448874 0.11088677190448874 0.11088677190448874 -29.089 36.2851 24.9071 0.09070841238435239 0.09070841238435239 0.09070841238435239 -30.089 35.2851 23.9071 0.13549218592400858 0.13549218592400858 0.13549218592400858 -30.089 35.2851 24.9071 0.056363031110710254 0.056363031110710254 0.056363031110710254 -30.089 36.2851 23.9071 0.15395857392841594 0.15395857392841594 0.15395857392841594 -30.089 36.2851 24.9071 0.05704785704829218 0.05704785704829218 0.05704785704829218 -29.089 35.2851 25.9071 0.04333527419937012 0.04333527419937012 0.04333527419937012 -29.089 35.2851 26.9071 0.06687613131431563 0.06687613131431563 0.06687613131431563 -29.089 36.2851 25.9071 0.039652693915497195 0.039652693915497195 0.039652693915497195 -29.089 36.2851 26.9071 0.08374862949034124 0.08374862949034124 0.08374862949034124 -30.089 36.2851 25.9071 0.11887813090729404 0.11887813090729404 0.11887813090729404 -30.089 36.2851 26.9071 0.1305010201841369 0.1305010201841369 0.1305010201841369 -29.089 37.2851 23.9071 0.1110466550696246 0.1110466550696246 0.1110466550696246 -30.089 37.2851 23.9071 0.1333452354566462 0.1333452354566462 0.1333452354566462 -30.089 37.2851 24.9071 0.07883237750691642 0.07883237750691642 0.07883237750691642 -30.089 38.2851 23.9071 0.10796704053652595 0.10796704053652595 0.10796704053652595 -30.089 38.2851 24.9071 0.07800868623714435 0.07800868623714435 0.07800868623714435 -29.089 37.2851 25.9071 0.10159934469968863 0.10159934469968863 0.10159934469968863 -29.089 37.2851 26.9071 0.03072336926100385 0.03072336926100385 0.03072336926100385 -29.089 38.2851 25.9071 0.07917630308925606 0.07917630308925606 0.07917630308925606 -29.089 38.2851 26.9071 0.05820870329065544 0.05820870329065544 0.05820870329065544 -30.089 37.2851 25.9071 0.07688509923426133 0.07688509923426133 0.07688509923426133 -30.089 37.2851 26.9071 0.058730712835812805 0.058730712835812805 0.058730712835812805 -30.089 38.2851 25.9071 0.0855296197082262 0.0855296197082262 0.0855296197082262 -30.089 38.2851 26.9071 0.09396949842023128 0.09396949842023128 0.09396949842023128 -31.089 35.2851 23.9071 0.05114648895353535 0.05114648895353535 0.05114648895353535 -31.089 36.2851 23.9071 0.12991786732590863 0.12991786732590863 0.12991786732590863 -31.089 36.2851 24.9071 0.0998428165070359 0.0998428165070359 0.0998428165070359 -32.089 35.2851 23.9071 0.07765382445025905 0.07765382445025905 0.07765382445025905 -32.089 36.2851 23.9071 0.07826042415936899 0.07826042415936899 0.07826042415936899 -32.089 36.2851 24.9071 0.10346270116930321 0.10346270116930321 0.10346270116930321 -31.089 36.2851 25.9071 0.12254776824086686 0.12254776824086686 0.12254776824086686 -31.089 36.2851 26.9071 0.15588254797860812 0.15588254797860812 0.15588254797860812 -32.089 35.2851 26.9071 0.12148657902557153 0.12148657902557153 0.12148657902557153 -32.089 36.2851 25.9071 0.12375514515542581 0.12375514515542581 0.12375514515542581 -32.089 36.2851 26.9071 0.12323138839970538 0.12323138839970538 0.12323138839970538 -31.089 37.2851 23.9071 0.15486034211884228 0.15486034211884228 0.15486034211884228 -31.089 38.2851 23.9071 0.14541335692559446 0.14541335692559446 0.14541335692559446 -32.089 37.2851 23.9071 0.11924204944144727 0.11924204944144727 0.11924204944144727 -32.089 38.2851 23.9071 0.11749554681188543 0.11749554681188543 0.11749554681188543 -31.089 37.2851 25.9071 0.13007128673828647 0.13007128673828647 0.13007128673828647 -31.089 37.2851 26.9071 0.10122490046036078 0.10122490046036078 0.10122490046036078 -31.089 38.2851 25.9071 0.07941115864821773 0.07941115864821773 0.07941115864821773 -31.089 38.2851 26.9071 0.09259452237178135 0.09259452237178135 0.09259452237178135 -29.089 39.2851 22.9071 0.10267927712241777 0.10267927712241777 0.10267927712241777 -30.089 39.2851 21.9071 0.0993687241006254 0.0993687241006254 0.0993687241006254 -30.089 39.2851 22.9071 0.1473784918864593 0.1473784918864593 0.1473784918864593 -31.089 39.2851 21.9071 0.12049847958693502 0.12049847958693502 0.12049847958693502 -31.089 39.2851 22.9071 0.15151981448868754 0.15151981448868754 0.15151981448868754 -32.089 39.2851 21.9071 0.09237111668007966 0.09237111668007966 0.09237111668007966 -32.089 39.2851 22.9071 0.11589763239956932 0.11589763239956932 0.11589763239956932 -29.089 39.2851 23.9071 0.10617610169519678 0.10617610169519678 0.10617610169519678 -29.089 39.2851 24.9071 0.08102884633272528 0.08102884633272528 0.08102884633272528 -29.089 40.2851 24.9071 0.15074247951266384 0.15074247951266384 0.15074247951266384 -30.089 39.2851 23.9071 0.11477851105099512 0.11477851105099512 0.11477851105099512 -30.089 39.2851 24.9071 0.08024753464977219 0.08024753464977219 0.08024753464977219 -30.089 40.2851 24.9071 0.12403549821412946 0.12403549821412946 0.12403549821412946 -30.089 39.2851 25.9071 0.08166057721422436 0.08166057721422436 0.08166057721422436 -30.089 40.2851 25.9071 0.13322636035615906 0.13322636035615906 0.13322636035615906 -30.089 40.2851 26.9071 0.08534236040737346 0.08534236040737346 0.08534236040737346 -29.089 41.2851 24.9071 0.14795991207245582 0.14795991207245582 0.14795991207245582 -29.089 41.2851 25.9071 0.15739615966734447 0.15739615966734447 0.15739615966734447 -29.089 41.2851 26.9071 0.08510286075219936 0.08510286075219936 0.08510286075219936 -29.089 42.2851 25.9071 0.1240949425767052 0.1240949425767052 0.1240949425767052 -29.089 42.2851 26.9071 0.14293097030583374 0.14293097030583374 0.14293097030583374 -30.089 41.2851 25.9071 0.1527106963778504 0.1527106963778504 0.1527106963778504 -30.089 41.2851 26.9071 0.1135798368918194 0.1135798368918194 0.1135798368918194 -30.089 42.2851 25.9071 0.10246232757603733 0.10246232757603733 0.10246232757603733 -30.089 42.2851 26.9071 0.12188583202303475 0.12188583202303475 0.12188583202303475 -31.089 39.2851 23.9071 0.1338207341021276 0.1338207341021276 0.1338207341021276 -32.089 39.2851 23.9071 0.0928693587386075 0.0928693587386075 0.0928693587386075 -31.089 39.2851 25.9071 0.0744875681865995 0.0744875681865995 0.0744875681865995 -31.089 39.2851 26.9071 0.09722241657623011 0.09722241657623011 0.09722241657623011 -31.089 40.2851 25.9071 0.07751067364652503 0.07751067364652503 0.07751067364652503 -31.089 40.2851 26.9071 0.08773892507739527 0.08773892507739527 0.08773892507739527 -31.089 42.2851 26.9071 0.10107303309403957 0.10107303309403957 0.10107303309403957 -33.089 28.2851 16.9071 0.06712517091111501 0.06712517091111501 0.06712517091111501 -34.089 27.2851 15.9071 0.03718376863096858 0.03718376863096858 0.03718376863096858 -34.089 27.2851 16.9071 0.04029825930371747 0.04029825930371747 0.04029825930371747 -34.089 28.2851 15.9071 0.04952755707116007 0.04952755707116007 0.04952755707116007 -34.089 28.2851 16.9071 0.06150615811904969 0.06150615811904969 0.06150615811904969 -33.089 27.2851 17.9071 0.06440940794292535 0.06440940794292535 0.06440940794292535 -33.089 28.2851 17.9071 0.08439882408051429 0.08439882408051429 0.08439882408051429 -33.089 28.2851 18.9071 0.08815361513931648 0.08815361513931648 0.08815361513931648 -34.089 27.2851 17.9071 0.08217415629821345 0.08217415629821345 0.08217415629821345 -34.089 27.2851 18.9071 0.08997790456212214 0.08997790456212214 0.08997790456212214 -34.089 28.2851 18.9071 0.06954567023051085 0.06954567023051085 0.06954567023051085 -33.089 29.2851 16.9071 0.10089384530372354 0.10089384530372354 0.10089384530372354 -34.089 29.2851 15.9071 0.04518904494005854 0.04518904494005854 0.04518904494005854 -34.089 29.2851 16.9071 0.07791239546985862 0.07791239546985862 0.07791239546985862 -34.089 30.2851 16.9071 0.07680335543702263 0.07680335543702263 0.07680335543702263 -33.089 29.2851 17.9071 0.11554012583608213 0.11554012583608213 0.11554012583608213 -33.089 29.2851 18.9071 0.11217627280184621 0.11217627280184621 0.11217627280184621 -33.089 30.2851 18.9071 0.11001986217561306 0.11001986217561306 0.11001986217561306 -34.089 29.2851 17.9071 0.10746407115976468 0.10746407115976468 0.10746407115976468 -34.089 29.2851 18.9071 0.09891069997000186 0.09891069997000186 0.09891069997000186 -34.089 30.2851 17.9071 0.09359501866885986 0.09359501866885986 0.09359501866885986 -34.089 30.2851 18.9071 0.079567567890669 0.079567567890669 0.079567567890669 -35.089 27.2851 15.9071 0.042191984387768625 0.042191984387768625 0.042191984387768625 -35.089 27.2851 16.9071 0.05017818908641282 0.05017818908641282 0.05017818908641282 -35.089 28.2851 15.9071 0.032490575221240374 0.032490575221240374 0.032490575221240374 -36.089 27.2851 16.9071 0.057135329112628405 0.057135329112628405 0.057135329112628405 -36.089 28.2851 15.9071 0.038837286283262835 0.038837286283262835 0.038837286283262835 -36.089 28.2851 16.9071 0.06084637247031409 0.06084637247031409 0.06084637247031409 -35.089 27.2851 17.9071 0.07811968571819171 0.07811968571819171 0.07811968571819171 -35.089 29.2851 15.9071 0.04497081458297773 0.04497081458297773 0.04497081458297773 -35.089 29.2851 16.9071 0.070300800311179 0.070300800311179 0.070300800311179 -35.089 30.2851 16.9071 0.07886275940068457 0.07886275940068457 0.07886275940068457 -36.089 29.2851 15.9071 0.042192547271836085 0.042192547271836085 0.042192547271836085 -36.089 29.2851 16.9071 0.0724936437427173 0.0724936437427173 0.0724936437427173 -36.089 30.2851 16.9071 0.07826339807008617 0.07826339807008617 0.07826339807008617 -35.089 29.2851 17.9071 0.09210511844674409 0.09210511844674409 0.09210511844674409 -35.089 29.2851 18.9071 0.08895325370081854 0.08895325370081854 0.08895325370081854 -35.089 30.2851 17.9071 0.089846107065009 0.089846107065009 0.089846107065009 -35.089 30.2851 18.9071 0.1101154717699077 0.1101154717699077 0.1101154717699077 -36.089 29.2851 17.9071 0.07624802590783372 0.07624802590783372 0.07624802590783372 -36.089 29.2851 18.9071 0.12383627894909237 0.12383627894909237 0.12383627894909237 -36.089 30.2851 17.9071 0.0884774898057658 0.0884774898057658 0.0884774898057658 -36.089 30.2851 18.9071 0.09084583390670213 0.09084583390670213 0.09084583390670213 -33.089 32.2851 16.9071 0.12947929503613234 0.12947929503613234 0.12947929503613234 -34.089 32.2851 16.9071 0.10061823281135923 0.10061823281135923 0.10061823281135923 -33.089 31.2851 17.9071 0.14103078049241005 0.14103078049241005 0.14103078049241005 -33.089 31.2851 18.9071 0.17382564628965913 0.17382564628965913 0.17382564628965913 -33.089 32.2851 17.9071 0.15738010027633406 0.15738010027633406 0.15738010027633406 -33.089 32.2851 18.9071 0.17231073802448937 0.17231073802448937 0.17231073802448937 -34.089 31.2851 18.9071 0.08959858435277436 0.08959858435277436 0.08959858435277436 -34.089 32.2851 17.9071 0.08189365733000573 0.08189365733000573 0.08189365733000573 -34.089 32.2851 18.9071 0.08015365778429916 0.08015365778429916 0.08015365778429916 -33.089 33.2851 16.9071 0.08457965600539992 0.08457965600539992 0.08457965600539992 -33.089 34.2851 16.9071 0.0884340922834234 0.0884340922834234 0.0884340922834234 -34.089 33.2851 16.9071 0.07404788982820802 0.07404788982820802 0.07404788982820802 -34.089 34.2851 16.9071 0.07350226734699586 0.07350226734699586 0.07350226734699586 -34.089 33.2851 17.9071 0.07579324602645178 0.07579324602645178 0.07579324602645178 -36.089 31.2851 16.9071 0.08471065843489796 0.08471065843489796 0.08471065843489796 -36.089 32.2851 16.9071 0.07447639540247863 0.07447639540247863 0.07447639540247863 -35.089 31.2851 17.9071 0.07446200742642076 0.07446200742642076 0.07446200742642076 -35.089 31.2851 18.9071 0.07729510300555882 0.07729510300555882 0.07729510300555882 -35.089 32.2851 17.9071 0.0777831502521525 0.0777831502521525 0.0777831502521525 -35.089 32.2851 18.9071 0.05422964598217798 0.05422964598217798 0.05422964598217798 -36.089 31.2851 17.9071 0.08519689258101451 0.08519689258101451 0.08519689258101451 -36.089 32.2851 17.9071 0.08581653547388204 0.08581653547388204 0.08581653547388204 -35.089 33.2851 16.9071 0.07168588370012371 0.07168588370012371 0.07168588370012371 -35.089 34.2851 16.9071 0.05278918708284211 0.05278918708284211 0.05278918708284211 -36.089 33.2851 16.9071 0.06768900399948463 0.06768900399948463 0.06768900399948463 -35.089 33.2851 17.9071 0.08086327736780724 0.08086327736780724 0.08086327736780724 -35.089 34.2851 17.9071 0.07276243979312289 0.07276243979312289 0.07276243979312289 -35.089 34.2851 18.9071 0.06490557229350712 0.06490557229350712 0.06490557229350712 -36.089 33.2851 17.9071 0.11166368862721636 0.11166368862721636 0.11166368862721636 -36.089 34.2851 17.9071 0.07647862999446187 0.07647862999446187 0.07647862999446187 -36.089 34.2851 18.9071 0.09570927955529614 0.09570927955529614 0.09570927955529614 -37.089 27.2851 16.9071 0.115200292281627 0.115200292281627 0.115200292281627 -37.089 28.2851 16.9071 0.10973463960163907 0.10973463960163907 0.10973463960163907 -38.089 27.2851 16.9071 0.10233778220174726 0.10233778220174726 0.10233778220174726 -38.089 28.2851 16.9071 0.10430316607500739 0.10430316607500739 0.10430316607500739 -37.089 28.2851 17.9071 0.13036848581478874 0.13036848581478874 0.13036848581478874 -37.089 28.2851 18.9071 0.16695815483954954 0.16695815483954954 0.16695815483954954 -38.089 27.2851 17.9071 0.13301190280495354 0.13301190280495354 0.13301190280495354 -38.089 27.2851 18.9071 0.1567513725992384 0.1567513725992384 0.1567513725992384 -38.089 28.2851 17.9071 0.14553622945988423 0.14553622945988423 0.14553622945988423 -38.089 28.2851 18.9071 0.1596853930569658 0.1596853930569658 0.1596853930569658 -37.089 29.2851 16.9071 0.07427150716558303 0.07427150716558303 0.07427150716558303 -37.089 30.2851 16.9071 0.07226785115109496 0.07226785115109496 0.07226785115109496 -38.089 30.2851 16.9071 0.06392079722042057 0.06392079722042057 0.06392079722042057 -37.089 29.2851 17.9071 0.08178756577482485 0.08178756577482485 0.08178756577482485 -37.089 29.2851 18.9071 0.11504604111661226 0.11504604111661226 0.11504604111661226 -37.089 30.2851 18.9071 0.06724398294552614 0.06724398294552614 0.06724398294552614 -38.089 29.2851 17.9071 0.057413180921426075 0.057413180921426075 0.057413180921426075 -38.089 29.2851 18.9071 0.0945312147791126 0.0945312147791126 0.0945312147791126 -38.089 30.2851 17.9071 0.07895398538843121 0.07895398538843121 0.07895398538843121 -38.089 30.2851 18.9071 0.09000603204878356 0.09000603204878356 0.09000603204878356 -39.089 27.2851 17.9071 0.09312651472287642 0.09312651472287642 0.09312651472287642 -39.089 27.2851 18.9071 0.11758873742213517 0.11758873742213517 0.11758873742213517 -39.089 30.2851 16.9071 0.07707864763838443 0.07707864763838443 0.07707864763838443 -40.089 30.2851 16.9071 0.05861614919523321 0.05861614919523321 0.05861614919523321 -39.089 29.2851 17.9071 0.0710361490434529 0.0710361490434529 0.0710361490434529 -39.089 29.2851 18.9071 0.069321316293483 0.069321316293483 0.069321316293483 -39.089 30.2851 17.9071 0.0974409873889379 0.0974409873889379 0.0974409873889379 -39.089 30.2851 18.9071 0.09401610736602871 0.09401610736602871 0.09401610736602871 -40.089 30.2851 17.9071 0.0633252637192675 0.0633252637192675 0.0633252637192675 -40.089 30.2851 18.9071 0.0623290536558335 0.0623290536558335 0.0623290536558335 -37.089 31.2851 16.9071 0.07383673083015817 0.07383673083015817 0.07383673083015817 -37.089 32.2851 16.9071 0.06772461522384234 0.06772461522384234 0.06772461522384234 -38.089 31.2851 16.9071 0.057985202095640204 0.057985202095640204 0.057985202095640204 -38.089 32.2851 16.9071 0.045351953435328184 0.045351953435328184 0.045351953435328184 -37.089 32.2851 17.9071 0.07889844605491331 0.07889844605491331 0.07889844605491331 -38.089 32.2851 17.9071 0.055784807724458506 0.055784807724458506 0.055784807724458506 -38.089 32.2851 18.9071 0.07065641798377095 0.07065641798377095 0.07065641798377095 -37.089 33.2851 17.9071 0.08459572993461904 0.08459572993461904 0.08459572993461904 -37.089 33.2851 18.9071 0.09923372778576581 0.09923372778576581 0.09923372778576581 -37.089 34.2851 17.9071 0.055678360140897346 0.055678360140897346 0.055678360140897346 -37.089 34.2851 18.9071 0.08336927991042176 0.08336927991042176 0.08336927991042176 -38.089 33.2851 18.9071 0.08398170355701005 0.08398170355701005 0.08398170355701005 -39.089 31.2851 16.9071 0.08925864120495992 0.08925864120495992 0.08925864120495992 -39.089 32.2851 16.9071 0.05460036942623034 0.05460036942623034 0.05460036942623034 -40.089 31.2851 16.9071 0.062019222736870994 0.062019222736870994 0.062019222736870994 -40.089 32.2851 16.9071 0.03800361591261865 0.03800361591261865 0.03800361591261865 -39.089 32.2851 17.9071 0.11488054214192163 0.11488054214192163 0.11488054214192163 -39.089 32.2851 18.9071 0.06456054063560301 0.06456054063560301 0.06456054063560301 -40.089 31.2851 17.9071 0.07481519532423511 0.07481519532423511 0.07481519532423511 -40.089 31.2851 18.9071 0.07092948048691063 0.07092948048691063 0.07092948048691063 -40.089 32.2851 17.9071 0.04647147806634987 0.04647147806634987 0.04647147806634987 -40.089 32.2851 18.9071 0.0457902608833874 0.0457902608833874 0.0457902608833874 -33.089 27.2851 19.9071 0.07646520690958922 0.07646520690958922 0.07646520690958922 -33.089 27.2851 20.9071 0.07633169933877812 0.07633169933877812 0.07633169933877812 -33.089 28.2851 19.9071 0.084328902293921 0.084328902293921 0.084328902293921 -33.089 28.2851 20.9071 0.054380797798666836 0.054380797798666836 0.054380797798666836 -34.089 27.2851 19.9071 0.12811858117805972 0.12811858117805972 0.12811858117805972 -34.089 27.2851 20.9071 0.06969655212149838 0.06969655212149838 0.06969655212149838 -34.089 28.2851 19.9071 0.09668402270332056 0.09668402270332056 0.09668402270332056 -34.089 28.2851 20.9071 0.05659168225980912 0.05659168225980912 0.05659168225980912 -33.089 27.2851 21.9071 0.07113172459302816 0.07113172459302816 0.07113172459302816 -33.089 27.2851 22.9071 0.08588725965108113 0.08588725965108113 0.08588725965108113 -34.089 27.2851 21.9071 0.054950750152509616 0.054950750152509616 0.054950750152509616 -34.089 27.2851 22.9071 0.08646269496388798 0.08646269496388798 0.08646269496388798 -34.089 28.2851 21.9071 0.03488935808535047 0.03488935808535047 0.03488935808535047 -34.089 28.2851 22.9071 0.05186448506708361 0.05186448506708361 0.05186448506708361 -33.089 29.2851 19.9071 0.08222800555843351 0.08222800555843351 0.08222800555843351 -33.089 29.2851 20.9071 0.0571551067904556 0.0571551067904556 0.0571551067904556 -33.089 30.2851 19.9071 0.10514683616539226 0.10514683616539226 0.10514683616539226 -33.089 30.2851 20.9071 0.06165649234000203 0.06165649234000203 0.06165649234000203 -34.089 29.2851 19.9071 0.06991174120157914 0.06991174120157914 0.06991174120157914 -34.089 29.2851 20.9071 0.07737089841608379 0.07737089841608379 0.07737089841608379 -34.089 30.2851 19.9071 0.09762902209827096 0.09762902209827096 0.09762902209827096 -34.089 30.2851 20.9071 0.05989676042786825 0.05989676042786825 0.05989676042786825 -33.089 29.2851 21.9071 0.04647236255139031 0.04647236255139031 0.04647236255139031 -33.089 30.2851 21.9071 0.05421573678478771 0.05421573678478771 0.05421573678478771 -33.089 30.2851 22.9071 0.04648860491126789 0.04648860491126789 0.04648860491126789 -34.089 29.2851 21.9071 0.06711777529829559 0.06711777529829559 0.06711777529829559 -36.089 28.2851 19.9071 0.15724118641039161 0.15724118641039161 0.15724118641039161 -36.089 28.2851 20.9071 0.15604956859717437 0.15604956859717437 0.15604956859717437 -35.089 27.2851 21.9071 0.09110942540960916 0.09110942540960916 0.09110942540960916 -35.089 27.2851 22.9071 0.0866660251727534 0.0866660251727534 0.0866660251727534 -35.089 28.2851 21.9071 0.0894386585590818 0.0894386585590818 0.0894386585590818 -35.089 28.2851 22.9071 0.088640632134028 0.088640632134028 0.088640632134028 -36.089 27.2851 22.9071 0.1236507153995832 0.1236507153995832 0.1236507153995832 -36.089 28.2851 21.9071 0.16177543596784452 0.16177543596784452 0.16177543596784452 -36.089 28.2851 22.9071 0.12754746006329107 0.12754746006329107 0.12754746006329107 -35.089 29.2851 19.9071 0.08579805073550727 0.08579805073550727 0.08579805073550727 -35.089 29.2851 20.9071 0.07096492951046744 0.07096492951046744 0.07096492951046744 -35.089 30.2851 19.9071 0.06604122405916676 0.06604122405916676 0.06604122405916676 -36.089 29.2851 19.9071 0.10096696682687926 0.10096696682687926 0.10096696682687926 -36.089 29.2851 20.9071 0.12070092046036901 0.12070092046036901 0.12070092046036901 -35.089 29.2851 21.9071 0.08029849173807721 0.08029849173807721 0.08029849173807721 -35.089 29.2851 22.9071 0.0930332957735507 0.0930332957735507 0.0930332957735507 -36.089 29.2851 21.9071 0.08063260547488789 0.08063260547488789 0.08063260547488789 -36.089 29.2851 22.9071 0.10329958889398368 0.10329958889398368 0.10329958889398368 -36.089 30.2851 21.9071 0.10580087527156311 0.10580087527156311 0.10580087527156311 -36.089 30.2851 22.9071 0.0999673657436429 0.0999673657436429 0.0999673657436429 -33.089 27.2851 23.9071 0.10446386582193264 0.10446386582193264 0.10446386582193264 -33.089 27.2851 24.9071 0.12274297411964309 0.12274297411964309 0.12274297411964309 -33.089 28.2851 24.9071 0.08659449800371134 0.08659449800371134 0.08659449800371134 -33.089 27.2851 25.9071 0.11953205839714036 0.11953205839714036 0.11953205839714036 -33.089 27.2851 26.9071 0.1286607810165302 0.1286607810165302 0.1286607810165302 -33.089 28.2851 25.9071 0.09188010414883188 0.09188010414883188 0.09188010414883188 -33.089 28.2851 26.9071 0.10044627585093578 0.10044627585093578 0.10044627585093578 -34.089 27.2851 25.9071 0.10344502399288259 0.10344502399288259 0.10344502399288259 -34.089 27.2851 26.9071 0.1125514694928174 0.1125514694928174 0.1125514694928174 -33.089 29.2851 24.9071 0.0364737636804908 0.0364737636804908 0.0364737636804908 -33.089 30.2851 23.9071 0.053171655716388926 0.053171655716388926 0.053171655716388926 -33.089 30.2851 24.9071 0.12007270942101778 0.12007270942101778 0.12007270942101778 -34.089 30.2851 23.9071 0.06693545715006095 0.06693545715006095 0.06693545715006095 -34.089 30.2851 24.9071 0.10641232471306188 0.10641232471306188 0.10641232471306188 -33.089 29.2851 25.9071 0.0822111274359675 0.0822111274359675 0.0822111274359675 -33.089 29.2851 26.9071 0.05376043034279257 0.05376043034279257 0.05376043034279257 -33.089 30.2851 25.9071 0.11494240344899846 0.11494240344899846 0.11494240344899846 -33.089 30.2851 26.9071 0.11813100822813956 0.11813100822813956 0.11813100822813956 -34.089 30.2851 25.9071 0.11125715402865513 0.11125715402865513 0.11125715402865513 -34.089 30.2851 26.9071 0.12384270538469377 0.12384270538469377 0.12384270538469377 -35.089 27.2851 23.9071 0.1266453856836191 0.1266453856836191 0.1266453856836191 -35.089 27.2851 24.9071 0.12595858139995755 0.12595858139995755 0.12595858139995755 -35.089 28.2851 23.9071 0.12319282948539723 0.12319282948539723 0.12319282948539723 -35.089 28.2851 24.9071 0.1108883787720409 0.1108883787720409 0.1108883787720409 -36.089 27.2851 23.9071 0.0963714311746638 0.0963714311746638 0.0963714311746638 -36.089 28.2851 23.9071 0.11037176919742493 0.11037176919742493 0.11037176919742493 -36.089 28.2851 24.9071 0.11876405455991827 0.11876405455991827 0.11876405455991827 -35.089 27.2851 25.9071 0.11037096575849385 0.11037096575849385 0.11037096575849385 -35.089 27.2851 26.9071 0.10988488373142538 0.10988488373142538 0.10988488373142538 -35.089 28.2851 25.9071 0.09699982730742025 0.09699982730742025 0.09699982730742025 -36.089 27.2851 26.9071 0.10067448033545898 0.10067448033545898 0.10067448033545898 -36.089 28.2851 25.9071 0.11527018724341802 0.11527018724341802 0.11527018724341802 -36.089 28.2851 26.9071 0.10835270182655067 0.10835270182655067 0.10835270182655067 -35.089 29.2851 23.9071 0.08812950531052194 0.08812950531052194 0.08812950531052194 -35.089 29.2851 24.9071 0.09465014706732747 0.09465014706732747 0.09465014706732747 -35.089 30.2851 23.9071 0.07735168834530498 0.07735168834530498 0.07735168834530498 -35.089 30.2851 24.9071 0.10355992557019054 0.10355992557019054 0.10355992557019054 -36.089 29.2851 24.9071 0.11697897966137569 0.11697897966137569 0.11697897966137569 -35.089 30.2851 25.9071 0.10605879340817456 0.10605879340817456 0.10605879340817456 -35.089 30.2851 26.9071 0.1239471348913155 0.1239471348913155 0.1239471348913155 -36.089 29.2851 25.9071 0.11930551409451688 0.11930551409451688 0.11930551409451688 -36.089 29.2851 26.9071 0.1090380495156841 0.1090380495156841 0.1090380495156841 -36.089 30.2851 26.9071 0.10873434399158437 0.10873434399158437 0.10873434399158437 -33.089 31.2851 19.9071 0.15756076824028029 0.15756076824028029 0.15756076824028029 -33.089 31.2851 20.9071 0.08260253822200911 0.08260253822200911 0.08260253822200911 -33.089 32.2851 19.9071 0.10532440750504625 0.10532440750504625 0.10532440750504625 -33.089 32.2851 20.9071 0.07510022020319772 0.07510022020319772 0.07510022020319772 -34.089 31.2851 19.9071 0.09666232615828278 0.09666232615828278 0.09666232615828278 -34.089 31.2851 20.9071 0.08233490025180899 0.08233490025180899 0.08233490025180899 -34.089 32.2851 19.9071 0.05986444190682281 0.05986444190682281 0.05986444190682281 -33.089 31.2851 21.9071 0.06574740474242793 0.06574740474242793 0.06574740474242793 -33.089 31.2851 22.9071 0.06883185116170185 0.06883185116170185 0.06883185116170185 -33.089 32.2851 21.9071 0.08822433726210963 0.08822433726210963 0.08822433726210963 -33.089 32.2851 22.9071 0.0981577669169858 0.0981577669169858 0.0981577669169858 -34.089 31.2851 22.9071 0.06741166999729493 0.06741166999729493 0.06741166999729493 -34.089 32.2851 22.9071 0.089260248504537 0.089260248504537 0.089260248504537 -33.089 33.2851 19.9071 0.07228939351185014 0.07228939351185014 0.07228939351185014 -33.089 33.2851 20.9071 0.046964215134451835 0.046964215134451835 0.046964215134451835 -33.089 34.2851 20.9071 0.11879458204902058 0.11879458204902058 0.11879458204902058 -34.089 33.2851 19.9071 0.043832211814610465 0.043832211814610465 0.043832211814610465 -34.089 33.2851 20.9071 0.06444043840192226 0.06444043840192226 0.06444043840192226 -34.089 34.2851 19.9071 0.0442896651034281 0.0442896651034281 0.0442896651034281 -34.089 34.2851 20.9071 0.09502140753867923 0.09502140753867923 0.09502140753867923 -33.089 33.2851 21.9071 0.07722758635493217 0.07722758635493217 0.07722758635493217 -33.089 33.2851 22.9071 0.12193242479907397 0.12193242479907397 0.12193242479907397 -33.089 34.2851 21.9071 0.13738447486069338 0.13738447486069338 0.13738447486069338 -33.089 34.2851 22.9071 0.15385819839339046 0.15385819839339046 0.15385819839339046 -34.089 33.2851 22.9071 0.09241531569708698 0.09241531569708698 0.09241531569708698 -34.089 34.2851 21.9071 0.07524851955051237 0.07524851955051237 0.07524851955051237 -34.089 34.2851 22.9071 0.08360878472622747 0.08360878472622747 0.08360878472622747 -35.089 32.2851 19.9071 0.04288272057450804 0.04288272057450804 0.04288272057450804 -36.089 32.2851 20.9071 0.0934254575214366 0.0934254575214366 0.0934254575214366 -35.089 31.2851 22.9071 0.0833781207048868 0.0833781207048868 0.0833781207048868 -35.089 32.2851 22.9071 0.08757899558704973 0.08757899558704973 0.08757899558704973 -36.089 31.2851 22.9071 0.1346665043087175 0.1346665043087175 0.1346665043087175 -36.089 32.2851 21.9071 0.07803585339437949 0.07803585339437949 0.07803585339437949 -36.089 32.2851 22.9071 0.1121955549014275 0.1121955549014275 0.1121955549014275 -35.089 33.2851 19.9071 0.035571069666832725 0.035571069666832725 0.035571069666832725 -35.089 34.2851 19.9071 0.051816324050113015 0.051816324050113015 0.051816324050113015 -35.089 34.2851 20.9071 0.055451877162571064 0.055451877162571064 0.055451877162571064 -36.089 33.2851 19.9071 0.06055140867004496 0.06055140867004496 0.06055140867004496 -36.089 33.2851 20.9071 0.046144459158814786 0.046144459158814786 0.046144459158814786 -36.089 34.2851 19.9071 0.07513735534996939 0.07513735534996939 0.07513735534996939 -36.089 34.2851 20.9071 0.03263871186598483 0.03263871186598483 0.03263871186598483 -35.089 33.2851 22.9071 0.0810336687246612 0.0810336687246612 0.0810336687246612 -35.089 34.2851 21.9071 0.05730786104895514 0.05730786104895514 0.05730786104895514 -35.089 34.2851 22.9071 0.07014863340825238 0.07014863340825238 0.07014863340825238 -36.089 33.2851 21.9071 0.06061982364618175 0.06061982364618175 0.06061982364618175 -36.089 33.2851 22.9071 0.08150786918602952 0.08150786918602952 0.08150786918602952 -36.089 34.2851 21.9071 0.044843365850836196 0.044843365850836196 0.044843365850836196 -33.089 31.2851 24.9071 0.12121666038364702 0.12121666038364702 0.12121666038364702 -33.089 32.2851 23.9071 0.0977857173536569 0.0977857173536569 0.0977857173536569 -33.089 32.2851 24.9071 0.13171068742857994 0.13171068742857994 0.13171068742857994 -34.089 31.2851 23.9071 0.05798319219000284 0.05798319219000284 0.05798319219000284 -34.089 31.2851 24.9071 0.18112281746618317 0.18112281746618317 0.18112281746618317 -34.089 32.2851 24.9071 0.12291247349028459 0.12291247349028459 0.12291247349028459 -33.089 31.2851 25.9071 0.15131825417791536 0.15131825417791536 0.15131825417791536 -33.089 31.2851 26.9071 0.15282311857212263 0.15282311857212263 0.15282311857212263 -34.089 31.2851 25.9071 0.07627840877754537 0.07627840877754537 0.07627840877754537 -34.089 31.2851 26.9071 0.09603955246411208 0.09603955246411208 0.09603955246411208 -34.089 32.2851 25.9071 0.11885081686702241 0.11885081686702241 0.11885081686702241 -34.089 32.2851 26.9071 0.12152594208518505 0.12152594208518505 0.12152594208518505 -33.089 33.2851 23.9071 0.11402331627606895 0.11402331627606895 0.11402331627606895 -33.089 34.2851 23.9071 0.09488801111630182 0.09488801111630182 0.09488801111630182 -34.089 33.2851 23.9071 0.10077733284926355 0.10077733284926355 0.10077733284926355 -34.089 33.2851 24.9071 0.14174636865308987 0.14174636865308987 0.14174636865308987 -34.089 34.2851 23.9071 0.09072046691324649 0.09072046691324649 0.09072046691324649 -34.089 34.2851 24.9071 0.13225928882298083 0.13225928882298083 0.13225928882298083 -33.089 34.2851 26.9071 0.14384892420196901 0.14384892420196901 0.14384892420196901 -34.089 33.2851 25.9071 0.14699060840369488 0.14699060840369488 0.14699060840369488 -34.089 33.2851 26.9071 0.08230114404818605 0.08230114404818605 0.08230114404818605 -34.089 34.2851 25.9071 0.1402806509411138 0.1402806509411138 0.1402806509411138 -34.089 34.2851 26.9071 0.12901742602916022 0.12901742602916022 0.12901742602916022 -35.089 31.2851 23.9071 0.08527485050961982 0.08527485050961982 0.08527485050961982 -35.089 31.2851 24.9071 0.07174512560684697 0.07174512560684697 0.07174512560684697 -35.089 32.2851 23.9071 0.0733363613686407 0.0733363613686407 0.0733363613686407 -35.089 32.2851 24.9071 0.08944106950305868 0.08944106950305868 0.08944106950305868 -36.089 31.2851 23.9071 0.07794679652516494 0.07794679652516494 0.07794679652516494 -36.089 31.2851 24.9071 0.08528047633659776 0.08528047633659776 0.08528047633659776 -36.089 32.2851 23.9071 0.06550945452307035 0.06550945452307035 0.06550945452307035 -35.089 31.2851 26.9071 0.09493783390234758 0.09493783390234758 0.09493783390234758 -35.089 32.2851 25.9071 0.08021691215689314 0.08021691215689314 0.08021691215689314 -35.089 32.2851 26.9071 0.09591660431339973 0.09591660431339973 0.09591660431339973 -36.089 31.2851 25.9071 0.09535007609340036 0.09535007609340036 0.09535007609340036 -36.089 31.2851 26.9071 0.1066437261805334 0.1066437261805334 0.1066437261805334 -36.089 32.2851 25.9071 0.0170704874071162 0.0170704874071162 0.0170704874071162 -35.089 33.2851 23.9071 0.07651568412729153 0.07651568412729153 0.07651568412729153 -35.089 33.2851 24.9071 0.07784029788334605 0.07784029788334605 0.07784029788334605 -35.089 34.2851 23.9071 0.059267109690322985 0.059267109690322985 0.059267109690322985 -35.089 34.2851 24.9071 0.07385634364205539 0.07385634364205539 0.07385634364205539 -36.089 33.2851 23.9071 0.08384025179019501 0.08384025179019501 0.08384025179019501 -36.089 34.2851 23.9071 0.06584338851685005 0.06584338851685005 0.06584338851685005 -36.089 34.2851 24.9071 0.09136015798897477 0.09136015798897477 0.09136015798897477 -35.089 33.2851 25.9071 0.060645388804479804 0.060645388804479804 0.060645388804479804 -35.089 34.2851 25.9071 0.09329607650033678 0.09329607650033678 0.09329607650033678 -35.089 34.2851 26.9071 0.10750424454820162 0.10750424454820162 0.10750424454820162 -36.089 34.2851 25.9071 0.08647716116173572 0.08647716116173572 0.08647716116173572 -36.089 34.2851 26.9071 0.08436587244151747 0.08436587244151747 0.08436587244151747 -37.089 28.2851 19.9071 0.1965025086775173 0.1965025086775173 0.1965025086775173 -37.089 28.2851 20.9071 0.1775754634530834 0.1775754634530834 0.1775754634530834 -38.089 27.2851 19.9071 0.15432233381810584 0.15432233381810584 0.15432233381810584 -38.089 27.2851 20.9071 0.18645198337263924 0.18645198337263924 0.18645198337263924 -38.089 28.2851 19.9071 0.15158405671267544 0.15158405671267544 0.15158405671267544 -38.089 28.2851 20.9071 0.1667734935978505 0.1667734935978505 0.1667734935978505 -37.089 27.2851 21.9071 0.13927511299095335 0.13927511299095335 0.13927511299095335 -37.089 27.2851 22.9071 0.09263631041790098 0.09263631041790098 0.09263631041790098 -37.089 28.2851 21.9071 0.15726126068330543 0.15726126068330543 0.15726126068330543 -38.089 27.2851 21.9071 0.10963661921600296 0.10963661921600296 0.10963661921600296 -38.089 27.2851 22.9071 0.10706715700370688 0.10706715700370688 0.10706715700370688 -37.089 29.2851 19.9071 0.12016348702274093 0.12016348702274093 0.12016348702274093 -37.089 29.2851 20.9071 0.11669779863642679 0.11669779863642679 0.11669779863642679 -37.089 30.2851 19.9071 0.12260641038590468 0.12260641038590468 0.12260641038590468 -37.089 30.2851 20.9071 0.1468813903568534 0.1468813903568534 0.1468813903568534 -38.089 30.2851 19.9071 0.09621473316474016 0.09621473316474016 0.09621473316474016 -37.089 30.2851 21.9071 0.14911952763106273 0.14911952763106273 0.14911952763106273 -38.089 29.2851 22.9071 0.0761870993779171 0.0761870993779171 0.0761870993779171 -38.089 30.2851 22.9071 0.07639744842904687 0.07639744842904687 0.07639744842904687 -39.089 27.2851 19.9071 0.12654899245363452 0.12654899245363452 0.12654899245363452 -39.089 27.2851 20.9071 0.04678104723600686 0.04678104723600686 0.04678104723600686 -39.089 27.2851 21.9071 0.09177161488748282 0.09177161488748282 0.09177161488748282 -39.089 27.2851 22.9071 0.10916258451819177 0.10916258451819177 0.10916258451819177 -39.089 28.2851 22.9071 0.09413745121893688 0.09413745121893688 0.09413745121893688 -40.089 27.2851 22.9071 0.09841249532338744 0.09841249532338744 0.09841249532338744 -40.089 28.2851 22.9071 0.09266443697519389 0.09266443697519389 0.09266443697519389 -39.089 30.2851 19.9071 0.06575142416575809 0.06575142416575809 0.06575142416575809 -39.089 30.2851 22.9071 0.05487485321780408 0.05487485321780408 0.05487485321780408 -40.089 29.2851 22.9071 0.09279221178305373 0.09279221178305373 0.09279221178305373 -37.089 27.2851 24.9071 0.08777830465186338 0.08777830465186338 0.08777830465186338 -37.089 28.2851 23.9071 0.09247639066245289 0.09247639066245289 0.09247639066245289 -37.089 28.2851 24.9071 0.10986560107806558 0.10986560107806558 0.10986560107806558 -38.089 27.2851 23.9071 0.10508737780118718 0.10508737780118718 0.10508737780118718 -38.089 27.2851 24.9071 0.11075982926566845 0.11075982926566845 0.11075982926566845 -38.089 28.2851 23.9071 0.10681566989549945 0.10681566989549945 0.10681566989549945 -37.089 27.2851 26.9071 0.23883384720359815 0.23883384720359815 0.23883384720359815 -37.089 28.2851 25.9071 0.10036270784962359 0.10036270784962359 0.10036270784962359 -38.089 27.2851 25.9071 0.1328167218401216 0.1328167218401216 0.1328167218401216 -38.089 27.2851 26.9071 0.145867904056671 0.145867904056671 0.145867904056671 -38.089 28.2851 26.9071 0.06600159267903712 0.06600159267903712 0.06600159267903712 -37.089 29.2851 23.9071 0.09983719169824976 0.09983719169824976 0.09983719169824976 -37.089 29.2851 24.9071 0.0928323924983104 0.0928323924983104 0.0928323924983104 -37.089 30.2851 23.9071 0.08537129320335772 0.08537129320335772 0.08537129320335772 -37.089 30.2851 24.9071 0.08326319030106573 0.08326319030106573 0.08326319030106573 -38.089 29.2851 23.9071 0.10822414826863057 0.10822414826863057 0.10822414826863057 -38.089 30.2851 23.9071 0.09591660431339973 0.09591660431339973 0.09591660431339973 -37.089 29.2851 25.9071 0.10524646900150711 0.10524646900150711 0.10524646900150711 -37.089 30.2851 25.9071 0.09645178901009939 0.09645178901009939 0.09645178901009939 -38.089 29.2851 26.9071 0.08590011858572189 0.08590011858572189 0.08590011858572189 -38.089 30.2851 26.9071 0.07594620603662222 0.07594620603662222 0.07594620603662222 -39.089 27.2851 23.9071 0.1061624425198839 0.1061624425198839 0.1061624425198839 -39.089 27.2851 24.9071 0.13523596850852646 0.13523596850852646 0.13523596850852646 -39.089 28.2851 23.9071 0.09778491378902804 0.09778491378902804 0.09778491378902804 -39.089 28.2851 26.9071 0.04926994007368563 0.04926994007368563 0.04926994007368563 -40.089 28.2851 26.9071 0.04664604306147147 0.04664604306147147 0.04664604306147147 -39.089 29.2851 23.9071 0.10548349823666162 0.10548349823666162 0.10548349823666162 -39.089 30.2851 23.9071 0.09670812996870659 0.09670812996870659 0.09670812996870659 -40.089 29.2851 23.9071 0.11945011691450765 0.11945011691450765 0.11945011691450765 -40.089 29.2851 24.9071 0.10652882900730956 0.10652882900730956 0.10652882900730956 -40.089 30.2851 23.9071 0.07964673689285671 0.07964673689285671 0.07964673689285671 -40.089 30.2851 24.9071 0.07467236098787965 0.07467236098787965 0.07467236098787965 -39.089 29.2851 26.9071 0.0651706958006942 0.0651706958006942 0.0651706958006942 -39.089 30.2851 26.9071 0.07529642540591741 0.07529642540591741 0.07529642540591741 -40.089 29.2851 25.9071 0.127565935212027 0.127565935212027 0.127565935212027 -40.089 29.2851 26.9071 0.09178366925709516 0.09178366925709516 0.09178366925709516 -40.089 30.2851 25.9071 0.06580496286545537 0.06580496286545537 0.06580496286545537 -40.089 30.2851 26.9071 0.05232060625756659 0.05232060625756659 0.05232060625756659 -37.089 31.2851 20.9071 0.11667289398399437 0.11667289398399437 0.11667289398399437 -37.089 32.2851 20.9071 0.12777639095479007 0.12777639095479007 0.12777639095479007 -38.089 31.2851 19.9071 0.11644473487376401 0.11644473487376401 0.11644473487376401 -38.089 31.2851 20.9071 0.12753059144551332 0.12753059144551332 0.12753059144551332 -38.089 32.2851 19.9071 0.11190310922808917 0.11190310922808917 0.11190310922808917 -38.089 32.2851 20.9071 0.10625323581810633 0.10625323581810633 0.10625323581810633 -37.089 31.2851 21.9071 0.14526076985709524 0.14526076985709524 0.14526076985709524 -37.089 31.2851 22.9071 0.13114521443342145 0.13114521443342145 0.13114521443342145 -37.089 32.2851 21.9071 0.1095217263168735 0.1095217263168735 0.1095217263168735 -37.089 33.2851 19.9071 0.08117753661761516 0.08117753661761516 0.08117753661761516 -37.089 33.2851 20.9071 0.09210913655348085 0.09210913655348085 0.09210913655348085 -37.089 34.2851 19.9071 0.06671969739674793 0.06671969739674793 0.06671969739674793 -38.089 33.2851 19.9071 0.07770148774388713 0.07770148774388713 0.07770148774388713 -37.089 33.2851 22.9071 0.0743251205757497 0.0743251205757497 0.0743251205757497 -39.089 31.2851 19.9071 0.06699896307750498 0.06699896307750498 0.06699896307750498 -39.089 32.2851 19.9071 0.05178713797737186 0.05178713797737186 0.05178713797737186 -37.089 31.2851 23.9071 0.09171455751356095 0.09171455751356095 0.09171455751356095 -37.089 31.2851 24.9071 0.08859241276110336 0.08859241276110336 0.08859241276110336 -37.089 32.2851 23.9071 0.08885199337774173 0.08885199337774173 0.08885199337774173 -38.089 31.2851 23.9071 0.09751973702154117 0.09751973702154117 0.09751973702154117 -38.089 31.2851 24.9071 0.11318295290633668 0.11318295290633668 0.11318295290633668 -38.089 32.2851 23.9071 0.08451616395361915 0.08451616395361915 0.08451616395361915 -38.089 32.2851 24.9071 0.11881064914388145 0.11881064914388145 0.11881064914388145 -37.089 31.2851 25.9071 0.09390842458831404 0.09390842458831404 0.09390842458831404 -37.089 31.2851 26.9071 0.1163804645850651 0.1163804645850651 0.1163804645850651 -38.089 31.2851 25.9071 0.10876567874156064 0.10876567874156064 0.10876567874156064 -38.089 31.2851 26.9071 0.1579373592697798 0.1579373592697798 0.1579373592697798 -38.089 32.2851 25.9071 0.13039579594513262 0.13039579594513262 0.13039579594513262 -38.089 32.2851 26.9071 0.1688288296105108 0.1688288296105108 0.1688288296105108 -37.089 33.2851 23.9071 0.11111173305088258 0.11111173305088258 0.11111173305088258 -37.089 34.2851 23.9071 0.0838884740113785 0.0838884740113785 0.0838884740113785 -37.089 34.2851 24.9071 0.10462135126248644 0.10462135126248644 0.10462135126248644 -38.089 33.2851 23.9071 0.08131095577445291 0.08131095577445291 0.08131095577445291 -38.089 33.2851 24.9071 0.11157129458065759 0.11157129458065759 0.11157129458065759 -38.089 34.2851 23.9071 0.05279200113240328 0.05279200113240328 0.05279200113240328 -38.089 34.2851 24.9071 0.10728811148200641 0.10728811148200641 0.10728811148200641 -38.089 33.2851 25.9071 0.11044006147765059 0.11044006147765059 0.11044006147765059 -38.089 33.2851 26.9071 0.13397013005582722 0.13397013005582722 0.13397013005582722 -39.089 31.2851 23.9071 0.07342984428515352 0.07342984428515352 0.07342984428515352 -39.089 31.2851 24.9071 0.10758218086459434 0.10758218086459434 0.10758218086459434 -39.089 32.2851 23.9071 0.05841114016808643 0.05841114016808643 0.05841114016808643 -39.089 32.2851 24.9071 0.11400724822512574 0.11400724822512574 0.11400724822512574 -40.089 31.2851 23.9071 0.04126217496213647 0.04126217496213647 0.04126217496213647 -40.089 31.2851 24.9071 0.07517834867390177 0.07517834867390177 0.07517834867390177 -39.089 31.2851 25.9071 0.10105374832858811 0.10105374832858811 0.10105374832858811 -39.089 31.2851 26.9071 0.09430138566998143 0.09430138566998143 0.09430138566998143 -39.089 32.2851 25.9071 0.10369812864858516 0.10369812864858516 0.10369812864858516 -39.089 32.2851 26.9071 0.11976583216832286 0.11976583216832286 0.11976583216832286 -40.089 31.2851 25.9071 0.07130093081745083 0.07130093081745083 0.07130093081745083 -39.089 34.2851 24.9071 0.0742765711024116 0.0742765711024116 0.0742765711024116 -39.089 33.2851 25.9071 0.10154952603874057 0.10154952603874057 0.10154952603874057 -39.089 33.2851 26.9071 0.09974880179427753 0.09974880179427753 0.09974880179427753 -39.089 34.2851 25.9071 0.09500855006182277 0.09500855006182277 0.09500855006182277 -39.089 34.2851 26.9071 0.08273997359045862 0.08273997359045862 0.08273997359045862 -33.089 35.2851 15.9071 0.09120827200055652 0.09120827200055652 0.09120827200055652 -33.089 35.2851 16.9071 0.0995752358820781 0.0995752358820781 0.0995752358820781 -33.089 36.2851 15.9071 0.08640000807650228 0.08640000807650228 0.08640000807650228 -33.089 36.2851 16.9071 0.11879136862966336 0.11879136862966336 0.11879136862966336 -34.089 35.2851 16.9071 0.06230019296415286 0.06230019296415286 0.06230019296415286 -33.089 35.2851 17.9071 0.09437933477708314 0.09437933477708314 0.09437933477708314 -33.089 36.2851 17.9071 0.09078797224168667 0.09078797224168667 0.09078797224168667 -33.089 36.2851 18.9071 0.056515465282324436 0.056515465282324436 0.056515465282324436 -34.089 35.2851 17.9071 0.0784661059957884 0.0784661059957884 0.0784661059957884 -34.089 35.2851 18.9071 0.06890652915145372 0.06890652915145372 0.06890652915145372 -34.089 36.2851 17.9071 0.03071637241866454 0.03071637241866454 0.03071637241866454 -34.089 36.2851 18.9071 0.05794178812245213 0.05794178812245213 0.05794178812245213 -33.089 37.2851 16.9071 0.0923879926712442 0.0923879926712442 0.0923879926712442 -35.089 35.2851 17.9071 0.04960458471482809 0.04960458471482809 0.04960458471482809 -35.089 35.2851 18.9071 0.1120758451251897 0.1120758451251897 0.1120758451251897 -33.089 35.2851 20.9071 0.14083642211508196 0.14083642211508196 0.14083642211508196 -33.089 36.2851 19.9071 0.06337205120302487 0.06337205120302487 0.06337205120302487 -33.089 36.2851 20.9071 0.07443194538991066 0.07443194538991066 0.07443194538991066 -34.089 35.2851 19.9071 0.08703330412899145 0.08703330412899145 0.08703330412899145 -34.089 35.2851 20.9071 0.09027846633938313 0.09027846633938313 0.09027846633938313 -34.089 36.2851 19.9071 0.07085166942353566 0.07085166942353566 0.07085166942353566 -34.089 36.2851 20.9071 0.0731608093213423 0.0731608093213423 0.0731608093213423 -33.089 35.2851 21.9071 0.1727996543022477 0.1727996543022477 0.1727996543022477 -33.089 35.2851 22.9071 0.14890109716914365 0.14890109716914365 0.14890109716914365 -33.089 36.2851 21.9071 0.12555452888918253 0.12555452888918253 0.12555452888918253 -33.089 36.2851 22.9071 0.14116891921893754 0.14116891921893754 0.14116891921893754 -33.089 37.2851 21.9071 0.13157976150628375 0.13157976150628375 0.13157976150628375 -33.089 37.2851 22.9071 0.13983490683502073 0.13983490683502073 0.13983490683502073 -33.089 38.2851 21.9071 0.08316915621218367 0.08316915621218367 0.08316915621218367 -33.089 38.2851 22.9071 0.10920356050913009 0.10920356050913009 0.10920356050913009 -35.089 35.2851 19.9071 0.06334745160155317 0.06334745160155317 0.06334745160155317 -33.089 35.2851 23.9071 0.10186531154504738 0.10186531154504738 0.10186531154504738 -33.089 35.2851 24.9071 0.11599082486071102 0.11599082486071102 0.11599082486071102 -33.089 36.2851 23.9071 0.07138436824508419 0.07138436824508419 0.07138436824508419 -33.089 36.2851 24.9071 0.08990879126738216 0.08990879126738216 0.08990879126738216 -34.089 35.2851 24.9071 0.07031092868435924 0.07031092868435924 0.07031092868435924 -33.089 35.2851 25.9071 0.14188611239953955 0.14188611239953955 0.14188611239953955 -33.089 35.2851 26.9071 0.1214881856814335 0.1214881856814335 0.1214881856814335 -33.089 36.2851 25.9071 0.11529991266853126 0.11529991266853126 0.11529991266853126 -34.089 35.2851 25.9071 0.12198142751717822 0.12198142751717822 0.12198142751717822 -35.089 35.2851 26.9071 0.06810395819082218 0.06810395819082218 0.06810395819082218 -36.089 35.2851 25.9071 0.06491811302487523 0.06491811302487523 0.06491811302487523 -36.089 35.2851 26.9071 0.10078295759232181 0.10078295759232181 0.10078295759232181 -37.089 35.2851 24.9071 0.08115101350583705 0.08115101350583705 0.08115101350583705 -38.089 35.2851 24.9071 0.07633997826141932 0.07633997826141932 0.07633997826141932 -37.089 35.2851 25.9071 0.10497729936228634 0.10497729936228634 0.10497729936228634 -37.089 35.2851 26.9071 0.10736926188347863 0.10736926188347863 0.10736926188347863 -37.089 36.2851 25.9071 0.05841765222757341 0.05841765222757341 0.05841765222757341 -37.089 36.2851 26.9071 0.07524538477037976 0.07524538477037976 0.07524538477037976 -38.089 35.2851 25.9071 0.10904849439425866 0.10904849439425866 0.10904849439425866 -38.089 36.2851 25.9071 0.0712953843957886 0.0712953843957886 0.0712953843957886 -38.089 36.2851 26.9071 0.06820862084336933 0.06820862084336933 0.06820862084336933 -39.089 35.2851 24.9071 0.053868810072109315 0.053868810072109315 0.053868810072109315 -39.089 35.2851 25.9071 0.1041617500322029 0.1041617500322029 0.1041617500322029 -39.089 35.2851 26.9071 0.0967957196388241 0.0967957196388241 0.0967957196388241 -39.089 36.2851 25.9071 0.053872026085583766 0.053872026085583766 0.053872026085583766 -39.089 36.2851 26.9071 0.062186036366400146 0.062186036366400146 0.062186036366400146 -28.089 43.2851 26.9071 0.10920918466312168 0.10920918466312168 0.10920918466312168 -28.089 44.2851 26.9071 0.0792902748321611 0.0792902748321611 0.0792902748321611 -29.089 43.2851 25.9071 0.07075151168365032 0.07075151168365032 0.07075151168365032 -29.089 43.2851 26.9071 0.12914996262416265 0.12914996262416265 0.12914996262416265 -29.089 44.2851 26.9071 0.10133096638745885 0.10133096638745885 0.10133096638745885 -30.089 43.2851 25.9071 0.0654085666331467 0.0654085666331467 0.0654085666331467 -30.089 43.2851 26.9071 0.1129290746742781 0.1129290746742781 0.1129290746742781 -30.089 44.2851 26.9071 0.0192890734780166 0.0192890734780166 0.0192890734780166 -29.089 45.2851 26.9071 0.03535490410951177 0.03535490410951177 0.03535490410951177 -29.089 46.2851 26.9071 0.025364574873813488 0.025364574873813488 0.025364574873813488 -30.089 45.2851 26.9071 0.04393425250818063 0.04393425250818063 0.04393425250818063 -30.089 46.2851 26.9071 0.034054199242316216 0.034054199242316216 0.034054199242316216 -31.089 43.2851 26.9071 0.06948731093625107 0.06948731093625107 0.06948731093625107 -31.089 44.2851 26.9071 0.05252522879644859 0.05252522879644859 0.05252522879644859 -32.089 43.2851 26.9071 0.06844310649159135 0.06844310649159135 0.06844310649159135 -32.089 44.2851 26.9071 0.06478330006025226 0.06478330006025226 0.06478330006025226 -31.089 45.2851 26.9071 0.054315513112770615 0.054315513112770615 0.054315513112770615 -31.089 46.2851 26.9071 0.03765388512194934 0.03765388512194934 0.03765388512194934 -32.089 45.2851 26.9071 0.04928063392924675 0.04928063392924675 0.04928063392924675 -32.089 46.2851 26.9071 0.028028574861599095 0.028028574861599095 0.028028574861599095 -33.089 44.2851 26.9071 0.06959020332738881 0.06959020332738881 0.06959020332738881 -41.089 27.2851 22.9071 0.10534851218156978 0.10534851218156978 0.10534851218156978 -41.089 28.2851 22.9071 0.09502622909197957 0.09502622909197957 0.09502622909197957 -42.089 27.2851 22.9071 0.06006631185918164 0.06006631185918164 0.06006631185918164 -42.089 28.2851 22.9071 0.05436552183011542 0.05436552183011542 0.05436552183011542 -41.089 29.2851 22.9071 0.08784018680139806 0.08784018680139806 0.08784018680139806 -42.089 27.2851 23.9071 0.05957775515423153 0.05957775515423153 0.05957775515423153 -42.089 27.2851 24.9071 0.05875016853962568 0.05875016853962568 0.05875016853962568 -42.089 28.2851 23.9071 0.07345106481169923 0.07345106481169923 0.07345106481169923 -42.089 28.2851 24.9071 0.06787630439346205 0.06787630439346205 0.06787630439346205 -41.089 27.2851 25.9071 0.0817578279653168 0.0817578279653168 0.0817578279653168 -41.089 27.2851 26.9071 0.08486496777147523 0.08486496777147523 0.08486496777147523 -41.089 28.2851 25.9071 0.13404000871312313 0.13404000871312313 0.13404000871312313 -41.089 28.2851 26.9071 0.1081036291215148 0.1081036291215148 0.1081036291215148 -42.089 27.2851 25.9071 0.07109362299982608 0.07109362299982608 0.07109362299982608 -42.089 27.2851 26.9071 0.10047279260244364 0.10047279260244364 0.10047279260244364 -42.089 28.2851 25.9071 0.07113558298122352 0.07113558298122352 0.07113558298122352 -41.089 29.2851 23.9071 0.10269293688908279 0.10269293688908279 0.10269293688908279 -41.089 29.2851 24.9071 0.10453055612264744 0.10453055612264744 0.10453055612264744 -42.089 29.2851 23.9071 0.03630866592414707 0.03630866592414707 0.03630866592414707 -42.089 29.2851 24.9071 0.058495475317399806 0.058495475317399806 0.058495475317399806 -41.089 29.2851 25.9071 0.14805788577853765 0.14805788577853765 0.14805788577853765 -41.089 29.2851 26.9071 0.12102386079927001 0.12102386079927001 0.12102386079927001 -43.089 27.2851 26.9071 0.09408923514036145 0.09408923514036145 0.09408923514036145 -25.089 27.2851 27.9071 0.4093712585464929 0.4093712585464929 0.4093712585464929 -25.089 27.2851 28.9071 0.3777717541866544 0.3777717541866544 0.3777717541866544 -25.089 28.2851 27.9071 0.3456102857440806 0.3456102857440806 0.3456102857440806 -25.089 28.2851 28.9071 0.4755003742912753 0.4755003742912753 0.4755003742912753 -26.089 27.2851 27.9071 0.19471835518758465 0.19471835518758465 0.19471835518758465 -26.089 27.2851 28.9071 0.10860257721713613 0.10860257721713613 0.10860257721713613 -26.089 28.2851 27.9071 0.28610070338591 0.28610070338591 0.28610070338591 -26.089 28.2851 28.9071 0.10678433438603765 0.10678433438603765 0.10678433438603765 -25.089 27.2851 29.9071 0.08702767842458015 0.08702767842458015 0.08702767842458015 -25.089 27.2851 30.9071 0.11981483620604627 0.11981483620604627 0.11981483620604627 -25.089 28.2851 29.9071 0.18569746107459878 0.18569746107459878 0.18569746107459878 -25.089 28.2851 30.9071 0.13092191576402645 0.13092191576402645 0.13092191576402645 -25.089 29.2851 28.9071 0.891041696287719 0.891041696287719 0.891041696287719 -26.089 29.2851 28.9071 0.5169937413567602 0.5169937413567602 0.5169937413567602 -26.089 30.2851 28.9071 0.9759357989437822 0.9759357989437822 0.9759357989437822 -25.089 29.2851 29.9071 0.5092984593516746 0.5092984593516746 0.5092984593516746 -25.089 29.2851 30.9071 0.2789421309234932 0.2789421309234932 0.2789421309234932 -25.089 30.2851 29.9071 0.8964441864162341 0.8964441864162341 0.8964441864162341 -25.089 30.2851 30.9071 0.2362412336969661 0.2362412336969661 0.2362412336969661 -26.089 29.2851 29.9071 0.1918120987287507 0.1918120987287507 0.1918120987287507 -26.089 29.2851 30.9071 0.1976036398945525 0.1976036398945525 0.1976036398945525 -26.089 30.2851 29.9071 1.0 1.0 1.0 -27.089 27.2851 27.9071 0.23161731832672847 0.23161731832672847 0.23161731832672847 -27.089 27.2851 28.9071 0.19236911928378447 0.19236911928378447 0.19236911928378447 -27.089 28.2851 27.9071 0.31786925370938746 0.31786925370938746 0.31786925370938746 -27.089 28.2851 28.9071 0.14082598136252603 0.14082598136252603 0.14082598136252603 -28.089 27.2851 27.9071 0.21987824647728202 0.21987824647728202 0.21987824647728202 -28.089 27.2851 28.9071 0.1582850419601972 0.1582850419601972 0.1582850419601972 -28.089 28.2851 27.9071 0.6582431369661487 0.6582431369661487 0.6582431369661487 -28.089 28.2851 28.9071 0.16117163352764635 0.16117163352764635 0.16117163352764635 -27.089 27.2851 29.9071 0.1824007577782187 0.1824007577782187 0.1824007577782187 -27.089 28.2851 29.9071 0.21863620510824944 0.21863620510824944 0.21863620510824944 -27.089 28.2851 30.9071 0.18508260043738933 0.18508260043738933 0.18508260043738933 -28.089 27.2851 29.9071 0.19597119944936872 0.19597119944936872 0.19597119944936872 -28.089 27.2851 30.9071 0.16851410968805094 0.16851410968805094 0.16851410968805094 -28.089 28.2851 29.9071 0.25807369092514 0.25807369092514 0.25807369092514 -28.089 28.2851 30.9071 0.172587710664876 0.172587710664876 0.172587710664876 -27.089 29.2851 27.9071 0.709611467490865 0.709611467490865 0.709611467490865 -27.089 29.2851 28.9071 0.5367537978197732 0.5367537978197732 0.5367537978197732 -27.089 30.2851 28.9071 0.5942047914677331 0.5942047914677331 0.5942047914677331 -28.089 29.2851 27.9071 0.799865523071429 0.799865523071429 0.799865523071429 -28.089 29.2851 28.9071 0.5923208207393335 0.5923208207393335 0.5923208207393335 -28.089 30.2851 27.9071 0.6928315995787062 0.6928315995787062 0.6928315995787062 -28.089 30.2851 28.9071 0.29684578452204735 0.29684578452204735 0.29684578452204735 -27.089 29.2851 29.9071 0.21409713503954056 0.21409713503954056 0.21409713503954056 -27.089 29.2851 30.9071 0.2190068938807893 0.2190068938807893 0.2190068938807893 -27.089 30.2851 29.9071 0.10310112178789067 0.10310112178789067 0.10310112178789067 -27.089 30.2851 30.9071 0.1515141932916451 0.1515141932916451 0.1515141932916451 -28.089 29.2851 29.9071 0.1631066758706597 0.1631066758706597 0.1631066758706597 -28.089 29.2851 30.9071 0.18287275572511524 0.18287275572511524 0.18287275572511524 -28.089 30.2851 29.9071 0.14083722524985154 0.14083722524985154 0.14083722524985154 -28.089 30.2851 30.9071 0.1373539544245331 0.1373539544245331 0.1373539544245331 -25.089 27.2851 31.9071 0.1773009162956261 0.1773009162956261 0.1773009162956261 -25.089 27.2851 32.9071 0.1692752159605237 0.1692752159605237 0.1692752159605237 -25.089 28.2851 31.9071 0.13520062811132152 0.13520062811132152 0.13520062811132152 -25.089 28.2851 32.9071 0.17625489909658967 0.17625489909658967 0.17625489909658967 -26.089 27.2851 31.9071 0.0923928143823655 0.0923928143823655 0.0923928143823655 -26.089 27.2851 32.9071 0.11405143535752002 0.11405143535752002 0.11405143535752002 -26.089 28.2851 31.9071 0.0876240009029053 0.0876240009029053 0.0876240009029053 -25.089 27.2851 33.9071 0.15059873596183843 0.15059873596183843 0.15059873596183843 -25.089 28.2851 33.9071 0.21241447674281477 0.21241447674281477 0.21241447674281477 -25.089 28.2851 34.9071 0.15997605920929903 0.15997605920929903 0.15997605920929903 -26.089 27.2851 33.9071 0.10241893759655549 0.10241893759655549 0.10241893759655549 -26.089 28.2851 33.9071 0.20786221617848022 0.20786221617848022 0.20786221617848022 -25.089 29.2851 31.9071 0.18252036296207774 0.18252036296207774 0.18252036296207774 -25.089 29.2851 32.9071 0.20888776113088345 0.20888776113088345 0.20888776113088345 -25.089 30.2851 31.9071 0.18099598559930458 0.18099598559930458 0.18099598559930458 -26.089 29.2851 31.9071 0.10171505243833731 0.10171505243833731 0.10171505243833731 -26.089 29.2851 32.9071 0.227922166464725 0.227922166464725 0.227922166464725 -26.089 30.2851 31.9071 0.205774172671731 0.205774172671731 0.205774172671731 -26.089 30.2851 32.9071 0.23761135050160986 0.23761135050160986 0.23761135050160986 -25.089 29.2851 33.9071 0.24422015179547188 0.24422015179547188 0.24422015179547188 -25.089 29.2851 34.9071 0.2082963490880815 0.2082963490880815 0.2082963490880815 -25.089 30.2851 33.9071 0.27704835788895926 0.27704835788895926 0.27704835788895926 -25.089 30.2851 34.9071 0.13210748002669778 0.13210748002669778 0.13210748002669778 -26.089 29.2851 33.9071 0.18307343428536088 0.18307343428536088 0.18307343428536088 -26.089 29.2851 34.9071 0.18538280713190083 0.18538280713190083 0.18538280713190083 -26.089 30.2851 33.9071 0.2885385934746443 0.2885385934746443 0.2885385934746443 -26.089 30.2851 34.9071 0.13051949465466053 0.13051949465466053 0.13051949465466053 -27.089 27.2851 31.9071 0.08219344558959142 0.08219344558959142 0.08219344558959142 -27.089 27.2851 32.9071 0.11246791406424801 0.11246791406424801 0.11246791406424801 -27.089 28.2851 31.9071 0.09675795162762225 0.09675795162762225 0.09675795162762225 -27.089 28.2851 32.9071 0.7935244735692911 0.7935244735692911 0.7935244735692911 -28.089 27.2851 31.9071 0.2867035689742162 0.2867035689742162 0.2867035689742162 -28.089 27.2851 32.9071 0.12561798856297826 0.12561798856297826 0.12561798856297826 -28.089 28.2851 31.9071 0.3516086480325836 0.3516086480325836 0.3516086480325836 -28.089 28.2851 32.9071 0.2331038350243738 0.2331038350243738 0.2331038350243738 -27.089 28.2851 33.9071 0.2362067398229244 0.2362067398229244 0.2362067398229244 -27.089 29.2851 31.9071 0.12692010575545112 0.12692010575545112 0.12692010575545112 -27.089 30.2851 31.9071 0.1513712541492 0.1513712541492 0.1513712541492 -28.089 29.2851 31.9071 0.26395990082944 0.26395990082944 0.26395990082944 -28.089 29.2851 32.9071 0.14975233018047712 0.14975233018047712 0.14975233018047712 -28.089 30.2851 31.9071 0.19047892580306172 0.19047892580306172 0.19047892580306172 -28.089 30.2851 32.9071 0.16892517219780062 0.16892517219780062 0.16892517219780062 -27.089 29.2851 33.9071 0.2455291738857797 0.2455291738857797 0.2455291738857797 -27.089 29.2851 34.9071 0.19440453912362007 0.19440453912362007 0.19440453912362007 -27.089 30.2851 33.9071 0.09407396670945645 0.09407396670945645 0.09407396670945645 -27.089 30.2851 34.9071 0.09608857095547745 0.09608857095547745 0.09608857095547745 -28.089 29.2851 33.9071 0.2155711372581298 0.2155711372581298 0.2155711372581298 -28.089 29.2851 34.9071 0.17514303935047348 0.17514303935047348 0.17514303935047348 -28.089 30.2851 33.9071 0.13824064869412225 0.13824064869412225 0.13824064869412225 -28.089 30.2851 34.9071 0.1225991805347252 0.1225991805347252 0.1225991805347252 -26.089 31.2851 28.9071 0.7216684159580342 0.7216684159580342 0.7216684159580342 -25.089 31.2851 29.9071 0.4948220438442799 0.4948220438442799 0.4948220438442799 -25.089 31.2851 30.9071 0.2521533653271096 0.2521533653271096 0.2521533653271096 -25.089 32.2851 29.9071 0.20944787327699158 0.20944787327699158 0.20944787327699158 -25.089 32.2851 30.9071 0.26987615033342144 0.26987615033342144 0.26987615033342144 -26.089 31.2851 29.9071 0.48566680114095845 0.48566680114095845 0.48566680114095845 -26.089 31.2851 30.9071 0.12974918595891777 0.12974918595891777 0.12974918595891777 -26.089 32.2851 29.9071 0.4323563448008142 0.4323563448008142 0.4323563448008142 -26.089 32.2851 30.9071 0.3020382451033044 0.3020382451033044 0.3020382451033044 -25.089 33.2851 27.9071 0.39423636519357014 0.39423636519357014 0.39423636519357014 -25.089 33.2851 28.9071 0.1759594750456724 0.1759594750456724 0.1759594750456724 -25.089 34.2851 27.9071 0.11948305418716093 0.11948305418716093 0.11948305418716093 -25.089 34.2851 28.9071 0.10238840389327276 0.10238840389327276 0.10238840389327276 -26.089 33.2851 28.9071 0.0 0.0 0.0 -26.089 34.2851 27.9071 0.07672225457676085 0.07672225457676085 0.07672225457676085 -26.089 34.2851 28.9071 0.06588623550815619 0.06588623550815619 0.06588623550815619 -25.089 33.2851 29.9071 0.16574660878721026 0.16574660878721026 0.16574660878721026 -25.089 33.2851 30.9071 0.24999589101520484 0.24999589101520484 0.24999589101520484 -25.089 34.2851 29.9071 0.11139454045679305 0.11139454045679305 0.11139454045679305 -26.089 33.2851 29.9071 0.20269336693625312 0.20269336693625312 0.20269336693625312 -26.089 33.2851 30.9071 0.2140682484987148 0.2140682484987148 0.2140682484987148 -26.089 34.2851 29.9071 0.050318333182962464 0.050318333182962464 0.050318333182962464 -26.089 34.2851 30.9071 0.05094475742545475 0.05094475742545475 0.05094475742545475 -27.089 31.2851 28.9071 0.2030922171502655 0.2030922171502655 0.2030922171502655 -27.089 32.2851 28.9071 0.22371738102475838 0.22371738102475838 0.22371738102475838 -28.089 31.2851 27.9071 0.46773953172754884 0.46773953172754884 0.46773953172754884 -28.089 31.2851 28.9071 0.12927366324917877 0.12927366324917877 0.12927366324917877 -28.089 32.2851 27.9071 0.27362710621245573 0.27362710621245573 0.27362710621245573 -28.089 32.2851 28.9071 0.21402973309481957 0.21402973309481957 0.21402973309481957 -27.089 31.2851 29.9071 0.16283609391044257 0.16283609391044257 0.16283609391044257 -27.089 31.2851 30.9071 0.1554778427341232 0.1554778427341232 0.1554778427341232 -27.089 32.2851 29.9071 0.17149346247269454 0.17149346247269454 0.17149346247269454 -27.089 32.2851 30.9071 0.10718124993735886 0.10718124993735886 0.10718124993735886 -28.089 32.2851 29.9071 0.180119395331426 0.180119395331426 0.180119395331426 -27.089 33.2851 27.9071 0.21531356995533382 0.21531356995533382 0.21531356995533382 -27.089 33.2851 28.9071 0.13530584606640264 0.13530584606640264 0.13530584606640264 -27.089 34.2851 27.9071 0.08210664374193526 0.08210664374193526 0.08210664374193526 -27.089 34.2851 28.9071 0.10076688689682123 0.10076688689682123 0.10076688689682123 -28.089 33.2851 27.9071 0.14665572612864464 0.14665572612864464 0.14665572612864464 -28.089 33.2851 28.9071 0.17360166323978737 0.17360166323978737 0.17360166323978737 -28.089 34.2851 27.9071 0.08501686573562214 0.08501686573562214 0.08501686573562214 -28.089 34.2851 28.9071 0.0624077572721368 0.0624077572721368 0.0624077572721368 -27.089 33.2851 29.9071 0.09879498819811174 0.09879498819811174 0.09879498819811174 -27.089 33.2851 30.9071 0.07131644471950295 0.07131644471950295 0.07131644471950295 -27.089 34.2851 30.9071 0.14828997055702361 0.14828997055702361 0.14828997055702361 -28.089 33.2851 29.9071 0.15699306798365498 0.15699306798365498 0.15699306798365498 -28.089 33.2851 30.9071 0.060551971425678495 0.060551971425678495 0.060551971425678495 -28.089 34.2851 29.9071 0.08821871164097989 0.08821871164097989 0.08821871164097989 -28.089 34.2851 30.9071 0.043919054966268654 0.043919054966268654 0.043919054966268654 -25.089 31.2851 31.9071 0.20398942227623793 0.20398942227623793 0.20398942227623793 -25.089 32.2851 31.9071 0.2001958936808296 0.2001958936808296 0.2001958936808296 -26.089 31.2851 31.9071 0.23671131152981262 0.23671131152981262 0.23671131152981262 -26.089 31.2851 32.9071 0.2495772220109341 0.2495772220109341 0.2495772220109341 -26.089 32.2851 31.9071 0.24671786299406392 0.24671786299406392 0.24671786299406392 -26.089 32.2851 32.9071 0.153136293856369 0.153136293856369 0.153136293856369 -25.089 31.2851 33.9071 0.3227262074680907 0.3227262074680907 0.3227262074680907 -25.089 31.2851 34.9071 0.34375653471701956 0.34375653471701956 0.34375653471701956 -25.089 32.2851 33.9071 0.20096231804390757 0.20096231804390757 0.20096231804390757 -25.089 32.2851 34.9071 0.25327057742908043 0.25327057742908043 0.25327057742908043 -26.089 31.2851 33.9071 0.2724901312163032 0.2724901312163032 0.2724901312163032 -26.089 31.2851 34.9071 0.047691816948063355 0.047691816948063355 0.047691816948063355 -26.089 32.2851 33.9071 0.16026993607473058 0.16026993607473058 0.16026993607473058 -26.089 32.2851 34.9071 0.05048444744137122 0.05048444744137122 0.05048444744137122 -26.089 33.2851 31.9071 0.2709017069447886 0.2709017069447886 0.2709017069447886 -26.089 33.2851 32.9071 0.1726166121028499 0.1726166121028499 0.1726166121028499 -26.089 34.2851 32.9071 0.14103238675802518 0.14103238675802518 0.14103238675802518 -25.089 33.2851 34.9071 0.12805512347662104 0.12805512347662104 0.12805512347662104 -25.089 34.2851 33.9071 0.11096309807823765 0.11096309807823765 0.11096309807823765 -25.089 34.2851 34.9071 0.12106483074960801 0.12106483074960801 0.12106483074960801 -26.089 33.2851 33.9071 0.16413600308333362 0.16413600308333362 0.16413600308333362 -26.089 33.2851 34.9071 0.05982729970987941 0.05982729970987941 0.05982729970987941 -26.089 34.2851 33.9071 0.1772182308570382 0.1772182308570382 0.1772182308570382 -26.089 34.2851 34.9071 0.11270492202500677 0.11270492202500677 0.11270492202500677 -27.089 31.2851 31.9071 0.11903880154475088 0.11903880154475088 0.11903880154475088 -27.089 31.2851 32.9071 0.15396901297685983 0.15396901297685983 0.15396901297685983 -27.089 32.2851 31.9071 0.13427534673331362 0.13427534673331362 0.13427534673331362 -27.089 32.2851 32.9071 0.0 0.0 0.0 -27.089 31.2851 33.9071 0.07658689874681825 0.07658689874681825 0.07658689874681825 -27.089 31.2851 34.9071 0.10784411061177591 0.10784411061177591 0.10784411061177591 -27.089 32.2851 33.9071 0.21476713939573447 0.21476713939573447 0.21476713939573447 -27.089 32.2851 34.9071 0.04831022105216396 0.04831022105216396 0.04831022105216396 -27.089 33.2851 31.9071 0.11229276874972723 0.11229276874972723 0.11229276874972723 -27.089 33.2851 32.9071 0.1500221531041971 0.1500221531041971 0.1500221531041971 -27.089 34.2851 31.9071 0.1104826436936381 0.1104826436936381 0.1104826436936381 -27.089 34.2851 32.9071 0.1316954261357107 0.1316954261357107 0.1316954261357107 -28.089 34.2851 31.9071 0.10343457838680029 0.10343457838680029 0.10343457838680029 -28.089 34.2851 32.9071 0.08675844782507551 0.08675844782507551 0.08675844782507551 -27.089 33.2851 33.9071 0.18564207564841345 0.18564207564841345 0.18564207564841345 -27.089 34.2851 33.9071 0.21296573777190297 0.21296573777190297 0.21296573777190297 -29.089 27.2851 27.9071 0.1329685292981275 0.1329685292981275 0.1329685292981275 -29.089 27.2851 28.9071 0.08032445251356195 0.08032445251356195 0.08032445251356195 -29.089 28.2851 27.9071 0.08011949879495157 0.08011949879495157 0.08011949879495157 -29.089 27.2851 29.9071 0.16165579994008347 0.16165579994008347 0.16165579994008347 -29.089 27.2851 30.9071 0.18155789741424752 0.18155789741424752 0.18155789741424752 -29.089 28.2851 29.9071 0.15396178594346738 0.15396178594346738 0.15396178594346738 -29.089 28.2851 30.9071 0.13346571679818026 0.13346571679818026 0.13346571679818026 -30.089 27.2851 29.9071 0.08952947073220044 0.08952947073220044 0.08952947073220044 -30.089 27.2851 30.9071 0.10141533691144004 0.10141533691144004 0.10141533691144004 -30.089 28.2851 30.9071 0.048724873176783076 0.048724873176783076 0.048724873176783076 -29.089 29.2851 27.9071 0.27577031651659073 0.27577031651659073 0.27577031651659073 -29.089 29.2851 28.9071 0.17833006192501816 0.17833006192501816 0.17833006192501816 -29.089 30.2851 27.9071 0.6504751631771033 0.6504751631771033 0.6504751631771033 -29.089 30.2851 28.9071 0.1429727322153163 0.1429727322153163 0.1429727322153163 -30.089 29.2851 27.9071 0.11880904243454868 0.11880904243454868 0.11880904243454868 -30.089 29.2851 28.9071 0.19327366750199867 0.19327366750199867 0.19327366750199867 -30.089 30.2851 27.9071 0.3635199351102516 0.3635199351102516 0.3635199351102516 -29.089 29.2851 29.9071 0.17426558250790003 0.17426558250790003 0.17426558250790003 -29.089 29.2851 30.9071 0.12284097853862096 0.12284097853862096 0.12284097853862096 -29.089 30.2851 29.9071 0.16890510083496027 0.16890510083496027 0.16890510083496027 -29.089 30.2851 30.9071 0.13602148514826964 0.13602148514826964 0.13602148514826964 -30.089 29.2851 29.9071 0.10678433438603765 0.10678433438603765 0.10678433438603765 -30.089 29.2851 30.9071 0.062140614858173064 0.062140614858173064 0.062140614858173064 -30.089 30.2851 29.9071 0.15966612233570676 0.15966612233570676 0.15966612233570676 -30.089 30.2851 30.9071 0.17249699219491318 0.17249699219491318 0.17249699219491318 -31.089 28.2851 27.9071 0.08724868794484257 0.08724868794484257 0.08724868794484257 -32.089 27.2851 27.9071 0.121725167071131 0.121725167071131 0.121725167071131 -32.089 27.2851 28.9071 0.14471868187871806 0.14471868187871806 0.14471868187871806 -32.089 28.2851 27.9071 0.11050353307436674 0.11050353307436674 0.11050353307436674 -32.089 28.2851 28.9071 0.04507775878919619 0.04507775878919619 0.04507775878919619 -31.089 27.2851 29.9071 0.050710301175741206 0.050710301175741206 0.050710301175741206 -31.089 27.2851 30.9071 0.05204699817532835 0.05204699817532835 0.05204699817532835 -31.089 28.2851 29.9071 0.00645094444703564 0.00645094444703564 0.00645094444703564 -31.089 28.2851 30.9071 0.060663316567852114 0.060663316567852114 0.060663316567852114 -32.089 27.2851 29.9071 0.11797756604491966 0.11797756604491966 0.11797756604491966 -32.089 27.2851 30.9071 0.05971177289680657 0.05971177289680657 0.05971177289680657 -32.089 28.2851 29.9071 0.09489845783205131 0.09489845783205131 0.09489845783205131 -32.089 28.2851 30.9071 0.04993898675124178 0.04993898675124178 0.04993898675124178 -31.089 29.2851 27.9071 0.1972601399369172 0.1972601399369172 0.1972601399369172 -31.089 29.2851 28.9071 0.18070218443077782 0.18070218443077782 0.18070218443077782 -32.089 29.2851 27.9071 0.0 0.0 0.0 -32.089 29.2851 28.9071 0.07905574042102301 0.07905574042102301 0.07905574042102301 -32.089 30.2851 27.9071 0.11410767349092113 0.11410767349092113 0.11410767349092113 -31.089 29.2851 29.9071 0.07921263260451764 0.07921263260451764 0.07921263260451764 -31.089 29.2851 30.9071 0.1728309641104219 0.1728309641104219 0.1728309641104219 -31.089 30.2851 29.9071 0.29340773914243135 0.29340773914243135 0.29340773914243135 -31.089 30.2851 30.9071 0.17963453727136572 0.17963453727136572 0.17963453727136572 -32.089 29.2851 29.9071 0.211030289387334 0.211030289387334 0.211030289387334 -32.089 29.2851 30.9071 0.23883625367485306 0.23883625367485306 0.23883625367485306 -32.089 30.2851 29.9071 0.12587343332588677 0.12587343332588677 0.12587343332588677 -32.089 30.2851 30.9071 0.19533956291669205 0.19533956291669205 0.19533956291669205 -29.089 27.2851 31.9071 0.2997025610180032 0.2997025610180032 0.2997025610180032 -29.089 28.2851 31.9071 0.1264381400963766 0.1264381400963766 0.1264381400963766 -30.089 27.2851 31.9071 0.13165767450412091 0.13165767450412091 0.13165767450412091 -30.089 28.2851 31.9071 0.11283507525222716 0.11283507525222716 0.11283507525222716 -29.089 27.2851 34.9071 0.13618694064054365 0.13618694064054365 0.13618694064054365 -29.089 28.2851 34.9071 0.09063688880909229 0.09063688880909229 0.09063688880909229 -30.089 27.2851 34.9071 0.11775905101712478 0.11775905101712478 0.11775905101712478 -30.089 28.2851 34.9071 0.10118633099765789 0.10118633099765789 0.10118633099765789 -29.089 29.2851 31.9071 0.20208746393439306 0.20208746393439306 0.20208746393439306 -29.089 29.2851 32.9071 0.12920458370282203 0.12920458370282203 0.12920458370282203 -29.089 30.2851 31.9071 0.10211279652078974 0.10211279652078974 0.10211279652078974 -29.089 30.2851 32.9071 0.15361247855512 0.15361247855512 0.15361247855512 -30.089 29.2851 31.9071 0.10993228690131177 0.10993228690131177 0.10993228690131177 -30.089 30.2851 32.9071 0.0883923020546068 0.0883923020546068 0.0883923020546068 -29.089 29.2851 33.9071 0.1330625052000215 0.1330625052000215 0.1330625052000215 -29.089 29.2851 34.9071 0.10637134730049881 0.10637134730049881 0.10637134730049881 -29.089 30.2851 33.9071 0.13580542867762943 0.13580542867762943 0.13580542867762943 -29.089 30.2851 34.9071 0.14151346186958516 0.14151346186958516 0.14151346186958516 -30.089 29.2851 33.9071 0.0682755019755372 0.0682755019755372 0.0682755019755372 -30.089 29.2851 34.9071 0.10779188542349423 0.10779188542349423 0.10779188542349423 -30.089 30.2851 33.9071 0.08497668111691695 0.08497668111691695 0.08497668111691695 -31.089 27.2851 32.9071 0.06308384951757673 0.06308384951757673 0.06308384951757673 -31.089 28.2851 31.9071 0.08585993440817448 0.08585993440817448 0.08585993440817448 -31.089 28.2851 32.9071 0.11338782241457758 0.11338782241457758 0.11338782241457758 -32.089 27.2851 32.9071 0.07541643105604169 0.07541643105604169 0.07541643105604169 -32.089 28.2851 31.9071 0.05297893420418372 0.05297893420418372 0.05297893420418372 -32.089 28.2851 32.9071 0.062424076807038806 0.062424076807038806 0.062424076807038806 -31.089 27.2851 33.9071 0.06667218837184168 0.06667218837184168 0.06667218837184168 -31.089 27.2851 34.9071 0.08283481189493651 0.08283481189493651 0.08283481189493651 -31.089 28.2851 33.9071 0.11523162451339142 0.11523162451339142 0.11523162451339142 -31.089 28.2851 34.9071 0.08569357169959728 0.08569357169959728 0.08569357169959728 -32.089 27.2851 33.9071 0.04507856288042886 0.04507856288042886 0.04507856288042886 -32.089 27.2851 34.9071 0.08963635572498242 0.08963635572498242 0.08963635572498242 -32.089 28.2851 33.9071 0.12420740476410098 0.12420740476410098 0.12420740476410098 -32.089 28.2851 34.9071 0.1082345932528695 0.1082345932528695 0.1082345932528695 -31.089 29.2851 31.9071 0.09726661292816599 0.09726661292816599 0.09726661292816599 -31.089 29.2851 32.9071 0.08253582974216067 0.08253582974216067 0.08253582974216067 -32.089 29.2851 31.9071 0.15094404126589858 0.15094404126589858 0.15094404126589858 -32.089 29.2851 32.9071 0.09933497504315511 0.09933497504315511 0.09933497504315511 -31.089 29.2851 33.9071 0.09467505853784917 0.09467505853784917 0.09467505853784917 -31.089 29.2851 34.9071 0.09703920234927323 0.09703920234927323 0.09703920234927323 -31.089 30.2851 33.9071 0.10463661769187968 0.10463661769187968 0.10463661769187968 -32.089 29.2851 33.9071 0.10776376415423615 0.10776376415423615 0.10776376415423615 -32.089 29.2851 34.9071 0.11298852724350662 0.11298852724350662 0.11298852724350662 -32.089 30.2851 33.9071 0.08467288475011814 0.08467288475011814 0.08467288475011814 -32.089 30.2851 34.9071 0.09195162661890349 0.09195162661890349 0.09195162661890349 -29.089 31.2851 27.9071 0.3708976248321643 0.3708976248321643 0.3708976248321643 -29.089 31.2851 28.9071 0.09067787423640622 0.09067787423640622 0.09067787423640622 -29.089 32.2851 27.9071 0.13199020954351942 0.13199020954351942 0.13199020954351942 -29.089 32.2851 28.9071 0.14253101861339487 0.14253101861339487 0.14253101861339487 -30.089 32.2851 27.9071 0.21940245382581755 0.21940245382581755 0.21940245382581755 -30.089 32.2851 28.9071 0.17355108633577737 0.17355108633577737 0.17355108633577737 -29.089 32.2851 29.9071 0.14204834334096866 0.14204834334096866 0.14204834334096866 -29.089 32.2851 30.9071 0.07021229756747951 0.07021229756747951 0.07021229756747951 -30.089 31.2851 29.9071 0.08956724213685574 0.08956724213685574 0.08956724213685574 -30.089 32.2851 29.9071 0.0023332905176177894 0.0023332905176177894 0.0023332905176177894 -30.089 32.2851 30.9071 0.03876089165368518 0.03876089165368518 0.03876089165368518 -29.089 33.2851 27.9071 0.13797319574533767 0.13797319574533767 0.13797319574533767 -29.089 33.2851 28.9071 0.144615082427116 0.144615082427116 0.144615082427116 -30.089 33.2851 27.9071 0.1341412121781864 0.1341412121781864 0.1341412121781864 -30.089 33.2851 28.9071 0.09460112769956251 0.09460112769956251 0.09460112769956251 -29.089 33.2851 29.9071 0.14157771208410166 0.14157771208410166 0.14157771208410166 -29.089 33.2851 30.9071 0.08447035320161103 0.08447035320161103 0.08447035320161103 -29.089 34.2851 29.9071 0.0992441739372712 0.0992441739372712 0.0992441739372712 -29.089 34.2851 30.9071 0.058624188754285114 0.058624188754285114 0.058624188754285114 -30.089 33.2851 29.9071 0.039284796524722686 0.039284796524722686 0.039284796524722686 -30.089 33.2851 30.9071 0.0 0.0 0.0 -30.089 34.2851 29.9071 0.03633729468746592 0.03633729468746592 0.03633729468746592 -30.089 34.2851 30.9071 0.05032428307034986 0.05032428307034986 0.05032428307034986 -31.089 31.2851 27.9071 0.2057236159886833 0.2057236159886833 0.2057236159886833 -31.089 32.2851 27.9071 0.20225278361669757 0.20225278361669757 0.20225278361669757 -31.089 32.2851 28.9071 0.19254730083741095 0.19254730083741095 0.19254730083741095 -32.089 31.2851 27.9071 0.19013057956812326 0.19013057956812326 0.19013057956812326 -32.089 32.2851 27.9071 0.14652562760266402 0.14652562760266402 0.14652562760266402 -32.089 32.2851 28.9071 0.15660362489700588 0.15660362489700588 0.15660362489700588 -31.089 31.2851 29.9071 0.14612569377953363 0.14612569377953363 0.14612569377953363 -31.089 32.2851 29.9071 0.06254860359249015 0.06254860359249015 0.06254860359249015 -32.089 31.2851 29.9071 0.08461662603778858 0.08461662603778858 0.08461662603778858 -32.089 31.2851 30.9071 0.09489685064510947 0.09489685064510947 0.09489685064510947 -32.089 32.2851 29.9071 0.08024423931644746 0.08024423931644746 0.08024423931644746 -32.089 32.2851 30.9071 0.1258782530305873 0.1258782530305873 0.1258782530305873 -31.089 33.2851 28.9071 0.0951073918623968 0.0951073918623968 0.0951073918623968 -31.089 34.2851 28.9071 0.044134152183670075 0.044134152183670075 0.044134152183670075 -32.089 33.2851 28.9071 0.16549209348048466 0.16549209348048466 0.16549209348048466 -32.089 34.2851 27.9071 0.19112183735901034 0.19112183735901034 0.19112183735901034 -32.089 34.2851 28.9071 0.0330887496413584 0.0330887496413584 0.0330887496413584 -31.089 33.2851 29.9071 0.029064618056012514 0.029064618056012514 0.029064618056012514 -32.089 33.2851 29.9071 0.04567214083935759 0.04567214083935759 0.04567214083935759 -32.089 33.2851 30.9071 0.09382243898322407 0.09382243898322407 0.09382243898322407 -32.089 34.2851 29.9071 0.1162270190631877 0.1162270190631877 0.1162270190631877 -32.089 34.2851 30.9071 0.10627814369617769 0.10627814369617769 0.10627814369617769 -30.089 31.2851 32.9071 0.21339743591151045 0.21339743591151045 0.21339743591151045 -30.089 32.2851 32.9071 0.19023171250137547 0.19023171250137547 0.19023171250137547 -29.089 31.2851 33.9071 0.12025185450125367 0.12025185450125367 0.12025185450125367 -29.089 31.2851 34.9071 0.13285607935673505 0.13285607935673505 0.13285607935673505 -29.089 32.2851 34.9071 0.11141060902954622 0.11141060902954622 0.11141060902954622 -30.089 31.2851 33.9071 0.15193497895587735 0.15193497895587735 0.15193497895587735 -30.089 31.2851 34.9071 0.0846977993101452 0.0846977993101452 0.0846977993101452 -30.089 32.2851 33.9071 0.19620234347224325 0.19620234347224325 0.19620234347224325 -30.089 32.2851 34.9071 0.0932486635274695 0.0932486635274695 0.0932486635274695 -29.089 33.2851 31.9071 0.035674648790551426 0.035674648790551426 0.035674648790551426 -29.089 34.2851 31.9071 0.06538565581979909 0.06538565581979909 0.06538565581979909 -29.089 34.2851 32.9071 0.0 0.0 0.0 -30.089 33.2851 31.9071 0.06684453908311311 0.06684453908311311 0.06684453908311311 -30.089 33.2851 32.9071 0.09530186074154401 0.09530186074154401 0.09530186074154401 -30.089 34.2851 31.9071 0.08008453604964595 0.08008453604964595 0.08008453604964595 -30.089 34.2851 32.9071 0.111000859421637 0.111000859421637 0.111000859421637 -30.089 33.2851 33.9071 0.11765220337939927 0.11765220337939927 0.11765220337939927 -30.089 34.2851 33.9071 0.14665652920530722 0.14665652920530722 0.14665652920530722 -31.089 32.2851 32.9071 0.15451264462825917 0.15451264462825917 0.15451264462825917 -32.089 31.2851 32.9071 0.16980911005103697 0.16980911005103697 0.16980911005103697 -32.089 32.2851 31.9071 0.10677549616321544 0.10677549616321544 0.10677549616321544 -32.089 32.2851 32.9071 0.10876648219652273 0.10876648219652273 0.10876648219652273 -31.089 31.2851 33.9071 0.09367698648875415 0.09367698648875415 0.09367698648875415 -31.089 32.2851 33.9071 0.08686614017299484 0.08686614017299484 0.08686614017299484 -31.089 32.2851 34.9071 0.11765782694280126 0.11765782694280126 0.11765782694280126 -32.089 31.2851 33.9071 0.11025607390804663 0.11025607390804663 0.11025607390804663 -32.089 31.2851 34.9071 0.11068189602743585 0.11068189602743585 0.11068189602743585 -32.089 32.2851 34.9071 0.08198769290968967 0.08198769290968967 0.08198769290968967 -31.089 33.2851 31.9071 0.06387063366140998 0.06387063366140998 0.06387063366140998 -31.089 33.2851 32.9071 0.05693980319047152 0.05693980319047152 0.05693980319047152 -31.089 34.2851 31.9071 0.07372749381083264 0.07372749381083264 0.07372749381083264 -31.089 34.2851 32.9071 0.08841882277925918 0.08841882277925918 0.08841882277925918 -32.089 33.2851 31.9071 0.09119782480561948 0.09119782480561948 0.09119782480561948 -32.089 34.2851 31.9071 0.10474991057727033 0.10474991057727033 0.10474991057727033 -32.089 34.2851 32.9071 0.1033783327923213 0.1033783327923213 0.1033783327923213 -31.089 33.2851 33.9071 0.10133337697508923 0.10133337697508923 0.10133337697508923 -31.089 33.2851 34.9071 0.0948100625020366 0.0948100625020366 0.0948100625020366 -31.089 34.2851 33.9071 0.13160707122544607 0.13160707122544607 0.13160707122544607 -31.089 34.2851 34.9071 0.0822215757979167 0.0822215757979167 0.0822215757979167 -32.089 33.2851 34.9071 0.0818277519864352 0.0818277519864352 0.0818277519864352 -32.089 34.2851 33.9071 0.11177857846755161 0.11177857846755161 0.11177857846755161 -32.089 34.2851 34.9071 0.09301641991772594 0.09301641991772594 0.09301641991772594 -25.089 27.2851 35.9071 0.09969657135082594 0.09969657135082594 0.09969657135082594 -25.089 27.2851 36.9071 0.14393325015011382 0.14393325015011382 0.14393325015011382 -26.089 27.2851 36.9071 0.15118896622270786 0.15118896622270786 0.15118896622270786 -25.089 27.2851 37.9071 0.14157128706496253 0.14157128706496253 0.14157128706496253 -25.089 28.2851 37.9071 0.12562200499633736 0.12562200499633736 0.12562200499633736 -26.089 27.2851 37.9071 0.1298375429095372 0.1298375429095372 0.1298375429095372 -26.089 28.2851 37.9071 0.13587289618801054 0.13587289618801054 0.13587289618801054 -25.089 30.2851 35.9071 0.15237503489170456 0.15237503489170456 0.15237503489170456 -25.089 30.2851 36.9071 0.10909509460527111 0.10909509460527111 0.10909509460527111 -26.089 29.2851 35.9071 0.0997632656033746 0.0997632656033746 0.0997632656033746 -26.089 29.2851 36.9071 0.07950029427124175 0.07950029427124175 0.07950029427124175 -26.089 30.2851 35.9071 0.13095725804075292 0.13095725804075292 0.13095725804075292 -26.089 30.2851 36.9071 0.10977561530122605 0.10977561530122605 0.10977561530122605 -25.089 29.2851 37.9071 0.0977929494349913 0.0977929494349913 0.0977929494349913 -25.089 30.2851 37.9071 0.07543893711919453 0.07543893711919453 0.07543893711919453 -26.089 29.2851 37.9071 0.1060170123331363 0.1060170123331363 0.1060170123331363 -26.089 30.2851 37.9071 0.0881134320873176 0.0881134320873176 0.0881134320873176 -27.089 27.2851 35.9071 0.0695343359907154 0.0695343359907154 0.0695343359907154 -27.089 27.2851 36.9071 0.09977371168612517 0.09977371168612517 0.09977371168612517 -27.089 28.2851 36.9071 0.07063391058272767 0.07063391058272767 0.07063391058272767 -27.089 27.2851 37.9071 0.058362098715549204 0.058362098715549204 0.058362098715549204 -27.089 28.2851 37.9071 0.08144598216575331 0.08144598216575331 0.08144598216575331 -28.089 27.2851 37.9071 0.0725618074194379 0.0725618074194379 0.0725618074194379 -28.089 28.2851 37.9071 0.05390740222533601 0.05390740222533601 0.05390740222533601 -27.089 29.2851 35.9071 0.08602951150104142 0.08602951150104142 0.08602951150104142 -27.089 29.2851 36.9071 0.07839376777798715 0.07839376777798715 0.07839376777798715 -27.089 30.2851 35.9071 0.09482292001063147 0.09482292001063147 0.09482292001063147 -27.089 30.2851 36.9071 0.07770687297090222 0.07770687297090222 0.07770687297090222 -28.089 29.2851 35.9071 0.07483529017394593 0.07483529017394593 0.07483529017394593 -28.089 29.2851 36.9071 0.07985370117520346 0.07985370117520346 0.07985370117520346 -28.089 30.2851 35.9071 0.10534208426853871 0.10534208426853871 0.10534208426853871 -28.089 29.2851 37.9071 0.0 0.0 0.0 -26.089 32.2851 35.9071 0.06601308819293207 0.06601308819293207 0.06601308819293207 -26.089 32.2851 36.9071 0.04323291110224542 0.04323291110224542 0.04323291110224542 -26.089 33.2851 35.9071 0.08237428247145064 0.08237428247145064 0.08237428247145064 -26.089 33.2851 36.9071 0.10006861207777536 0.10006861207777536 0.10006861207777536 -26.089 34.2851 35.9071 0.11717982264897787 0.11717982264897787 0.11717982264897787 -26.089 34.2851 36.9071 0.11794864497239084 0.11794864497239084 0.11794864497239084 -27.089 31.2851 35.9071 0.07418445563042071 0.07418445563042071 0.07418445563042071 -27.089 31.2851 36.9071 0.05135626026114208 0.05135626026114208 0.05135626026114208 -27.089 32.2851 35.9071 0.060756090669721784 0.060756090669721784 0.060756090669721784 -27.089 32.2851 36.9071 0.07528444894473146 0.07528444894473146 0.07528444894473146 -28.089 31.2851 35.9071 0.08881341798305205 0.08881341798305205 0.08881341798305205 -28.089 31.2851 36.9071 0.06454888413483433 0.06454888413483433 0.06454888413483433 -28.089 32.2851 35.9071 0.0 0.0 0.0 -28.089 32.2851 36.9071 0.09042553225443242 0.09042553225443242 0.09042553225443242 -27.089 32.2851 37.9071 0.04200221182421789 0.04200221182421789 0.04200221182421789 -28.089 32.2851 37.9071 0.06626767722990137 0.06626767722990137 0.06626767722990137 -27.089 33.2851 36.9071 0.09155704680647231 0.09155704680647231 0.09155704680647231 -27.089 34.2851 36.9071 0.1421551585842146 0.1421551585842146 0.1421551585842146 -28.089 33.2851 36.9071 0.07796809623660468 0.07796809623660468 0.07796809623660468 -28.089 34.2851 36.9071 0.1390678999347033 0.1390678999347033 0.1390678999347033 -27.089 33.2851 37.9071 0.09861177755224336 0.09861177755224336 0.09861177755224336 -27.089 34.2851 37.9071 0.05590580726131238 0.05590580726131238 0.05590580726131238 -28.089 33.2851 37.9071 0.07957359599002135 0.07957359599002135 0.07957359599002135 -28.089 34.2851 37.9071 0.0911632686896465 0.0911632686896465 0.0911632686896465 -29.089 27.2851 35.9071 0.08612434592793827 0.08612434592793827 0.08612434592793827 -29.089 28.2851 36.9071 0.07131314902034826 0.07131314902034826 0.07131314902034826 -30.089 27.2851 35.9071 0.07817128716267496 0.07817128716267496 0.07817128716267496 -30.089 27.2851 36.9071 0.0764181055282133 0.0764181055282133 0.0764181055282133 -30.089 28.2851 35.9071 0.08189365733000573 0.08189365733000573 0.08189365733000573 -30.089 28.2851 36.9071 0.05772391394018784 0.05772391394018784 0.05772391394018784 -29.089 27.2851 37.9071 0.09570847596990999 0.09570847596990999 0.09570847596990999 -29.089 28.2851 37.9071 0.07761130523194172 0.07761130523194172 0.07761130523194172 -30.089 27.2851 37.9071 0.07609378042137396 0.07609378042137396 0.07609378042137396 -30.089 28.2851 37.9071 0.059284233811580316 0.059284233811580316 0.059284233811580316 -29.089 29.2851 35.9071 0.07269218636663954 0.07269218636663954 0.07269218636663954 -29.089 29.2851 36.9071 0.08614202691042061 0.08614202691042061 0.08614202691042061 -29.089 30.2851 35.9071 0.09890105732870513 0.09890105732870513 0.09890105732870513 -30.089 29.2851 35.9071 0.0737750790501472 0.0737750790501472 0.0737750790501472 -30.089 29.2851 36.9071 0.06001156342752578 0.06001156342752578 0.06001156342752578 -29.089 29.2851 37.9071 0.08056589536165176 0.08056589536165176 0.08056589536165176 -29.089 31.2851 35.9071 0.08092194990405845 0.08092194990405845 0.08092194990405845 -29.089 32.2851 35.9071 0.08731860719393175 0.08731860719393175 0.08731860719393175 -29.089 32.2851 36.9071 0.06704172906623423 0.06704172906623423 0.06704172906623423 -30.089 32.2851 35.9071 0.12461789041404904 0.12461789041404904 0.12461789041404904 -30.089 32.2851 36.9071 0.08334838348328054 0.08334838348328054 0.08334838348328054 -29.089 33.2851 35.9071 0.062417806247218155 0.062417806247218155 0.062417806247218155 -29.089 33.2851 36.9071 0.0 0.0 0.0 -29.089 34.2851 36.9071 0.09843901274521374 0.09843901274521374 0.09843901274521374 -30.089 33.2851 36.9071 0.11262940092007966 0.11262940092007966 0.11262940092007966 -30.089 34.2851 36.9071 0.0976531290804994 0.0976531290804994 0.0976531290804994 -30.089 33.2851 37.9071 0.04850978823250837 0.04850978823250837 0.04850978823250837 -31.089 32.2851 35.9071 0.12444036165219817 0.12444036165219817 0.12444036165219817 -31.089 32.2851 36.9071 0.07716473151734408 0.07716473151734408 0.07716473151734408 -32.089 32.2851 35.9071 0.09676277307683624 0.09676277307683624 0.09676277307683624 -32.089 32.2851 36.9071 0.049227727472022635 0.049227727472022635 0.049227727472022635 -31.089 33.2851 36.9071 0.09458184138275891 0.09458184138275891 0.09458184138275891 -31.089 34.2851 36.9071 0.08605844404991468 0.08605844404991468 0.08605844404991468 -32.089 33.2851 35.9071 0.08010913053413463 0.08010913053413463 0.08010913053413463 -32.089 33.2851 36.9071 0.055565641322617106 0.055565641322617106 0.055565641322617106 -32.089 34.2851 35.9071 0.0678342623258171 0.0678342623258171 0.0678342623258171 -32.089 34.2851 36.9071 0.044486829965598926 0.044486829965598926 0.044486829965598926 -25.089 35.2851 27.9071 0.0991292661962031 0.0991292661962031 0.0991292661962031 -25.089 35.2851 28.9071 0.05160808159141979 0.05160808159141979 0.05160808159141979 -25.089 36.2851 27.9071 0.11025446702784789 0.11025446702784789 0.11025446702784789 -25.089 36.2851 28.9071 0.09533962943629187 0.09533962943629187 0.09533962943629187 -26.089 35.2851 27.9071 0.006628251067549084 0.006628251067549084 0.006628251067549084 -26.089 35.2851 28.9071 0.03663644857124032 0.03663644857124032 0.03663644857124032 -26.089 36.2851 27.9071 0.08778955595531907 0.08778955595531907 0.08778955595531907 -26.089 36.2851 28.9071 0.09562731380588665 0.09562731380588665 0.09562731380588665 -25.089 35.2851 29.9071 0.1559419688153279 0.1559419688153279 0.1559419688153279 -25.089 35.2851 30.9071 0.12607264754664554 0.12607264754664554 0.12607264754664554 -25.089 36.2851 29.9071 0.17737798225897924 0.17737798225897924 0.17737798225897924 -25.089 36.2851 30.9071 0.12868728847050195 0.12868728847050195 0.12868728847050195 -25.089 37.2851 27.9071 0.09279542624101059 0.09279542624101059 0.09279542624101059 -26.089 37.2851 27.9071 0.08301162877426951 0.08301162877426951 0.08301162877426951 -25.089 37.2851 29.9071 0.08499757712114352 0.08499757712114352 0.08499757712114352 -25.089 37.2851 30.9071 0.09366493240283014 0.09366493240283014 0.09366493240283014 -25.089 38.2851 30.9071 0.07337108590404683 0.07337108590404683 0.07337108590404683 -27.089 35.2851 27.9071 0.06495469014685203 0.06495469014685203 0.06495469014685203 -27.089 35.2851 28.9071 0.04718268130561218 0.04718268130561218 0.04718268130561218 -27.089 36.2851 27.9071 0.07341449155223302 0.07341449155223302 0.07341449155223302 -27.089 36.2851 28.9071 0.0703105267648153 0.0703105267648153 0.0703105267648153 -28.089 35.2851 27.9071 0.07638249815162511 0.07638249815162511 0.07638249815162511 -28.089 35.2851 28.9071 0.036349839872681436 0.036349839872681436 0.036349839872681436 -28.089 36.2851 27.9071 0.07219550736006476 0.07219550736006476 0.07219550736006476 -28.089 36.2851 28.9071 0.06158598803713505 0.06158598803713505 0.06158598803713505 -27.089 36.2851 29.9071 0.14414526928638538 0.14414526928638538 0.14414526928638538 -28.089 35.2851 29.9071 0.07058142008371239 0.07058142008371239 0.07058142008371239 -27.089 37.2851 27.9071 0.07755439856811074 0.07755439856811074 0.07755439856811074 -27.089 37.2851 28.9071 0.07436659659266713 0.07436659659266713 0.07436659659266713 -27.089 38.2851 27.9071 0.07885464148839938 0.07885464148839938 0.07885464148839938 -27.089 38.2851 28.9071 0.11345530872659222 0.11345530872659222 0.11345530872659222 -28.089 37.2851 27.9071 0.0639463613298215 0.0639463613298215 0.0639463613298215 -28.089 37.2851 28.9071 0.03805194603108543 0.03805194603108543 0.03805194603108543 -28.089 38.2851 27.9071 0.06435699377256388 0.06435699377256388 0.06435699377256388 -28.089 38.2851 28.9071 0.05069397926461356 0.05069397926461356 0.05069397926461356 -27.089 38.2851 29.9071 0.08988227103387492 0.08988227103387492 0.08988227103387492 -27.089 38.2851 30.9071 0.06646454707587417 0.06646454707587417 0.06646454707587417 -28.089 38.2851 29.9071 0.0493253390544326 0.0493253390544326 0.0493253390544326 -28.089 38.2851 30.9071 0.05375729472531392 0.05375729472531392 0.05375729472531392 -25.089 35.2851 32.9071 0.06098665877154301 0.06098665877154301 0.06098665877154301 -25.089 36.2851 31.9071 0.13051949465466053 0.13051949465466053 0.13051949465466053 -25.089 36.2851 32.9071 0.054811176920768624 0.054811176920768624 0.054811176920768624 -26.089 35.2851 32.9071 0.09766759326637284 0.09766759326637284 0.09766759326637284 -26.089 36.2851 32.9071 0.04301821353123773 0.04301821353123773 0.04301821353123773 -25.089 35.2851 33.9071 0.07318026153593384 0.07318026153593384 0.07318026153593384 -25.089 35.2851 34.9071 0.18023338471602066 0.18023338471602066 0.18023338471602066 -25.089 36.2851 33.9071 0.15544572318307814 0.15544572318307814 0.15544572318307814 -25.089 36.2851 34.9071 0.20833245985302903 0.20833245985302903 0.20833245985302903 -26.089 35.2851 33.9071 0.11121617908361607 0.11121617908361607 0.11121617908361607 -26.089 35.2851 34.9071 0.21415972250907112 0.21415972250907112 0.21415972250907112 -26.089 36.2851 34.9071 0.2558826919176085 0.2558826919176085 0.2558826919176085 -25.089 37.2851 31.9071 0.06252882724047683 0.06252882724047683 0.06252882724047683 -25.089 37.2851 32.9071 0.11355894830981689 0.11355894830981689 0.11355894830981689 -25.089 38.2851 31.9071 0.07137343617857214 0.07137343617857214 0.07137343617857214 -25.089 38.2851 32.9071 0.11089882341041907 0.11089882341041907 0.11089882341041907 -26.089 37.2851 31.9071 0.09147266594369993 0.09147266594369993 0.09147266594369993 -26.089 37.2851 32.9071 0.10013610956308532 0.10013610956308532 0.10013610956308532 -26.089 38.2851 31.9071 0.08446151252716633 0.08446151252716633 0.08446151252716633 -26.089 38.2851 32.9071 0.10544894825602692 0.10544894825602692 0.10544894825602692 -25.089 37.2851 34.9071 0.18844982792205386 0.18844982792205386 0.18844982792205386 -25.089 38.2851 33.9071 0.1353419896069993 0.1353419896069993 0.1353419896069993 -25.089 38.2851 34.9071 0.10551162030297333 0.10551162030297333 0.10551162030297333 -26.089 37.2851 34.9071 0.2300120419819842 0.2300120419819842 0.2300120419819842 -26.089 38.2851 33.9071 0.13571225916551513 0.13571225916551513 0.13571225916551513 -26.089 38.2851 34.9071 0.12610558210820227 0.12610558210820227 0.12610558210820227 -27.089 35.2851 31.9071 0.15901653574003285 0.15901653574003285 0.15901653574003285 -27.089 35.2851 32.9071 0.14590243668428618 0.14590243668428618 0.14590243668428618 -27.089 36.2851 32.9071 0.11027053582831967 0.11027053582831967 0.11027053582831967 -28.089 35.2851 31.9071 0.09178447288166583 0.09178447288166583 0.09178447288166583 -28.089 35.2851 32.9071 0.098087053525499 0.098087053525499 0.098087053525499 -28.089 36.2851 31.9071 0.07477524674810516 0.07477524674810516 0.07477524674810516 -28.089 36.2851 32.9071 0.08445990513170025 0.08445990513170025 0.08445990513170025 -27.089 35.2851 33.9071 0.21490033720167734 0.21490033720167734 0.21490033720167734 -27.089 35.2851 34.9071 0.16568719519143882 0.16568719519143882 0.16568719519143882 -27.089 36.2851 33.9071 0.17798969072453377 0.17798969072453377 0.17798969072453377 -27.089 36.2851 34.9071 0.21968086909155057 0.21968086909155057 0.21968086909155057 -28.089 35.2851 33.9071 0.18066044210121307 0.18066044210121307 0.18066044210121307 -28.089 35.2851 34.9071 0.11773896688552059 0.11773896688552059 0.11773896688552059 -28.089 36.2851 33.9071 0.12624454974387989 0.12624454974387989 0.12624454974387989 -28.089 36.2851 34.9071 0.13313077822231265 0.13313077822231265 0.13313077822231265 -27.089 37.2851 32.9071 0.11020465372601845 0.11020465372601845 0.11020465372601845 -27.089 38.2851 31.9071 0.0841761993303262 0.0841761993303262 0.0841761993303262 -27.089 38.2851 32.9071 0.07215684359618454 0.07215684359618454 0.07215684359618454 -28.089 37.2851 31.9071 0.08245706544173628 0.08245706544173628 0.08245706544173628 -28.089 37.2851 32.9071 0.09317633859977392 0.09317633859977392 0.09317633859977392 -28.089 38.2851 31.9071 0.06945202203118067 0.06945202203118067 0.06945202203118067 -27.089 37.2851 33.9071 0.19621759253375054 0.19621759253375054 0.19621759253375054 -27.089 37.2851 34.9071 0.2178001432083193 0.2178001432083193 0.2178001432083193 -27.089 38.2851 33.9071 0.13573876429631998 0.13573876429631998 0.13573876429631998 -27.089 38.2851 34.9071 0.12385395164576994 0.12385395164576994 0.12385395164576994 -28.089 37.2851 34.9071 0.12335429481574069 0.12335429481574069 0.12335429481574069 -25.089 40.2851 27.9071 0.06692452447899898 0.06692452447899898 0.06692452447899898 -25.089 40.2851 28.9071 0.0718735767011758 0.0718735767011758 0.0718735767011758 -26.089 39.2851 27.9071 0.09233656106804716 0.09233656106804716 0.09233656106804716 -26.089 39.2851 28.9071 0.12513440852037097 0.12513440852037097 0.12513440852037097 -26.089 40.2851 27.9071 0.07431033067305791 0.07431033067305791 0.07431033067305791 -26.089 40.2851 28.9071 0.09491613688641767 0.09491613688641767 0.09491613688641767 -25.089 39.2851 30.9071 0.06514320274260472 0.06514320274260472 0.06514320274260472 -25.089 40.2851 29.9071 0.07020441993433774 0.07020441993433774 0.07020441993433774 -25.089 40.2851 30.9071 0.056997528409350205 0.056997528409350205 0.056997528409350205 -26.089 39.2851 29.9071 0.06862341158351953 0.06862341158351953 0.06862341158351953 -26.089 39.2851 30.9071 0.08067761467665534 0.08067761467665534 0.08067761467665534 -26.089 40.2851 29.9071 0.047487423335943836 0.047487423335943836 0.047487423335943836 -25.089 41.2851 28.9071 0.07048576349664144 0.07048576349664144 0.07048576349664144 -26.089 41.2851 27.9071 0.08468011801026992 0.08468011801026992 0.08468011801026992 -26.089 42.2851 27.9071 0.05108666905535493 0.05108666905535493 0.05108666905535493 -25.089 41.2851 29.9071 0.06577272710608584 0.06577272710608584 0.06577272710608584 -27.089 39.2851 27.9071 0.0700121411395103 0.0700121411395103 0.0700121411395103 -27.089 39.2851 28.9071 0.0889757559775141 0.0889757559775141 0.0889757559775141 -27.089 40.2851 27.9071 0.07732162738851679 0.07732162738851679 0.07732162738851679 -27.089 40.2851 28.9071 0.09198778964135593 0.09198778964135593 0.09198778964135593 -28.089 39.2851 27.9071 0.06266155380251362 0.06266155380251362 0.06266155380251362 -28.089 39.2851 28.9071 0.06486971865330288 0.06486971865330288 0.06486971865330288 -28.089 40.2851 28.9071 0.09109335278170762 0.09109335278170762 0.09109335278170762 -27.089 39.2851 29.9071 0.0808962304413936 0.0808962304413936 0.0808962304413936 -27.089 39.2851 30.9071 0.08187276051959637 0.08187276051959637 0.08187276051959637 -28.089 39.2851 29.9071 0.041182164049349386 0.041182164049349386 0.041182164049349386 -28.089 39.2851 30.9071 0.038256363615398116 0.038256363615398116 0.038256363615398116 -28.089 40.2851 29.9071 0.09111103267222984 0.09111103267222984 0.09111103267222984 -27.089 41.2851 27.9071 0.08414565870281669 0.08414565870281669 0.08414565870281669 -27.089 41.2851 28.9071 0.08246510261878606 0.08246510261878606 0.08246510261878606 -27.089 42.2851 27.9071 0.09090530279681702 0.09090530279681702 0.09090530279681702 -27.089 42.2851 28.9071 0.08272711415072422 0.08272711415072422 0.08272711415072422 -28.089 41.2851 28.9071 0.08602790413690212 0.08602790413690212 0.08602790413690212 -28.089 42.2851 27.9071 0.0728281918003217 0.0728281918003217 0.0728281918003217 -28.089 42.2851 28.9071 0.09377824073923974 0.09377824073923974 0.09377824073923974 -28.089 41.2851 29.9071 0.09972389189469956 0.09972389189469956 0.09972389189469956 -28.089 42.2851 29.9071 0.09848079775582376 0.09848079775582376 0.09848079775582376 -25.089 39.2851 31.9071 0.06839929623212958 0.06839929623212958 0.06839929623212958 -26.089 39.2851 31.9071 0.0740758621244017 0.0740758621244017 0.0740758621244017 -27.089 39.2851 31.9071 0.06966367484491781 0.06966367484491781 0.06966367484491781 -29.089 36.2851 27.9071 0.09344554772344506 0.09344554772344506 0.09344554772344506 -29.089 36.2851 28.9071 0.09024551710844295 0.09024551710844295 0.09024551710844295 -30.089 36.2851 27.9071 0.10298943360602687 0.10298943360602687 0.10298943360602687 -29.089 37.2851 27.9071 0.06433504733831537 0.06433504733831537 0.06433504733831537 -29.089 37.2851 28.9071 0.05465335275008211 0.05465335275008211 0.05465335275008211 -30.089 37.2851 27.9071 0.06505035331035455 0.06505035331035455 0.06505035331035455 -30.089 37.2851 28.9071 0.09777286031856045 0.09777286031856045 0.09777286031856045 -30.089 38.2851 28.9071 0.09010648727804749 0.09010648727804749 0.09010648727804749 -29.089 37.2851 30.9071 0.14716005669762822 0.14716005669762822 0.14716005669762822 -29.089 38.2851 29.9071 0.04560355233393934 0.04560355233393934 0.04560355233393934 -29.089 38.2851 30.9071 0.052192927961780135 0.052192927961780135 0.052192927961780135 -30.089 37.2851 29.9071 0.07630469236194605 0.07630469236194605 0.07630469236194605 -30.089 37.2851 30.9071 0.11693800763033298 0.11693800763033298 0.11693800763033298 -30.089 38.2851 29.9071 0.04346891694714701 0.04346891694714701 0.04346891694714701 -30.089 38.2851 30.9071 0.07167647894292929 0.07167647894292929 0.07167647894292929 -31.089 35.2851 28.9071 0.21434908942808412 0.21434908942808412 0.21434908942808412 -31.089 36.2851 27.9071 0.1452985151062445 0.1452985151062445 0.1452985151062445 -31.089 36.2851 28.9071 0.14911470931845758 0.14911470931845758 0.14911470931845758 -32.089 35.2851 27.9071 0.1774510343018927 0.1774510343018927 0.1774510343018927 -32.089 35.2851 28.9071 0.11329382352850774 0.11329382352850774 0.11329382352850774 -32.089 36.2851 27.9071 0.16643387638156146 0.16643387638156146 0.16643387638156146 -32.089 36.2851 28.9071 0.08266040577418556 0.08266040577418556 0.08266040577418556 -31.089 36.2851 30.9071 0.09008077075131331 0.09008077075131331 0.09008077075131331 -31.089 37.2851 27.9071 0.05957799633813404 0.05957799633813404 0.05957799633813404 -31.089 37.2851 28.9071 0.12857884883085288 0.12857884883085288 0.12857884883085288 -31.089 38.2851 27.9071 0.08090346404109465 0.08090346404109465 0.08090346404109465 -31.089 38.2851 28.9071 0.09519417968471525 0.09519417968471525 0.09519417968471525 -32.089 37.2851 28.9071 0.10591979090145774 0.10591979090145774 0.10591979090145774 -32.089 38.2851 28.9071 0.07370747906495051 0.07370747906495051 0.07370747906495051 -31.089 37.2851 29.9071 0.08141785168624614 0.08141785168624614 0.08141785168624614 -31.089 37.2851 30.9071 0.0679286358848413 0.0679286358848413 0.0679286358848413 -32.089 37.2851 29.9071 0.10273713023596998 0.10273713023596998 0.10273713023596998 -32.089 37.2851 30.9071 0.08291116468595777 0.08291116468595777 0.08291116468595777 -32.089 38.2851 29.9071 0.07653473364230712 0.07653473364230712 0.07653473364230712 -32.089 38.2851 30.9071 0.07030112184686389 0.07030112184686389 0.07030112184686389 -29.089 35.2851 32.9071 0.10272588102271644 0.10272588102271644 0.10272588102271644 -29.089 36.2851 31.9071 0.04013670761417303 0.04013670761417303 0.04013670761417303 -29.089 36.2851 32.9071 0.08777026800558983 0.08777026800558983 0.08777026800558983 -30.089 35.2851 31.9071 0.07425543117357444 0.07425543117357444 0.07425543117357444 -30.089 35.2851 32.9071 0.10095732443202829 0.10095732443202829 0.10095732443202829 -30.089 36.2851 31.9071 0.10727364902562224 0.10727364902562224 0.10727364902562224 -30.089 36.2851 32.9071 0.07943695896043043 0.07943695896043043 0.07943695896043043 -29.089 35.2851 33.9071 0.15763223234514145 0.15763223234514145 0.15763223234514145 -29.089 36.2851 33.9071 0.1156999997540836 0.1156999997540836 0.1156999997540836 -30.089 35.2851 33.9071 0.14907375364956504 0.14907375364956504 0.14907375364956504 -30.089 36.2851 33.9071 0.09830562198925356 0.09830562198925356 0.09830562198925356 -29.089 37.2851 31.9071 0.0964501818541694 0.0964501818541694 0.0964501818541694 -30.089 37.2851 31.9071 0.1330689308987023 0.1330689308987023 0.1330689308987023 -29.089 37.2851 33.9071 0.10795900590665389 0.10795900590665389 0.10795900590665389 -29.089 37.2851 34.9071 0.1334102954034806 0.1334102954034806 0.1334102954034806 -30.089 37.2851 33.9071 0.08172246406942991 0.08172246406942991 0.08172246406942991 -30.089 37.2851 34.9071 0.11267117856136456 0.11267117856136456 0.11267117856136456 -31.089 35.2851 31.9071 0.0697549112639805 0.0697549112639805 0.0697549112639805 -31.089 35.2851 32.9071 0.1035904588288646 0.1035904588288646 0.1035904588288646 -31.089 36.2851 31.9071 0.10222930704125249 0.10222930704125249 0.10222930704125249 -31.089 36.2851 32.9071 0.07087932129765749 0.07087932129765749 0.07087932129765749 -32.089 35.2851 31.9071 0.1310271393149509 0.1310271393149509 0.1310271393149509 -32.089 35.2851 32.9071 0.09597205154188405 0.09597205154188405 0.09597205154188405 -32.089 36.2851 31.9071 0.10810443258308847 0.10810443258308847 0.10810443258308847 -32.089 36.2851 32.9071 0.09936068861202883 0.09936068861202883 0.09936068861202883 -31.089 35.2851 33.9071 0.13953131754358633 0.13953131754358633 0.13953131754358633 -31.089 35.2851 34.9071 0.10795016781287321 0.10795016781287321 0.10795016781287321 -31.089 36.2851 33.9071 0.1140972292691106 0.1140972292691106 0.1140972292691106 -31.089 36.2851 34.9071 0.10337511875716494 0.10337511875716494 0.10337511875716494 -32.089 35.2851 34.9071 0.09555338384264013 0.09555338384264013 0.09555338384264013 -32.089 36.2851 33.9071 0.10065760608235272 0.10065760608235272 0.10065760608235272 -32.089 36.2851 34.9071 0.09295534536232758 0.09295534536232758 0.09295534536232758 -32.089 37.2851 31.9071 0.05976089392110423 0.05976089392110423 0.05976089392110423 -32.089 37.2851 32.9071 0.08777348266419915 0.08777348266419915 0.08777348266419915 -31.089 37.2851 34.9071 0.08200698224579107 0.08200698224579107 0.08200698224579107 -32.089 37.2851 33.9071 0.09815535623420517 0.09815535623420517 0.09815535623420517 -29.089 39.2851 28.9071 0.06558284937861247 0.06558284937861247 0.06558284937861247 -29.089 40.2851 28.9071 0.0886245590129368 0.0886245590129368 0.0886245590129368 -30.089 39.2851 28.9071 0.07035972170237602 0.07035972170237602 0.07035972170237602 -30.089 40.2851 27.9071 0.0798367421802545 0.0798367421802545 0.0798367421802545 -30.089 40.2851 28.9071 0.08826934221698654 0.08826934221698654 0.08826934221698654 -29.089 39.2851 29.9071 0.03430342087728652 0.03430342087728652 0.03430342087728652 -29.089 40.2851 29.9071 0.09062403063152168 0.09062403063152168 0.09062403063152168 -30.089 41.2851 27.9071 0.09466702258046952 0.09466702258046952 0.09466702258046952 -30.089 41.2851 28.9071 0.1270060559946432 0.1270060559946432 0.1270060559946432 -30.089 42.2851 28.9071 0.09708741665997053 0.09708741665997053 0.09708741665997053 -29.089 41.2851 29.9071 0.10048404213074928 0.10048404213074928 0.10048404213074928 -29.089 42.2851 29.9071 0.09616410758861507 0.09616410758861507 0.09616410758861507 -30.089 41.2851 29.9071 0.10384517003528429 0.10384517003528429 0.10384517003528429 -30.089 42.2851 29.9071 0.1009541103001545 0.1009541103001545 0.1009541103001545 -31.089 39.2851 27.9071 0.08504579864866046 0.08504579864866046 0.08504579864866046 -31.089 39.2851 28.9071 0.06749286063024727 0.06749286063024727 0.06749286063024727 -31.089 40.2851 27.9071 0.07616555806078391 0.07616555806078391 0.07616555806078391 -31.089 41.2851 27.9071 0.10126186284477688 0.10126186284477688 0.10126186284477688 -31.089 41.2851 28.9071 0.11963087007402705 0.11963087007402705 0.11963087007402705 -31.089 42.2851 27.9071 0.1187423639685316 0.1187423639685316 0.1187423639685316 -31.089 42.2851 28.9071 0.13070745207002976 0.13070745207002976 0.13070745207002976 -31.089 42.2851 29.9071 0.11217707622274915 0.11217707622274915 0.11217707622274915 -25.089 36.2851 35.9071 0.14362485768176397 0.14362485768176397 0.14362485768176397 -26.089 36.2851 35.9071 0.19522318715685902 0.19522318715685902 0.19522318715685902 -25.089 37.2851 35.9071 0.14441591411441596 0.14441591411441596 0.14441591411441596 -26.089 37.2851 35.9071 0.1718097763920702 0.1718097763920702 0.1718097763920702 -27.089 35.2851 35.9071 0.14243946312703135 0.14243946312703135 0.14243946312703135 -27.089 35.2851 36.9071 0.10373508989674696 0.10373508989674696 0.10373508989674696 -28.089 35.2851 35.9071 0.08945312422184146 0.08945312422184146 0.08945312422184146 -28.089 35.2851 36.9071 0.09081449217666585 0.09081449217666585 0.09081449217666585 -28.089 36.2851 35.9071 0.1212158570530089 0.1212158570530089 0.1212158570530089 -28.089 36.2851 36.9071 0.08771963711551002 0.08771963711551002 0.08771963711551002 -28.089 37.2851 35.9071 0.1349331650564233 0.1349331650564233 0.1349331650564233 -29.089 35.2851 36.9071 0.0803867422657596 0.0803867422657596 0.0803867422657596 -29.089 36.2851 36.9071 0.08677853969197058 0.08677853969197058 0.08677853969197058 -30.089 35.2851 36.9071 0.08166379211696409 0.08166379211696409 0.08166379211696409 -30.089 36.2851 36.9071 0.08706866569055918 0.08706866569055918 0.08706866569055918 -29.089 37.2851 35.9071 0.12940700267094862 0.12940700267094862 0.12940700267094862 -29.089 37.2851 36.9071 0.0878908176155966 0.0878908176155966 0.0878908176155966 -30.089 37.2851 35.9071 0.12035468199043355 0.12035468199043355 0.12035468199043355 -30.089 37.2851 36.9071 0.09518132223546967 0.09518132223546967 0.09518132223546967 -31.089 35.2851 35.9071 0.09471684550336679 0.09471684550336679 0.09471684550336679 -31.089 35.2851 36.9071 0.07684965281910269 0.07684965281910269 0.07684965281910269 -31.089 36.2851 35.9071 0.13019819891066733 0.13019819891066733 0.13019819891066733 -31.089 36.2851 36.9071 0.07928754208422606 0.07928754208422606 0.07928754208422606 -31.089 37.2851 35.9071 0.11536016687494466 0.11536016687494466 0.11536016687494466 -33.089 27.2851 27.9071 0.11582854136731238 0.11582854136731238 0.11582854136731238 -33.089 27.2851 28.9071 0.22947774499970694 0.22947774499970694 0.22947774499970694 -33.089 28.2851 27.9071 0.11205736641901645 0.11205736641901645 0.11205736641901645 -33.089 28.2851 28.9071 0.18343224630348642 0.18343224630348642 0.18343224630348642 -34.089 27.2851 27.9071 0.12268433207414499 0.12268433207414499 0.12268433207414499 -34.089 27.2851 28.9071 0.11711233946107644 0.11711233946107644 0.11711233946107644 -34.089 28.2851 27.9071 0.11702959214149834 0.11702959214149834 0.11702959214149834 -33.089 27.2851 29.9071 0.08308717768604684 0.08308717768604684 0.08308717768604684 -33.089 27.2851 30.9071 0.07150011944650492 0.07150011944650492 0.07150011944650492 -33.089 28.2851 29.9071 0.13547210621871725 0.13547210621871725 0.13547210621871725 -34.089 27.2851 29.9071 0.102087083831471 0.102087083831471 0.102087083831471 -34.089 27.2851 30.9071 0.08183177060648508 0.08183177060648508 0.08183177060648508 -34.089 28.2851 30.9071 0.11605991575358736 0.11605991575358736 0.11605991575358736 -33.089 29.2851 27.9071 0.10260133605641426 0.10260133605641426 0.10260133605641426 -33.089 29.2851 28.9071 0.0741848575306124 0.0741848575306124 0.0741848575306124 -33.089 30.2851 27.9071 0.1462855069312905 0.1462855069312905 0.1462855069312905 -33.089 30.2851 28.9071 1.0 1.0 1.0 -34.089 30.2851 28.9071 0.0749323884170008 0.0749323884170008 0.0749323884170008 -33.089 29.2851 29.9071 0.08068404456056406 0.08068404456056406 0.08068404456056406 -33.089 30.2851 29.9071 0.09613196434914084 0.09613196434914084 0.09613196434914084 -35.089 27.2851 27.9071 0.09318276748486458 0.09318276748486458 0.09318276748486458 -35.089 27.2851 28.9071 0.08080621225726513 0.08080621225726513 0.08080621225726513 -35.089 28.2851 27.9071 0.11538426854486762 0.11538426854486762 0.11538426854486762 -36.089 27.2851 27.9071 0.05092714910943269 0.05092714910943269 0.05092714910943269 -36.089 28.2851 27.9071 0.13762542526602822 0.13762542526602822 0.13762542526602822 -35.089 27.2851 29.9071 0.06703216299177654 0.06703216299177654 0.06703216299177654 -35.089 27.2851 30.9071 0.05132739563302722 0.05132739563302722 0.05132739563302722 -35.089 28.2851 30.9071 0.14063081935364605 0.14063081935364605 0.14063081935364605 -36.089 27.2851 30.9071 0.06726207001252331 0.06726207001252331 0.06726207001252331 -36.089 28.2851 30.9071 0.12102064746895115 0.12102064746895115 0.12102064746895115 -35.089 30.2851 27.9071 0.10669675558975589 0.10669675558975589 0.10669675558975589 -35.089 30.2851 28.9071 0.23229439679630365 0.23229439679630365 0.23229439679630365 -36.089 29.2851 27.9071 0.11650579160047439 0.11650579160047439 0.11650579160047439 -36.089 30.2851 27.9071 0.07108767464821064 0.07108767464821064 0.07108767464821064 -35.089 29.2851 30.9071 0.1652640727742791 0.1652640727742791 0.1652640727742791 -35.089 30.2851 29.9071 0.06361089204065772 0.06361089204065772 0.06361089204065772 -35.089 30.2851 30.9071 0.10847643443207863 0.10847643443207863 0.10847643443207863 -36.089 29.2851 30.9071 0.16578354154085614 0.16578354154085614 0.16578354154085614 -36.089 30.2851 30.9071 0.06402578687573451 0.06402578687573451 0.06402578687573451 -33.089 27.2851 31.9071 0.09471523831277912 0.09471523831277912 0.09471523831277912 -33.089 27.2851 32.9071 0.09296498871625944 0.09296498871625944 0.09296498871625944 -33.089 28.2851 32.9071 0.05543459142806056 0.05543459142806056 0.05543459142806056 -34.089 27.2851 31.9071 0.1129612112036347 0.1129612112036347 0.1129612112036347 -34.089 27.2851 32.9071 0.09528016382376737 0.09528016382376737 0.09528016382376737 -34.089 28.2851 31.9071 0.34011379752953425 0.34011379752953425 0.34011379752953425 -34.089 28.2851 32.9071 0.09171295026301488 0.09171295026301488 0.09171295026301488 -33.089 28.2851 33.9071 0.1381980811671622 0.1381980811671622 0.1381980811671622 -33.089 28.2851 34.9071 0.1432586400902252 0.1432586400902252 0.1432586400902252 -34.089 27.2851 33.9071 0.11105388595904048 0.11105388595904048 0.11105388595904048 -34.089 27.2851 34.9071 0.12038520887599524 0.12038520887599524 0.12038520887599524 -34.089 28.2851 33.9071 0.09374047131150083 0.09374047131150083 0.09374047131150083 -34.089 28.2851 34.9071 0.11612338291686715 0.11612338291686715 0.11612338291686715 -34.089 29.2851 31.9071 0.2525648027443163 0.2525648027443163 0.2525648027443163 -34.089 29.2851 32.9071 0.11887331078322454 0.11887331078322454 0.11887331078322454 -34.089 30.2851 31.9071 0.13239262329665152 0.13239262329665152 0.13239262329665152 -34.089 30.2851 32.9071 0.12862302796096242 0.12862302796096242 0.12862302796096242 -33.089 29.2851 34.9071 0.1324247520524524 0.1324247520524524 0.1324247520524524 -33.089 30.2851 34.9071 0.08843087765120956 0.08843087765120956 0.08843087765120956 -34.089 29.2851 34.9071 0.11883474978016541 0.11883474978016541 0.11883474978016541 -35.089 27.2851 31.9071 0.09734054131713082 0.09734054131713082 0.09734054131713082 -35.089 27.2851 32.9071 0.12678515566194282 0.12678515566194282 0.12678515566194282 -35.089 28.2851 32.9071 0.09325509240678086 0.09325509240678086 0.09325509240678086 -36.089 27.2851 31.9071 0.10116945685190555 0.10116945685190555 0.10116945685190555 -36.089 27.2851 32.9071 0.1191946517565065 0.1191946517565065 0.1191946517565065 -36.089 28.2851 32.9071 0.09072528872430555 0.09072528872430555 0.09072528872430555 -35.089 27.2851 33.9071 0.13207053181070846 0.13207053181070846 0.13207053181070846 -35.089 27.2851 34.9071 0.12611120508078139 0.12611120508078139 0.12611120508078139 -36.089 27.2851 33.9071 0.10586676098011537 0.10586676098011537 0.10586676098011537 -36.089 27.2851 34.9071 0.10226707248409661 0.10226707248409661 0.10226707248409661 -36.089 28.2851 33.9071 0.10419790756679488 0.10419790756679488 0.10419790756679488 -36.089 28.2851 34.9071 0.0982863365604457 0.0982863365604457 0.0982863365604457 -35.089 29.2851 31.9071 0.1483084409431545 0.1483084409431545 0.1483084409431545 -35.089 29.2851 32.9071 0.06730210270630975 0.06730210270630975 0.06730210270630975 -35.089 30.2851 31.9071 0.10339440296617718 0.10339440296617718 0.10339440296617718 -35.089 30.2851 32.9071 0.07608003575972122 0.07608003575972122 0.07608003575972122 -36.089 29.2851 32.9071 0.07595890580370464 0.07595890580370464 0.07595890580370464 -36.089 30.2851 31.9071 0.0560649153454363 0.0560649153454363 0.0560649153454363 -36.089 30.2851 32.9071 0.08626016792091952 0.08626016792091952 0.08626016792091952 -36.089 30.2851 33.9071 0.08423004725056438 0.08423004725056438 0.08423004725056438 -36.089 30.2851 34.9071 0.09030739736030831 0.09030739736030831 0.09030739736030831 -33.089 31.2851 27.9071 0.13720777743815485 0.13720777743815485 0.13720777743815485 -33.089 31.2851 28.9071 0.06240952589184699 0.06240952589184699 0.06240952589184699 -33.089 32.2851 27.9071 0.15084366196983606 0.15084366196983606 0.15084366196983606 -33.089 32.2851 28.9071 0.026883780675804585 0.026883780675804585 0.026883780675804585 -34.089 31.2851 27.9071 0.09658357568642945 0.09658357568642945 0.09658357568642945 -34.089 31.2851 28.9071 0.04358494954991058 0.04358494954991058 0.04358494954991058 -34.089 32.2851 27.9071 0.11597074028769189 0.11597074028769189 0.11597074028769189 -34.089 32.2851 28.9071 0.0638761805949498 0.0638761805949498 0.0638761805949498 -33.089 31.2851 29.9071 0.11214413595895313 0.11214413595895313 0.11214413595895313 -33.089 31.2851 30.9071 0.10304407244818843 0.10304407244818843 0.10304407244818843 -33.089 32.2851 29.9071 0.08216933397463741 0.08216933397463741 0.08216933397463741 -33.089 32.2851 30.9071 0.10784170021921381 0.10784170021921381 0.10784170021921381 -34.089 31.2851 30.9071 0.07234485702606552 0.07234485702606552 0.07234485702606552 -34.089 32.2851 30.9071 0.09737188050500117 0.09737188050500117 0.09737188050500117 -33.089 33.2851 27.9071 0.16206609456934978 0.16206609456934978 0.16206609456934978 -33.089 33.2851 28.9071 0.11560198663600665 0.11560198663600665 0.11560198663600665 -33.089 34.2851 27.9071 0.1336287679264059 0.1336287679264059 0.1336287679264059 -34.089 33.2851 27.9071 0.09065697970744574 0.09065697970744574 0.09065697970744574 -34.089 33.2851 28.9071 0.15659318619040113 0.15659318619040113 0.15659318619040113 -34.089 34.2851 27.9071 0.09881186284186527 0.09881186284186527 0.09881186284186527 -34.089 34.2851 28.9071 0.0883714069320405 0.0883714069320405 0.0883714069320405 -33.089 33.2851 29.9071 0.08814156022582234 0.08814156022582234 0.08814156022582234 -33.089 33.2851 30.9071 0.10516611994976093 0.10516611994976093 0.10516611994976093 -33.089 34.2851 29.9071 0.12426363579884732 0.12426363579884732 0.12426363579884732 -35.089 31.2851 27.9071 0.10165478801189502 0.10165478801189502 0.10165478801189502 -35.089 31.2851 28.9071 0.05838010738355569 0.05838010738355569 0.05838010738355569 -35.089 32.2851 27.9071 0.10251214567176589 0.10251214567176589 0.10251214567176589 -35.089 32.2851 28.9071 0.0593258783729158 0.0593258783729158 0.0593258783729158 -36.089 31.2851 27.9071 0.06340356440699334 0.06340356440699334 0.06340356440699334 -36.089 31.2851 28.9071 0.06860604829310549 0.06860604829310549 0.06860604829310549 -36.089 32.2851 28.9071 0.06003326985863633 0.06003326985863633 0.06003326985863633 -35.089 31.2851 29.9071 0.07113453800109477 0.07113453800109477 0.07113453800109477 -35.089 31.2851 30.9071 0.09269417075363005 0.09269417075363005 0.09269417075363005 -35.089 32.2851 30.9071 0.08357181423073387 0.08357181423073387 0.08357181423073387 -36.089 31.2851 29.9071 0.06347495141522466 0.06347495141522466 0.06347495141522466 -36.089 31.2851 30.9071 0.0862135544817295 0.0862135544817295 0.0862135544817295 -36.089 32.2851 30.9071 0.10157443537306175 0.10157443537306175 0.10157443537306175 -35.089 34.2851 27.9071 0.08599897157704621 0.08599897157704621 0.08599897157704621 -36.089 33.2851 30.9071 0.08576670703897687 0.08576670703897687 0.08576670703897687 -36.089 34.2851 29.9071 0.07851859135089194 0.07851859135089194 0.07851859135089194 -36.089 34.2851 30.9071 0.09358939342325327 0.09358939342325327 0.09358939342325327 -33.089 31.2851 31.9071 0.18100722387406679 0.18100722387406679 0.18100722387406679 -33.089 31.2851 32.9071 0.13413880257335184 0.13413880257335184 0.13413880257335184 -33.089 32.2851 31.9071 0.2296638668737358 0.2296638668737358 0.2296638668737358 -33.089 32.2851 32.9071 0.17244159768066916 0.17244159768066916 0.17244159768066916 -34.089 31.2851 31.9071 0.1074166665355963 0.1074166665355963 0.1074166665355963 -34.089 31.2851 32.9071 0.07358891771714071 0.07358891771714071 0.07358891771714071 -34.089 32.2851 31.9071 0.06109141107648051 0.06109141107648051 0.06109141107648051 -34.089 32.2851 32.9071 0.08218138978301769 0.08218138978301769 0.08218138978301769 -33.089 31.2851 33.9071 0.0941302188089998 0.0941302188089998 0.0941302188089998 -33.089 31.2851 34.9071 0.13661423189123706 0.13661423189123706 0.13661423189123706 -33.089 32.2851 33.9071 0.08435140586404097 0.08435140586404097 0.08435140586404097 -34.089 31.2851 34.9071 0.1174561817803087 0.1174561817803087 0.1174561817803087 -34.089 32.2851 33.9071 0.09292962974617386 0.09292962974617386 0.09292962974617386 -34.089 32.2851 34.9071 0.07448523717420173 0.07448523717420173 0.07448523717420173 -33.089 33.2851 31.9071 0.17129275502616917 0.17129275502616917 0.17129275502616917 -33.089 33.2851 32.9071 0.15079547986324682 0.15079547986324682 0.15079547986324682 -33.089 34.2851 32.9071 0.10645330210475407 0.10645330210475407 0.10645330210475407 -34.089 33.2851 31.9071 0.10930318832160958 0.10930318832160958 0.10930318832160958 -34.089 33.2851 32.9071 0.10719169505701102 0.10719169505701102 0.10719169505701102 -34.089 34.2851 32.9071 0.12204970994344218 0.12204970994344218 0.12204970994344218 -33.089 33.2851 33.9071 0.11390280581571172 0.11390280581571172 0.11390280581571172 -33.089 34.2851 33.9071 0.13188980659676058 0.13188980659676058 0.13188980659676058 -33.089 34.2851 34.9071 0.10235063850738195 0.10235063850738195 0.10235063850738195 -34.089 33.2851 33.9071 0.1131950040683192 0.1131950040683192 0.1131950040683192 -34.089 34.2851 33.9071 0.11472468357294337 0.11472468357294337 0.11472468357294337 -34.089 34.2851 34.9071 0.0785627176030253 0.0785627176030253 0.0785627176030253 -35.089 31.2851 31.9071 0.09163098044209053 0.09163098044209053 0.09163098044209053 -35.089 32.2851 31.9071 0.07264918223662539 0.07264918223662539 0.07264918223662539 -35.089 32.2851 32.9071 0.07906361718752188 0.07906361718752188 0.07906361718752188 -36.089 31.2851 31.9071 0.06992130693365857 0.06992130693365857 0.06992130693365857 -36.089 31.2851 32.9071 0.08958411871616842 0.08958411871616842 0.08958411871616842 -36.089 32.2851 31.9071 0.07842206006646125 0.07842206006646125 0.07842206006646125 -36.089 32.2851 32.9071 0.10827155241702306 0.10827155241702306 0.10827155241702306 -35.089 31.2851 34.9071 0.09404021543084111 0.09404021543084111 0.09404021543084111 -35.089 32.2851 34.9071 0.10789794269343635 0.10789794269343635 0.10789794269343635 -36.089 31.2851 34.9071 0.08067198852780921 0.08067198852780921 0.08067198852780921 -36.089 32.2851 33.9071 0.10828922853300386 0.10828922853300386 0.10828922853300386 -36.089 32.2851 34.9071 0.09535971916031853 0.09535971916031853 0.09535971916031853 -35.089 33.2851 31.9071 0.07449448084361598 0.07449448084361598 0.07449448084361598 -35.089 33.2851 32.9071 0.04263851103110641 0.04263851103110641 0.04263851103110641 -35.089 34.2851 31.9071 0.0701196951374027 0.0701196951374027 0.0701196951374027 -36.089 33.2851 31.9071 0.0770927940151027 0.0770927940151027 0.0770927940151027 -36.089 33.2851 32.9071 0.10772037703379386 0.10772037703379386 0.10772037703379386 -36.089 34.2851 31.9071 0.09401048214986399 0.09401048214986399 0.09401048214986399 -36.089 34.2851 32.9071 0.11419685102186357 0.11419685102186357 0.11419685102186357 -35.089 33.2851 33.9071 0.09512024932345725 0.09512024932345725 0.09512024932345725 -35.089 33.2851 34.9071 0.06456504245613488 0.06456504245613488 0.06456504245613488 -35.089 34.2851 34.9071 0.04365450470281513 0.04365450470281513 0.04365450470281513 -36.089 33.2851 33.9071 0.11107316832760328 0.11107316832760328 0.11107316832760328 -36.089 34.2851 33.9071 0.12685745038305057 0.12685745038305057 0.12685745038305057 -36.089 34.2851 34.9071 0.06021600561864433 0.06021600561864433 0.06021600561864433 -37.089 27.2851 27.9071 0.19651133704895402 0.19651133704895402 0.19651133704895402 -37.089 28.2851 27.9071 0.19250716989129 0.19250716989129 0.19250716989129 -37.089 28.2851 28.9071 0.07614594581179222 0.07614594581179222 0.07614594581179222 -38.089 28.2851 27.9071 0.1240748600266953 0.1240748600266953 0.1240748600266953 -38.089 28.2851 28.9071 0.08806039042793364 0.08806039042793364 0.08806039042793364 -37.089 27.2851 30.9071 0.08203270135339297 0.08203270135339297 0.08203270135339297 -37.089 28.2851 30.9071 0.129751595695225 0.129751595695225 0.129751595695225 -38.089 28.2851 29.9071 0.13251471250044092 0.13251471250044092 0.13251471250044092 -38.089 28.2851 30.9071 0.08895486100649659 0.08895486100649659 0.08895486100649659 -37.089 29.2851 27.9071 0.08341830612203598 0.08341830612203598 0.08341830612203598 -37.089 30.2851 27.9071 0.09201270193626926 0.09201270193626926 0.09201270193626926 -38.089 29.2851 27.9071 0.07770341678047049 0.07770341678047049 0.07770341678047049 -38.089 29.2851 28.9071 0.07832544829031866 0.07832544829031866 0.07832544829031866 -38.089 30.2851 27.9071 0.08889780163492299 0.08889780163492299 0.08889780163492299 -38.089 30.2851 28.9071 0.09868409759387547 0.09868409759387547 0.09868409759387547 -37.089 29.2851 30.9071 0.0834126801648427 0.0834126801648427 0.0834126801648427 -37.089 30.2851 30.9071 0.10115820741945565 0.10115820741945565 0.10115820741945565 -38.089 29.2851 29.9071 0.0913617652465865 0.0913617652465865 0.0913617652465865 -38.089 29.2851 30.9071 0.1009380396388594 0.1009380396388594 0.1009380396388594 -38.089 30.2851 29.9071 0.10756209419233248 0.10756209419233248 0.10756209419233248 -38.089 30.2851 30.9071 0.09322776966613297 0.09322776966613297 0.09322776966613297 -39.089 27.2851 28.9071 0.09459389533130742 0.09459389533130742 0.09459389533130742 -39.089 28.2851 28.9071 0.05715181051114941 0.05715181051114941 0.05715181051114941 -40.089 27.2851 28.9071 0.115404353264294 0.115404353264294 0.115404353264294 -40.089 28.2851 27.9071 0.07456609915053464 0.07456609915053464 0.07456609915053464 -40.089 28.2851 28.9071 0.06860661099238394 0.06860661099238394 0.06860661099238394 -39.089 27.2851 29.9071 0.12553203684088243 0.12553203684088243 0.12553203684088243 -39.089 27.2851 30.9071 0.09212681622076714 0.09212681622076714 0.09212681622076714 -39.089 28.2851 29.9071 0.09845910169532733 0.09845910169532733 0.09845910169532733 -39.089 28.2851 30.9071 0.09716777378026384 0.09716777378026384 0.09716777378026384 -39.089 29.2851 27.9071 0.07596630060384522 0.07596630060384522 0.07596630060384522 -39.089 29.2851 28.9071 0.05307919447278582 0.05307919447278582 0.05307919447278582 -40.089 29.2851 27.9071 0.07336377124621576 0.07336377124621576 0.07336377124621576 -40.089 29.2851 28.9071 0.05871897509486808 0.05871897509486808 0.05871897509486808 -37.089 27.2851 31.9071 0.07505995025194565 0.07505995025194565 0.07505995025194565 -37.089 27.2851 32.9071 0.09090369553010422 0.09090369553010422 0.09090369553010422 -38.089 27.2851 31.9071 0.06719004326829171 0.06719004326829171 0.06719004326829171 -37.089 28.2851 33.9071 0.0954561497657885 0.0954561497657885 0.0954561497657885 -37.089 28.2851 34.9071 0.08255994124727847 0.08255994124727847 0.08255994124727847 -37.089 29.2851 33.9071 0.06264812841220115 0.06264812841220115 0.06264812841220115 -37.089 29.2851 34.9071 0.08386034438586586 0.08386034438586586 0.08386034438586586 -37.089 30.2851 33.9071 0.060948311193712426 0.060948311193712426 0.060948311193712426 -37.089 30.2851 34.9071 0.0777915897783036 0.0777915897783036 0.0777915897783036 -39.089 27.2851 31.9071 0.09002049760952983 0.09002049760952983 0.09002049760952983 -37.089 31.2851 27.9071 0.054689210943400186 0.054689210943400186 0.054689210943400186 -37.089 31.2851 28.9071 0.059506043109103283 0.059506043109103283 0.059506043109103283 -37.089 32.2851 27.9071 0.061116332940160785 0.061116332940160785 0.061116332940160785 -38.089 31.2851 27.9071 0.08369397754249228 0.08369397754249228 0.08369397754249228 -38.089 31.2851 28.9071 0.07418767083191583 0.07418767083191583 0.07418767083191583 -38.089 32.2851 27.9071 0.08818736888750507 0.08818736888750507 0.08818736888750507 -38.089 32.2851 28.9071 0.11434548002045983 0.11434548002045983 0.11434548002045983 -37.089 31.2851 29.9071 0.050944355409152896 0.050944355409152896 0.050944355409152896 -37.089 31.2851 30.9071 0.08658646123918534 0.08658646123918534 0.08658646123918534 -37.089 32.2851 30.9071 0.13313640070390184 0.13313640070390184 0.13313640070390184 -38.089 31.2851 29.9071 0.12447329688196858 0.12447329688196858 0.12447329688196858 -38.089 31.2851 30.9071 0.1294029864265219 0.1294029864265219 0.1294029864265219 -38.089 32.2851 29.9071 0.14313977963639915 0.14313977963639915 0.14313977963639915 -38.089 32.2851 30.9071 0.13483437217162914 0.13483437217162914 0.13483437217162914 -37.089 34.2851 28.9071 0.09342304669685564 0.09342304669685564 0.09342304669685564 -38.089 33.2851 27.9071 0.08908023075121928 0.08908023075121928 0.08908023075121928 -38.089 33.2851 28.9071 0.0961769648808019 0.0961769648808019 0.0961769648808019 -38.089 34.2851 27.9071 0.07852325314187206 0.07852325314187206 0.07852325314187206 -38.089 34.2851 28.9071 0.10325057479589468 0.10325057479589468 0.10325057479589468 -37.089 33.2851 30.9071 0.09327920069963211 0.09327920069963211 0.09327920069963211 -37.089 34.2851 29.9071 0.09255835962202792 0.09255835962202792 0.09255835962202792 -38.089 33.2851 29.9071 0.13521990469352982 0.13521990469352982 0.13521990469352982 -38.089 33.2851 30.9071 0.1142322006464135 0.1142322006464135 0.1142322006464135 -38.089 34.2851 29.9071 0.08930766382790022 0.08930766382790022 0.08930766382790022 -39.089 32.2851 28.9071 0.09910596320771725 0.09910596320771725 0.09910596320771725 -39.089 32.2851 29.9071 0.12509986697752942 0.12509986697752942 0.12509986697752942 -39.089 34.2851 27.9071 0.07641882892846572 0.07641882892846572 0.07641882892846572 -39.089 33.2851 29.9071 0.11242854657264831 0.11242854657264831 0.11242854657264831 -37.089 31.2851 32.9071 0.06242359445629661 0.06242359445629661 0.06242359445629661 -37.089 31.2851 33.9071 0.07847607258959277 0.07847607258959277 0.07847607258959277 -37.089 32.2851 33.9071 0.09895248473561744 0.09895248473561744 0.09895248473561744 -37.089 34.2851 31.9071 0.0915417778950062 0.0915417778950062 0.0915417778950062 -37.089 34.2851 32.9071 0.12112829396483049 0.12112829396483049 0.12112829396483049 -37.089 34.2851 33.9071 0.10561928755166632 0.10561928755166632 0.10561928755166632 -34.089 28.2851 35.9071 0.10446627631567831 0.10446627631567831 0.10446627631567831 -33.089 29.2851 35.9071 0.1363885388630179 0.1363885388630179 0.1363885388630179 -33.089 30.2851 35.9071 0.12436726145993117 0.12436726145993117 0.12436726145993117 -34.089 29.2851 35.9071 0.10937389185561966 0.10937389185561966 0.10937389185561966 -34.089 30.2851 35.9071 0.16588791662251118 0.16588791662251118 0.16588791662251118 -35.089 28.2851 35.9071 0.11367945928523099 0.11367945928523099 0.11367945928523099 -36.089 28.2851 35.9071 0.07576045161961979 0.07576045161961979 0.07576045161961979 -35.089 29.2851 35.9071 0.12022373758681018 0.12022373758681018 0.12022373758681018 -35.089 30.2851 35.9071 0.13530102692642246 0.13530102692642246 0.13530102692642246 -36.089 29.2851 35.9071 0.07385369108990077 0.07385369108990077 0.07385369108990077 -36.089 30.2851 35.9071 0.08011483709644465 0.08011483709644465 0.08011483709644465 -33.089 31.2851 35.9071 0.13829446044123805 0.13829446044123805 0.13829446044123805 -34.089 31.2851 35.9071 0.12580756399920914 0.12580756399920914 0.12580756399920914 -35.089 31.2851 35.9071 0.1402501316036034 0.1402501316036034 0.1402501316036034 -33.089 35.2851 28.9071 0.15670961784133677 0.15670961784133677 0.15670961784133677 -33.089 36.2851 28.9071 0.08239035684128697 0.08239035684128697 0.08239035684128697 -34.089 35.2851 28.9071 0.07829659333634595 0.07829659333634595 0.07829659333634595 -34.089 36.2851 28.9071 0.0766831911005232 0.0766831911005232 0.0766831911005232 -34.089 36.2851 29.9071 0.06207766784065395 0.06207766784065395 0.06207766784065395 -34.089 36.2851 30.9071 0.07089153956458295 0.07089153956458295 0.07089153956458295 -33.089 37.2851 28.9071 0.09848963688989956 0.09848963688989956 0.09848963688989956 -33.089 38.2851 28.9071 0.06308569851354164 0.06308569851354164 0.06308569851354164 -34.089 37.2851 28.9071 0.07974913404511197 0.07974913404511197 0.07974913404511197 -33.089 38.2851 29.9071 0.08037340020676859 0.08037340020676859 0.08037340020676859 -33.089 38.2851 30.9071 0.06781352263616826 0.06781352263616826 0.06781352263616826 -34.089 37.2851 29.9071 0.10127632638188087 0.10127632638188087 0.10127632638188087 -34.089 37.2851 30.9071 0.09021658606526584 0.09021658606526584 0.09021658606526584 -34.089 38.2851 29.9071 0.06300450343297968 0.06300450343297968 0.06300450343297968 -34.089 38.2851 30.9071 0.0659888109518879 0.0659888109518879 0.0659888109518879 -35.089 35.2851 27.9071 0.11345370191028928 0.11345370191028928 0.11345370191028928 -35.089 35.2851 28.9071 0.08466966996761775 0.08466966996761775 0.08466966996761775 -35.089 36.2851 28.9071 0.07522086917803092 0.07522086917803092 0.07522086917803092 -36.089 35.2851 27.9071 0.10479169231033869 0.10479169231033869 0.10479169231033869 -36.089 35.2851 28.9071 0.110350076343345 0.110350076343345 0.110350076343345 -36.089 36.2851 28.9071 0.06531065300627076 0.06531065300627076 0.06531065300627076 -35.089 36.2851 29.9071 0.08454670444048423 0.08454670444048423 0.08454670444048423 -35.089 36.2851 30.9071 0.058569037363062515 0.058569037363062515 0.058569037363062515 -36.089 35.2851 29.9071 0.08627624151439299 0.08627624151439299 0.08627624151439299 -36.089 35.2851 30.9071 0.0903596338995168 0.0903596338995168 0.0903596338995168 -36.089 36.2851 29.9071 0.07720339287466567 0.07720339287466567 0.07720339287466567 -36.089 36.2851 30.9071 0.0749186435569363 0.0749186435569363 0.0749186435569363 -35.089 37.2851 29.9071 0.06049818804908951 0.06049818804908951 0.06049818804908951 -33.089 36.2851 31.9071 0.08354046966688433 0.08354046966688433 0.08354046966688433 -33.089 36.2851 32.9071 0.09860856332666397 0.09860856332666397 0.09860856332666397 -34.089 36.2851 31.9071 0.1554633889377389 0.1554633889377389 0.1554633889377389 -33.089 35.2851 34.9071 0.07567934970806424 0.07567934970806424 0.07567934970806424 -33.089 36.2851 34.9071 0.07085392015782073 0.07085392015782073 0.07085392015782073 -34.089 35.2851 34.9071 0.061574572283311466 0.061574572283311466 0.061574572283311466 -34.089 36.2851 33.9071 0.08675121475177426 0.08675121475177426 0.08675121475177426 -34.089 36.2851 34.9071 0.05370535601788537 0.05370535601788537 0.05370535601788537 -33.089 37.2851 31.9071 0.07427343628440822 0.07427343628440822 0.07427343628440822 -33.089 37.2851 32.9071 0.11261333259074577 0.11261333259074577 0.11261333259074577 -34.089 37.2851 31.9071 0.11665120282880187 0.11665120282880187 0.11665120282880187 -34.089 37.2851 32.9071 0.14741061465832841 0.14741061465832841 0.14741061465832841 -33.089 37.2851 33.9071 0.09813044584126608 0.09813044584126608 0.09813044584126608 -33.089 37.2851 34.9071 0.058494269381671966 0.058494269381671966 0.058494269381671966 -34.089 37.2851 33.9071 0.0873459319414233 0.0873459319414233 0.0873459319414233 -35.089 36.2851 31.9071 0.13698690511425468 0.13698690511425468 0.13698690511425468 -35.089 36.2851 32.9071 0.10007745103742485 0.10007745103742485 0.10007745103742485 -36.089 35.2851 31.9071 0.04540775715794941 0.04540775715794941 0.04540775715794941 -36.089 36.2851 31.9071 0.06050220773467465 0.06050220773467465 0.06050220773467465 -36.089 36.2851 32.9071 0.07903034186252907 0.07903034186252907 0.07903034186252907 -35.089 35.2851 34.9071 0.050653134270510485 0.050653134270510485 0.050653134270510485 -35.089 36.2851 33.9071 0.07384991321245489 0.07384991321245489 0.07384991321245489 -35.089 36.2851 34.9071 0.04789058159922893 0.04789058159922893 0.04789058159922893 -36.089 35.2851 33.9071 0.0851446526896991 0.0851446526896991 0.0851446526896991 -36.089 35.2851 34.9071 0.06271348672844261 0.06271348672844261 0.06271348672844261 -36.089 36.2851 33.9071 0.07493021817611006 0.07493021817611006 0.07493021817611006 -35.089 37.2851 31.9071 0.11555539019372733 0.11555539019372733 0.11555539019372733 -35.089 37.2851 32.9071 0.1253721824593628 0.1253721824593628 0.1253721824593628 -37.089 35.2851 27.9071 0.07529964056297503 0.07529964056297503 0.07529964056297503 -37.089 35.2851 28.9071 0.12369971707112931 0.12369971707112931 0.12369971707112931 -38.089 35.2851 27.9071 0.08735477229892051 0.08735477229892051 0.08735477229892051 -38.089 36.2851 27.9071 0.04403508691983666 0.04403508691983666 0.04403508691983666 -37.089 35.2851 29.9071 0.12614333634511526 0.12614333634511526 0.12614333634511526 -39.089 35.2851 27.9071 0.07393133848935463 0.07393133848935463 0.07393133848935463 -37.089 35.2851 31.9071 0.0678947932499206 0.0678947932499206 0.0678947932499206 -37.089 35.2851 32.9071 0.1170946652834633 0.1170946652834633 0.1170946652834633 -37.089 36.2851 32.9071 0.08269094696548837 0.08269094696548837 0.08269094696548837 -37.089 35.2851 33.9071 0.09701589875540718 0.09701589875540718 0.09701589875540718 -28.089 43.2851 27.9071 0.08667325825371344 0.08667325825371344 0.08667325825371344 -28.089 43.2851 28.9071 0.07284185663615615 0.07284185663615615 0.07284185663615615 -28.089 44.2851 27.9071 0.0949611380981338 0.0949611380981338 0.0949611380981338 -28.089 44.2851 28.9071 0.0753765631573019 0.0753765631573019 0.0753765631573019 -28.089 43.2851 29.9071 0.07365595513797801 0.07365595513797801 0.07365595513797801 -28.089 44.2851 29.9071 0.07609177096807399 0.07609177096807399 0.07609177096807399 -29.089 44.2851 27.9071 0.09893239590869843 0.09893239590869843 0.09893239590869843 -29.089 44.2851 28.9071 0.08149742073139282 0.08149742073139282 0.08149742073139282 -29.089 43.2851 29.9071 0.0689352267028133 0.0689352267028133 0.0689352267028133 -29.089 43.2851 30.9071 0.04861439597255339 0.04861439597255339 0.04861439597255339 -29.089 44.2851 29.9071 0.07819724862457021 0.07819724862457021 0.07819724862457021 -29.089 44.2851 30.9071 0.052854231803230386 0.052854231803230386 0.052854231803230386 -30.089 43.2851 30.9071 0.052449088368321815 0.052449088368321815 0.052449088368321815 -30.089 44.2851 30.9071 0.053021788047196726 0.053021788047196726 0.053021788047196726 -29.089 45.2851 27.9071 0.054005249330876845 0.054005249330876845 0.054005249330876845 -29.089 45.2851 28.9071 0.08077245541226143 0.08077245541226143 0.08077245541226143 -29.089 46.2851 27.9071 0.031003242456041885 0.031003242456041885 0.031003242456041885 -30.089 45.2851 27.9071 0.05627788974675484 0.05627788974675484 0.05627788974675484 -30.089 45.2851 28.9071 0.05906965946555261 0.05906965946555261 0.05906965946555261 -30.089 46.2851 27.9071 0.045815830754349494 0.045815830754349494 0.045815830754349494 -30.089 46.2851 28.9071 0.037770569443003166 0.037770569443003166 0.037770569443003166 -29.089 45.2851 29.9071 0.06296205686317942 0.06296205686317942 0.06296205686317942 -30.089 45.2851 29.9071 0.05187590219876766 0.05187590219876766 0.05187590219876766 -30.089 46.2851 29.9071 0.03273529809819492 0.03273529809819492 0.03273529809819492 -31.089 43.2851 27.9071 0.07996887757242993 0.07996887757242993 0.07996887757242993 -31.089 43.2851 28.9071 0.12404674444825618 0.12404674444825618 0.12404674444825618 -32.089 43.2851 27.9071 0.07696981690697957 0.07696981690697957 0.07696981690697957 -32.089 43.2851 28.9071 0.08357342164392537 0.08357342164392537 0.08357342164392537 -32.089 44.2851 28.9071 0.09037088484196847 0.09037088484196847 0.09037088484196847 -31.089 43.2851 29.9071 0.125513561225085 0.125513561225085 0.125513561225085 -31.089 43.2851 30.9071 0.06971496017514671 0.06971496017514671 0.06971496017514671 -31.089 44.2851 29.9071 0.08343196915928076 0.08343196915928076 0.08343196915928076 -31.089 44.2851 30.9071 0.06736142822795047 0.06736142822795047 0.06736142822795047 -32.089 43.2851 29.9071 0.11021027781002901 0.11021027781002901 0.11021027781002901 -32.089 44.2851 29.9071 0.06954406253701333 0.06954406253701333 0.06954406253701333 -31.089 46.2851 27.9071 0.03731919076875372 0.03731919076875372 0.03731919076875372 -31.089 46.2851 28.9071 0.04132907849848135 0.04132907849848135 0.04132907849848135 -32.089 45.2851 27.9071 0.05786155260662049 0.05786155260662049 0.05786155260662049 -32.089 45.2851 28.9071 0.06368412784715725 0.06368412784715725 0.06368412784715725 -32.089 46.2851 27.9071 0.04345186987013278 0.04345186987013278 0.04345186987013278 -32.089 46.2851 28.9071 0.04003160636571428 0.04003160636571428 0.04003160636571428 -31.089 45.2851 29.9071 0.047744563602394305 0.047744563602394305 0.047744563602394305 -31.089 46.2851 29.9071 0.03372278715332968 0.03372278715332968 0.03372278715332968 -32.089 45.2851 29.9071 0.053643126005374936 0.053643126005374936 0.053643126005374936 -32.089 46.2851 29.9071 0.032817167103489475 0.032817167103489475 0.032817167103489475 -33.089 43.2851 27.9071 0.06066846175482841 0.06066846175482841 0.06066846175482841 -33.089 43.2851 28.9071 0.05639703939237279 0.05639703939237279 0.05639703939237279 -33.089 44.2851 27.9071 0.09508569489217567 0.09508569489217567 0.09508569489217567 -33.089 44.2851 28.9071 0.08563972475888619 0.08563972475888619 0.08563972475888619 -33.089 45.2851 27.9071 0.0616088999325335 0.0616088999325335 0.0616088999325335 -33.089 45.2851 28.9071 0.06451069903428328 0.06451069903428328 0.06451069903428328 -41.089 27.2851 27.9071 0.09522873406940352 0.09522873406940352 0.09522873406940352 -41.089 27.2851 28.9071 0.07666438275334529 0.07666438275334529 0.07666438275334529 -41.089 28.2851 27.9071 0.0764191504397008 0.0764191504397008 0.0764191504397008 -41.089 28.2851 28.9071 0.05538940730451159 0.05538940730451159 0.05538940730451159 -42.089 27.2851 27.9071 0.1196541671183775 0.1196541671183775 0.1196541671183775 -42.089 27.2851 28.9071 0.09208342066686934 0.09208342066686934 0.09208342066686934 -41.089 29.2851 27.9071 0.06659943761097349 0.06659943761097349 0.06659943761097349 -43.089 27.2851 27.9071 0.10673612588612752 0.10673612588612752 0.10673612588612752 diff --git a/tensorflow/script/ocnn_lrp_results/molecule_heatmap.ply b/tensorflow/script/ocnn_lrp_results/molecule_heatmap.ply deleted file mode 100644 index 2d07296..0000000 --- a/tensorflow/script/ocnn_lrp_results/molecule_heatmap.ply +++ /dev/null @@ -1,6985 +0,0 @@ -ply -format ascii 1.0 -element vertex 6973 -property float x -property float y -property float z -property float nx -property float ny -property float nz -element face 0 -property list uchar int vertex_indices -end_header --3.281250000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 4.425776004791259766e-01 4.425776004791259766e-01 4.425776004791259766e-01 --4.531250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 2.278840392827987671e-01 2.278840392827987671e-01 2.278840392827987671e-01 --4.218750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.964834891259670258e-02 1.964834891259670258e-02 1.964834891259670258e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 3.388115167617797852e-01 3.388115167617797852e-01 3.388115167617797852e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 4.920637980103492737e-02 4.920637980103492737e-02 4.920637980103492737e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 3.108010888099670410e-01 3.108010888099670410e-01 3.108010888099670410e-01 --3.281250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 2.137900516390800476e-02 2.137900516390800476e-02 2.137900516390800476e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 6.154166907072067261e-02 6.154166907072067261e-02 6.154166907072067261e-02 --2.656250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 3.811557590961456299e-02 3.811557590961456299e-02 3.811557590961456299e-02 --2.656250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 8.070454746484756470e-02 8.070454746484756470e-02 8.070454746484756470e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.575966924428939819e-01 1.575966924428939819e-01 1.575966924428939819e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 2.136050760746002197e-01 2.136050760746002197e-01 2.136050760746002197e-01 --2.656250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 3.285989910364151001e-02 3.285989910364151001e-02 3.285989910364151001e-02 --2.968750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.041049659252166748e-01 1.041049659252166748e-01 1.041049659252166748e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 5.425592139363288879e-02 5.425592139363288879e-02 5.425592139363288879e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.968750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.968750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.968750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.343750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.343750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.713927984237670898e-01 1.713927984237670898e-01 1.713927984237670898e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 2.107907533645629883e-01 2.107907533645629883e-01 2.107907533645629883e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 2.258708029985427856e-01 2.258708029985427856e-01 2.258708029985427856e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.718750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.718750000000000000e-01 -2.968750000000000000e-01 7.173488289117813110e-02 7.173488289117813110e-02 7.173488289117813110e-02 --1.562500000000000000e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.562500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.562500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -4.687500000000000000e-02 -4.218750000000000000e-01 2.278747409582138062e-01 2.278747409582138062e-01 2.278747409582138062e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 9.217484295368194580e-02 9.217484295368194580e-02 9.217484295368194580e-02 --2.343750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 2.972230017185211182e-01 2.972230017185211182e-01 2.972230017185211182e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 9.418463706970214844e-02 9.418463706970214844e-02 9.418463706970214844e-02 --2.031250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.395282149314880371e-01 1.395282149314880371e-01 1.395282149314880371e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 6.085897684097290039e-01 6.085897684097290039e-01 6.085897684097290039e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 5.941802263259887695e-01 5.941802263259887695e-01 5.941802263259887695e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 4.056304395198822021e-01 4.056304395198822021e-01 4.056304395198822021e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 5.864781141281127930e-01 5.864781141281127930e-01 5.864781141281127930e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 4.947310090065002441e-01 4.947310090065002441e-01 4.947310090065002441e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 5.120110139250755310e-02 5.120110139250755310e-02 5.120110139250755310e-02 --1.093750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 4.019317403435707092e-02 4.019317403435707092e-02 4.019317403435707092e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 3.633100539445877075e-02 3.633100539445877075e-02 3.633100539445877075e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 1.433825492858886719e-01 1.433825492858886719e-01 1.433825492858886719e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 5.448602139949798584e-02 5.448602139949798584e-02 5.448602139949798584e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 2.574630677700042725e-01 2.574630677700042725e-01 2.574630677700042725e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 4.544095322489738464e-02 4.544095322489738464e-02 4.544095322489738464e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.214984297752380371e-01 2.214984297752380371e-01 2.214984297752380371e-01 --2.968750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 2.283029071986675262e-02 2.283029071986675262e-02 2.283029071986675262e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 1.149257570505142212e-01 1.149257570505142212e-01 1.149257570505142212e-01 --3.593750000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 4.498673081398010254e-01 4.498673081398010254e-01 4.498673081398010254e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 2.244837731122970581e-01 2.244837731122970581e-01 2.244837731122970581e-01 --3.281250000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 3.951892256736755371e-01 3.951892256736755371e-01 3.951892256736755371e-01 --2.656250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.966535985469818115e-01 2.966535985469818115e-01 2.966535985469818115e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 3.290420770645141602e-01 3.290420770645141602e-01 3.290420770645141602e-01 --2.656250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 2.857773751020431519e-02 2.857773751020431519e-02 2.857773751020431519e-02 --1.718750000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 1.054359972476959229e-01 1.054359972476959229e-01 1.054359972476959229e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.147764623165130615e-01 1.147764623165130615e-01 1.147764623165130615e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 4.873665049672126770e-03 4.873665049672126770e-03 4.873665049672126770e-03 --2.031250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.987960487604141235e-01 1.987960487604141235e-01 1.987960487604141235e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.718750000000000000e-01 1.562500000000000000e-02 1.270040422677993774e-01 1.270040422677993774e-01 1.270040422677993774e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 1.093750000000000000e-01 1.551542617380619049e-02 1.551542617380619049e-02 1.551542617380619049e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 1.604571565985679626e-02 1.604571565985679626e-02 1.604571565985679626e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 1.093750000000000000e-01 1.994476420804858208e-03 1.994476420804858208e-03 1.994476420804858208e-03 --7.812500000000000000e-02 -1.562500000000000000e-02 1.093750000000000000e-01 1.099985018372535706e-01 1.099985018372535706e-01 1.099985018372535706e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 1.093750000000000000e-01 3.404997289180755615e-02 3.404997289180755615e-02 3.404997289180755615e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 1.093750000000000000e-01 2.610612213611602783e-01 2.610612213611602783e-01 2.610612213611602783e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 8.874052762985229492e-02 8.874052762985229492e-02 8.874052762985229492e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 4.434191808104515076e-02 4.434191808104515076e-02 4.434191808104515076e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 3.481982052326202393e-01 3.481982052326202393e-01 3.481982052326202393e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 1.406250000000000000e-01 6.887491941452026367e-01 6.887491941452026367e-01 6.887491941452026367e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.562500000000000000e-02 1.406250000000000000e-01 6.811731457710266113e-01 6.811731457710266113e-01 6.811731457710266113e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.355491578578948975e-01 1.355491578578948975e-01 1.355491578578948975e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 3.316329717636108398e-01 3.316329717636108398e-01 3.316329717636108398e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 4.284448325634002686e-01 4.284448325634002686e-01 4.284448325634002686e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 8.745803833007812500e-01 8.745803833007812500e-01 8.745803833007812500e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 4.949212670326232910e-01 4.949212670326232910e-01 4.949212670326232910e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 1.406250000000000000e-01 7.592107057571411133e-01 7.592107057571411133e-01 7.592107057571411133e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 7.675122022628784180e-01 7.675122022628784180e-01 7.675122022628784180e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 1.406250000000000000e-01 5.760897994041442871e-01 5.760897994041442871e-01 5.760897994041442871e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 7.039735913276672363e-01 7.039735913276672363e-01 7.039735913276672363e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 5.567247867584228516e-01 5.567247867584228516e-01 5.567247867584228516e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 2.031250000000000000e-01 8.039999604225158691e-01 8.039999604225158691e-01 8.039999604225158691e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 9.005385041236877441e-01 9.005385041236877441e-01 9.005385041236877441e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 7.459559440612792969e-01 7.459559440612792969e-01 7.459559440612792969e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.562500000000000000e-02 2.031250000000000000e-01 8.875834345817565918e-01 8.875834345817565918e-01 8.875834345817565918e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.399284094572067261e-01 2.399284094572067261e-01 2.399284094572067261e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 6.641442328691482544e-02 6.641442328691482544e-02 6.641442328691482544e-02 --2.031250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 3.509371075779199600e-03 3.509371075779199600e-03 3.509371075779199600e-03 --2.031250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 5.055915191769599915e-02 5.055915191769599915e-02 5.055915191769599915e-02 --1.718750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 9.238491207361221313e-02 9.238491207361221313e-02 9.238491207361221313e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 2.673626244068145752e-01 2.673626244068145752e-01 2.673626244068145752e-01 --1.093750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.130444332957267761e-01 1.130444332957267761e-01 1.130444332957267761e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 6.931606680154800415e-02 6.931606680154800415e-02 6.931606680154800415e-02 --1.562500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.093750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.074153870344161987e-01 2.074153870344161987e-01 2.074153870344161987e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 2.968750000000000000e-01 5.366598367691040039e-01 5.366598367691040039e-01 5.366598367691040039e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -7.812500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -7.812500000000000000e-02 3.281250000000000000e-01 5.698948502540588379e-01 5.698948502540588379e-01 5.698948502540588379e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 3.433007299900054932e-01 3.433007299900054932e-01 3.433007299900054932e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 8.677808642387390137e-01 8.677808642387390137e-01 8.677808642387390137e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 4.764995872974395752e-01 4.764995872974395752e-01 4.764995872974395752e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -4.687500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 6.591564416885375977e-01 6.591564416885375977e-01 6.591564416885375977e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 4.009755849838256836e-01 4.009755849838256836e-01 4.009755849838256836e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 4.046059250831604004e-01 4.046059250831604004e-01 4.046059250831604004e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -7.812500000000000000e-02 3.281250000000000000e-01 6.139069795608520508e-01 6.139069795608520508e-01 6.139069795608520508e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 4.447971284389495850e-01 4.447971284389495850e-01 4.447971284389495850e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 7.065923213958740234e-01 7.065923213958740234e-01 7.065923213958740234e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 3.656181395053863525e-01 3.656181395053863525e-01 3.656181395053863525e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 3.281250000000000000e-01 4.425925612449645996e-01 4.425925612449645996e-01 4.425925612449645996e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 5.692958831787109375e-01 5.692958831787109375e-01 5.692958831787109375e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 5.862883329391479492e-01 5.862883329391479492e-01 5.862883329391479492e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 3.281250000000000000e-01 5.387992858886718750e-01 5.387992858886718750e-01 5.387992858886718750e-01 --5.156250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --5.156250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --5.156250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --5.156250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --5.156250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --5.156250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --5.156250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --5.156250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --5.156250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --5.156250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --5.156250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --5.156250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --5.156250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 2.232382446527481079e-01 2.232382446527481079e-01 2.232382446527481079e-01 --2.968750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 2.029125988483428955e-01 2.029125988483428955e-01 2.029125988483428955e-01 --2.656250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 3.416660130023956299e-01 3.416660130023956299e-01 3.416660130023956299e-01 --2.656250000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 2.239068895578384399e-01 2.239068895578384399e-01 2.239068895578384399e-01 --2.968750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 1.577214151620864868e-01 1.577214151620864868e-01 1.577214151620864868e-01 --2.968750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 2.650000452995300293e-01 2.650000452995300293e-01 2.650000452995300293e-01 --2.656250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 1.705096960067749023e-01 1.705096960067749023e-01 1.705096960067749023e-01 --4.531250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.843750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 3.258775472640991211e-01 3.258775472640991211e-01 3.258775472640991211e-01 --3.593750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 2.512836754322052002e-01 2.512836754322052002e-01 2.512836754322052002e-01 --3.281250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 1.176468059420585632e-01 1.176468059420585632e-01 1.176468059420585632e-01 --3.281250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.891476064920425415e-01 1.891476064920425415e-01 1.891476064920425415e-01 --3.593750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 5.103859305381774902e-02 5.103859305381774902e-02 5.103859305381774902e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 2.232075780630111694e-01 2.232075780630111694e-01 2.232075780630111694e-01 --2.968750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 3.399148955941200256e-02 3.399148955941200256e-02 3.399148955941200256e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 2.292422950267791748e-01 2.292422950267791748e-01 2.292422950267791748e-01 --2.968750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 1.114577725529670715e-01 1.114577725529670715e-01 1.114577725529670715e-01 --2.656250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 3.199563622474670410e-01 3.199563622474670410e-01 3.199563622474670410e-01 --2.968750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 5.369729362428188324e-03 5.369729362428188324e-03 5.369729362428188324e-03 --3.281250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 3.671896085143089294e-02 3.671896085143089294e-02 3.671896085143089294e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.190001666545867920e-01 1.190001666545867920e-01 1.190001666545867920e-01 --2.656250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 1.719738394021987915e-01 1.719738394021987915e-01 1.719738394021987915e-01 --2.968750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 3.242304921150207520e-01 3.242304921150207520e-01 3.242304921150207520e-01 --2.656250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 4.468435049057006836e-02 4.468435049057006836e-02 4.468435049057006836e-02 --3.593750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.014997139573097229e-01 1.014997139573097229e-01 1.014997139573097229e-01 --3.281250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 9.007460623979568481e-02 9.007460623979568481e-02 9.007460623979568481e-02 --3.593750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 6.125095114111900330e-02 6.125095114111900330e-02 6.125095114111900330e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.142172068357467651e-01 1.142172068357467651e-01 1.142172068357467651e-01 --2.968750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 5.309529602527618408e-02 5.309529602527618408e-02 5.309529602527618408e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 1.465583685785531998e-02 1.465583685785531998e-02 1.465583685785531998e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 2.370358556509017944e-01 2.370358556509017944e-01 2.370358556509017944e-01 --2.656250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 1.804552674293518066e-01 1.804552674293518066e-01 1.804552674293518066e-01 --2.656250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 1.929316818714141846e-01 1.929316818714141846e-01 1.929316818714141846e-01 --2.656250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 1.749820858240127563e-01 1.749820858240127563e-01 1.749820858240127563e-01 --2.656250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 -3.906250000000000000e-01 3.103428184986114502e-01 3.103428184986114502e-01 3.103428184986114502e-01 --2.343750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.406250000000000000e-01 -3.906250000000000000e-01 2.879890799522399902e-01 2.879890799522399902e-01 2.879890799522399902e-01 --1.406250000000000000e-01 1.406250000000000000e-01 -3.906250000000000000e-01 4.000855386257171631e-01 4.000855386257171631e-01 4.000855386257171631e-01 --1.406250000000000000e-01 1.718750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 6.605759263038635254e-02 6.605759263038635254e-02 6.605759263038635254e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.406250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 4.691895097494125366e-02 4.691895097494125366e-02 4.691895097494125366e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.562500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.562500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.406250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.718750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.406250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 1.208281219005584717e-01 1.208281219005584717e-01 1.208281219005584717e-01 --7.812500000000000000e-02 1.406250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.718750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.406250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.718750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.406250000000000000e-01 -3.593750000000000000e-01 6.167607754468917847e-02 6.167607754468917847e-02 6.167607754468917847e-02 --1.562500000000000000e-02 1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.031250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 5.127487331628799438e-02 5.127487331628799438e-02 5.127487331628799438e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 3.352923095226287842e-01 3.352923095226287842e-01 3.352923095226287842e-01 --2.031250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 1.948419064283370972e-01 1.948419064283370972e-01 1.948419064283370972e-01 --2.031250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 2.099536657333374023e-01 2.099536657333374023e-01 2.099536657333374023e-01 --2.343750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.982236504554748535e-01 1.982236504554748535e-01 1.982236504554748535e-01 --2.343750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 3.756810724735260010e-01 3.756810724735260010e-01 3.756810724735260010e-01 --2.343750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 2.965636551380157471e-01 2.965636551380157471e-01 2.965636551380157471e-01 --2.343750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.338518708944320679e-01 1.338518708944320679e-01 1.338518708944320679e-01 --2.343750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 3.175033628940582275e-01 3.175033628940582275e-01 3.175033628940582275e-01 --2.031250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 2.234344631433486938e-01 2.234344631433486938e-01 2.234344631433486938e-01 --1.718750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 8.547580242156982422e-02 8.547580242156982422e-02 8.547580242156982422e-02 --2.343750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 1.800238341093063354e-02 1.800238341093063354e-02 1.800238341093063354e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 2.164595574140548706e-01 2.164595574140548706e-01 2.164595574140548706e-01 --1.406250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 1.130126044154167175e-01 1.130126044154167175e-01 1.130126044154167175e-01 --1.718750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 2.115428000688552856e-01 2.115428000688552856e-01 2.115428000688552856e-01 --1.718750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 6.774917989969253540e-02 6.774917989969253540e-02 6.774917989969253540e-02 --2.031250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 5.023014917969703674e-02 5.023014917969703674e-02 5.023014917969703674e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 2.190705835819244385e-01 2.190705835819244385e-01 2.190705835819244385e-01 --2.343750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 2.097777128219604492e-01 2.097777128219604492e-01 2.097777128219604492e-01 --2.031250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 4.776800796389579773e-02 4.776800796389579773e-02 4.776800796389579773e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 1.674975603818893433e-01 1.674975603818893433e-01 1.674975603818893433e-01 --2.031250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 4.710741937160491943e-01 4.710741937160491943e-01 4.710741937160491943e-01 --2.031250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 3.335225582122802734e-01 3.335225582122802734e-01 3.335225582122802734e-01 --1.718750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 6.526760756969451904e-02 6.526760756969451904e-02 6.526760756969451904e-02 --1.406250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 3.967373073101043701e-02 3.967373073101043701e-02 3.967373073101043701e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.648860722780227661e-01 1.648860722780227661e-01 1.648860722780227661e-01 --1.406250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 2.575703561305999756e-01 2.575703561305999756e-01 2.575703561305999756e-01 --1.406250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 2.426275610923767090e-01 2.426275610923767090e-01 2.426275610923767090e-01 --1.718750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 3.781557381153106689e-01 3.781557381153106689e-01 3.781557381153106689e-01 --1.406250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 2.376309633255004883e-01 2.376309633255004883e-01 2.376309633255004883e-01 --1.406250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 4.317420423030853271e-01 4.317420423030853271e-01 4.317420423030853271e-01 --1.562500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 2.906089425086975098e-01 2.906089425086975098e-01 2.906089425086975098e-01 --7.812500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.718750000000000000e-01 -1.562500000000000000e-02 2.044218219816684723e-02 2.044218219816684723e-02 2.044218219816684723e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 2.961981594562530518e-01 2.961981594562530518e-01 2.961981594562530518e-01 --7.812500000000000000e-02 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 1.776569150388240814e-02 1.776569150388240814e-02 1.776569150388240814e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 -4.687500000000000000e-02 4.406116902828216553e-03 4.406116902828216553e-03 4.406116902828216553e-03 --1.562500000000000000e-02 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.656250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.968750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.656250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 -3.906250000000000000e-01 8.330740779638290405e-02 8.330740779638290405e-02 8.330740779638290405e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -3.906250000000000000e-01 4.342906177043914795e-01 4.342906177043914795e-01 4.342906177043914795e-01 --7.812500000000000000e-02 2.656250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.968750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.656250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.656250000000000000e-01 -3.281250000000000000e-01 1.485160589218139648e-01 1.485160589218139648e-01 1.485160589218139648e-01 --4.687500000000000000e-02 2.968750000000000000e-01 -3.593750000000000000e-01 5.400191526859998703e-03 5.400191526859998703e-03 5.400191526859998703e-03 --4.687500000000000000e-02 2.968750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 -3.593750000000000000e-01 2.778072953224182129e-01 2.778072953224182129e-01 2.778072953224182129e-01 --4.687500000000000000e-02 2.656250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.656250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.968750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.968750000000000000e-01 -2.656250000000000000e-01 1.869818568229675293e-02 1.869818568229675293e-02 1.869818568229675293e-02 --1.562500000000000000e-02 2.656250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.281250000000000000e-01 -3.593750000000000000e-01 3.968341946601867676e-01 3.968341946601867676e-01 3.968341946601867676e-01 --4.687500000000000000e-02 3.281250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.593750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.906250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.906250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 7.934836298227310181e-02 7.934836298227310181e-02 7.934836298227310181e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 2.142702043056488037e-01 2.142702043056488037e-01 2.142702043056488037e-01 --1.718750000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 3.281250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 4.831219315528869629e-01 4.831219315528869629e-01 4.831219315528869629e-01 --1.406250000000000000e-01 3.281250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.593750000000000000e-01 -2.031250000000000000e-01 3.799397647380828857e-01 3.799397647380828857e-01 3.799397647380828857e-01 --1.718750000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 3.297866284847259521e-01 3.297866284847259521e-01 3.297866284847259521e-01 --1.406250000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 2.777010500431060791e-01 2.777010500431060791e-01 2.777010500431060791e-01 --2.343750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 5.230801701545715332e-01 5.230801701545715332e-01 5.230801701545715332e-01 --2.343750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 3.498491644859313965e-01 3.498491644859313965e-01 3.498491644859313965e-01 --2.031250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 4.322407245635986328e-01 4.322407245635986328e-01 4.322407245635986328e-01 --2.343750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 3.876886367797851562e-01 3.876886367797851562e-01 3.876886367797851562e-01 --1.406250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 1.830562800168991089e-01 1.830562800168991089e-01 1.830562800168991089e-01 --1.406250000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 3.547269403934478760e-01 3.547269403934478760e-01 3.547269403934478760e-01 --1.718750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 1.465243566781282425e-02 1.465243566781282425e-02 1.465243566781282425e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 2.039049416780471802e-01 2.039049416780471802e-01 2.039049416780471802e-01 --1.406250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 3.719345033168792725e-01 3.719345033168792725e-01 3.719345033168792725e-01 --1.406250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.281250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.593750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.593750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 2.499386370182037354e-01 2.499386370182037354e-01 2.499386370182037354e-01 --1.406250000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.906250000000000000e-01 -7.812500000000000000e-02 1.393149197101593018e-01 1.393149197101593018e-01 1.393149197101593018e-01 --1.406250000000000000e-01 4.218750000000000000e-01 -1.093750000000000000e-01 1.126839667558670044e-01 1.126839667558670044e-01 1.126839667558670044e-01 --1.406250000000000000e-01 4.218750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.906250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 3.906250000000000000e-01 -1.562500000000000000e-02 2.837452292442321777e-01 2.837452292442321777e-01 2.837452292442321777e-01 --1.406250000000000000e-01 4.218750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.218750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.531250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 1.308409422636032104e-01 1.308409422636032104e-01 1.308409422636032104e-01 --1.093750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 1.097246855497360229e-01 1.097246855497360229e-01 1.097246855497360229e-01 --7.812500000000000000e-02 2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.968750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 3.593750000000000000e-01 -2.031250000000000000e-01 4.327362775802612305e-01 4.327362775802612305e-01 4.327362775802612305e-01 --7.812500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 3.593750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 3.593750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 3.143242895603179932e-01 3.143242895603179932e-01 3.143242895603179932e-01 --7.812500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 4.748543798923492432e-01 4.748543798923492432e-01 4.748543798923492432e-01 --1.562500000000000000e-02 2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.593750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.593750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.281250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.593750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 2.282859683036804199e-01 2.282859683036804199e-01 2.282859683036804199e-01 --1.093750000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.656250000000000000e-01 -1.093750000000000000e-01 9.735811501741409302e-02 9.735811501741409302e-02 9.735811501741409302e-02 --7.812500000000000000e-02 2.968750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.968750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 3.281250000000000000e-01 -7.812500000000000000e-02 1.430073082447052002e-01 1.430073082447052002e-01 1.430073082447052002e-01 --1.093750000000000000e-01 3.593750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 3.281250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 9.964729845523834229e-02 9.964729845523834229e-02 9.964729845523834229e-02 --1.093750000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.656250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.656250000000000000e-01 -7.812500000000000000e-02 4.681757837533950806e-02 4.681757837533950806e-02 4.681757837533950806e-02 --4.687500000000000000e-02 2.968750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.968750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.656250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.656250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 -1.562500000000000000e-02 1.199710741639137268e-01 1.199710741639137268e-01 1.199710741639137268e-01 --4.687500000000000000e-02 3.281250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.281250000000000000e-01 -7.812500000000000000e-02 1.026583313941955566e-01 1.026583313941955566e-01 1.026583313941955566e-01 --1.562500000000000000e-02 3.281250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 3.906250000000000000e-01 -1.718750000000000000e-01 2.635212838649749756e-01 2.635212838649749756e-01 2.635212838649749756e-01 --1.093750000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 3.693298697471618652e-01 3.693298697471618652e-01 3.693298697471618652e-01 --7.812500000000000000e-02 3.906250000000000000e-01 -1.718750000000000000e-01 3.336153626441955566e-01 3.336153626441955566e-01 3.336153626441955566e-01 --7.812500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.218750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.218750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 2.677167952060699463e-01 2.677167952060699463e-01 2.677167952060699463e-01 --1.093750000000000000e-01 4.218750000000000000e-01 -1.093750000000000000e-01 3.303319588303565979e-02 3.303319588303565979e-02 3.303319588303565979e-02 --7.812500000000000000e-02 4.218750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 3.906250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.218750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 3.906250000000000000e-01 -1.562500000000000000e-02 3.303061425685882568e-01 3.303061425685882568e-01 3.303061425685882568e-01 --1.093750000000000000e-01 4.531250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.531250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.531250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.531250000000000000e-01 -7.812500000000000000e-02 5.904260277748107910e-01 5.904260277748107910e-01 5.904260277748107910e-01 --7.812500000000000000e-02 4.843750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.531250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.843750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.531250000000000000e-01 -4.687500000000000000e-02 4.370562434196472168e-01 4.370562434196472168e-01 4.370562434196472168e-01 --7.812500000000000000e-02 4.843750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.843750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.218750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.218750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.906250000000000000e-01 -7.812500000000000000e-02 5.124938488006591797e-01 5.124938488006591797e-01 5.124938488006591797e-01 --1.562500000000000000e-02 4.218750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.218750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.906250000000000000e-01 -4.687500000000000000e-02 4.630583226680755615e-01 4.630583226680755615e-01 4.630583226680755615e-01 --4.687500000000000000e-02 3.906250000000000000e-01 -1.562500000000000000e-02 4.115875661373138428e-01 4.115875661373138428e-01 4.115875661373138428e-01 --1.562500000000000000e-02 3.906250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.218750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.218750000000000000e-01 -1.562500000000000000e-02 2.022098749876022339e-01 2.022098749876022339e-01 2.022098749876022339e-01 --4.687500000000000000e-02 4.531250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.843750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.531250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.843750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.531250000000000000e-01 -1.562500000000000000e-02 3.285313248634338379e-01 3.285313248634338379e-01 3.285313248634338379e-01 --4.687500000000000000e-02 4.843750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.843750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.531250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.531250000000000000e-01 -1.562500000000000000e-02 1.990623772144317627e-01 1.990623772144317627e-01 1.990623772144317627e-01 --1.562500000000000000e-02 4.843750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.843750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 1.292289942502975464e-01 1.292289942502975464e-01 1.292289942502975464e-01 --4.218750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 2.782931551337242126e-04 2.782931551337242126e-04 2.782931551337242126e-04 --3.906250000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 5.236979201436042786e-02 5.236979201436042786e-02 5.236979201436042786e-02 --3.906250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 2.506443858146667480e-01 2.506443858146667480e-01 2.506443858146667480e-01 --3.906250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 3.458234369754791260e-01 3.458234369754791260e-01 3.458234369754791260e-01 --3.906250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.626348048448562622e-01 1.626348048448562622e-01 1.626348048448562622e-01 --3.593750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 2.056629359722137451e-01 2.056629359722137451e-01 2.056629359722137451e-01 --3.281250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 3.225256502628326416e-01 3.225256502628326416e-01 3.225256502628326416e-01 --3.593750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 2.154106507077813148e-03 2.154106507077813148e-03 2.154106507077813148e-03 --3.593750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 2.313354760408401489e-01 2.313354760408401489e-01 2.313354760408401489e-01 --3.281250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 4.740570187568664551e-01 4.740570187568664551e-01 4.740570187568664551e-01 --2.656250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 7.430864572525024414e-01 7.430864572525024414e-01 7.430864572525024414e-01 --2.968750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 6.233723163604736328e-01 6.233723163604736328e-01 6.233723163604736328e-01 --2.968750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 3.965276479721069336e-01 3.965276479721069336e-01 3.965276479721069336e-01 --2.968750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 7.356050014495849609e-01 7.356050014495849609e-01 7.356050014495849609e-01 --2.968750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 6.400148272514343262e-01 6.400148272514343262e-01 6.400148272514343262e-01 --2.656250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 3.687835633754730225e-01 3.687835633754730225e-01 3.687835633754730225e-01 --2.968750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 2.304736673831939697e-01 2.304736673831939697e-01 2.304736673831939697e-01 --2.656250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 2.137450277805328369e-01 2.137450277805328369e-01 2.137450277805328369e-01 --2.656250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 7.102854549884796143e-02 7.102854549884796143e-02 7.102854549884796143e-02 --3.593750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 2.425750046968460083e-01 2.425750046968460083e-01 2.425750046968460083e-01 --3.593750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 2.176284044981002808e-01 2.176284044981002808e-01 2.176284044981002808e-01 --3.281250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 6.042087078094482422e-02 6.042087078094482422e-02 6.042087078094482422e-02 --2.968750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.938432753086090088e-01 1.938432753086090088e-01 1.938432753086090088e-01 --2.656250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 2.139845788478851318e-01 2.139845788478851318e-01 2.139845788478851318e-01 --2.656250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 8.779796212911605835e-02 8.779796212911605835e-02 8.779796212911605835e-02 --2.656250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 3.155229091644287109e-01 3.155229091644287109e-01 3.155229091644287109e-01 --2.968750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 5.436403155326843262e-01 5.436403155326843262e-01 5.436403155326843262e-01 --2.656250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 3.044113516807556152e-01 3.044113516807556152e-01 3.044113516807556152e-01 --2.656250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 5.601586699485778809e-01 5.601586699485778809e-01 5.601586699485778809e-01 --2.968750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 1.539908200502395630e-01 1.539908200502395630e-01 1.539908200502395630e-01 --2.656250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 6.183704137802124023e-01 6.183704137802124023e-01 6.183704137802124023e-01 --3.281250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 1.722110658884048462e-01 1.722110658884048462e-01 1.722110658884048462e-01 --2.656250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.850931644439697266e-01 1.850931644439697266e-01 1.850931644439697266e-01 --2.656250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 1.795693933963775635e-01 1.795693933963775635e-01 1.795693933963775635e-01 --2.656250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 2.561063766479492188e-01 2.561063766479492188e-01 2.561063766479492188e-01 --2.656250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 1.703705489635467529e-01 1.703705489635467529e-01 1.703705489635467529e-01 --3.593750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 1.298407465219497681e-01 1.298407465219497681e-01 1.298407465219497681e-01 --3.281250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 2.771708965301513672e-01 2.771708965301513672e-01 2.771708965301513672e-01 --3.281250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 3.212071955204010010e-01 3.212071955204010010e-01 3.212071955204010010e-01 --3.281250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 3.153990805149078369e-01 3.153990805149078369e-01 3.153990805149078369e-01 --2.968750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 1.310337185859680176e-01 1.310337185859680176e-01 1.310337185859680176e-01 --2.656250000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 4.163170456886291504e-01 4.163170456886291504e-01 4.163170456886291504e-01 --2.656250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 3.226362168788909912e-01 3.226362168788909912e-01 3.226362168788909912e-01 --2.656250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.968750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 2.207489162683486938e-01 2.207489162683486938e-01 2.207489162683486938e-01 --2.656250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 2.266403287649154663e-01 2.266403287649154663e-01 2.266403287649154663e-01 --2.968750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 1.805800646543502808e-01 1.805800646543502808e-01 1.805800646543502808e-01 --4.218750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 1.329411119222640991e-01 1.329411119222640991e-01 1.329411119222640991e-01 --4.218750000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 2.063592225313186646e-01 2.063592225313186646e-01 2.063592225313186646e-01 --3.906250000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 3.297948511317372322e-03 3.297948511317372322e-03 3.297948511317372322e-03 --4.218750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.218750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.906250000000000000e-01 1.093750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 3.505539298057556152e-01 3.505539298057556152e-01 3.505539298057556152e-01 --3.593750000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 3.356745541095733643e-01 3.356745541095733643e-01 3.356745541095733643e-01 --3.281250000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 3.592727780342102051e-01 3.592727780342102051e-01 3.592727780342102051e-01 --3.281250000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.593750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --3.281250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 2.435351461172103882e-01 2.435351461172103882e-01 2.435351461172103882e-01 --3.281250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 2.015769481658935547e-02 2.015769481658935547e-02 2.015769481658935547e-02 --2.968750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 4.698176383972167969e-01 4.698176383972167969e-01 4.698176383972167969e-01 --2.656250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 1.746224611997604370e-01 1.746224611997604370e-01 1.746224611997604370e-01 --2.031250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.978546828031539917e-01 1.978546828031539917e-01 1.978546828031539917e-01 --1.718750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 8.364808559417724609e-02 8.364808559417724609e-02 8.364808559417724609e-02 --1.406250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 2.296194434165954590e-01 2.296194434165954590e-01 2.296194434165954590e-01 --2.343750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.848620176315307617e-01 1.848620176315307617e-01 1.848620176315307617e-01 --2.031250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.008996069431304932e-01 1.008996069431304932e-01 1.008996069431304932e-01 --2.031250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 2.761931121349334717e-01 2.761931121349334717e-01 2.761931121349334717e-01 --2.031250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.144051775336265564e-01 1.144051775336265564e-01 1.144051775336265564e-01 --2.343750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 3.316285610198974609e-01 3.316285610198974609e-01 3.316285610198974609e-01 --2.343750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 2.504697442054748535e-01 2.504697442054748535e-01 2.504697442054748535e-01 --2.343750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 2.824339270591735840e-01 2.824339270591735840e-01 2.824339270591735840e-01 --2.031250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 2.199327796697616577e-01 2.199327796697616577e-01 2.199327796697616577e-01 --2.031250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 3.262327015399932861e-01 3.262327015399932861e-01 3.262327015399932861e-01 --2.031250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 5.495651960372924805e-01 5.495651960372924805e-01 5.495651960372924805e-01 --2.343750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 5.529127120971679688e-01 5.529127120971679688e-01 5.529127120971679688e-01 --2.031250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.934515535831451416e-01 1.934515535831451416e-01 1.934515535831451416e-01 --1.406250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.017895266413688660e-01 1.017895266413688660e-01 1.017895266413688660e-01 --1.718750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 4.984111487865447998e-01 4.984111487865447998e-01 4.984111487865447998e-01 --1.718750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 2.403384894132614136e-01 2.403384894132614136e-01 2.403384894132614136e-01 --1.718750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 3.133664727210998535e-01 3.133664727210998535e-01 3.133664727210998535e-01 --1.406250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.483789831399917603e-01 1.483789831399917603e-01 1.483789831399917603e-01 --1.718750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.354259401559829712e-01 1.354259401559829712e-01 1.354259401559829712e-01 --1.406250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 2.235395759344100952e-01 2.235395759344100952e-01 2.235395759344100952e-01 --1.406250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 3.124723732471466064e-01 3.124723732471466064e-01 3.124723732471466064e-01 --1.406250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 9.949411451816558838e-02 9.949411451816558838e-02 9.949411451816558838e-02 --2.031250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 9.148263186216354370e-02 9.148263186216354370e-02 9.148263186216354370e-02 --2.031250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 1.240823939442634583e-01 1.240823939442634583e-01 1.240823939442634583e-01 --2.031250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 1.650204062461853027e-01 1.650204062461853027e-01 1.650204062461853027e-01 --2.343750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 4.829036816954612732e-02 4.829036816954612732e-02 4.829036816954612732e-02 --2.031250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 3.731182813644409180e-01 3.731182813644409180e-01 3.731182813644409180e-01 --2.031250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 1.608756184577941895e-02 1.608756184577941895e-02 1.608756184577941895e-02 --2.343750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 3.096773326396942139e-01 3.096773326396942139e-01 3.096773326396942139e-01 --1.718750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 6.135079860687255859e-01 6.135079860687255859e-01 6.135079860687255859e-01 --1.406250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 7.696842551231384277e-01 7.696842551231384277e-01 7.696842551231384277e-01 --1.718750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 5.642106533050537109e-01 5.642106533050537109e-01 5.642106533050537109e-01 --1.718750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 6.913469433784484863e-01 6.913469433784484863e-01 6.913469433784484863e-01 --1.406250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 6.369185447692871094e-01 6.369185447692871094e-01 6.369185447692871094e-01 --1.406250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 6.887591481208801270e-01 6.887591481208801270e-01 6.887591481208801270e-01 --1.718750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 3.577667772769927979e-01 3.577667772769927979e-01 3.577667772769927979e-01 --1.718750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 1.720748543739318848e-01 1.720748543739318848e-01 1.720748543739318848e-01 --1.406250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 6.044585108757019043e-01 6.044585108757019043e-01 6.044585108757019043e-01 --1.406250000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 3.629812300205230713e-01 3.629812300205230713e-01 3.629812300205230713e-01 --2.343750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 4.854609072208404541e-01 4.854609072208404541e-01 4.854609072208404541e-01 --2.343750000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 3.561596572399139404e-01 3.561596572399139404e-01 3.561596572399139404e-01 --2.343750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 4.028021395206451416e-01 4.028021395206451416e-01 4.028021395206451416e-01 --2.343750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 3.695307075977325439e-01 3.695307075977325439e-01 3.695307075977325439e-01 --2.343750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 2.569379210472106934e-01 2.569379210472106934e-01 2.569379210472106934e-01 --2.343750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 6.524004936218261719e-01 6.524004936218261719e-01 6.524004936218261719e-01 --2.343750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 5.602052211761474609e-01 5.602052211761474609e-01 5.602052211761474609e-01 --2.031250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 4.299766421318054199e-01 4.299766421318054199e-01 4.299766421318054199e-01 --2.031250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 4.057937562465667725e-01 4.057937562465667725e-01 4.057937562465667725e-01 --2.031250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 9.296212792396545410e-01 9.296212792396545410e-01 9.296212792396545410e-01 --1.406250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 --1.406250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 --1.406250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 2.669739425182342529e-01 2.669739425182342529e-01 2.669739425182342529e-01 --1.406250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 4.713183045387268066e-01 4.713183045387268066e-01 4.713183045387268066e-01 --1.406250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 3.790494501590728760e-01 3.790494501590728760e-01 3.790494501590728760e-01 --1.406250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.835879534482955933e-01 1.835879534482955933e-01 1.835879534482955933e-01 --1.718750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 5.259668827056884766e-01 5.259668827056884766e-01 5.259668827056884766e-01 --1.718750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 9.516152143478393555e-01 9.516152143478393555e-01 9.516152143478393555e-01 --1.406250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 9.296497702598571777e-01 9.296497702598571777e-01 9.296497702598571777e-01 --1.718750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 5.439957976341247559e-01 5.439957976341247559e-01 5.439957976341247559e-01 --1.718750000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 4.313041865825653076e-01 4.313041865825653076e-01 4.313041865825653076e-01 --1.406250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 4.938433468341827393e-01 4.938433468341827393e-01 4.938433468341827393e-01 --1.406250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 1.093750000000000000e-01 1.565135866403579712e-01 1.565135866403579712e-01 1.565135866403579712e-01 --1.093750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.093750000000000000e-01 4.687500000000000000e-02 9.464319795370101929e-02 9.464319795370101929e-02 9.464319795370101929e-02 --1.093750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 3.828380629420280457e-02 3.828380629420280457e-02 3.828380629420280457e-02 --1.093750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 6.697414070367813110e-02 6.697414070367813110e-02 6.697414070367813110e-02 --7.812500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 2.055037021636962891e-02 2.055037021636962891e-02 2.055037021636962891e-02 --7.812500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 1.997196674346923828e-01 1.997196674346923828e-01 1.997196674346923828e-01 --1.562500000000000000e-02 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 1.551365405321121216e-01 1.551365405321121216e-01 1.551365405321121216e-01 --1.093750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 2.846386432647705078e-01 2.846386432647705078e-01 2.846386432647705078e-01 --1.093750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.182409748435020447e-01 1.182409748435020447e-01 1.182409748435020447e-01 --7.812500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 7.080832719802856445e-01 7.080832719802856445e-01 7.080832719802856445e-01 --7.812500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 6.051982939243316650e-02 6.051982939243316650e-02 6.051982939243316650e-02 --7.812500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 2.531674802303314209e-01 2.531674802303314209e-01 2.531674802303314209e-01 --1.093750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 7.606208324432373047e-01 7.606208324432373047e-01 7.606208324432373047e-01 --1.093750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.431086212396621704e-01 1.431086212396621704e-01 1.431086212396621704e-01 --1.093750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 3.321918547153472900e-01 3.321918547153472900e-01 3.321918547153472900e-01 --7.812500000000000000e-02 1.562500000000000000e-02 2.343750000000000000e-01 9.731078147888183594e-01 9.731078147888183594e-01 9.731078147888183594e-01 --7.812500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 1.699231863021850586e-01 1.699231863021850586e-01 1.699231863021850586e-01 --7.812500000000000000e-02 4.687500000000000000e-02 2.343750000000000000e-01 3.566423356533050537e-01 3.566423356533050537e-01 3.566423356533050537e-01 --1.093750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 1.584354937076568604e-01 1.584354937076568604e-01 1.584354937076568604e-01 --1.093750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.078366413712501526e-01 1.078366413712501526e-01 1.078366413712501526e-01 --7.812500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 2.817717194557189941e-01 2.817717194557189941e-01 2.817717194557189941e-01 --1.093750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 3.821367323398590088e-01 3.821367323398590088e-01 3.821367323398590088e-01 --7.812500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 5.686414837837219238e-01 5.686414837837219238e-01 5.686414837837219238e-01 --7.812500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 4.908827543258666992e-01 4.908827543258666992e-01 4.908827543258666992e-01 --4.687500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.562500000000000000e-02 1.406250000000000000e-01 5.803207755088806152e-01 5.803207755088806152e-01 5.803207755088806152e-01 --1.562500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 5.260995626449584961e-01 5.260995626449584961e-01 5.260995626449584961e-01 --4.687500000000000000e-02 1.562500000000000000e-02 2.343750000000000000e-01 7.497662305831909180e-01 7.497662305831909180e-01 7.497662305831909180e-01 --4.687500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 1.237798109650611877e-01 1.237798109650611877e-01 1.237798109650611877e-01 --4.687500000000000000e-02 4.687500000000000000e-02 2.343750000000000000e-01 4.856248199939727783e-01 4.856248199939727783e-01 4.856248199939727783e-01 --1.562500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 7.800137996673583984e-01 7.800137996673583984e-01 7.800137996673583984e-01 --1.562500000000000000e-02 1.562500000000000000e-02 2.343750000000000000e-01 4.582982957363128662e-01 4.582982957363128662e-01 4.582982957363128662e-01 --1.562500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 6.720073521137237549e-02 6.720073521137237549e-02 6.720073521137237549e-02 --1.562500000000000000e-02 4.687500000000000000e-02 2.343750000000000000e-01 3.610552251338958740e-01 3.610552251338958740e-01 3.610552251338958740e-01 --4.687500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 1.023431345820426941e-01 1.023431345820426941e-01 1.023431345820426941e-01 --4.687500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 4.368255436420440674e-01 4.368255436420440674e-01 4.368255436420440674e-01 --4.687500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 5.272350311279296875e-01 5.272350311279296875e-01 5.272350311279296875e-01 --1.562500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 5.075244307518005371e-01 5.075244307518005371e-01 5.075244307518005371e-01 --1.093750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 7.915565371513366699e-01 7.915565371513366699e-01 7.915565371513366699e-01 --1.093750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.718750000000000000e-01 1.562500000000000000e-02 1.730523407459259033e-01 1.730523407459259033e-01 1.730523407459259033e-01 --7.812500000000000000e-02 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 5.902995169162750244e-02 5.902995169162750244e-02 5.902995169162750244e-02 --7.812500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 --4.687500000000000000e-02 1.406250000000000000e-01 1.562500000000000000e-02 1.384212970733642578e-01 1.384212970733642578e-01 1.384212970733642578e-01 --4.687500000000000000e-02 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.718750000000000000e-01 4.687500000000000000e-02 3.137773275375366211e-01 3.137773275375366211e-01 3.137773275375366211e-01 --1.562500000000000000e-02 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 4.687500000000000000e-02 2.942277789115905762e-01 2.942277789115905762e-01 2.942277789115905762e-01 --4.687500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 7.025327533483505249e-02 7.025327533483505249e-02 7.025327533483505249e-02 --4.687500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 1.562500000000000000e-02 2.372446209192276001e-01 2.372446209192276001e-01 2.372446209192276001e-01 --4.687500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 2.068237662315368652e-01 2.068237662315368652e-01 2.068237662315368652e-01 --4.687500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 1.176846995949745178e-01 1.176846995949745178e-01 1.176846995949745178e-01 --4.687500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 2.754612863063812256e-01 2.754612863063812256e-01 2.754612863063812256e-01 --1.562500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 2.256830483675003052e-01 2.256830483675003052e-01 2.256830483675003052e-01 --1.562500000000000000e-02 2.031250000000000000e-01 7.812500000000000000e-02 2.548623681068420410e-01 2.548623681068420410e-01 2.548623681068420410e-01 --1.562500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 4.616785943508148193e-01 4.616785943508148193e-01 4.616785943508148193e-01 --1.093750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 --1.093750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 --7.812500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 --7.812500000000000000e-02 1.718750000000000000e-01 1.718750000000000000e-01 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 --1.093750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 3.718856871128082275e-01 3.718856871128082275e-01 3.718856871128082275e-01 --1.093750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 5.991138145327568054e-02 5.991138145327568054e-02 5.991138145327568054e-02 --7.812500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 5.403352975845336914e-01 5.403352975845336914e-01 5.403352975845336914e-01 --7.812500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 2.318668738007545471e-02 2.318668738007545471e-02 2.318668738007545471e-02 --1.093750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 7.584202289581298828e-01 7.584202289581298828e-01 7.584202289581298828e-01 --1.093750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 1.718750000000000000e-01 6.330475807189941406e-01 6.330475807189941406e-01 6.330475807189941406e-01 --7.812500000000000000e-02 2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 2.244447618722915649e-01 2.244447618722915649e-01 2.244447618722915649e-01 --4.687500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 1.271051615476608276e-01 1.271051615476608276e-01 1.271051615476608276e-01 --1.562500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 5.837466120719909668e-01 5.837466120719909668e-01 5.837466120719909668e-01 --4.687500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 2.613211870193481445e-01 2.613211870193481445e-01 2.613211870193481445e-01 --1.562500000000000000e-02 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 2.274972200393676758e-01 2.274972200393676758e-01 2.274972200393676758e-01 --4.687500000000000000e-02 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 2.389525771141052246e-01 2.389525771141052246e-01 2.389525771141052246e-01 --1.562500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 3.231874108314514160e-01 3.231874108314514160e-01 3.231874108314514160e-01 --1.562500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 5.246847867965698242e-01 5.246847867965698242e-01 5.246847867965698242e-01 --1.562500000000000000e-02 2.343750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 2.957033812999725342e-01 2.957033812999725342e-01 2.957033812999725342e-01 --1.718750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 1.838272362947463989e-01 1.838272362947463989e-01 1.838272362947463989e-01 --1.406250000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 6.814283132553100586e-01 6.814283132553100586e-01 6.814283132553100586e-01 --1.406250000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 1.984653025865554810e-01 1.984653025865554810e-01 1.984653025865554810e-01 --1.406250000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.093750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 4.089130163192749023e-01 4.089130163192749023e-01 4.089130163192749023e-01 --1.406250000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 7.812500000000000000e-02 3.281250000000000000e-01 4.193037450313568115e-01 4.193037450313568115e-01 4.193037450313568115e-01 --1.406250000000000000e-01 1.093750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 6.705778837203979492e-02 6.705778837203979492e-02 6.705778837203979492e-02 --2.031250000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 2.192473858594894409e-01 2.192473858594894409e-01 2.192473858594894409e-01 --2.343750000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 1.965992450714111328e-01 1.965992450714111328e-01 1.965992450714111328e-01 --2.031250000000000000e-01 2.343750000000000000e-01 2.656250000000000000e-01 3.852314054965972900e-01 3.852314054965972900e-01 3.852314054965972900e-01 --1.718750000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 3.313612937927246094e-01 3.313612937927246094e-01 3.313612937927246094e-01 --1.406250000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.343750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 2.601408064365386963e-01 2.601408064365386963e-01 2.601408064365386963e-01 --1.406250000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 3.807025849819183350e-01 3.807025849819183350e-01 3.807025849819183350e-01 --1.406250000000000000e-01 2.343750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 5.424423217773437500e-01 5.424423217773437500e-01 5.424423217773437500e-01 --1.093750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 8.198261260986328125e-01 8.198261260986328125e-01 8.198261260986328125e-01 --7.812500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 2.656250000000000000e-01 7.085696458816528320e-01 7.085696458816528320e-01 7.085696458816528320e-01 --1.093750000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.562500000000000000e-02 3.593750000000000000e-01 4.779216647148132324e-01 4.779216647148132324e-01 4.779216647148132324e-01 --1.093750000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 3.984828293323516846e-01 3.984828293323516846e-01 3.984828293323516846e-01 --1.093750000000000000e-01 4.687500000000000000e-02 3.593750000000000000e-01 4.897422790527343750e-01 4.897422790527343750e-01 4.897422790527343750e-01 --7.812500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.562500000000000000e-02 3.593750000000000000e-01 3.680257499217987061e-01 3.680257499217987061e-01 3.680257499217987061e-01 --7.812500000000000000e-02 4.687500000000000000e-02 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 1.880862712860107422e-01 1.880862712860107422e-01 1.880862712860107422e-01 --1.093750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 2.968750000000000000e-01 6.705319285392761230e-01 6.705319285392761230e-01 6.705319285392761230e-01 --7.812500000000000000e-02 7.812500000000000000e-02 2.656250000000000000e-01 3.222749233245849609e-01 3.222749233245849609e-01 3.222749233245849609e-01 --7.812500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 7.812500000000000000e-02 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.093750000000000000e-01 3.281250000000000000e-01 7.310229539871215820e-01 7.310229539871215820e-01 7.310229539871215820e-01 --1.093750000000000000e-01 1.093750000000000000e-01 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 7.812500000000000000e-02 3.593750000000000000e-01 7.240851521492004395e-01 7.240851521492004395e-01 7.240851521492004395e-01 --7.812500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 7.216916680335998535e-01 7.216916680335998535e-01 7.216916680335998535e-01 --7.812500000000000000e-02 1.093750000000000000e-01 3.593750000000000000e-01 5.080190300941467285e-01 5.080190300941467285e-01 5.080190300941467285e-01 --4.687500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 8.055689930915832520e-01 8.055689930915832520e-01 8.055689930915832520e-01 --4.687500000000000000e-02 4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 5.956901907920837402e-01 5.956901907920837402e-01 5.956901907920837402e-01 --4.687500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 7.567780017852783203e-01 7.567780017852783203e-01 7.567780017852783203e-01 --4.687500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.687500000000000000e-02 3.593750000000000000e-01 6.197754144668579102e-01 6.197754144668579102e-01 6.197754144668579102e-01 --1.562500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.687500000000000000e-02 3.593750000000000000e-01 6.185219287872314453e-01 6.185219287872314453e-01 6.185219287872314453e-01 --4.687500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 5.270277857780456543e-01 5.270277857780456543e-01 5.270277857780456543e-01 --1.562500000000000000e-02 7.812500000000000000e-02 2.656250000000000000e-01 6.236333250999450684e-01 6.236333250999450684e-01 6.236333250999450684e-01 --1.562500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 4.687797129154205322e-01 4.687797129154205322e-01 4.687797129154205322e-01 --1.562500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 4.906441271305084229e-01 4.906441271305084229e-01 4.906441271305084229e-01 --4.687500000000000000e-02 7.812500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 5.900743007659912109e-01 5.900743007659912109e-01 5.900743007659912109e-01 --1.562500000000000000e-02 7.812500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 5.485261678695678711e-01 5.485261678695678711e-01 5.485261678695678711e-01 --1.093750000000000000e-01 4.687500000000000000e-02 3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.687500000000000000e-02 3.906250000000000000e-01 6.151098012924194336e-01 6.151098012924194336e-01 6.151098012924194336e-01 --7.812500000000000000e-02 7.812500000000000000e-02 3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 7.497042417526245117e-01 7.497042417526245117e-01 7.497042417526245117e-01 --1.093750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 3.243439197540283203e-01 3.243439197540283203e-01 3.243439197540283203e-01 --7.812500000000000000e-02 1.406250000000000000e-01 2.656250000000000000e-01 5.075748562812805176e-01 5.075748562812805176e-01 5.075748562812805176e-01 --7.812500000000000000e-02 1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 1.406250000000000000e-01 3.281250000000000000e-01 5.143924951553344727e-01 5.143924951553344727e-01 5.143924951553344727e-01 --1.093750000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.343750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 5.620667710900306702e-02 5.620667710900306702e-02 5.620667710900306702e-02 --2.031250000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 2.809591591358184814e-01 2.809591591358184814e-01 2.809591591358184814e-01 --1.406250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 4.737159907817840576e-01 4.737159907817840576e-01 4.737159907817840576e-01 --1.406250000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 2.773662209510803223e-01 2.773662209510803223e-01 2.773662209510803223e-01 --1.718750000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 1.441520601511001587e-01 1.441520601511001587e-01 1.441520601511001587e-01 --1.406250000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 3.834974765777587891e-01 3.834974765777587891e-01 3.834974765777587891e-01 --1.406250000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 5.111560821533203125e-01 5.111560821533203125e-01 5.111560821533203125e-01 --2.343750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 3.116346001625061035e-01 3.116346001625061035e-01 3.116346001625061035e-01 --2.343750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 4.822090864181518555e-01 4.822090864181518555e-01 4.822090864181518555e-01 --2.031250000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 2.660870254039764404e-01 2.660870254039764404e-01 2.660870254039764404e-01 --2.031250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 3.174264729022979736e-01 3.174264729022979736e-01 3.174264729022979736e-01 --1.718750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 3.995276093482971191e-01 3.995276093482971191e-01 3.995276093482971191e-01 --1.718750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 2.307141572237014771e-01 2.307141572237014771e-01 2.307141572237014771e-01 --1.718750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 3.045694828033447266e-01 3.045694828033447266e-01 3.045694828033447266e-01 --1.406250000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 4.006167650222778320e-01 4.006167650222778320e-01 4.006167650222778320e-01 --1.093750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 2.995467185974121094e-01 2.995467185974121094e-01 2.995467185974121094e-01 --1.093750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.656250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.968750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.968750000000000000e-01 1.093750000000000000e-01 2.683747112751007080e-01 2.683747112751007080e-01 2.683747112751007080e-01 --1.093750000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 6.418635603040456772e-03 6.418635603040456772e-03 6.418635603040456772e-03 --1.093750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 2.957356572151184082e-01 2.957356572151184082e-01 2.957356572151184082e-01 --7.812500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 3.281250000000000000e-01 4.687500000000000000e-02 3.059448897838592529e-01 3.059448897838592529e-01 3.059448897838592529e-01 --7.812500000000000000e-02 3.281250000000000000e-01 1.093750000000000000e-01 4.845153689384460449e-01 4.845153689384460449e-01 4.845153689384460449e-01 --4.687500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 7.224148511886596680e-02 7.224148511886596680e-02 7.224148511886596680e-02 --1.562500000000000000e-02 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.968750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.968750000000000000e-01 1.093750000000000000e-01 2.712952494621276855e-01 2.712952494621276855e-01 2.712952494621276855e-01 --1.562500000000000000e-02 2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.656250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 1.093750000000000000e-01 3.159608244895935059e-01 3.159608244895935059e-01 3.159608244895935059e-01 --4.687500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.281250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.593750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.593750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.281250000000000000e-01 1.093750000000000000e-01 3.861318826675415039e-01 3.861318826675415039e-01 3.861318826675415039e-01 --4.687500000000000000e-02 3.593750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 7.812500000000000000e-02 2.499072104692459106e-01 2.499072104692459106e-01 2.499072104692459106e-01 --1.562500000000000000e-02 3.593750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 2.364787310361862183e-01 2.364787310361862183e-01 2.364787310361862183e-01 --1.093750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 4.658479094505310059e-01 4.658479094505310059e-01 4.658479094505310059e-01 --1.093750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 2.057223618030548096e-01 2.057223618030548096e-01 2.057223618030548096e-01 --7.812500000000000000e-02 2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 3.281250000000000000e-01 1.406250000000000000e-01 3.839849531650543213e-01 3.839849531650543213e-01 3.839849531650543213e-01 --4.687500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 4.431312680244445801e-01 4.431312680244445801e-01 4.431312680244445801e-01 --1.562500000000000000e-02 2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 3.589976578950881958e-02 3.589976578950881958e-02 3.589976578950881958e-02 --1.562500000000000000e-02 2.656250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 2.968750000000000000e-01 2.031250000000000000e-01 1.970909386873245239e-01 1.970909386873245239e-01 1.970909386873245239e-01 --1.562500000000000000e-02 2.968750000000000000e-01 2.343750000000000000e-01 2.732340432703495026e-02 2.732340432703495026e-02 2.732340432703495026e-02 --4.687500000000000000e-02 3.281250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.281250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.593750000000000000e-01 2.031250000000000000e-01 8.125411719083786011e-02 8.125411719083786011e-02 8.125411719083786011e-02 --1.093750000000000000e-01 4.218750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 3.906250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 5.153449997305870056e-02 5.153449997305870056e-02 5.153449997305870056e-02 --1.093750000000000000e-01 4.531250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.843750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --7.812500000000000000e-02 4.843750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.906250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.906250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.218750000000000000e-01 4.687500000000000000e-02 1.046673730015754700e-01 1.046673730015754700e-01 1.046673730015754700e-01 --1.562500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.906250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.218750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.218750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 9.607367962598800659e-02 9.607367962598800659e-02 9.607367962598800659e-02 --1.562500000000000000e-02 4.218750000000000000e-01 1.093750000000000000e-01 7.907020300626754761e-02 7.907020300626754761e-02 7.907020300626754761e-02 --4.687500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.531250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.843750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.562500000000000000e-02 4.531250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 4.531250000000000000e-01 7.812500000000000000e-02 2.091339081525802612e-01 2.091339081525802612e-01 2.091339081525802612e-01 --1.562500000000000000e-02 4.531250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 5.086289048194885254e-01 5.086289048194885254e-01 5.086289048194885254e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 4.601906985044479370e-02 4.601906985044479370e-02 4.601906985044479370e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 4.500936567783355713e-01 4.500936567783355713e-01 4.500936567783355713e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 4.459514915943145752e-01 4.459514915943145752e-01 4.459514915943145752e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 7.232865095138549805e-01 7.232865095138549805e-01 7.232865095138549805e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.406250000000000000e-01 -3.593750000000000000e-01 1.239932850003242493e-01 1.239932850003242493e-01 1.239932850003242493e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 -3.593750000000000000e-01 4.773437976837158203e-03 4.773437976837158203e-03 4.773437976837158203e-03 -1.093750000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 1.652112789452075958e-02 1.652112789452075958e-02 1.652112789452075958e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -3.593750000000000000e-01 6.934171169996261597e-02 6.934171169996261597e-02 6.934171169996261597e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 -3.906250000000000000e-01 3.534085154533386230e-01 3.534085154533386230e-01 3.534085154533386230e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 1.781846880912780762e-01 1.781846880912780762e-01 1.781846880912780762e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -3.906250000000000000e-01 3.174742758274078369e-01 3.174742758274078369e-01 3.174742758274078369e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 4.245605766773223877e-01 4.245605766773223877e-01 4.245605766773223877e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 9.910304844379425049e-02 9.910304844379425049e-02 9.910304844379425049e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 1.593691408634185791e-01 1.593691408634185791e-01 1.593691408634185791e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.093750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.093750000000000000e-01 -3.906250000000000000e-01 2.465016990900039673e-01 2.465016990900039673e-01 2.465016990900039673e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 5.912303179502487183e-02 5.912303179502487183e-02 5.912303179502487183e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 4.980734735727310181e-02 4.980734735727310181e-02 4.980734735727310181e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 5.361485294997692108e-03 5.361485294997692108e-03 5.361485294997692108e-03 -1.093750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 -3.593750000000000000e-01 1.617765128612518311e-01 1.617765128612518311e-01 1.617765128612518311e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 4.680657759308815002e-02 4.680657759308815002e-02 4.680657759308815002e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 3.013006448745727539e-01 3.013006448745727539e-01 3.013006448745727539e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 4.741850867867469788e-02 4.741850867867469788e-02 4.741850867867469788e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 1.056085005402565002e-01 1.056085005402565002e-01 1.056085005402565002e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 1.788885742425918579e-01 1.788885742425918579e-01 1.788885742425918579e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.009709760546684265e-01 1.009709760546684265e-01 1.009709760546684265e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.868459582328796387e-01 1.868459582328796387e-01 1.868459582328796387e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 2.992495298385620117e-01 2.992495298385620117e-01 2.992495298385620117e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 2.966653406620025635e-01 2.966653406620025635e-01 2.966653406620025635e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 -2.031250000000000000e-01 5.631601437926292419e-02 5.631601437926292419e-02 5.631601437926292419e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 2.896757237613201141e-02 2.896757237613201141e-02 2.896757237613201141e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 9.650616347789764404e-02 9.650616347789764404e-02 9.650616347789764404e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 3.628053665161132812e-01 3.628053665161132812e-01 3.628053665161132812e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 9.944137185811996460e-03 9.944137185811996460e-03 9.944137185811996460e-03 -1.093750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 2.928013503551483154e-01 2.928013503551483154e-01 2.928013503551483154e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 4.031975865364074707e-01 4.031975865364074707e-01 4.031975865364074707e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 6.389837265014648438e-01 6.389837265014648438e-01 6.389837265014648438e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 1.568382140249013901e-03 1.568382140249013901e-03 1.568382140249013901e-03 -4.687500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 4.267668724060058594e-01 4.267668724060058594e-01 4.267668724060058594e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.050946488976478577e-02 1.050946488976478577e-02 1.050946488976478577e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 3.021506369113922119e-01 3.021506369113922119e-01 3.021506369113922119e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 7.935941219329833984e-02 7.935941219329833984e-02 7.935941219329833984e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 5.436796229332685471e-03 5.436796229332685471e-03 5.436796229332685471e-03 -1.718750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 1.140592768788337708e-01 1.140592768788337708e-01 1.140592768788337708e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.249661967158317566e-01 1.249661967158317566e-01 1.249661967158317566e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.174604296684265137e-01 1.174604296684265137e-01 1.174604296684265137e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.378805637359619141e-01 1.378805637359619141e-01 1.378805637359619141e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 2.168514132499694824e-01 2.168514132499694824e-01 2.168514132499694824e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 8.292185515165328979e-02 8.292185515165328979e-02 8.292185515165328979e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 7.450989633798599243e-02 7.450989633798599243e-02 7.450989633798599243e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 3.735510865226387978e-03 3.735510865226387978e-03 3.735510865226387978e-03 -2.343750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.644307076930999756e-01 1.644307076930999756e-01 1.644307076930999756e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 4.494915902614593506e-02 4.494915902614593506e-02 4.494915902614593506e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 4.049475770443677902e-03 4.049475770443677902e-03 4.049475770443677902e-03 -2.656250000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 1.038925275206565857e-01 1.038925275206565857e-01 1.038925275206565857e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 7.775482535362243652e-02 7.775482535362243652e-02 7.775482535362243652e-02 -2.656250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 2.151440382003784180e-01 2.151440382003784180e-01 2.151440382003784180e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 2.760972678661346436e-01 2.760972678661346436e-01 2.760972678661346436e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 4.666979908943176270e-01 4.666979908943176270e-01 4.666979908943176270e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 3.358954489231109619e-01 3.358954489231109619e-01 3.358954489231109619e-01 -3.593750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 4.464930891990661621e-01 4.464930891990661621e-01 4.464930891990661621e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 5.143991112709045410e-01 5.143991112709045410e-01 5.143991112709045410e-01 -3.593750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 4.156987965106964111e-01 4.156987965106964111e-01 4.156987965106964111e-01 -3.593750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.400859504938125610e-01 1.400859504938125610e-01 1.400859504938125610e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 3.652644455432891846e-01 3.652644455432891846e-01 3.652644455432891846e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 2.720777690410614014e-01 2.720777690410614014e-01 2.720777690410614014e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 3.099829852581024170e-01 3.099829852581024170e-01 3.099829852581024170e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 2.512306347489356995e-02 2.512306347489356995e-02 2.512306347489356995e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 8.870366215705871582e-02 8.870366215705871582e-02 8.870366215705871582e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 2.469485551118850708e-01 2.469485551118850708e-01 2.469485551118850708e-01 -3.281250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 6.258539855480194092e-03 6.258539855480194092e-03 6.258539855480194092e-03 -3.593750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 2.178748100996017456e-01 2.178748100996017456e-01 2.178748100996017456e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.021909937262535095e-01 1.021909937262535095e-01 1.021909937262535095e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 3.035236895084381104e-01 3.035236895084381104e-01 3.035236895084381104e-01 -3.593750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.068767309188842773e-01 1.068767309188842773e-01 1.068767309188842773e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 3.077608905732631683e-02 3.077608905732631683e-02 3.077608905732631683e-02 -3.906250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 3.444319665431976318e-01 3.444319665431976318e-01 3.444319665431976318e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 3.447274267673492432e-01 3.447274267673492432e-01 3.447274267673492432e-01 -4.218750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.585861146450042725e-01 1.585861146450042725e-01 1.585861146450042725e-01 -4.218750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.551405042409896851e-01 1.551405042409896851e-01 1.551405042409896851e-01 -4.531250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 8.739697188138961792e-02 8.739697188138961792e-02 8.739697188138961792e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 2.794045209884643555e-01 2.794045209884643555e-01 2.794045209884643555e-01 -4.218750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 2.138967365026473999e-01 2.138967365026473999e-01 2.138967365026473999e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 2.085112184286117554e-01 2.085112184286117554e-01 2.085112184286117554e-01 -4.218750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 3.473097681999206543e-01 3.473097681999206543e-01 3.473097681999206543e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 3.671218454837799072e-01 3.671218454837799072e-01 3.671218454837799072e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 2.185321748256683350e-01 2.185321748256683350e-01 2.185321748256683350e-01 -3.906250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 3.483222723007202148e-01 3.483222723007202148e-01 3.483222723007202148e-01 -3.906250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 5.384283885359764099e-02 5.384283885359764099e-02 5.384283885359764099e-02 -4.531250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 4.993721097707748413e-02 4.993721097707748413e-02 4.993721097707748413e-02 -4.531250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 9.371704608201980591e-02 9.371704608201980591e-02 9.371704608201980591e-02 -5.468750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.781250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.781250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.781250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.781250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 2.826496064662933350e-01 2.826496064662933350e-01 2.826496064662933350e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 1.562500000000000000e-02 5.047593712806701660e-01 5.047593712806701660e-01 5.047593712806701660e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 -1.718750000000000000e-01 -3.281250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -3.281250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 6.331486254930496216e-02 6.331486254930496216e-02 6.331486254930496216e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.968750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.968750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -3.281250000000000000e-01 1.562500000000000000e-02 1.441833912394940853e-03 1.441833912394940853e-03 1.441833912394940853e-03 -2.031250000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -3.281250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -3.281250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -3.281250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -3.281250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -3.281250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 6.002321466803550720e-02 6.002321466803550720e-02 6.002321466803550720e-02 -2.343750000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.656250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.656250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.656250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.656250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -3.281250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -3.281250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.656250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.656250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.656250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 1.374218761920928955e-01 1.374218761920928955e-01 1.374218761920928955e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 6.547911465167999268e-02 6.547911465167999268e-02 6.547911465167999268e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 2.343750000000000000e-01 2.191359102725982666e-01 2.191359102725982666e-01 2.191359102725982666e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 1.621225476264953613e-02 1.621225476264953613e-02 1.621225476264953613e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.343750000000000000e-01 1.562500000000000000e-02 8.508485741913318634e-03 8.508485741913318634e-03 8.508485741913318634e-03 -2.343750000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 2.887659966945648193e-01 2.887659966945648193e-01 2.887659966945648193e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 1.340148746967315674e-01 1.340148746967315674e-01 1.340148746967315674e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 4.950833320617675781e-01 4.950833320617675781e-01 4.950833320617675781e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.693190038204193115e-01 1.693190038204193115e-01 1.693190038204193115e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 3.579476475715637207e-01 3.579476475715637207e-01 3.579476475715637207e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 3.583001792430877686e-01 3.583001792430877686e-01 3.583001792430877686e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 3.221783339977264404e-01 3.221783339977264404e-01 3.221783339977264404e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.214438155293464661e-01 1.214438155293464661e-01 1.214438155293464661e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 1.688999384641647339e-01 1.688999384641647339e-01 1.688999384641647339e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.209618896245956421e-01 1.209618896245956421e-01 1.209618896245956421e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 4.306126013398170471e-02 4.306126013398170471e-02 4.306126013398170471e-02 -2.343750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 4.771920144557952881e-01 4.771920144557952881e-01 4.771920144557952881e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.718750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.718750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -2.031250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -2.031250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.406250000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -7.812500000000000000e-02 3.281250000000000000e-01 6.833490133285522461e-01 6.833490133285522461e-01 6.833490133285522461e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -7.812500000000000000e-02 3.281250000000000000e-01 3.669555187225341797e-01 3.669555187225341797e-01 3.669555187225341797e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 4.611999988555908203e-01 4.611999988555908203e-01 4.611999988555908203e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 5.891620516777038574e-01 5.891620516777038574e-01 5.891620516777038574e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 2.656250000000000000e-01 3.689036369323730469e-01 3.689036369323730469e-01 3.689036369323730469e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 3.199976384639739990e-01 3.199976384639739990e-01 3.199976384639739990e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.093750000000000000e-01 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -7.812500000000000000e-02 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 5.972124338150024414e-01 5.972124338150024414e-01 5.972124338150024414e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 -1.562500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -4.687500000000000000e-02 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 -1.562500000000000000e-02 3.281250000000000000e-01 4.170200601220130920e-02 4.170200601220130920e-02 4.170200601220130920e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.093750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -7.812500000000000000e-02 3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -4.687500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.562500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 -1.562500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.120718345046043396e-01 1.120718345046043396e-01 1.120718345046043396e-01 -2.656250000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -3.281250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -3.281250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.968750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 3.739233016967773438e-01 3.739233016967773438e-01 3.739233016967773438e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 4.374813139438629150e-01 4.374813139438629150e-01 4.374813139438629150e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 5.481383204460144043e-01 5.481383204460144043e-01 5.481383204460144043e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 6.404861807823181152e-01 6.404861807823181152e-01 6.404861807823181152e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 3.221320509910583496e-01 3.221320509910583496e-01 3.221320509910583496e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 3.511516451835632324e-01 3.511516451835632324e-01 3.511516451835632324e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 4.111535549163818359e-01 4.111535549163818359e-01 4.111535549163818359e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 3.926698267459869385e-01 3.926698267459869385e-01 3.926698267459869385e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 4.311031699180603027e-01 4.311031699180603027e-01 4.311031699180603027e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.509005427360534668e-01 1.509005427360534668e-01 1.509005427360534668e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 6.542556881904602051e-01 6.542556881904602051e-01 6.542556881904602051e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 3.985409736633300781e-01 3.985409736633300781e-01 3.985409736633300781e-01 -2.968750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 5.677279829978942871e-01 5.677279829978942871e-01 5.677279829978942871e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 6.688762307167053223e-01 6.688762307167053223e-01 6.688762307167053223e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 3.923726379871368408e-01 3.923726379871368408e-01 3.923726379871368408e-01 -3.593750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 4.585393071174621582e-01 4.585393071174621582e-01 4.585393071174621582e-01 -3.593750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 2.767907977104187012e-01 2.767907977104187012e-01 2.767907977104187012e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 9.402299672365188599e-02 9.402299672365188599e-02 9.402299672365188599e-02 -2.656250000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 2.119558751583099365e-01 2.119558751583099365e-01 2.119558751583099365e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.343750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -2.343750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 3.490033149719238281e-01 3.490033149719238281e-01 3.490033149719238281e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 3.542190492153167725e-01 3.542190492153167725e-01 3.542190492153167725e-01 -2.968750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 3.221168816089630127e-01 3.221168816089630127e-01 3.221168816089630127e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 3.849580585956573486e-01 3.849580585956573486e-01 3.849580585956573486e-01 -3.281250000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 2.916021347045898438e-01 2.916021347045898438e-01 2.916021347045898438e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 6.414133310317993164e-01 6.414133310317993164e-01 6.414133310317993164e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.569925397634506226e-01 1.569925397634506226e-01 1.569925397634506226e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 3.282317221164703369e-01 3.282317221164703369e-01 3.282317221164703369e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 3.817994892597198486e-01 3.817994892597198486e-01 3.817994892597198486e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 4.175035953521728516e-01 4.175035953521728516e-01 4.175035953521728516e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 4.737297296524047852e-01 4.737297296524047852e-01 4.737297296524047852e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 5.146769285202026367e-01 5.146769285202026367e-01 5.146769285202026367e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 2.323443591594696045e-01 2.323443591594696045e-01 2.323443591594696045e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 4.051067531108856201e-01 4.051067531108856201e-01 4.051067531108856201e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 4.692062139511108398e-01 4.692062139511108398e-01 4.692062139511108398e-01 -3.593750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 6.188195943832397461e-01 6.188195943832397461e-01 6.188195943832397461e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 2.005845755338668823e-01 2.005845755338668823e-01 2.005845755338668823e-01 -3.593750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 2.592002749443054199e-01 2.592002749443054199e-01 2.592002749443054199e-01 -3.593750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.235123798251152039e-01 1.235123798251152039e-01 1.235123798251152039e-01 -3.281250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 1.476191580295562744e-01 1.476191580295562744e-01 1.476191580295562744e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 4.132266044616699219e-01 4.132266044616699219e-01 4.132266044616699219e-01 -3.593750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 3.302051424980163574e-01 3.302051424980163574e-01 3.302051424980163574e-01 -3.593750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 2.086589187383651733e-01 2.086589187383651733e-01 2.086589187383651733e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 3.742521107196807861e-01 3.742521107196807861e-01 3.742521107196807861e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.367637366056442261e-01 1.367637366056442261e-01 1.367637366056442261e-01 -3.281250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 2.740669250488281250e-01 2.740669250488281250e-01 2.740669250488281250e-01 -3.593750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 5.772974491119384766e-01 5.772974491119384766e-01 5.772974491119384766e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 6.652159690856933594e-01 6.652159690856933594e-01 6.652159690856933594e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 5.894226431846618652e-01 5.894226431846618652e-01 5.894226431846618652e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 2.664337456226348877e-01 2.664337456226348877e-01 2.664337456226348877e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 2.546266615390777588e-01 2.546266615390777588e-01 2.546266615390777588e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 3.923707008361816406e-01 3.923707008361816406e-01 3.923707008361816406e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 2.791481614112854004e-01 2.791481614112854004e-01 2.791481614112854004e-01 -3.906250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 2.616875767707824707e-01 2.616875767707824707e-01 2.616875767707824707e-01 -4.218750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 9.909581393003463745e-02 9.909581393003463745e-02 9.909581393003463745e-02 -4.843750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 2.778893150389194489e-02 2.778893150389194489e-02 2.778893150389194489e-02 -4.531250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 2.210315763950347900e-01 2.210315763950347900e-01 2.210315763950347900e-01 -4.843750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 1.013706345111131668e-02 1.013706345111131668e-02 1.013706345111131668e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 3.325082957744598389e-01 3.325082957744598389e-01 3.325082957744598389e-01 -4.218750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -1.093750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -1.093750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 6.742215901613235474e-02 6.742215901613235474e-02 6.742215901613235474e-02 -5.156250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.883911490440368652e-01 1.883911490440368652e-01 1.883911490440368652e-01 -5.156250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 7.411558926105499268e-02 7.411558926105499268e-02 7.411558926105499268e-02 -5.156250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 2.014756500720977783e-01 2.014756500720977783e-01 2.014756500720977783e-01 -5.468750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.781250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.781250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.687500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 -4.218750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 1.129456087946891785e-01 1.129456087946891785e-01 1.129456087946891785e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 1.224463805556297302e-01 1.224463805556297302e-01 1.224463805556297302e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 4.046156704425811768e-01 4.046156704425811768e-01 4.046156704425811768e-01 -1.718750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 5.500275641679763794e-02 5.500275641679763794e-02 5.500275641679763794e-02 -1.718750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 4.776329100131988525e-01 4.776329100131988525e-01 4.776329100131988525e-01 -2.343750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.031250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.343750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.031250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 4.869153499603271484e-01 4.869153499603271484e-01 4.869153499603271484e-01 -1.562500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 2.953108549118041992e-01 2.953108549118041992e-01 2.953108549118041992e-01 -1.093750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 4.268010258674621582e-01 4.268010258674621582e-01 4.268010258674621582e-01 -1.093750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 5.250653028488159180e-01 5.250653028488159180e-01 5.250653028488159180e-01 -1.562500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 4.095318019390106201e-01 4.095318019390106201e-01 4.095318019390106201e-01 -1.093750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 2.907088398933410645e-01 2.907088398933410645e-01 2.907088398933410645e-01 -7.812500000000000000e-02 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 3.108264505863189697e-02 3.108264505863189697e-02 3.108264505863189697e-02 -1.406250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 2.270879447460174561e-01 2.270879447460174561e-01 2.270879447460174561e-01 -1.718750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 3.433333039283752441e-01 3.433333039283752441e-01 3.433333039283752441e-01 -1.406250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 2.423833012580871582e-01 2.423833012580871582e-01 2.423833012580871582e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 5.293469876050949097e-02 5.293469876050949097e-02 5.293469876050949097e-02 -2.031250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 2.103516608476638794e-01 2.103516608476638794e-01 2.103516608476638794e-01 -2.343750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 8.051632344722747803e-02 8.051632344722747803e-02 8.051632344722747803e-02 -2.343750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 2.294254954904317856e-03 2.294254954904317856e-03 2.294254954904317856e-03 -2.031250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 2.241871505975723267e-02 2.241871505975723267e-02 2.241871505975723267e-02 -2.031250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.375904083251953125e-01 1.375904083251953125e-01 1.375904083251953125e-01 -2.343750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 6.363616883754730225e-02 6.363616883754730225e-02 6.363616883754730225e-02 -2.343750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 5.691540241241455078e-02 5.691540241241455078e-02 5.691540241241455078e-02 -1.718750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 1.351757794618606567e-01 1.351757794618606567e-01 1.351757794618606567e-01 -1.718750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 3.342442214488983154e-01 3.342442214488983154e-01 3.342442214488983154e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.983005702495574951e-01 1.983005702495574951e-01 1.983005702495574951e-01 -2.343750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 1.401524841785430908e-01 1.401524841785430908e-01 1.401524841785430908e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 2.058016955852508545e-01 2.058016955852508545e-01 2.058016955852508545e-01 -2.343750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.647010296583175659e-01 1.647010296583175659e-01 1.647010296583175659e-01 -2.031250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.656250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.656250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.968750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.281250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.593750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.656250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.656250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.968750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.968750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.593750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.593750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.593750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.656250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.968750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.968750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.656250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.656250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.968750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.968750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.656250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.593750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.593750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.281250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.593750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.281250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.281250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.593750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.593750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.906250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.906250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.906250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.906250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.906250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.906250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.906250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.906250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.656250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.968750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.656250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.281250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.593750000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.281250000000000000e-01 -3.906250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.656250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 3.571086749434471130e-02 3.571086749434471130e-02 3.571086749434471130e-02 -1.718750000000000000e-01 2.968750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.593750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.593750000000000000e-01 -3.281250000000000000e-01 1.173156574368476868e-01 1.173156574368476868e-01 1.173156574368476868e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.593750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.593750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.593750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.593750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.656250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 1.452538520097732544e-01 1.452538520097732544e-01 1.452538520097732544e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.281250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.281250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.593750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.593750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.281250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.281250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.593750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.593750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.281250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.593750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.906250000000000000e-01 -3.281250000000000000e-01 7.745577394962310791e-02 7.745577394962310791e-02 7.745577394962310791e-02 -1.718750000000000000e-01 3.906250000000000000e-01 -3.281250000000000000e-01 3.251103218644857407e-03 3.251103218644857407e-03 3.251103218644857407e-03 -1.406250000000000000e-01 3.906250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.906250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.906250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.906250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.906250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.906250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.906250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.968750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 1.231478713452816010e-02 1.231478713452816010e-02 1.231478713452816010e-02 -1.562500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.968750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 5.547196790575981140e-02 5.547196790575981140e-02 5.547196790575981140e-02 -4.687500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 1.859259307384490967e-01 1.859259307384490967e-01 1.859259307384490967e-01 -7.812500000000000000e-02 2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.656250000000000000e-01 -2.031250000000000000e-01 7.712789624929428101e-02 7.712789624929428101e-02 7.712789624929428101e-02 -7.812500000000000000e-02 2.968750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.968750000000000000e-01 -2.031250000000000000e-01 2.146736085414886475e-01 2.146736085414886475e-01 2.146736085414886475e-01 -1.093750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 7.548835873603820801e-02 7.548835873603820801e-02 7.548835873603820801e-02 -7.812500000000000000e-02 2.968750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.968750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 1.311578005552291870e-01 1.311578005552291870e-01 1.311578005552291870e-01 -1.093750000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 -1.406250000000000000e-01 4.322816729545593262e-01 4.322816729545593262e-01 4.322816729545593262e-01 -7.812500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.593750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.656250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 1.814221739768981934e-01 1.814221739768981934e-01 1.814221739768981934e-01 -1.093750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 4.931659996509552002e-02 4.931659996509552002e-02 4.931659996509552002e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 3.249576985836029053e-01 3.249576985836029053e-01 3.249576985836029053e-01 -7.812500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 2.747722901403903961e-02 2.747722901403903961e-02 2.747722901403903961e-02 -1.093750000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.906250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.906250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.906250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 3.152631819248199463e-01 3.152631819248199463e-01 3.152631819248199463e-01 -1.093750000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 3.271080851554870605e-01 3.271080851554870605e-01 3.271080851554870605e-01 -1.562500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.906250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 2.117803245782852173e-01 2.117803245782852173e-01 2.117803245782852173e-01 -4.687500000000000000e-02 3.906250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.906250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.218750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.218750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.906250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.906250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.218750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.218750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.531250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 8.557986021041870117e-01 8.557986021041870117e-01 8.557986021041870117e-01 -7.812500000000000000e-02 3.906250000000000000e-01 -7.812500000000000000e-02 5.589661002159118652e-01 5.589661002159118652e-01 5.589661002159118652e-01 -7.812500000000000000e-02 4.218750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.906250000000000000e-01 -7.812500000000000000e-02 1.185349151492118835e-01 1.185349151492118835e-01 1.185349151492118835e-01 -1.093750000000000000e-01 4.218750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.218750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.218750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.531250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.531250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.531250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.843750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.843750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.843750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 3.159831762313842773e-01 3.159831762313842773e-01 3.159831762313842773e-01 -1.718750000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 3.732601106166839600e-01 3.732601106166839600e-01 3.732601106166839600e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 2.993881404399871826e-01 2.993881404399871826e-01 2.993881404399871826e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.593750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.593750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 3.831520676612854004e-01 3.831520676612854004e-01 3.831520676612854004e-01 -1.406250000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 3.023627400398254395e-01 3.023627400398254395e-01 3.023627400398254395e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 2.473387271165847778e-01 2.473387271165847778e-01 2.473387271165847778e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 4.552163183689117432e-01 4.552163183689117432e-01 4.552163183689117432e-01 -2.031250000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.281250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.593750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.281250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 3.338397145271301270e-01 3.338397145271301270e-01 3.338397145271301270e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 3.827688097953796387e-01 3.827688097953796387e-01 3.827688097953796387e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 5.092305690050125122e-02 5.092305690050125122e-02 5.092305690050125122e-02 -1.718750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 2.126179486513137817e-01 2.126179486513137817e-01 2.126179486513137817e-01 -1.718750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 4.738178104162216187e-02 4.738178104162216187e-02 4.738178104162216187e-02 -1.718750000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.593750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.593750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 9.997073560953140259e-02 9.997073560953140259e-02 9.997073560953140259e-02 -2.031250000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.593750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.593750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 1.747441738843917847e-01 1.747441738843917847e-01 1.747441738843917847e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 3.619059547781944275e-02 3.619059547781944275e-02 3.619059547781944275e-02 -2.031250000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.906250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 4.466844201087951660e-01 4.466844201087951660e-01 4.466844201087951660e-01 -2.031250000000000000e-01 3.906250000000000000e-01 -1.718750000000000000e-01 2.785130143165588379e-01 2.785130143165588379e-01 2.785130143165588379e-01 -2.031250000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.906250000000000000e-01 -1.718750000000000000e-01 5.763244256377220154e-02 5.763244256377220154e-02 5.763244256377220154e-02 -2.343750000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.906250000000000000e-01 -7.812500000000000000e-02 3.944887518882751465e-01 3.944887518882751465e-01 3.944887518882751465e-01 -1.406250000000000000e-01 4.218750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.906250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.218750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.906250000000000000e-01 -4.687500000000000000e-02 5.780985951423645020e-02 5.780985951423645020e-02 5.780985951423645020e-02 -1.718750000000000000e-01 4.218750000000000000e-01 -4.687500000000000000e-02 2.697472572326660156e-01 2.697472572326660156e-01 2.697472572326660156e-01 -1.718750000000000000e-01 4.218750000000000000e-01 -1.562500000000000000e-02 2.895794808864593506e-01 2.895794808864593506e-01 2.895794808864593506e-01 -1.406250000000000000e-01 4.531250000000000000e-01 -7.812500000000000000e-02 6.797990202903747559e-02 6.797990202903747559e-02 6.797990202903747559e-02 -1.406250000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.531250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.843750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 2.427028566598892212e-01 2.427028566598892212e-01 2.427028566598892212e-01 -1.718750000000000000e-01 4.531250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.843750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 9.273488819599151611e-02 9.273488819599151611e-02 9.273488819599151611e-02 -2.031250000000000000e-01 3.906250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.906250000000000000e-01 -1.562500000000000000e-02 1.957161277532577515e-01 1.957161277532577515e-01 1.957161277532577515e-01 -2.031250000000000000e-01 4.218750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.218750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 1.568426564335823059e-02 1.568426564335823059e-02 1.568426564335823059e-02 -2.968750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 2.493243813514709473e-01 2.493243813514709473e-01 2.493243813514709473e-01 -2.968750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 1.002395059913396835e-02 1.002395059913396835e-02 1.002395059913396835e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 2.298788130283355713e-01 2.298788130283355713e-01 2.298788130283355713e-01 -3.593750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 2.205133736133575439e-01 2.205133736133575439e-01 2.205133736133575439e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 1.152702495455741882e-01 1.152702495455741882e-01 1.152702495455741882e-01 -2.656250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 2.596209645271301270e-01 2.596209645271301270e-01 2.596209645271301270e-01 -2.968750000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 5.411303043365478516e-01 5.411303043365478516e-01 5.411303043365478516e-01 -2.968750000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 5.383300185203552246e-01 5.383300185203552246e-01 5.383300185203552246e-01 -3.593750000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 6.852964311838150024e-02 6.852964311838150024e-02 6.852964311838150024e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 2.251827716827392578e-01 2.251827716827392578e-01 2.251827716827392578e-01 -3.906250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 1.647746749222278595e-02 1.647746749222278595e-02 1.647746749222278595e-02 -4.218750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 7.694841176271438599e-02 7.694841176271438599e-02 7.694841176271438599e-02 -4.843750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 1.386220306158065796e-01 1.386220306158065796e-01 1.386220306158065796e-01 -2.968750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 2.547592520713806152e-01 2.547592520713806152e-01 2.547592520713806152e-01 -2.656250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 9.949502535164356232e-03 9.949502535164356232e-03 9.949502535164356232e-03 -2.656250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 2.264405339956283569e-01 2.264405339956283569e-01 2.264405339956283569e-01 -2.968750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.984616219997406006e-01 1.984616219997406006e-01 1.984616219997406006e-01 -2.968750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 2.444769293069839478e-01 2.444769293069839478e-01 2.444769293069839478e-01 -2.968750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 5.458157137036323547e-02 5.458157137036323547e-02 5.458157137036323547e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 8.941216394305229187e-03 8.941216394305229187e-03 8.941216394305229187e-03 -2.656250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 5.084299296140670776e-02 5.084299296140670776e-02 5.084299296140670776e-02 -2.968750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 1.858822256326675415e-02 1.858822256326675415e-02 1.858822256326675415e-02 -2.656250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 2.403150945901870728e-01 2.403150945901870728e-01 2.403150945901870728e-01 -2.968750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 5.497474670410156250e-01 5.497474670410156250e-01 5.497474670410156250e-01 -4.218750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 5.674498677253723145e-01 5.674498677253723145e-01 5.674498677253723145e-01 -3.906250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 6.272959113121032715e-01 6.272959113121032715e-01 6.272959113121032715e-01 -4.531250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.119376659393310547e-01 7.119376659393310547e-01 7.119376659393310547e-01 -4.843750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 3.038319647312164307e-01 3.038319647312164307e-01 3.038319647312164307e-01 -4.843750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 4.773023724555969238e-01 4.773023724555969238e-01 4.773023724555969238e-01 -4.531250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.656250000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 -3.593750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 4.463837444782257080e-01 4.463837444782257080e-01 4.463837444782257080e-01 -2.656250000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.656250000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 3.281250000000000000e-01 -3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.656250000000000000e-01 -2.656250000000000000e-01 2.245651185512542725e-01 2.245651185512542725e-01 2.245651185512542725e-01 -2.656250000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 6.838322430849075317e-02 6.838322430849075317e-02 6.838322430849075317e-02 -2.968750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 1.501959264278411865e-01 1.501959264278411865e-01 1.501959264278411865e-01 -2.968750000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 4.224406480789184570e-01 4.224406480789184570e-01 4.224406480789184570e-01 -2.656250000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 3.132068514823913574e-01 3.132068514823913574e-01 3.132068514823913574e-01 -2.656250000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 3.046729266643524170e-01 3.046729266643524170e-01 3.046729266643524170e-01 -3.281250000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 3.907313644886016846e-01 3.907313644886016846e-01 3.907313644886016846e-01 -2.656250000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 2.262105792760848999e-02 2.262105792760848999e-02 2.262105792760848999e-02 -1.093750000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 1.939054876565933228e-01 1.939054876565933228e-01 1.939054876565933228e-01 -1.406250000000000000e-01 5.156250000000000000e-01 -4.687500000000000000e-02 1.732930541038513184e-01 1.732930541038513184e-01 1.732930541038513184e-01 -1.406250000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 5.156250000000000000e-01 -4.687500000000000000e-02 3.785587847232818604e-01 3.785587847232818604e-01 3.785587847232818604e-01 -1.718750000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 1.966807544231414795e-01 1.966807544231414795e-01 1.966807544231414795e-01 -1.718750000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 5.781250000000000000e-01 -1.562500000000000000e-02 2.255087494850158691e-01 2.255087494850158691e-01 2.255087494850158691e-01 -1.406250000000000000e-01 6.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 5.781250000000000000e-01 -1.562500000000000000e-02 1.308773010969161987e-01 1.308773010969161987e-01 1.308773010969161987e-01 -1.718750000000000000e-01 6.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 1.461101025342941284e-01 1.461101025342941284e-01 1.461101025342941284e-01 -2.343750000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 8.353342115879058838e-02 8.353342115879058838e-02 8.353342115879058838e-02 -2.031250000000000000e-01 5.781250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 6.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 5.781250000000000000e-01 -1.562500000000000000e-02 5.953224841505289078e-03 5.953224841505289078e-03 5.953224841505289078e-03 -2.343750000000000000e-01 6.093750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 7.912502437829971313e-02 7.912502437829971313e-02 7.912502437829971313e-02 -5.156250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.781250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.081086508929729462e-02 1.081086508929729462e-02 1.081086508929729462e-02 -1.562500000000000000e-02 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 7.132060360163450241e-03 7.132060360163450241e-03 7.132060360163450241e-03 -4.687500000000000000e-02 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 1.082237660884857178e-01 1.082237660884857178e-01 1.082237660884857178e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 1.242450997233390808e-01 1.242450997233390808e-01 1.242450997233390808e-01 -1.562500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.687500000000000000e-02 2.343750000000000000e-01 3.890742659568786621e-01 3.890742659568786621e-01 3.890742659568786621e-01 -4.687500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 8.755740523338317871e-02 8.755740523338317871e-02 8.755740523338317871e-02 -4.687500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 2.360306233167648315e-01 2.360306233167648315e-01 2.360306233167648315e-01 -4.687500000000000000e-02 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 2.220075279474258423e-01 2.220075279474258423e-01 2.220075279474258423e-01 -4.687500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 3.137970566749572754e-01 3.137970566749572754e-01 3.137970566749572754e-01 -4.687500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 1.718750000000000000e-01 3.580526411533355713e-01 3.580526411533355713e-01 3.580526411533355713e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 3.914027214050292969e-01 3.914027214050292969e-01 3.914027214050292969e-01 -1.562500000000000000e-02 1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 3.208076059818267822e-01 3.208076059818267822e-01 3.208076059818267822e-01 -4.687500000000000000e-02 1.718750000000000000e-01 2.031250000000000000e-01 3.886510729789733887e-01 3.886510729789733887e-01 3.886510729789733887e-01 -4.687500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 2.133721858263015747e-01 2.133721858263015747e-01 2.133721858263015747e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.031250000000000000e-01 1.718750000000000000e-01 5.618150830268859863e-01 5.618150830268859863e-01 5.618150830268859863e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 5.178744196891784668e-01 5.178744196891784668e-01 5.178744196891784668e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.343750000000000000e-01 3.800226151943206787e-01 3.800226151943206787e-01 3.800226151943206787e-01 -4.687500000000000000e-02 2.031250000000000000e-01 2.031250000000000000e-01 7.490567564964294434e-01 7.490567564964294434e-01 7.490567564964294434e-01 -4.687500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 7.797820568084716797e-01 7.797820568084716797e-01 7.797820568084716797e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 1.718750000000000000e-01 4.482865631580352783e-01 4.482865631580352783e-01 4.482865631580352783e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 2.031250000000000000e-01 3.510578349232673645e-02 3.510578349232673645e-02 3.510578349232673645e-02 -7.812500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 2.139717042446136475e-01 2.139717042446136475e-01 2.139717042446136475e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.031250000000000000e-01 1.718750000000000000e-01 1.726109981536865234e-01 1.726109981536865234e-01 1.726109981536865234e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.605061888694763184e-01 1.605061888694763184e-01 1.605061888694763184e-01 -1.718750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 1.021246705204248428e-02 1.021246705204248428e-02 1.021246705204248428e-02 -1.406250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 8.023406262509524822e-04 8.023406262509524822e-04 8.023406262509524822e-04 -1.406250000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 3.389302194118499756e-01 3.389302194118499756e-01 3.389302194118499756e-01 -1.718750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 1.625957340002059937e-01 1.625957340002059937e-01 1.625957340002059937e-01 -2.031250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.231523528695106506e-01 1.231523528695106506e-01 1.231523528695106506e-01 -2.031250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.861429810523986816e-01 1.861429810523986816e-01 1.861429810523986816e-01 -2.031250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 3.715258836746215820e-01 3.715258836746215820e-01 3.715258836746215820e-01 -2.031250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 9.153933823108673096e-02 9.153933823108673096e-02 9.153933823108673096e-02 -2.343750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 7.074891775846481323e-02 7.074891775846481323e-02 7.074891775846481323e-02 -2.031250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 2.026582658290863037e-01 2.026582658290863037e-01 2.026582658290863037e-01 -1.406250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 5.440830066800117493e-02 5.440830066800117493e-02 5.440830066800117493e-02 -1.718750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 2.639078795909881592e-01 2.639078795909881592e-01 2.639078795909881592e-01 -1.718750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.403030455112457275e-01 1.403030455112457275e-01 1.403030455112457275e-01 -1.718750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 5.939164012670516968e-02 5.939164012670516968e-02 5.939164012670516968e-02 -2.343750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 7.086093723773956299e-02 7.086093723773956299e-02 7.086093723773956299e-02 -2.031250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 5.458653718233108521e-02 5.458653718233108521e-02 5.458653718233108521e-02 -2.343750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 6.335155963897705078e-01 6.335155963897705078e-01 6.335155963897705078e-01 -1.562500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 5.811913609504699707e-01 5.811913609504699707e-01 5.811913609504699707e-01 -1.562500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 6.152125000953674316e-01 6.152125000953674316e-01 6.152125000953674316e-01 -4.687500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 6.616143584251403809e-01 6.616143584251403809e-01 6.616143584251403809e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 3.004314303398132324e-01 3.004314303398132324e-01 3.004314303398132324e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 7.812500000000000000e-02 3.281250000000000000e-01 7.110294699668884277e-01 7.110294699668884277e-01 7.110294699668884277e-01 -1.562500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 7.812500000000000000e-02 3.281250000000000000e-01 5.226732492446899414e-01 5.226732492446899414e-01 5.226732492446899414e-01 -4.687500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 5.183886289596557617e-01 5.183886289596557617e-01 5.183886289596557617e-01 -7.812500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 2.968750000000000000e-01 5.955324769020080566e-01 5.955324769020080566e-01 5.955324769020080566e-01 -7.812500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 4.410778582096099854e-01 4.410778582096099854e-01 4.410778582096099854e-01 -1.093750000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 5.103558301925659180e-01 5.103558301925659180e-01 5.103558301925659180e-01 -1.093750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 7.812500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.031250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.031250000000000000e-01 2.968750000000000000e-01 1.230131685733795166e-01 1.230131685733795166e-01 1.230131685733795166e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 2.968750000000000000e-01 9.151579439640045166e-02 9.151579439640045166e-02 9.151579439640045166e-02 -1.093750000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.718750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.031250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.343750000000000000e-01 2.968750000000000000e-01 2.090509235858917236e-01 2.090509235858917236e-01 2.090509235858917236e-01 -1.093750000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.031250000000000000e-01 3.281250000000000000e-01 2.991815507411956787e-01 2.991815507411956787e-01 2.991815507411956787e-01 -7.812500000000000000e-02 2.343750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.031250000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.343750000000000000e-01 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 7.812500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 5.493601039052009583e-02 5.493601039052009583e-02 5.493601039052009583e-02 -1.406250000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 1.967428773641586304e-01 1.967428773641586304e-01 1.967428773641586304e-01 -1.718750000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 1.766448020935058594e-01 1.766448020935058594e-01 1.766448020935058594e-01 -1.718750000000000000e-01 2.031250000000000000e-01 3.281250000000000000e-01 3.494293894618749619e-03 3.494293894618749619e-03 3.494293894618749619e-03 -2.031250000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 5.032732337713241577e-02 5.032732337713241577e-02 5.032732337713241577e-02 -2.031250000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 1.310360580682754517e-01 1.310360580682754517e-01 1.310360580682754517e-01 -2.343750000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 3.366396576166152954e-02 3.366396576166152954e-02 3.366396576166152954e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 1.264200657606124878e-01 1.264200657606124878e-01 1.264200657606124878e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 9.192319959402084351e-02 9.192319959402084351e-02 9.192319959402084351e-02 -1.562500000000000000e-02 2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.656250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 1.093750000000000000e-01 3.765815496444702148e-01 3.765815496444702148e-01 3.765815496444702148e-01 -1.562500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 1.093750000000000000e-01 5.575451254844665527e-01 5.575451254844665527e-01 5.575451254844665527e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 1.357357650995254517e-01 1.357357650995254517e-01 1.357357650995254517e-01 -7.812500000000000000e-02 2.968750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.593750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.593750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.593750000000000000e-01 1.562500000000000000e-02 3.783137723803520203e-02 3.783137723803520203e-02 3.783137723803520203e-02 -1.093750000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.593750000000000000e-01 7.812500000000000000e-02 5.814835429191589355e-02 5.814835429191589355e-02 5.814835429191589355e-02 -7.812500000000000000e-02 3.593750000000000000e-01 1.093750000000000000e-01 4.104813635349273682e-01 4.104813635349273682e-01 4.104813635349273682e-01 -1.093750000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 1.406250000000000000e-01 4.586666524410247803e-01 4.586666524410247803e-01 4.586666524410247803e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.656250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.656250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 2.343750000000000000e-01 2.992306649684906006e-01 2.992306649684906006e-01 2.992306649684906006e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.656250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.968750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 1.406250000000000000e-01 2.842587828636169434e-01 2.842587828636169434e-01 2.842587828636169434e-01 -1.562500000000000000e-02 3.593750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.281250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.281250000000000000e-01 1.718750000000000000e-01 5.535386800765991211e-01 5.535386800765991211e-01 5.535386800765991211e-01 -4.687500000000000000e-02 3.593750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.593750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.281250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.593750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.593750000000000000e-01 2.343750000000000000e-01 2.099007740616798401e-02 2.099007740616798401e-02 2.099007740616798401e-02 -7.812500000000000000e-02 2.656250000000000000e-01 1.406250000000000000e-01 3.798578977584838867e-01 3.798578977584838867e-01 3.798578977584838867e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 2.061296999454498291e-01 2.061296999454498291e-01 2.061296999454498291e-01 -7.812500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 4.577722251415252686e-01 4.577722251415252686e-01 4.577722251415252686e-01 -1.093750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.656250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.656250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.968750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.968750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.593750000000000000e-01 1.406250000000000000e-01 4.962390363216400146e-01 4.962390363216400146e-01 4.962390363216400146e-01 -7.812500000000000000e-02 3.593750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 1.600123792886734009e-01 1.600123792886734009e-01 1.600123792886734009e-01 -1.093750000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 1.477835327386856079e-01 1.477835327386856079e-01 1.477835327386856079e-01 -1.093750000000000000e-01 3.593750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.281250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.593750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.593750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.218750000000000000e-01 4.687500000000000000e-02 1.620915234088897705e-01 1.620915234088897705e-01 1.620915234088897705e-01 -4.687500000000000000e-02 3.906250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.906250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.218750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 3.791011571884155273e-01 3.791011571884155273e-01 3.791011571884155273e-01 -1.562500000000000000e-02 4.218750000000000000e-01 7.812500000000000000e-02 3.611684218049049377e-02 3.611684218049049377e-02 3.611684218049049377e-02 -1.562500000000000000e-02 4.218750000000000000e-01 1.093750000000000000e-01 2.132395058870315552e-01 2.132395058870315552e-01 2.132395058870315552e-01 -4.687500000000000000e-02 3.906250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 6.469061970710754395e-01 6.469061970710754395e-01 6.469061970710754395e-01 -4.687500000000000000e-02 4.218750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.531250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 4.843750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 4.531250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.906250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.906250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.218750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.906250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.906250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.218750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.906250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.906250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.906250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.218750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.531250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.843750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 4.843750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.531250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.843750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.843750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.531250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 4.843750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.906250000000000000e-01 1.406250000000000000e-01 4.126309752464294434e-01 4.126309752464294434e-01 4.126309752464294434e-01 -4.687500000000000000e-02 3.906250000000000000e-01 1.406250000000000000e-01 6.968655586242675781e-01 6.968655586242675781e-01 6.968655586242675781e-01 -7.812500000000000000e-02 3.906250000000000000e-01 1.406250000000000000e-01 5.924941897392272949e-01 5.924941897392272949e-01 5.924941897392272949e-01 -1.406250000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 1.034383773803710938e-01 1.034383773803710938e-01 1.034383773803710938e-01 -1.406250000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 8.931125700473785400e-02 8.931125700473785400e-02 8.931125700473785400e-02 -1.718750000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 1.589791178703308105e-01 1.589791178703308105e-01 1.589791178703308105e-01 -2.031250000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 9.162200242280960083e-02 9.162200242280960083e-02 9.162200242280960083e-02 -2.343750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 2.464164942502975464e-01 2.464164942502975464e-01 2.464164942502975464e-01 -2.031250000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 6.297185271978378296e-02 6.297185271978378296e-02 6.297185271978378296e-02 -2.031250000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.593750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 2.461835592985153198e-01 2.461835592985153198e-01 2.461835592985153198e-01 -2.343750000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 1.579165458679199219e-01 1.579165458679199219e-01 1.579165458679199219e-01 -1.718750000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 1.130895167589187622e-01 1.130895167589187622e-01 1.130895167589187622e-01 -2.031250000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 9.364792704582214355e-02 9.364792704582214355e-02 9.364792704582214355e-02 -2.343750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 2.711685001850128174e-02 2.711685001850128174e-02 2.711685001850128174e-02 -2.343750000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 3.440978527069091797e-01 3.440978527069091797e-01 3.440978527069091797e-01 -2.031250000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 7.661741971969604492e-02 7.661741971969604492e-02 7.661741971969604492e-02 -1.406250000000000000e-01 3.906250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.218750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.906250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.218750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.218750000000000000e-01 4.687500000000000000e-02 8.541314303874969482e-02 8.541314303874969482e-02 8.541314303874969482e-02 -1.406250000000000000e-01 3.906250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.218750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.531250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.531250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.843750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.531250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 4.843750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.531250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 4.843750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.906250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.906250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.218750000000000000e-01 1.562500000000000000e-02 1.777006387710571289e-01 1.777006387710571289e-01 1.777006387710571289e-01 -2.031250000000000000e-01 4.531250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.531250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.843750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.843750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 4.843750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 2.968750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.968750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.281250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 3.281250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.656250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 2.656250000000000000e-01 2.968750000000000000e-01 4.565095528960227966e-02 4.565095528960227966e-02 4.565095528960227966e-02 -1.093750000000000000e-01 2.656250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.656250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 2.968750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 3.281250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.656250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.968750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.656250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.968750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 3.281250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 3.281250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.656250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.656250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 2.968750000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.281250000000000000e-01 2.656250000000000000e-01 2.009964883327484131e-01 2.009964883327484131e-01 2.009964883327484131e-01 -2.656250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 9.801786541938781738e-01 9.801786541938781738e-01 9.801786541938781738e-01 -2.968750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 1.413761079311370850e-01 1.413761079311370850e-01 1.413761079311370850e-01 -3.281250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 2.418058216571807861e-01 2.418058216571807861e-01 2.418058216571807861e-01 -2.968750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 1.873555779457092285e-01 1.873555779457092285e-01 1.873555779457092285e-01 -2.968750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 1.831641644239425659e-01 1.831641644239425659e-01 1.831641644239425659e-01 -3.593750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 2.215846031904220581e-01 2.215846031904220581e-01 2.215846031904220581e-01 -4.218750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.747199147939682007e-01 1.747199147939682007e-01 1.747199147939682007e-01 -4.218750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 2.583877146244049072e-01 2.583877146244049072e-01 2.583877146244049072e-01 -3.906250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 6.764841824769973755e-02 6.764841824769973755e-02 6.764841824769973755e-02 -4.218750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.843750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 4.862986803054809570e-01 4.862986803054809570e-01 4.862986803054809570e-01 -2.656250000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 3.024868294596672058e-02 3.024868294596672058e-02 3.024868294596672058e-02 -2.968750000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 2.822819948196411133e-01 2.822819948196411133e-01 2.822819948196411133e-01 -2.968750000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 3.342270851135253906e-01 3.342270851135253906e-01 3.342270851135253906e-01 -3.281250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 4.058420062065124512e-01 4.058420062065124512e-01 4.058420062065124512e-01 -3.281250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 1.634646505117416382e-01 1.634646505117416382e-01 1.634646505117416382e-01 -3.281250000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 5.619165673851966858e-02 5.619165673851966858e-02 5.619165673851966858e-02 -2.656250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.968750000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 1.206930913031101227e-02 1.206930913031101227e-02 1.206930913031101227e-02 -3.593750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.593750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.281250000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.218750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.531250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -3.906250000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 5.156250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 5.156250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 5.468750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 5.468750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 5.156250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 5.468750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 5.468750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 5.468750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 5.156250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 5.156250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 5.468750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 5.468750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 5.156250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 5.468750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 5.781250000000000000e-01 1.562500000000000000e-02 5.432457104325294495e-02 5.432457104325294495e-02 5.432457104325294495e-02 -1.406250000000000000e-01 5.781250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 6.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 5.781250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 5.781250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 6.093750000000000000e-01 1.562500000000000000e-02 3.380157425999641418e-02 3.380157425999641418e-02 3.380157425999641418e-02 -1.718750000000000000e-01 6.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 5.781250000000000000e-01 7.812500000000000000e-02 5.221525207161903381e-02 5.221525207161903381e-02 5.221525207161903381e-02 -1.718750000000000000e-01 5.781250000000000000e-01 7.812500000000000000e-02 3.691260516643524170e-02 3.691260516643524170e-02 3.691260516643524170e-02 -1.718750000000000000e-01 6.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 5.156250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 5.156250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 5.156250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 5.156250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 5.468750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 5.156250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 5.156250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 5.468750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 5.468750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 5.156250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 5.468750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 6.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 6.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 5.781250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 5.781250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 6.093750000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 6.093750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 5.781250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 6.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 5.781250000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 6.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 5.156250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 5.156250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 5.468750000000000000e-01 1.562500000000000000e-02 4.598730504512786865e-01 4.598730504512786865e-01 4.598730504512786865e-01 -2.656250000000000000e-01 5.468750000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 5.781250000000000000e-01 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 5.781250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.468750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.156250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -5.781250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 diff --git a/tensorflow/script/ocnn_lrp_results/molecule_heatmap_filt.xyz b/tensorflow/script/ocnn_lrp_results/molecule_heatmap_filt.xyz deleted file mode 100644 index 69b3acc..0000000 --- a/tensorflow/script/ocnn_lrp_results/molecule_heatmap_filt.xyz +++ /dev/null @@ -1,699 +0,0 @@ -698 -H 10.088999999999999 21.2851 20.9071 -H 12.088999999999999 26.2851 20.9071 -H 13.088999999999999 26.2851 20.9071 -H 14.088999999999999 26.2851 21.9071 -H 15.088999999999999 25.2851 20.9071 -H 15.088999999999999 26.2851 19.9071 -H 18.089 24.2851 18.9071 -H 17.089 25.2851 18.9071 -H 18.089 25.2851 18.9071 -H 24.089 25.2851 13.9071 -H 17.089 26.2851 19.9071 -H 18.089 26.2851 19.9071 -H 23.089 21.2851 22.9071 -H 23.089 22.2851 22.9071 -H 23.089 21.2851 23.9071 -H 23.089 22.2851 23.9071 -H 23.089 22.2851 24.9071 -H 22.089 26.2851 21.9071 -H 24.089 26.2851 24.9071 -H 14.088999999999999 26.2851 34.9071 -H 13.088999999999999 25.2851 36.9071 -H 13.088999999999999 26.2851 36.9071 -H 14.088999999999999 26.2851 35.9071 -H 14.088999999999999 26.2851 36.9071 -H 16.089 24.2851 35.9071 -H 15.088999999999999 26.2851 35.9071 -H 20.089 26.2851 30.9071 -H 17.089 23.2851 34.9071 -H 24.089 21.2851 27.9071 -H 23.089 26.2851 30.9071 -H 21.089 24.2851 33.9071 -H 22.089 25.2851 31.9071 -H 22.089 26.2851 31.9071 -H 21.089 25.2851 33.9071 -H 21.089 26.2851 33.9071 -H 22.089 25.2851 34.9071 -H 22.089 26.2851 34.9071 -H 23.089 24.2851 33.9071 -H 23.089 26.2851 31.9071 -H 24.089 25.2851 32.9071 -H 24.089 26.2851 31.9071 -H 24.089 26.2851 32.9071 -H 23.089 25.2851 33.9071 -H 23.089 26.2851 33.9071 -H 23.089 26.2851 34.9071 -H 24.089 25.2851 33.9071 -H 24.089 26.2851 33.9071 -H 17.089 24.2851 35.9071 -H 20.089 26.2851 36.9071 -H 21.089 24.2851 35.9071 -H 22.089 24.2851 36.9071 -H 22.089 24.2851 37.9071 -H 22.089 24.2851 38.9071 -H 21.089 26.2851 36.9071 -H 22.089 25.2851 35.9071 -H 22.089 25.2851 37.9071 -H 22.089 25.2851 38.9071 -H 23.089 24.2851 38.9071 -H 24.089 24.2851 37.9071 -H 24.089 24.2851 38.9071 -H 23.089 26.2851 36.9071 -H 24.089 25.2851 35.9071 -H 23.089 26.2851 37.9071 -H 24.089 25.2851 37.9071 -H 24.089 25.2851 38.9071 -H 24.089 26.2851 37.9071 -H 15.088999999999999 28.2851 17.9071 -H 16.089 27.2851 17.9071 -H 16.089 29.2851 16.9071 -H 15.088999999999999 29.2851 17.9071 -H 16.089 31.2851 16.9071 -H 15.088999999999999 31.2851 18.9071 -H 16.089 31.2851 18.9071 -H 13.088999999999999 27.2851 21.9071 -H 14.088999999999999 27.2851 21.9071 -H 14.088999999999999 29.2851 19.9071 -H 13.088999999999999 29.2851 21.9071 -H 15.088999999999999 27.2851 21.9071 -H 15.088999999999999 29.2851 20.9071 -H 16.089 30.2851 20.9071 -H 16.089 30.2851 25.9071 -H 15.088999999999999 31.2851 19.9071 -H 16.089 31.2851 20.9071 -H 15.088999999999999 32.2851 25.9071 -H 15.088999999999999 34.2851 24.9071 -H 15.088999999999999 34.2851 26.9071 -H 16.089 34.2851 25.9071 -H 16.089 34.2851 26.9071 -H 20.089 30.2851 14.9071 -H 19.089 31.2851 14.9071 -H 20.089 31.2851 14.9071 -H 21.089 32.2851 16.9071 -H 17.089 30.2851 20.9071 -H 18.089 30.2851 19.9071 -H 18.089 30.2851 20.9071 -H 17.089 28.2851 25.9071 -H 18.089 28.2851 25.9071 -H 17.089 29.2851 26.9071 -H 17.089 30.2851 25.9071 -H 17.089 30.2851 26.9071 -H 18.089 30.2851 26.9071 -H 19.089 32.2851 22.9071 -H 19.089 33.2851 22.9071 -H 17.089 32.2851 25.9071 -H 17.089 32.2851 26.9071 -H 18.089 33.2851 23.9071 -H 18.089 34.2851 23.9071 -H 18.089 34.2851 26.9071 -H 20.089 31.2851 25.9071 -H 20.089 31.2851 26.9071 -H 20.089 34.2851 24.9071 -H 20.089 33.2851 26.9071 -H 20.089 34.2851 25.9071 -H 24.089 27.2851 23.9071 -H 21.089 32.2851 26.9071 -H 21.089 34.2851 26.9071 -H 24.089 38.2851 14.9071 -H 23.089 35.2851 16.9071 -H 24.089 36.2851 15.9071 -H 23.089 37.2851 15.9071 -H 20.089 36.2851 19.9071 -H 20.089 37.2851 19.9071 -H 20.089 38.2851 20.9071 -H 20.089 38.2851 21.9071 -H 20.089 38.2851 22.9071 -H 17.089 35.2851 23.9071 -H 18.089 35.2851 23.9071 -H 18.089 35.2851 24.9071 -H 19.089 35.2851 24.9071 -H 20.089 35.2851 24.9071 -H 19.089 35.2851 25.9071 -H 19.089 36.2851 26.9071 -H 20.089 35.2851 25.9071 -H 20.089 37.2851 26.9071 -H 20.089 39.2851 24.9071 -H 20.089 39.2851 26.9071 -H 21.089 35.2851 20.9071 -H 21.089 38.2851 20.9071 -H 21.089 38.2851 21.9071 -H 22.089 38.2851 21.9071 -H 21.089 36.2851 23.9071 -H 21.089 37.2851 24.9071 -H 24.089 36.2851 26.9071 -H 21.089 39.2851 21.9071 -H 21.089 39.2851 22.9071 -H 22.089 39.2851 21.9071 -H 21.089 39.2851 23.9071 -H 22.089 39.2851 26.9071 -H 22.089 41.2851 24.9071 -H 22.089 41.2851 25.9071 -H 24.089 39.2851 24.9071 -H 23.089 39.2851 25.9071 -H 23.089 39.2851 26.9071 -H 24.089 40.2851 26.9071 -H 23.089 41.2851 26.9071 -H 24.089 41.2851 26.9071 -H 11.088999999999999 29.2851 31.9071 -H 12.088999999999999 29.2851 33.9071 -H 12.088999999999999 30.2851 33.9071 -H 13.088999999999999 27.2851 28.9071 -H 13.088999999999999 28.2851 28.9071 -H 14.088999999999999 27.2851 28.9071 -H 13.088999999999999 30.2851 30.9071 -H 15.088999999999999 27.2851 28.9071 -H 16.089 28.2851 28.9071 -H 15.088999999999999 27.2851 29.9071 -H 15.088999999999999 27.2851 30.9071 -H 15.088999999999999 28.2851 29.9071 -H 15.088999999999999 28.2851 30.9071 -H 16.089 28.2851 30.9071 -H 16.089 30.2851 27.9071 -H 15.088999999999999 30.2851 29.9071 -H 13.088999999999999 29.2851 34.9071 -H 13.088999999999999 30.2851 34.9071 -H 16.089 27.2851 32.9071 -C 16.089 28.2851 31.9071 -C 16.089 28.2851 34.9071 -C 15.088999999999999 29.2851 32.9071 -C 16.089 29.2851 32.9071 -C 16.089 30.2851 32.9071 -C 15.088999999999999 30.2851 34.9071 -C 16.089 30.2851 33.9071 -C 14.088999999999999 31.2851 30.9071 -C 16.089 32.2851 27.9071 -C 16.089 31.2851 30.9071 -C 16.089 33.2851 28.9071 -C 13.088999999999999 31.2851 31.9071 -C 14.088999999999999 31.2851 31.9071 -C 13.088999999999999 32.2851 33.9071 -C 14.088999999999999 32.2851 33.9071 -C 14.088999999999999 33.2851 33.9071 -C 16.089 31.2851 31.9071 -C 16.089 31.2851 32.9071 -C 16.089 31.2851 34.9071 -C 16.089 33.2851 31.9071 -C 16.089 33.2851 32.9071 -C 10.088999999999999 28.2851 35.9071 -C 11.088999999999999 28.2851 35.9071 -C 11.088999999999999 28.2851 36.9071 -C 13.088999999999999 27.2851 36.9071 -C 13.088999999999999 28.2851 36.9071 -C 14.088999999999999 27.2851 36.9071 -C 14.088999999999999 29.2851 35.9071 -C 15.088999999999999 27.2851 35.9071 -C 17.089 30.2851 28.9071 -C 17.089 30.2851 30.9071 -C 20.089 30.2851 30.9071 -C 17.089 28.2851 31.9071 -C 18.089 28.2851 31.9071 -C 18.089 28.2851 32.9071 -C 17.089 29.2851 31.9071 -C 17.089 29.2851 32.9071 -C 17.089 30.2851 32.9071 -C 18.089 29.2851 31.9071 -C 18.089 29.2851 32.9071 -C 17.089 30.2851 33.9071 -C 17.089 30.2851 34.9071 -C 19.089 28.2851 32.9071 -C 20.089 28.2851 34.9071 -C 19.089 29.2851 32.9071 -C 20.089 30.2851 31.9071 -C 19.089 29.2851 33.9071 -C 19.089 29.2851 34.9071 -C 20.089 29.2851 33.9071 -C 20.089 29.2851 34.9071 -C 18.089 31.2851 29.9071 -C 17.089 33.2851 28.9071 -C 18.089 34.2851 27.9071 -C 19.089 32.2851 27.9071 -C 20.089 32.2851 27.9071 -C 20.089 32.2851 28.9071 -C 19.089 34.2851 27.9071 -C 20.089 33.2851 28.9071 -C 20.089 34.2851 27.9071 -C 20.089 34.2851 28.9071 -C 19.089 33.2851 30.9071 -C 19.089 34.2851 30.9071 -C 20.089 34.2851 29.9071 -C 17.089 31.2851 32.9071 -C 17.089 32.2851 32.9071 -C 17.089 31.2851 33.9071 -C 17.089 31.2851 34.9071 -C 17.089 32.2851 34.9071 -C 17.089 33.2851 31.9071 -C 17.089 33.2851 32.9071 -C 18.089 33.2851 31.9071 -C 18.089 33.2851 32.9071 -C 17.089 34.2851 33.9071 -C 19.089 32.2851 31.9071 -C 20.089 32.2851 31.9071 -C 20.089 32.2851 32.9071 -C 20.089 31.2851 33.9071 -C 20.089 31.2851 34.9071 -C 20.089 32.2851 33.9071 -C 19.089 33.2851 32.9071 -C 19.089 34.2851 31.9071 -C 20.089 34.2851 31.9071 -C 20.089 34.2851 32.9071 -C 19.089 34.2851 33.9071 -C 19.089 34.2851 34.9071 -C 20.089 34.2851 33.9071 -C 22.089 27.2851 30.9071 -C 22.089 30.2851 30.9071 -C 24.089 30.2851 30.9071 -C 21.089 27.2851 32.9071 -C 21.089 28.2851 32.9071 -C 22.089 27.2851 32.9071 -C 22.089 28.2851 32.9071 -C 21.089 27.2851 34.9071 -C 21.089 28.2851 33.9071 -C 22.089 27.2851 33.9071 -C 22.089 27.2851 34.9071 -C 22.089 28.2851 33.9071 -C 22.089 28.2851 34.9071 -C 21.089 29.2851 31.9071 -C 21.089 29.2851 33.9071 -C 21.089 30.2851 34.9071 -C 22.089 29.2851 34.9071 -C 22.089 30.2851 34.9071 -C 24.089 27.2851 31.9071 -C 23.089 27.2851 33.9071 -C 23.089 27.2851 34.9071 -C 23.089 28.2851 33.9071 -C 23.089 28.2851 34.9071 -C 24.089 27.2851 33.9071 -C 24.089 27.2851 34.9071 -C 24.089 28.2851 34.9071 -C 23.089 29.2851 34.9071 -C 23.089 30.2851 34.9071 -C 24.089 30.2851 34.9071 -C 21.089 32.2851 27.9071 -C 22.089 32.2851 27.9071 -C 22.089 33.2851 30.9071 -C 23.089 31.2851 27.9071 -C 23.089 32.2851 28.9071 -C 24.089 32.2851 28.9071 -C 23.089 33.2851 27.9071 -C 23.089 33.2851 28.9071 -C 23.089 34.2851 27.9071 -C 24.089 33.2851 28.9071 -C 24.089 34.2851 28.9071 -C 24.089 33.2851 29.9071 -C 21.089 31.2851 31.9071 -C 21.089 32.2851 31.9071 -C 21.089 32.2851 32.9071 -C 22.089 32.2851 31.9071 -C 22.089 32.2851 32.9071 -C 21.089 31.2851 34.9071 -C 22.089 31.2851 34.9071 -C 21.089 33.2851 32.9071 -C 22.089 33.2851 32.9071 -C 23.089 31.2851 31.9071 -C 23.089 32.2851 31.9071 -C 23.089 31.2851 34.9071 -C 23.089 32.2851 34.9071 -C 24.089 32.2851 34.9071 -C 23.089 34.2851 32.9071 -C 23.089 34.2851 33.9071 -C 24.089 34.2851 33.9071 -C 19.089 27.2851 35.9071 -C 20.089 27.2851 36.9071 -C 20.089 28.2851 36.9071 -C 20.089 27.2851 37.9071 -C 20.089 29.2851 35.9071 -C 20.089 29.2851 37.9071 -C 18.089 32.2851 36.9071 -C 18.089 33.2851 36.9071 -C 18.089 34.2851 35.9071 -C 20.089 32.2851 35.9071 -C 19.089 34.2851 36.9071 -C 20.089 33.2851 36.9071 -C 21.089 27.2851 36.9071 -C 22.089 27.2851 35.9071 -C 22.089 28.2851 35.9071 -C 21.089 27.2851 38.9071 -C 21.089 28.2851 37.9071 -C 21.089 28.2851 38.9071 -C 22.089 27.2851 38.9071 -C 21.089 29.2851 35.9071 -C 21.089 30.2851 36.9071 -C 22.089 29.2851 35.9071 -C 21.089 30.2851 37.9071 -C 22.089 29.2851 38.9071 -C 22.089 30.2851 37.9071 -C 22.089 30.2851 38.9071 -C 23.089 27.2851 36.9071 -C 24.089 27.2851 35.9071 -C 23.089 27.2851 37.9071 -C 23.089 28.2851 38.9071 -N 24.089 28.2851 38.9071 -N 23.089 30.2851 36.9071 -N 24.089 29.2851 35.9071 -N 24.089 30.2851 35.9071 -N 24.089 30.2851 36.9071 -N 23.089 30.2851 37.9071 -N 24.089 30.2851 37.9071 -N 22.089 28.2851 39.9071 -N 21.089 31.2851 36.9071 -N 21.089 32.2851 35.9071 -N 22.089 31.2851 35.9071 -N 21.089 31.2851 37.9071 -N 19.089 36.2851 27.9071 -N 20.089 35.2851 28.9071 -N 19.089 35.2851 30.9071 -N 19.089 36.2851 30.9071 -N 19.089 37.2851 27.9071 -N 20.089 37.2851 27.9071 -N 17.089 35.2851 31.9071 -N 17.089 36.2851 31.9071 -N 18.089 35.2851 32.9071 -N 18.089 36.2851 31.9071 -N 19.089 35.2851 31.9071 -N 19.089 35.2851 32.9071 -N 19.089 36.2851 31.9071 -N 20.089 35.2851 31.9071 -N 22.089 36.2851 28.9071 -N 22.089 36.2851 30.9071 -N 21.089 37.2851 28.9071 -N 22.089 37.2851 28.9071 -N 22.089 37.2851 30.9071 -N 23.089 36.2851 30.9071 -N 24.089 36.2851 30.9071 -N 23.089 37.2851 30.9071 -N 24.089 38.2851 29.9071 -N 21.089 35.2851 31.9071 -N 21.089 35.2851 32.9071 -N 22.089 35.2851 32.9071 -N 22.089 37.2851 31.9071 -N 24.089 35.2851 32.9071 -N 24.089 36.2851 33.9071 -N 23.089 41.2851 29.9071 -N 28.089 18.2851 22.9071 -N 29.089 18.2851 22.9071 -N 30.089 18.2851 23.9071 -N 26.089 22.2851 16.9071 -N 27.089 22.2851 15.9071 -N 25.089 23.2851 14.9071 -N 25.089 24.2851 14.9071 -N 26.089 23.2851 14.9071 -N 26.089 24.2851 14.9071 -N 26.089 25.2851 14.9071 -N 28.089 23.2851 14.9071 -N 29.089 21.2851 15.9071 -N 30.089 22.2851 17.9071 -N 27.089 22.2851 21.9071 -N 28.089 21.2851 26.9071 -N 25.089 23.2851 20.9071 -N 26.089 24.2851 20.9071 -N 27.089 24.2851 22.9071 -N 27.089 25.2851 22.9071 -N 25.089 25.2851 23.9071 -N 25.089 26.2851 23.9071 -N 26.089 26.2851 24.9071 -N 29.089 21.2851 19.9071 -N 32.089 22.2851 19.9071 -N 30.089 20.2851 24.9071 -N 30.089 20.2851 25.9071 -N 32.089 19.2851 24.9071 -N 32.089 22.2851 26.9071 -N 32.089 26.2851 21.9071 -N 34.089 24.2851 18.9071 -N 33.089 20.2851 24.9071 -N 34.089 22.2851 24.9071 -N 35.089 22.2851 24.9071 -N 35.089 22.2851 25.9071 -N 35.089 22.2851 26.9071 -N 36.089 22.2851 25.9071 -N 34.089 24.2851 19.9071 -N 33.089 26.2851 20.9071 -N 33.089 26.2851 21.9071 -N 34.089 26.2851 22.9071 -N 36.089 25.2851 19.9071 -N 34.089 24.2851 24.9071 -N 36.089 23.2851 26.9071 -N 37.089 21.2851 24.9071 -N 37.089 22.2851 24.9071 -N 38.089 21.2851 23.9071 -N 39.089 21.2851 23.9071 -N 37.089 23.2851 24.9071 -N 38.089 23.2851 24.9071 -N 37.089 24.2851 26.9071 -N 38.089 23.2851 25.9071 -N 38.089 24.2851 25.9071 -N 38.089 24.2851 26.9071 -N 37.089 25.2851 26.9071 -N 29.089 16.2851 28.9071 -N 30.089 16.2851 27.9071 -N 30.089 16.2851 28.9071 -N 25.089 22.2851 34.9071 -N 26.089 23.2851 34.9071 -N 32.089 19.2851 28.9071 -N 32.089 20.2851 28.9071 -N 32.089 20.2851 29.9071 -N 32.089 20.2851 30.9071 -N 32.089 21.2851 28.9071 -N 32.089 22.2851 27.9071 -N 32.089 22.2851 28.9071 -N 32.089 21.2851 30.9071 -N 32.089 21.2851 31.9071 -N 32.089 23.2851 27.9071 -N 32.089 25.2851 30.9071 -N 25.089 24.2851 37.9071 -N 26.089 24.2851 37.9071 -N 26.089 25.2851 36.9071 -N 26.089 25.2851 38.9071 -N 27.089 24.2851 35.9071 -N 27.089 24.2851 38.9071 -N 27.089 25.2851 36.9071 -N 33.089 18.2851 30.9071 -N 33.089 19.2851 28.9071 -N 33.089 20.2851 28.9071 -N 34.089 20.2851 28.9071 -N 33.089 19.2851 30.9071 -N 33.089 20.2851 29.9071 -N 33.089 20.2851 30.9071 -N 34.089 20.2851 30.9071 -N 33.089 21.2851 28.9071 -N 34.089 21.2851 27.9071 -N 34.089 21.2851 28.9071 -N 34.089 21.2851 30.9071 -N 35.089 21.2851 27.9071 -N 35.089 21.2851 28.9071 -N 35.089 22.2851 27.9071 -N 36.089 21.2851 28.9071 -N 36.089 22.2851 28.9071 -N 34.089 20.2851 31.9071 -N 33.089 21.2851 31.9071 -N 34.089 21.2851 31.9071 -N 34.089 22.2851 31.9071 -N 35.089 20.2851 31.9071 -N 35.089 21.2851 31.9071 -N 33.089 23.2851 29.9071 -N 33.089 23.2851 30.9071 -N 33.089 24.2851 29.9071 -N 33.089 24.2851 30.9071 -N 34.089 23.2851 29.9071 -N 34.089 24.2851 29.9071 -N 33.089 25.2851 29.9071 -N 33.089 25.2851 30.9071 -N 34.089 25.2851 30.9071 -N 36.089 23.2851 28.9071 -N 35.089 25.2851 28.9071 -N 36.089 25.2851 27.9071 -N 36.089 25.2851 28.9071 -N 35.089 25.2851 29.9071 -N 35.089 25.2851 30.9071 -N 36.089 25.2851 29.9071 -N 36.089 25.2851 30.9071 -N 34.089 24.2851 31.9071 -N 35.089 23.2851 31.9071 -N 35.089 24.2851 31.9071 -N 36.089 23.2851 31.9071 -N 37.089 22.2851 28.9071 -N 37.089 21.2851 29.9071 -N 37.089 22.2851 29.9071 -N 38.089 24.2851 27.9071 -N 38.089 24.2851 28.9071 -N 37.089 23.2851 29.9071 -N 38.089 25.2851 28.9071 -N 37.089 25.2851 29.9071 -N 39.089 25.2851 28.9071 -N 38.089 23.2851 31.9071 -N 41.089 25.2851 28.9071 -N 42.089 25.2851 28.9071 -O 25.089 30.2851 17.9071 -O 29.089 30.2851 18.9071 -O 32.089 31.2851 17.9071 -O 25.089 27.2851 22.9071 -O 28.089 27.2851 22.9071 -O 28.089 29.2851 21.9071 -O 25.089 27.2851 23.9071 -O 28.089 27.2851 23.9071 -O 28.089 34.2851 24.9071 -O 29.089 28.2851 22.9071 -O 29.089 29.2851 22.9071 -O 30.089 29.2851 22.9071 -O 32.089 27.2851 22.9071 -O 32.089 29.2851 21.9071 -O 29.089 34.2851 22.9071 -O 30.089 34.2851 22.9071 -O 32.089 31.2851 20.9071 -O 30.089 33.2851 25.9071 -O 31.089 32.2851 24.9071 -O 31.089 33.2851 24.9071 -O 29.089 38.2851 16.9071 -O 32.089 36.2851 18.9071 -O 26.089 38.2851 21.9071 -O 27.089 36.2851 20.9071 -O 27.089 37.2851 20.9071 -O 27.089 37.2851 22.9071 -O 28.089 35.2851 23.9071 -O 28.089 37.2851 23.9071 -O 27.089 39.2851 22.9071 -O 28.089 39.2851 22.9071 -O 26.089 39.2851 23.9071 -O 27.089 39.2851 23.9071 -O 27.089 39.2851 24.9071 -O 28.089 39.2851 24.9071 -O 29.089 35.2851 22.9071 -O 30.089 35.2851 22.9071 -O 30.089 36.2851 22.9071 -O 29.089 37.2851 22.9071 -O 30.089 37.2851 21.9071 -O 30.089 37.2851 22.9071 -O 30.089 38.2851 22.9071 -O 31.089 37.2851 21.9071 -O 31.089 38.2851 21.9071 -O 30.089 35.2851 23.9071 -O 31.089 37.2851 25.9071 -O 30.089 39.2851 22.9071 -O 31.089 39.2851 21.9071 -O 29.089 39.2851 24.9071 -O 30.089 40.2851 25.9071 -O 30.089 40.2851 26.9071 -O 30.089 41.2851 25.9071 -O 31.089 39.2851 26.9071 -O 34.089 29.2851 15.9071 -O 35.089 30.2851 18.9071 -O 33.089 31.2851 17.9071 -O 33.089 31.2851 18.9071 -O 33.089 34.2851 16.9071 -O 34.089 34.2851 16.9071 -O 35.089 34.2851 16.9071 -O 38.089 32.2851 16.9071 -O 34.089 28.2851 19.9071 -O 34.089 28.2851 20.9071 -O 33.089 27.2851 22.9071 -O 34.089 27.2851 22.9071 -O 34.089 29.2851 19.9071 -O 34.089 31.2851 24.9071 -O 38.089 29.2851 23.9071 -O 38.089 30.2851 23.9071 -O 39.089 28.2851 23.9071 -O 39.089 30.2851 23.9071 -O 40.089 29.2851 23.9071 -O 40.089 30.2851 24.9071 -O 34.089 35.2851 16.9071 -O 35.089 35.2851 18.9071 -O 34.089 36.2851 19.9071 -O 33.089 37.2851 21.9071 -O 33.089 37.2851 22.9071 -O 33.089 38.2851 22.9071 -O 33.089 36.2851 23.9071 -O 28.089 44.2851 26.9071 -O 29.089 43.2851 25.9071 -O 30.089 43.2851 25.9071 -O 30.089 43.2851 26.9071 -O 29.089 45.2851 26.9071 -O 30.089 45.2851 26.9071 -O 31.089 44.2851 26.9071 -O 25.089 27.2851 33.9071 -O 25.089 28.2851 34.9071 -O 26.089 30.2851 31.9071 -O 25.089 30.2851 34.9071 -O 26.089 29.2851 34.9071 -O 26.089 31.2851 32.9071 -O 25.089 31.2851 34.9071 -O 26.089 31.2851 34.9071 -O 26.089 32.2851 33.9071 -O 26.089 32.2851 34.9071 -O 26.089 33.2851 32.9071 -O 25.089 34.2851 33.9071 -O 25.089 34.2851 34.9071 -O 26.089 33.2851 33.9071 -O 26.089 34.2851 33.9071 -O 27.089 31.2851 32.9071 -O 27.089 32.2851 34.9071 -O 27.089 33.2851 32.9071 -O 29.089 32.2851 30.9071 -O 30.089 33.2851 30.9071 -O 30.089 34.2851 30.9071 -O 31.089 32.2851 27.9071 -O 32.089 32.2851 30.9071 -O 31.089 33.2851 28.9071 -O 30.089 32.2851 32.9071 -O 30.089 34.2851 31.9071 -O 30.089 34.2851 32.9071 -O 26.089 27.2851 36.9071 -O 25.089 27.2851 37.9071 -O 25.089 28.2851 37.9071 -O 26.089 28.2851 37.9071 -O 25.089 30.2851 35.9071 -O 25.089 29.2851 37.9071 -O 26.089 29.2851 37.9071 -O 26.089 30.2851 37.9071 -O 27.089 28.2851 36.9071 -O 27.089 28.2851 37.9071 -O 27.089 30.2851 36.9071 -O 26.089 33.2851 36.9071 -O 27.089 34.2851 36.9071 -O 27.089 33.2851 37.9071 -O 30.089 33.2851 36.9071 -O 30.089 34.2851 36.9071 -O 31.089 34.2851 36.9071 -O 25.089 35.2851 28.9071 -O 25.089 36.2851 30.9071 -O 25.089 38.2851 30.9071 -O 28.089 36.2851 28.9071 -O 27.089 38.2851 30.9071 -O 25.089 36.2851 31.9071 -O 25.089 36.2851 34.9071 -O 25.089 38.2851 31.9071 -O 26.089 37.2851 32.9071 -O 27.089 35.2851 31.9071 -O 27.089 35.2851 32.9071 -O 27.089 36.2851 32.9071 -O 27.089 38.2851 31.9071 -O 28.089 37.2851 31.9071 -O 28.089 37.2851 32.9071 -O 25.089 40.2851 28.9071 -O 25.089 39.2851 30.9071 -O 25.089 40.2851 30.9071 -O 26.089 39.2851 30.9071 -O 25.089 39.2851 31.9071 -O 26.089 39.2851 31.9071 -O 27.089 39.2851 31.9071 -O 31.089 35.2851 28.9071 -O 32.089 36.2851 28.9071 -O 31.089 37.2851 30.9071 -O 30.089 37.2851 33.9071 -O 30.089 37.2851 34.9071 -O 32.089 37.2851 32.9071 -O 31.089 40.2851 27.9071 -O 31.089 37.2851 35.9071 -O 33.089 30.2851 28.9071 -O 36.089 30.2851 27.9071 -O 33.089 32.2851 28.9071 -O 33.089 34.2851 27.9071 -O 35.089 34.2851 31.9071 -O 37.089 28.2851 28.9071 -O 38.089 28.2851 27.9071 -O 38.089 28.2851 28.9071 -O 34.089 37.2851 28.9071 -O 34.089 37.2851 29.9071 -O 35.089 35.2851 27.9071 -O 35.089 35.2851 28.9071 -O 35.089 36.2851 29.9071 -O 33.089 44.2851 27.9071 diff --git a/tensorflow/script/octree_heatmaps/heatmap_1.octree b/tensorflow/script/octree_heatmaps/heatmap_1.octree deleted file mode 100644 index 303a643..0000000 Binary files a/tensorflow/script/octree_heatmaps/heatmap_1.octree and /dev/null differ diff --git a/tensorflow/script/octree_heatmaps/molecule_heatmap-1.ply b/tensorflow/script/octree_heatmaps/molecule_heatmap-1.ply deleted file mode 100644 index 4556f22..0000000 --- a/tensorflow/script/octree_heatmaps/molecule_heatmap-1.ply +++ /dev/null @@ -1,6985 +0,0 @@ -ply -format ascii 1.0 -element vertex 6973 -property float x -property float y -property float z -property float nx -property float ny -property float nz -element face 0 -property list uchar int vertex_indices -end_header --3.281250000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 7.539046869681699514e-02 7.539046869681699514e-02 7.539046869681699514e-02 --3.281250000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 1.175019737539851339e-01 1.175019737539851339e-01 1.175019737539851339e-01 --3.281250000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 1.641576814399685891e-01 1.641576814399685891e-01 1.641576814399685891e-01 --3.281250000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.111928795957568550e-01 1.111928795957568550e-01 1.111928795957568550e-01 --2.968750000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 9.077350681894853779e-02 9.077350681894853779e-02 9.077350681894853779e-02 --2.968750000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 1.089183350412203377e-01 1.089183350412203377e-01 1.089183350412203377e-01 --2.968750000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 1.394068295399742419e-01 1.394068295399742419e-01 1.394068295399742419e-01 --2.968750000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.022180577569941906e-01 1.022180577569941906e-01 1.022180577569941906e-01 --2.656250000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 9.864311624493515840e-02 9.864311624493515840e-02 9.864311624493515840e-02 --2.656250000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.220995159119338536e-01 1.220995159119338536e-01 1.220995159119338536e-01 --3.281250000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 9.290230689501444150e-02 9.290230689501444150e-02 9.290230689501444150e-02 --3.281250000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.144017179483217822e-01 1.144017179483217822e-01 1.144017179483217822e-01 --3.281250000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 1.006993899407035570e-01 1.006993899407035570e-01 1.006993899407035570e-01 --2.968750000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 9.816419540403580057e-02 9.816419540403580057e-02 9.816419540403580057e-02 --2.968750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.157473994978779758e-01 1.157473994978779758e-01 1.157473994978779758e-01 --2.656250000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 7.788490676557656422e-02 7.788490676557656422e-02 7.788490676557656422e-02 --2.656250000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 9.781625280378537790e-02 9.781625280378537790e-02 9.781625280378537790e-02 --2.968750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 1.195151880987105897e-01 1.195151880987105897e-01 1.195151880987105897e-01 --2.656250000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 9.699580944493081669e-02 9.699580944493081669e-02 9.699580944493081669e-02 --4.843750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 5.403371099740653105e-02 5.403371099740653105e-02 5.403371099740653105e-02 --4.531250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 5.058020821570668318e-02 5.058020821570668318e-02 5.058020821570668318e-02 --4.531250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 4.910840639823602777e-02 4.910840639823602777e-02 4.910840639823602777e-02 --4.843750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 3.195705585947523908e-02 3.195705585947523908e-02 3.195705585947523908e-02 --4.843750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 2.818017804092118675e-02 2.818017804092118675e-02 2.818017804092118675e-02 --4.843750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 5.135256172998133722e-02 5.135256172998133722e-02 5.135256172998133722e-02 --4.843750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 3.901186784339424896e-02 3.901186784339424896e-02 3.901186784339424896e-02 --4.531250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 5.189375151408482517e-02 5.189375151408482517e-02 5.189375151408482517e-02 --4.531250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 4.251757195085604374e-02 4.251757195085604374e-02 4.251757195085604374e-02 --4.843750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 4.709656534062948291e-02 4.709656534062948291e-02 4.709656534062948291e-02 --4.531250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.531250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 6.430771477449195861e-02 6.430771477449195861e-02 6.430771477449195861e-02 --4.843750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 5.130584765875142311e-02 5.130584765875142311e-02 5.130584765875142311e-02 --4.843750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 3.341300689274472741e-02 3.341300689274472741e-02 3.341300689274472741e-02 --4.843750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 3.214677169660658251e-02 3.214677169660658251e-02 3.214677169660658251e-02 --4.843750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 2.910812803952768021e-02 2.910812803952768021e-02 2.910812803952768021e-02 --4.531250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 4.598718084351815366e-02 4.598718084351815366e-02 4.598718084351815366e-02 --4.531250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 4.718396781792828093e-02 4.718396781792828093e-02 4.718396781792828093e-02 --4.218750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 5.462521290107957839e-02 5.462521290107957839e-02 5.462521290107957839e-02 --4.218750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 8.326399401074854878e-02 8.326399401074854878e-02 8.326399401074854878e-02 --3.906250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 7.944009357724872433e-02 7.944009357724872433e-02 7.944009357724872433e-02 --3.906250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 8.314022262425974086e-02 8.314022262425974086e-02 8.314022262425974086e-02 --3.906250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 9.597446229008485541e-02 9.597446229008485541e-02 9.597446229008485541e-02 --4.218750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 5.646690506069143578e-02 5.646690506069143578e-02 5.646690506069143578e-02 --4.218750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 4.316608956008197856e-02 4.316608956008197856e-02 4.316608956008197856e-02 --4.218750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 6.482566527978557425e-02 6.482566527978557425e-02 6.482566527978557425e-02 --3.906250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 7.500087154446441473e-02 7.500087154446441473e-02 7.500087154446441473e-02 --3.906250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 7.545091355738328676e-02 7.545091355738328676e-02 7.545091355738328676e-02 --3.906250000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 7.677289238809258121e-02 7.677289238809258121e-02 7.677289238809258121e-02 --4.218750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 5.859460317302751797e-02 5.859460317302751797e-02 5.859460317302751797e-02 --4.218750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 6.243219637735447636e-02 6.243219637735447636e-02 6.243219637735447636e-02 --3.906250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 5.223650584117987827e-02 5.223650584117987827e-02 5.223650584117987827e-02 --3.906250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 6.111512704369874427e-02 6.111512704369874427e-02 6.111512704369874427e-02 --4.218750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 5.004914051998748253e-02 5.004914051998748253e-02 5.004914051998748253e-02 --3.906250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 6.773490469432279226e-02 6.773490469432279226e-02 6.773490469432279226e-02 --4.843750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 2.561269742777864955e-02 2.561269742777864955e-02 2.561269742777864955e-02 --4.531250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 3.122561227465975309e-02 3.122561227465975309e-02 3.122561227465975309e-02 --4.531250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 3.269910843276818690e-02 3.269910843276818690e-02 3.269910843276818690e-02 --4.531250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 4.466147967649419792e-02 4.466147967649419792e-02 4.466147967649419792e-02 --4.218750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 6.050550387671495972e-02 6.050550387671495972e-02 6.050550387671495972e-02 --3.906250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 8.401224424675746150e-02 8.401224424675746150e-02 8.401224424675746150e-02 --4.218750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 6.285344820861407666e-02 6.285344820861407666e-02 6.285344820861407666e-02 --4.218750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 5.954656203035946921e-02 5.954656203035946921e-02 5.954656203035946921e-02 --3.906250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 8.768427584005888953e-02 8.768427584005888953e-02 8.768427584005888953e-02 --3.906250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 7.309939816674426716e-02 7.309939816674426716e-02 7.309939816674426716e-02 --3.906250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 7.098148845942285623e-02 7.098148845942285623e-02 7.098148845942285623e-02 --4.531250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 7.378408165981772959e-02 7.378408165981772959e-02 7.378408165981772959e-02 --4.531250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 8.179319184565937706e-02 8.179319184565937706e-02 8.179319184565937706e-02 --4.531250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 6.092379124444410182e-02 6.092379124444410182e-02 6.092379124444410182e-02 --4.531250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 8.047828802049517005e-02 8.047828802049517005e-02 8.047828802049517005e-02 --4.531250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 7.765896855075937744e-02 7.765896855075937744e-02 7.765896855075937744e-02 --4.531250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.167580517959369985e-01 1.167580517959369985e-01 1.167580517959369985e-01 --4.531250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.067160390026334060e-01 1.067160390026334060e-01 1.067160390026334060e-01 --4.531250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.103950689230784599e-01 1.103950689230784599e-01 1.103950689230784599e-01 --4.531250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.022702865635182201e-01 1.022702865635182201e-01 1.022702865635182201e-01 --4.218750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 7.631377506646458420e-02 7.631377506646458420e-02 7.631377506646458420e-02 --4.218750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 7.712639164985303497e-02 7.712639164985303497e-02 7.712639164985303497e-02 --3.906250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 5.623696718941598172e-02 5.623696718941598172e-02 5.623696718941598172e-02 --3.906250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 5.731686550145202036e-02 5.731686550145202036e-02 5.731686550145202036e-02 --3.906250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 5.183602263315287978e-02 5.183602263315287978e-02 5.183602263315287978e-02 --4.218750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 6.553895717294182244e-02 6.553895717294182244e-02 6.553895717294182244e-02 --4.218750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 6.000103178662628128e-02 6.000103178662628128e-02 6.000103178662628128e-02 --4.218750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 9.216297916449225913e-02 9.216297916449225913e-02 9.216297916449225913e-02 --4.218750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.142715672554850403e-01 1.142715672554850403e-01 1.142715672554850403e-01 --3.906250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 4.615917383209790226e-02 4.615917383209790226e-02 4.615917383209790226e-02 --3.906250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 5.403009298951191169e-02 5.403009298951191169e-02 5.403009298951191169e-02 --3.906250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 5.664980971627568002e-02 5.664980971627568002e-02 5.664980971627568002e-02 --3.906250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 8.507714262604669508e-02 8.507714262604669508e-02 8.507714262604669508e-02 --4.218750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 8.582216126298233827e-02 8.582216126298233827e-02 8.582216126298233827e-02 --4.218750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 7.236294294634364188e-02 7.236294294634364188e-02 7.236294294634364188e-02 --3.906250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 7.512393204131480318e-02 7.512393204131480318e-02 7.512393204131480318e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 7.277321090800634162e-02 7.277321090800634162e-02 7.277321090800634162e-02 --4.218750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.205185630296818772e-01 1.205185630296818772e-01 1.205185630296818772e-01 --4.218750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 9.774875337218995319e-02 9.774875337218995319e-02 9.774875337218995319e-02 --4.531250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 6.972203401123031052e-02 6.972203401123031052e-02 6.972203401123031052e-02 --4.531250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 7.682963884991118875e-02 7.682963884991118875e-02 7.682963884991118875e-02 --4.218750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 7.763742762771028150e-02 7.763742762771028150e-02 7.763742762771028150e-02 --3.906250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 9.391003179501908327e-02 9.391003179501908327e-02 9.391003179501908327e-02 --3.906250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.118155360037002416e-01 1.118155360037002416e-01 1.118155360037002416e-01 --3.906250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.097667774070022195e-01 1.097667774070022195e-01 1.097667774070022195e-01 --3.906250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 9.863749135227350973e-02 9.863749135227350973e-02 9.863749135227350973e-02 --3.906250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.123674867516349513e-01 1.123674867516349513e-01 1.123674867516349513e-01 --3.906250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 9.147668408202326573e-02 9.147668408202326573e-02 9.147668408202326573e-02 --4.218750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 1.036491147932930290e-01 1.036491147932930290e-01 1.036491147932930290e-01 --4.218750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 7.504813451392355894e-02 7.504813451392355894e-02 7.504813451392355894e-02 --3.906250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 1.317243422670899278e-01 1.317243422670899278e-01 1.317243422670899278e-01 --3.906250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.104890711959757021e-01 1.104890711959757021e-01 1.104890711959757021e-01 --3.906250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.357459929668519416e-01 1.357459929668519416e-01 1.357459929668519416e-01 --3.906250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.172416821881615417e-01 1.172416821881615417e-01 1.172416821881615417e-01 --3.593750000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 7.710798529187476436e-02 7.710798529187476436e-02 7.710798529187476436e-02 --3.593750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 8.367468861087096199e-02 8.367468861087096199e-02 8.367468861087096199e-02 --3.593750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 8.635660943353773433e-02 8.635660943353773433e-02 8.635660943353773433e-02 --3.593750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 6.700209817896385367e-02 6.700209817896385367e-02 6.700209817896385367e-02 --3.281250000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 1.140867850459621052e-01 1.140867850459621052e-01 1.140867850459621052e-01 --3.281250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 9.533320072354814489e-02 9.533320072354814489e-02 9.533320072354814489e-02 --3.281250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.179743525929298625e-01 1.179743525929298625e-01 1.179743525929298625e-01 --3.593750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 6.376146350018589704e-02 6.376146350018589704e-02 6.376146350018589704e-02 --3.593750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 8.661941196869003823e-02 8.661941196869003823e-02 8.661941196869003823e-02 --3.281250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 1.205225797176225078e-01 1.205225797176225078e-01 1.205225797176225078e-01 --3.281250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 9.061599426948757641e-02 9.061599426948757641e-02 9.061599426948757641e-02 --3.593750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 7.637984568275578423e-02 7.637984568275578423e-02 7.637984568275578423e-02 --3.593750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 7.649743838506456450e-02 7.649743838506456450e-02 7.649743838506456450e-02 --3.281250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.182956971567590831e-01 1.182956971567590831e-01 1.182956971567590831e-01 --3.281250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 7.998294306672920628e-02 7.998294306672920628e-02 7.998294306672920628e-02 --3.281250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 6.049481151302564530e-02 6.049481151302564530e-02 6.049481151302564530e-02 --3.281250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 6.630425373832714298e-02 6.630425373832714298e-02 6.630425373832714298e-02 --3.593750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 7.183234054619754005e-02 7.183234054619754005e-02 7.183234054619754005e-02 --3.281250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 5.028134738657665664e-02 5.028134738657665664e-02 5.028134738657665664e-02 --3.281250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 4.771762743415977615e-02 4.771762743415977615e-02 4.771762743415977615e-02 --2.968750000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 1.086636398955340421e-01 1.086636398955340421e-01 1.086636398955340421e-01 --2.656250000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 8.557542985709029604e-02 8.557542985709029604e-02 8.557542985709029604e-02 --2.656250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 9.182626134852857336e-02 9.182626134852857336e-02 9.182626134852857336e-02 --2.656250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 7.572420092396336955e-02 7.572420092396336955e-02 7.572420092396336955e-02 --2.656250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 9.558954524619013571e-02 9.558954524619013571e-02 9.558954524619013571e-02 --2.968750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.062813576153642525e-01 1.062813576153642525e-01 1.062813576153642525e-01 --2.656250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.567080118886687856e-01 1.567080118886687856e-01 1.567080118886687856e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.291419301094637873e-01 1.291419301094637873e-01 1.291419301094637873e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 9.567874330546206896e-02 9.567874330546206896e-02 9.567874330546206896e-02 --2.968750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 7.389235403833800675e-02 7.389235403833800675e-02 7.389235403833800675e-02 --2.968750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 8.709840153711861932e-02 8.709840153711861932e-02 8.709840153711861932e-02 --2.656250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.252798041543660423e-01 1.252798041543660423e-01 1.252798041543660423e-01 --2.656250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 1.319034614048701648e-01 1.319034614048701648e-01 1.319034614048701648e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 1.066308705609191054e-01 1.066308705609191054e-01 1.066308705609191054e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.058273902583171944e-01 1.058273902583171944e-01 1.058273902583171944e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.018934348760753283e-01 1.018934348760753283e-01 1.018934348760753283e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 8.123862011445982800e-02 8.123862011445982800e-02 8.123862011445982800e-02 --2.968750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 7.100351346392462515e-02 7.100351346392462515e-02 7.100351346392462515e-02 --2.968750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 7.634134468546750762e-02 7.634134468546750762e-02 7.634134468546750762e-02 --2.656250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.101660885679393159e-01 1.101660885679393159e-01 1.101660885679393159e-01 --2.656250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 9.841812023177953783e-02 9.841812023177953783e-02 9.841812023177953783e-02 --2.656250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.045297526253822218e-01 1.045297526253822218e-01 1.045297526253822218e-01 --3.593750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 8.143553370307941852e-02 8.143553370307941852e-02 8.143553370307941852e-02 --3.593750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.017471934473214018e-01 1.017471934473214018e-01 1.017471934473214018e-01 --3.281250000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 9.368341533385730890e-02 9.368341533385730890e-02 9.368341533385730890e-02 --3.281250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.291379138518225222e-01 1.291379138518225222e-01 1.291379138518225222e-01 --3.593750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 9.351224715811509713e-02 9.351224715811509713e-02 9.351224715811509713e-02 --3.593750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 6.180634392560215018e-02 6.180634392560215018e-02 6.180634392560215018e-02 --3.593750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 9.347045956695618218e-02 9.347045956695618218e-02 9.347045956695618218e-02 --3.281250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.367716544115360477e-01 1.367716544115360477e-01 1.367716544115360477e-01 --3.281250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 6.819157900753458623e-02 6.819157900753458623e-02 6.819157900753458623e-02 --3.281250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.183969204285269944e-01 1.183969204285269944e-01 1.183969204285269944e-01 --3.281250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.007242995382536532e-01 1.007242995382536532e-01 1.007242995382536532e-01 --3.281250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.220601531329286171e-01 1.220601531329286171e-01 1.220601531329286171e-01 --2.968750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.060579899261717141e-01 1.060579899261717141e-01 1.060579899261717141e-01 --2.968750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.005362720629816020e-01 1.005362720629816020e-01 1.005362720629816020e-01 --2.656250000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.456534801999835316e-01 1.456534801999835316e-01 1.456534801999835316e-01 --2.656250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.504397344165026296e-01 1.504397344165026296e-01 1.504397344165026296e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.198349198194488541e-01 1.198349198194488541e-01 1.198349198194488541e-01 --2.968750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.351452079117143878e-01 1.351452079117143878e-01 1.351452079117143878e-01 --2.968750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.656250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.152517092709241381e-01 1.152517092709241381e-01 1.152517092709241381e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.001144139489896778e-01 1.001144139489896778e-01 1.001144139489896778e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.293298907431288947e-01 1.293298907431288947e-01 1.293298907431288947e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.119304256271954207e-01 1.119304256271954207e-01 1.119304256271954207e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.239053631049327475e-01 1.239053631049327475e-01 1.239053631049327475e-01 --2.968750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.317982390000548287e-01 1.317982390000548287e-01 1.317982390000548287e-01 --2.968750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.235727946473194894e-01 1.235727946473194894e-01 1.235727946473194894e-01 --2.656250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.248428131696481813e-01 1.248428131696481813e-01 1.248428131696481813e-01 --2.656250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.340930200678367712e-01 1.340930200678367712e-01 1.340930200678367712e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.151697634286966421e-01 1.151697634286966421e-01 1.151697634286966421e-01 --3.593750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 6.136796293764334304e-02 6.136796293764334304e-02 6.136796293764334304e-02 --3.593750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 4.447139129889229187e-02 4.447139129889229187e-02 4.447139129889229187e-02 --3.593750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 5.720961597492155160e-02 5.720961597492155160e-02 5.720961597492155160e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 4.451746606108814702e-02 4.451746606108814702e-02 4.451746606108814702e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 6.792662622757748847e-02 6.792662622757748847e-02 6.792662622757748847e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 5.533135933629136638e-02 5.533135933629136638e-02 5.533135933629136638e-02 --3.593750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 3.846809851212539683e-02 3.846809851212539683e-02 3.846809851212539683e-02 --3.593750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 5.578054660788777513e-02 5.578054660788777513e-02 5.578054660788777513e-02 --3.593750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 5.007165368042569564e-02 5.007165368042569564e-02 5.007165368042569564e-02 --3.593750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 5.991010588303691264e-02 5.991010588303691264e-02 5.991010588303691264e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 4.667072817760125475e-02 4.667072817760125475e-02 4.667072817760125475e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 7.787397558230028938e-02 7.787397558230028938e-02 7.787397558230028938e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 7.347694741603734425e-02 7.347694741603734425e-02 7.347694741603734425e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.188580470550487656e-01 1.188580470550487656e-01 1.188580470550487656e-01 --3.593750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 7.365531209343945118e-02 7.365531209343945118e-02 7.365531209343945118e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 8.594351747492760818e-02 8.594351747492760818e-02 8.594351747492760818e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 6.852485878352326809e-02 6.852485878352326809e-02 6.852485878352326809e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 5.780889298109218033e-02 5.780889298109218033e-02 5.780889298109218033e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 7.995529432131956438e-02 7.995529432131956438e-02 7.995529432131956438e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 8.393348139172385203e-02 8.393348139172385203e-02 8.393348139172385203e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 8.069690432685774906e-02 8.069690432685774906e-02 8.069690432685774906e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 5.472908909477083861e-02 5.472908909477083861e-02 5.472908909477083861e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 5.063649073352008423e-02 5.063649073352008423e-02 5.063649073352008423e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 6.596839233949158832e-02 6.596839233949158832e-02 6.596839233949158832e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 9.849285112023019317e-02 9.849285112023019317e-02 9.849285112023019317e-02 --2.656250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 7.227114681112394023e-02 7.227114681112394023e-02 7.227114681112394023e-02 --2.656250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.271506449748849854e-01 1.271506449748849854e-01 1.271506449748849854e-01 --2.656250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.174079796745758769e-01 1.174079796745758769e-01 1.174079796745758769e-01 --2.968750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 7.864309322780621558e-02 7.864309322780621558e-02 7.864309322780621558e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 9.492256563248709089e-02 9.492256563248709089e-02 9.492256563248709089e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.497932855039379452e-01 1.497932855039379452e-01 1.497932855039379452e-01 --2.968750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 6.757999979266543500e-02 6.757999979266543500e-02 6.757999979266543500e-02 --2.968750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.087568407363945638e-01 1.087568407363945638e-01 1.087568407363945638e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 8.063180173891798530e-02 8.063180173891798530e-02 8.063180173891798530e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 7.865064853240633092e-02 7.865064853240633092e-02 7.865064853240633092e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 8.006130791850910033e-02 8.006130791850910033e-02 8.006130791850910033e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 6.158799785276943689e-02 6.158799785276943689e-02 6.158799785276943689e-02 --2.968750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.304375643618217451e-01 1.304375643618217451e-01 1.304375643618217451e-01 --2.968750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 9.929801177347451213e-02 9.929801177347451213e-02 9.929801177347451213e-02 --2.968750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 8.820504941661384823e-02 8.820504941661384823e-02 8.820504941661384823e-02 --2.968750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 6.289179487837580351e-02 6.289179487837580351e-02 6.289179487837580351e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 9.990227874727386492e-02 9.990227874727386492e-02 9.990227874727386492e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 5.814832587075402515e-02 5.814832587075402515e-02 5.814832587075402515e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 7.723707084022596314e-02 7.723707084022596314e-02 7.723707084022596314e-02 --3.593750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.249311755087571391e-01 1.249311755087571391e-01 1.249311755087571391e-01 --3.593750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.056683002067157900e-01 1.056683002067157900e-01 1.056683002067157900e-01 --3.281250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.160671461924461800e-01 1.160671461924461800e-01 1.160671461924461800e-01 --3.593750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.026246380325121638e-01 1.026246380325121638e-01 1.026246380325121638e-01 --3.593750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.005748418373216962e-01 1.005748418373216962e-01 1.005748418373216962e-01 --3.281250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 8.696097361373121559e-02 8.696097361373121559e-02 8.696097361373121559e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 9.549391838810647459e-02 9.549391838810647459e-02 9.549391838810647459e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 9.157070846165298039e-02 9.157070846165298039e-02 9.157070846165298039e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 8.697463604937784309e-02 8.697463604937784309e-02 8.697463604937784309e-02 --3.593750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 7.757457311031001890e-02 7.757457311031001890e-02 7.757457311031001890e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.041006839368706222e-01 1.041006839368706222e-01 1.041006839368706222e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 8.066153996463532039e-02 8.066153996463532039e-02 8.066153996463532039e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 8.279784104376547438e-02 8.279784104376547438e-02 8.279784104376547438e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 4.308407026281656227e-02 4.308407026281656227e-02 4.308407026281656227e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 4.698656834373797497e-02 4.698656834373797497e-02 4.698656834373797497e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.425350342025105688e-01 1.425350342025105688e-01 1.425350342025105688e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 7.459672379430262734e-02 7.459672379430262734e-02 7.459672379430262734e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 6.200145606003656940e-02 6.200145606003656940e-02 6.200145606003656940e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 7.681629620101755596e-02 7.681629620101755596e-02 7.681629620101755596e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.155835087397172473e-01 1.155835087397172473e-01 1.155835087397172473e-01 --2.968750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.085905253672205112e-01 1.085905253672205112e-01 1.085905253672205112e-01 --2.968750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 6.561934580979411624e-02 6.561934580979411624e-02 6.561934580979411624e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.055959864428938355e-01 1.055959864428938355e-01 1.055959864428938355e-01 --2.968750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.076111056638396901e-01 1.076111056638396901e-01 1.076111056638396901e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 6.735756965876936453e-02 6.735756965876936453e-02 6.735756965876936453e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 8.784018680139805968e-02 8.784018680139805968e-02 8.784018680139805968e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 6.978674350566080320e-02 6.978674350566080320e-02 6.978674350566080320e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 7.426780968770103908e-02 7.426780968770103908e-02 7.426780968770103908e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.194926943619859239e-01 1.194926943619859239e-01 1.194926943619859239e-01 --2.968750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 9.036445573218365723e-02 9.036445573218365723e-02 9.036445573218365723e-02 --2.968750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.076191403284552095e-01 1.076191403284552095e-01 1.076191403284552095e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 3.967191298978430675e-02 3.967191298978430675e-02 3.967191298978430675e-02 --2.968750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 6.912766884156869296e-02 6.912766884156869296e-02 6.912766884156869296e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 8.408377371155002777e-02 8.408377371155002777e-02 8.408377371155002777e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 9.825258704893054251e-02 9.825258704893054251e-02 9.825258704893054251e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 6.473836235517212156e-02 6.473836235517212156e-02 6.473836235517212156e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 7.751421022193796806e-02 7.751421022193796806e-02 7.751421022193796806e-02 --2.031250000000000000e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 7.306362855902058528e-02 7.306362855902058528e-02 7.306362855902058528e-02 --1.718750000000000000e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 9.557508068671696777e-02 9.557508068671696777e-02 9.557508068671696777e-02 --1.406250000000000000e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 7.043391597124482040e-02 7.043391597124482040e-02 7.043391597124482040e-02 --2.343750000000000000e-01 -2.968750000000000000e-01 -2.343750000000000000e-01 5.086154000764064181e-02 5.086154000764064181e-02 5.086154000764064181e-02 --2.343750000000000000e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 5.312944516184188448e-02 5.312944516184188448e-02 5.312944516184188448e-02 --2.343750000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 7.451586184874961494e-02 7.451586184874961494e-02 7.451586184874961494e-02 --2.343750000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 8.600459735338961131e-02 8.600459735338961131e-02 8.600459735338961131e-02 --2.031250000000000000e-01 -2.968750000000000000e-01 -2.343750000000000000e-01 7.260666037332275113e-02 7.260666037332275113e-02 7.260666037332275113e-02 --2.031250000000000000e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 6.541435462706142456e-02 6.541435462706142456e-02 6.541435462706142456e-02 --2.031250000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 7.163114317492519367e-02 7.163114317492519367e-02 7.163114317492519367e-02 --2.343750000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 1.076392269864567403e-01 1.076392269864567403e-01 1.076392269864567403e-01 --2.343750000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.272165132019492662e-01 1.272165132019492662e-01 1.272165132019492662e-01 --2.031250000000000000e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 7.778017632368337819e-02 7.778017632368337819e-02 7.778017632368337819e-02 --2.031250000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 1.157939958289341265e-01 1.157939958289341265e-01 1.157939958289341265e-01 --1.718750000000000000e-01 -2.968750000000000000e-01 -2.343750000000000000e-01 6.146250486749712388e-02 6.146250486749712388e-02 6.146250486749712388e-02 --1.718750000000000000e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 5.353973081357209229e-02 5.353973081357209229e-02 5.353973081357209229e-02 --1.718750000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 7.589661262324587376e-02 7.589661262324587376e-02 7.589661262324587376e-02 --1.718750000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 1.196220332623368909e-01 1.196220332623368909e-01 1.196220332623368909e-01 --1.406250000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 9.095753894782467042e-02 9.095753894782467042e-02 9.095753894782467042e-02 --1.406250000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 9.508569489217566506e-02 9.508569489217566506e-02 9.508569489217566506e-02 --1.718750000000000000e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 8.300841392538808872e-02 8.300841392538808872e-02 8.300841392538808872e-02 --1.718750000000000000e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 1.443404227702736742e-01 1.443404227702736742e-01 1.443404227702736742e-01 --1.406250000000000000e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 1.276157377657625158e-01 1.276157377657625158e-01 1.276157377657625158e-01 --1.406250000000000000e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 2.073301794920948404e-01 2.073301794920948404e-01 2.073301794920948404e-01 --1.093750000000000000e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 6.521925076921332443e-02 6.521925076921332443e-02 6.521925076921332443e-02 --1.093750000000000000e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 7.646070575488277121e-02 7.646070575488277121e-02 7.646070575488277121e-02 --1.093750000000000000e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 1.351917930095947462e-01 1.351917930095947462e-01 1.351917930095947462e-01 --1.093750000000000000e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 2.249296590175056676e-01 2.249296590175056676e-01 2.249296590175056676e-01 --7.812500000000000000e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 2.225516193068741988e-01 2.225516193068741988e-01 2.225516193068741988e-01 --4.687500000000000000e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 1.033960099833951402e-01 1.033960099833951402e-01 1.033960099833951402e-01 --4.687500000000000000e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 1.875355934433045324e-01 1.875355934433045324e-01 1.875355934433045324e-01 --4.687500000000000000e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 1.323195303294078251e-01 1.323195303294078251e-01 1.323195303294078251e-01 --4.687500000000000000e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 2.291496239231368415e-01 2.291496239231368415e-01 2.291496239231368415e-01 --1.562500000000000000e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 9.889382534696079807e-02 9.889382534696079807e-02 9.889382534696079807e-02 --1.562500000000000000e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 2.306859250078792112e-01 2.306859250078792112e-01 2.306859250078792112e-01 --1.562500000000000000e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 1.337789674417829699e-01 1.337789674417829699e-01 1.337789674417829699e-01 --2.343750000000000000e-01 -2.343750000000000000e-01 -2.968750000000000000e-01 7.126942070666066054e-02 7.126942070666066054e-02 7.126942070666066054e-02 --2.343750000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 9.742330888939297606e-02 9.742330888939297606e-02 9.742330888939297606e-02 --2.343750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 7.393801005330528919e-02 7.393801005330528919e-02 7.393801005330528919e-02 --2.343750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.012739157925411360e-01 1.012739157925411360e-01 1.012739157925411360e-01 --2.031250000000000000e-01 -2.343750000000000000e-01 -2.968750000000000000e-01 7.842728449364909371e-02 7.842728449364909371e-02 7.842728449364909371e-02 --2.031250000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 7.851296505106361567e-02 7.851296505106361567e-02 7.851296505106361567e-02 --2.031250000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 6.385785159569373759e-02 6.385785159569373759e-02 6.385785159569373759e-02 --2.343750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 6.833699719824046226e-02 6.833699719824046226e-02 6.833699719824046226e-02 --2.343750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 1.166367420554483836e-01 1.166367420554483836e-01 1.166367420554483836e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 8.799690112298655387e-02 8.799690112298655387e-02 8.799690112298655387e-02 --2.031250000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 7.904722065229091710e-02 7.904722065229091710e-02 7.904722065229091710e-02 --2.031250000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 7.917493671335561201e-02 7.917493671335561201e-02 7.917493671335561201e-02 --2.031250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 1.158012262916912755e-01 1.158012262916912755e-01 1.158012262916912755e-01 --1.718750000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 5.128880224218856226e-02 5.128880224218856226e-02 5.128880224218856226e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 5.794114495230300727e-02 5.794114495230300727e-02 5.794114495230300727e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 6.942983583236694844e-02 6.942983583236694844e-02 6.942983583236694844e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 7.717694882978377857e-02 7.717694882978377857e-02 7.717694882978377857e-02 --1.406250000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 8.871296113924574678e-02 8.871296113924574678e-02 8.871296113924574678e-02 --1.718750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 7.344656348835799931e-02 7.344656348835799931e-02 7.344656348835799931e-02 --1.718750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 7.558876303626239912e-02 7.558876303626239912e-02 7.558876303626239912e-02 --1.718750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 1.154413091349223014e-01 1.154413091349223014e-01 1.154413091349223014e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 6.622675975351371980e-02 6.622675975351371980e-02 6.622675975351371980e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 1.216898207386566816e-01 1.216898207386566816e-01 1.216898207386566816e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 1.210808973911134123e-01 1.210808973911134123e-01 1.210808973911134123e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -3.906250000000000000e-01 1.035309993144325480e-01 1.035309993144325480e-01 1.035309993144325480e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -3.906250000000000000e-01 1.067787100625342267e-01 1.067787100625342267e-01 1.067787100625342267e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 -3.906250000000000000e-01 1.039311449292296824e-01 1.039311449292296824e-01 1.039311449292296824e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -3.906250000000000000e-01 1.046486701340781089e-01 1.046486701340781089e-01 1.046486701340781089e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -3.906250000000000000e-01 9.688571993446168373e-02 9.688571993446168373e-02 9.688571993446168373e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 -3.906250000000000000e-01 1.225373251146741060e-01 1.225373251146741060e-01 1.225373251146741060e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 -3.906250000000000000e-01 1.373346783536121829e-01 1.373346783536121829e-01 1.373346783536121829e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 -4.218750000000000000e-01 8.748014453704415494e-02 8.748014453704415494e-02 8.748014453704415494e-02 --1.406250000000000000e-01 -4.687500000000000000e-02 -3.906250000000000000e-01 1.065248116206679585e-01 1.065248116206679585e-01 1.065248116206679585e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 -4.218750000000000000e-01 9.827026536625600717e-02 9.827026536625600717e-02 9.827026536625600717e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 -3.906250000000000000e-01 1.617762388936173912e-01 1.617762388936173912e-01 1.617762388936173912e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 1.103645382467207808e-01 1.103645382467207808e-01 1.103645382467207808e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 1.162856658155271422e-01 1.162856658155271422e-01 1.162856658155271422e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.174746592465067546e-01 1.174746592465067546e-01 1.174746592465067546e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 1.034377924195813148e-01 1.034377924195813148e-01 1.034377924195813148e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 1.221734214857738837e-01 1.221734214857738837e-01 1.221734214857738837e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.299885527459669343e-01 1.299885527459669343e-01 1.299885527459669343e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -3.593750000000000000e-01 1.042919170806991536e-01 1.042919170806991536e-01 1.042919170806991536e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 9.675955877738641464e-02 9.675955877738641464e-02 9.675955877738641464e-02 --2.031250000000000000e-01 -1.562500000000000000e-02 -3.593750000000000000e-01 1.207274305370263506e-01 1.207274305370263506e-01 1.207274305370263506e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 1.268012211611443119e-01 1.268012211611443119e-01 1.268012211611443119e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.120742382813361554e-01 1.120742382813361554e-01 1.120742382813361554e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 1.156791117225386412e-01 1.156791117225386412e-01 1.156791117225386412e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --2.031250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 1.223485452919000488e-01 1.223485452919000488e-01 1.223485452919000488e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.303837473593484897e-01 1.303837473593484897e-01 1.303837473593484897e-01 --1.718750000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 9.222566156174957785e-02 9.222566156174957785e-02 9.222566156174957785e-02 --1.718750000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 1.049515875884298316e-01 1.049515875884298316e-01 1.049515875884298316e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 1.346448180042184029e-01 1.346448180042184029e-01 1.346448180042184029e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 1.557877957427626914e-01 1.557877957427626914e-01 1.557877957427626914e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 1.102263466193265234e-01 1.102263466193265234e-01 1.102263466193265234e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 1.099620142987030175e-01 1.099620142987030175e-01 1.099620142987030175e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 1.321902118400765380e-01 1.321902118400765380e-01 1.321902118400765380e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 1.686337355178923747e-01 1.686337355178923747e-01 1.686337355178923747e-01 --1.718750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 1.237519319341922608e-01 1.237519319341922608e-01 1.237519319341922608e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 1.482449991643404463e-01 1.482449991643404463e-01 1.482449991643404463e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.487316525420604718e-01 1.487316525420604718e-01 1.487316525420604718e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 1.281081387749275768e-01 1.281081387749275768e-01 1.281081387749275768e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 1.444062769254942924e-01 1.444062769254942924e-01 1.444062769254942924e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.650818163225419299e-01 1.650818163225419299e-01 1.650818163225419299e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 -3.593750000000000000e-01 1.505666144628587111e-01 1.505666144628587111e-01 1.505666144628587111e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 1.311974244645730536e-01 1.311974244645730536e-01 1.311974244645730536e-01 --1.718750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.520787201193249394e-01 1.520787201193249394e-01 1.520787201193249394e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.180900367837738885e-01 1.180900367837738885e-01 1.180900367837738885e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.395602308587965967e-01 1.395602308587965967e-01 1.395602308587965967e-01 --1.093750000000000000e-01 -2.031250000000000000e-01 -3.281250000000000000e-01 4.475362895679715208e-02 4.475362895679715208e-02 4.475362895679715208e-02 --7.812500000000000000e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 7.397667296122235892e-02 7.397667296122235892e-02 7.397667296122235892e-02 --1.093750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 5.527926084714889637e-02 5.527926084714889637e-02 5.527926084714889637e-02 --1.093750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.379137616359640828e-01 1.379137616359640828e-01 1.379137616359640828e-01 --7.812500000000000000e-02 -2.031250000000000000e-01 -2.968750000000000000e-01 7.624609683635440172e-02 7.624609683635440172e-02 7.624609683635440172e-02 --7.812500000000000000e-02 -2.031250000000000000e-01 -2.656250000000000000e-01 8.168951133427515554e-02 8.168951133427515554e-02 8.168951133427515554e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 5.302243125667358004e-02 5.302243125667358004e-02 5.302243125667358004e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 5.223353096824834285e-02 5.223353096824834285e-02 5.223353096824834285e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 -3.593750000000000000e-01 3.955000447425485038e-02 3.955000447425485038e-02 3.955000447425485038e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 -3.281250000000000000e-01 6.952452905855803500e-02 6.952452905855803500e-02 6.952452905855803500e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 4.149086903189980191e-02 4.149086903189980191e-02 4.149086903189980191e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 7.203908378508010191e-02 7.203908378508010191e-02 7.203908378508010191e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 6.954631330789730337e-02 6.954631330789730337e-02 6.954631330789730337e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 6.178447718802487082e-02 6.178447718802487082e-02 6.178447718802487082e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 6.917823104810416623e-02 6.917823104810416623e-02 6.917823104810416623e-02 --4.687500000000000000e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 6.900363455004823732e-02 6.900363455004823732e-02 6.900363455004823732e-02 --4.687500000000000000e-02 -2.031250000000000000e-01 -2.968750000000000000e-01 8.735879064292766116e-02 8.735879064292766116e-02 8.735879064292766116e-02 --4.687500000000000000e-02 -2.031250000000000000e-01 -2.656250000000000000e-01 8.353404001125652734e-02 8.353404001125652734e-02 8.353404001125652734e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 -3.281250000000000000e-01 5.935594605439842297e-02 5.935594605439842297e-02 5.935594605439842297e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 6.741440314864165229e-02 6.741440314864165229e-02 6.741440314864165229e-02 --1.562500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 9.211476190258588437e-02 9.211476190258588437e-02 9.211476190258588437e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 -2.968750000000000000e-01 8.362726996762134823e-02 8.362726996762134823e-02 8.362726996762134823e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 8.401385165114953757e-02 8.401385165114953757e-02 8.401385165114953757e-02 --1.562500000000000000e-02 -1.718750000000000000e-01 -2.968750000000000000e-01 8.914371920126011595e-02 8.914371920126011595e-02 8.914371920126011595e-02 --1.562500000000000000e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 1.052207573136724611e-01 1.052207573136724611e-01 1.052207573136724611e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 1.494865215940259506e-01 1.494865215940259506e-01 1.494865215940259506e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 1.556504851012942559e-01 1.556504851012942559e-01 1.556504851012942559e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -4.218750000000000000e-01 9.148873849580703432e-02 9.148873849580703432e-02 9.148873849580703432e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 -3.906250000000000000e-01 1.263047957541343636e-01 1.263047957541343636e-01 1.263047957541343636e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 1.152894686015088904e-01 1.152894686015088904e-01 1.152894686015088904e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 -4.218750000000000000e-01 9.744179095701969995e-02 9.744179095701969995e-02 9.744179095701969995e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 -4.218750000000000000e-01 1.191488607462209970e-01 1.191488607462209970e-01 1.191488607462209970e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 -3.906250000000000000e-01 1.668007913733142167e-01 1.668007913733142167e-01 1.668007913733142167e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -4.218750000000000000e-01 1.030922831604431517e-01 1.030922831604431517e-01 1.030922831604431517e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 1.306223090217441818e-01 1.306223090217441818e-01 1.306223090217441818e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 -4.218750000000000000e-01 1.490576925972403044e-01 1.490576925972403044e-01 1.490576925972403044e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 -3.906250000000000000e-01 1.526456520365795932e-01 1.526456520365795932e-01 1.526456520365795932e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 9.282114190005988363e-02 9.282114190005988363e-02 9.282114190005988363e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 -4.218750000000000000e-01 6.178134188324158060e-02 6.178134188324158060e-02 6.178134188324158060e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 9.017961860606259206e-02 9.017961860606259206e-02 9.017961860606259206e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 -4.218750000000000000e-01 6.770299125428674847e-02 6.770299125428674847e-02 6.770299125428674847e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 9.173063001736261879e-02 9.173063001736261879e-02 9.173063001736261879e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 -4.218750000000000000e-01 1.182491022745633530e-01 1.182491022745633530e-01 1.182491022745633530e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 -4.218750000000000000e-01 5.339195425123115235e-02 5.339195425123115235e-02 5.339195425123115235e-02 --1.562500000000000000e-02 -1.562500000000000000e-02 -4.218750000000000000e-01 6.568003917741353781e-02 6.568003917741353781e-02 6.568003917741353781e-02 --1.093750000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 1.039311449292296824e-01 1.039311449292296824e-01 1.039311449292296824e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 1.418989623870391681e-01 1.418989623870391681e-01 1.418989623870391681e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 1.397465608630986400e-01 1.397465608630986400e-01 1.397465608630986400e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 6.087692194355685121e-02 6.087692194355685121e-02 6.087692194355685121e-02 --7.812500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 8.998353006024467637e-02 8.998353006024467637e-02 8.998353006024467637e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -3.593750000000000000e-01 1.187761048859415636e-01 1.187761048859415636e-01 1.187761048859415636e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 -3.281250000000000000e-01 7.890576020956538428e-02 7.890576020956538428e-02 7.890576020956538428e-02 --1.093750000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 1.145077665053362004e-01 1.145077665053362004e-01 1.145077665053362004e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 1.745875051141830836e-01 1.745875051141830836e-01 1.745875051141830836e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 9.802196500793147749e-02 9.802196500793147749e-02 9.802196500793147749e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.283997222911621994e-01 1.283997222911621994e-01 1.283997222911621994e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 -2.968750000000000000e-01 5.883739756705946150e-02 5.883739756705946150e-02 5.883739756705946150e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 7.623580845435012909e-02 7.623580845435012909e-02 7.623580845435012909e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 8.629392246349407158e-02 8.629392246349407158e-02 8.629392246349407158e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 -3.593750000000000000e-01 1.211797071657592373e-01 1.211797071657592373e-01 1.211797071657592373e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -3.281250000000000000e-01 1.370591906688170825e-01 1.370591906688170825e-01 1.370591906688170825e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 6.827019650313012611e-02 6.827019650313012611e-02 6.827019650313012611e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.108208903068074874e-01 1.108208903068074874e-01 1.108208903068074874e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 5.260989172221697263e-02 5.260989172221697263e-02 5.260989172221697263e-02 --4.687500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 5.132948610782936405e-02 5.132948610782936405e-02 5.132948610782936405e-02 --4.687500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 8.828863004706896667e-02 8.828863004706896667e-02 8.828863004706896667e-02 --4.687500000000000000e-02 -7.812500000000000000e-02 -3.593750000000000000e-01 9.285328646230832372e-02 9.285328646230832372e-02 9.285328646230832372e-02 --4.687500000000000000e-02 -7.812500000000000000e-02 -3.281250000000000000e-01 6.651101118322948202e-02 6.651101118322948202e-02 6.651101118322948202e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 1.070776021381713849e-01 1.070776021381713849e-01 1.070776021381713849e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 -3.593750000000000000e-01 7.904826552963292730e-02 7.904826552963292730e-02 7.904826552963292730e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 -3.281250000000000000e-01 9.142444826807780145e-02 9.142444826807780145e-02 9.142444826807780145e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 -2.968750000000000000e-01 1.292190422174359365e-01 1.292190422174359365e-01 1.292190422174359365e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 1.013494475574340248e-01 1.013494475574340248e-01 1.013494475574340248e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 -2.968750000000000000e-01 8.509803860418087285e-02 8.509803860418087285e-02 8.509803860418087285e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 7.763453407043567622e-02 7.763453407043567622e-02 7.763453407043567622e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 -3.593750000000000000e-01 8.163164308376782974e-02 8.163164308376782974e-02 8.163164308376782974e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 -3.281250000000000000e-01 6.384571265091808223e-02 6.384571265091808223e-02 6.384571265091808223e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 -3.281250000000000000e-01 1.492994110956117615e-01 1.492994110956117615e-01 1.492994110956117615e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 -3.281250000000000000e-01 5.646063403655454671e-02 5.646063403655454671e-02 5.646063403655454671e-02 --1.562500000000000000e-02 -1.562500000000000000e-02 -3.281250000000000000e-01 7.163307235706166398e-02 7.163307235706166398e-02 7.163307235706166398e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 3.896981068966572787e-02 3.896981068966572787e-02 3.896981068966572787e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 8.400340352197349647e-02 8.400340352197349647e-02 8.400340352197349647e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 6.945684511707671260e-02 6.945684511707671260e-02 6.945684511707671260e-02 --1.562500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 6.281325251837364954e-02 6.281325251837364954e-02 6.281325251837364954e-02 --1.562500000000000000e-02 -4.687500000000000000e-02 -2.656250000000000000e-01 6.310201791094674495e-02 6.310201791094674495e-02 6.310201791094674495e-02 --1.562500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 8.580528389451916316e-02 8.580528389451916316e-02 8.580528389451916316e-02 --1.562500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 7.627093362813047728e-02 7.627093362813047728e-02 7.627093362813047728e-02 --2.343750000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 8.089623044139360175e-02 8.089623044139360175e-02 8.089623044139360175e-02 --2.343750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 8.657440609085537142e-02 8.657440609085537142e-02 8.657440609085537142e-02 --2.343750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 8.761998257216209451e-02 8.761998257216209451e-02 8.761998257216209451e-02 --2.031250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 9.233415021083697660e-02 9.233415021083697660e-02 9.233415021083697660e-02 --2.343750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 1.242507829943763215e-01 1.242507829943763215e-01 1.242507829943763215e-01 --2.343750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.572476101782647184e-01 1.572476101782647184e-01 1.572476101782647184e-01 --2.343750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.082731593368084222e-01 1.082731593368084222e-01 1.082731593368084222e-01 --2.343750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.514451328387952378e-01 1.514451328387952378e-01 1.514451328387952378e-01 --2.031250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 9.835142486413352148e-02 9.835142486413352148e-02 9.835142486413352148e-02 --2.031250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 8.331623512323041436e-02 8.331623512323041436e-02 8.331623512323041436e-02 --2.031250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 8.085363256323779835e-02 8.085363256323779835e-02 8.085363256323779835e-02 --2.031250000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 9.509774876523519049e-02 9.509774876523519049e-02 9.509774876523519049e-02 --2.343750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 9.284846477878355708e-02 9.284846477878355708e-02 9.284846477878355708e-02 --2.343750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 7.483641548536720811e-02 7.483641548536720811e-02 7.483641548536720811e-02 --2.343750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 7.518928022343471240e-02 7.518928022343471240e-02 7.518928022343471240e-02 --2.343750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.256621693189716726e-01 1.256621693189716726e-01 1.256621693189716726e-01 --2.031250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 5.275196121795594495e-02 5.275196121795594495e-02 5.275196121795594495e-02 --2.343750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.064733890538454159e-01 1.064733890538454159e-01 1.064733890538454159e-01 --2.343750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.238499351241273000e-01 1.238499351241273000e-01 1.238499351241273000e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 8.084881016052843095e-02 8.084881016052843095e-02 8.084881016052843095e-02 --2.343750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.567361160555965083e-01 1.567361160555965083e-01 1.567361160555965083e-01 --2.031250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 8.653984798902454589e-02 8.653984798902454589e-02 8.653984798902454589e-02 --2.031250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 8.890101624848044393e-02 8.890101624848044393e-02 8.890101624848044393e-02 --2.031250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 6.150294241072164214e-02 6.150294241072164214e-02 6.150294241072164214e-02 --2.031250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.000252208073302562e-01 1.000252208073302562e-01 1.000252208073302562e-01 --1.718750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 6.280143498162860105e-02 6.280143498162860105e-02 6.280143498162860105e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 9.421138248330546139e-02 9.421138248330546139e-02 9.421138248330546139e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 9.392931827286818414e-02 9.392931827286818414e-02 9.392931827286818414e-02 --1.406250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 6.976487893697833065e-02 6.976487893697833065e-02 6.976487893697833065e-02 --1.406250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 7.156595286801743783e-02 7.156595286801743783e-02 7.156595286801743783e-02 --1.718750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 9.585954987899167334e-02 9.585954987899167334e-02 9.585954987899167334e-02 --1.718750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 6.941600964739975954e-02 6.941600964739975954e-02 6.941600964739975954e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 7.499524499863050031e-02 7.499524499863050031e-02 7.499524499863050031e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 8.926507040311121299e-02 8.926507040311121299e-02 8.926507040311121299e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 6.288906157338486347e-02 6.288906157338486347e-02 6.288906157338486347e-02 --1.406250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 5.818466488256675284e-02 5.818466488256675284e-02 5.818466488256675284e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 9.349617501024477806e-02 9.349617501024477806e-02 9.349617501024477806e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 8.220710883486612164e-02 8.220710883486612164e-02 8.220710883486612164e-02 --1.406250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 1.180924468693172746e-01 1.180924468693172746e-01 1.180924468693172746e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 9.203038162474691530e-02 9.203038162474691530e-02 9.203038162474691530e-02 --1.718750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 9.185920993209682750e-02 9.185920993209682750e-02 9.185920993209682750e-02 --1.718750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.044927917422926317e-01 1.044927917422926317e-01 1.044927917422926317e-01 --1.718750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.057124919192717338e-01 1.057124919192717338e-01 1.057124919192717338e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 9.842695937274144324e-02 9.842695937274144324e-02 9.842695937274144324e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.315717292341713751e-01 1.315717292341713751e-01 1.315717292341713751e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 8.865750890773117787e-02 8.865750890773117787e-02 8.865750890773117787e-02 --1.406250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.106939475640552617e-01 1.106939475640552617e-01 1.106939475640552617e-01 --2.343750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.408805945148082772e-01 1.408805945148082772e-01 1.408805945148082772e-01 --2.343750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 2.638472766944958275e-02 2.638472766944958275e-02 2.638472766944958275e-02 --2.343750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.483606398375743041e-01 1.483606398375743041e-01 1.483606398375743041e-01 --2.343750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.285483250540796485e-01 1.285483250540796485e-01 1.285483250540796485e-01 --2.031250000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 9.288141294372928569e-02 9.288141294372928569e-02 9.288141294372928569e-02 --2.031250000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.292776795000612766e-01 1.292776795000612766e-01 1.292776795000612766e-01 --2.031250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.196646106188170161e-01 1.196646106188170161e-01 1.196646106188170161e-01 --2.343750000000000000e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 1.296600256649342309e-01 1.296600256649342309e-01 1.296600256649342309e-01 --2.343750000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.618573343540823106e-01 1.618573343540823106e-01 1.618573343540823106e-01 --2.343750000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 1.376695994287303881e-01 1.376695994287303881e-01 1.376695994287303881e-01 --2.031250000000000000e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 1.642219135735042135e-01 1.642219135735042135e-01 1.642219135735042135e-01 --2.031250000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 1.804605602614018367e-01 1.804605602614018367e-01 1.804605602614018367e-01 --2.343750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.288069735327325716e-01 1.288069735327325716e-01 1.288069735327325716e-01 --2.343750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.460188838076717788e-01 1.460188838076717788e-01 1.460188838076717788e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.060354924266912607e-01 1.060354924266912607e-01 1.060354924266912607e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.011140132052601309e-01 1.011140132052601309e-01 1.011140132052601309e-01 --2.031250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.431381734128575056e-01 1.431381734128575056e-01 1.431381734128575056e-01 --2.031250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.395273018045299906e-01 1.395273018045299906e-01 1.395273018045299906e-01 --2.031250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.631074787831292006e-01 1.631074787831292006e-01 1.631074787831292006e-01 --2.343750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.670617255243636023e-01 1.670617255243636023e-01 1.670617255243636023e-01 --2.343750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.196051629827737661e-01 1.196051629827737661e-01 1.196051629827737661e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.416821185732613786e-01 1.416821185732613786e-01 1.416821185732613786e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.446785270683475233e-01 1.446785270683475233e-01 1.446785270683475233e-01 --2.031250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.323781653523543600e-01 1.323781653523543600e-01 1.323781653523543600e-01 --2.031250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.283306419944182097e-01 1.283306419944182097e-01 1.283306419944182097e-01 --1.718750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 3.280309336096205730e-02 3.280309336096205730e-02 3.280309336096205730e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.463730426436523624e-01 1.463730426436523624e-01 1.463730426436523624e-01 --1.718750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.962087641300807039e-01 1.962087641300807039e-01 1.962087641300807039e-01 --1.406250000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.756383607164624661e-01 1.756383607164624661e-01 1.756383607164624661e-01 --1.718750000000000000e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 1.777392279781046802e-01 1.777392279781046802e-01 1.777392279781046802e-01 --1.718750000000000000e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 1.725459641250368659e-01 1.725459641250368659e-01 1.725459641250368659e-01 --1.718750000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 2.168124235691231694e-01 2.168124235691231694e-01 2.168124235691231694e-01 --1.718750000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 2.083701755235670972e-01 2.083701755235670972e-01 2.083701755235670972e-01 --1.406250000000000000e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 1.996694241290424832e-01 1.996694241290424832e-01 1.996694241290424832e-01 --1.406250000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.581886866306736750e-01 1.581886866306736750e-01 1.581886866306736750e-01 --1.406250000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 1.379667704383377436e-01 1.379667704383377436e-01 1.379667704383377436e-01 --1.718750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.771756839477653389e-01 1.771756839477653389e-01 1.771756839477653389e-01 --1.718750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.953387603258261718e-01 1.953387603258261718e-01 1.953387603258261718e-01 --1.718750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.572042497351411328e-01 1.572042497351411328e-01 1.572042497351411328e-01 --1.718750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.395441679071769137e-01 1.395441679071769137e-01 1.395441679071769137e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.914284425589312666e-01 1.914284425589312666e-01 1.914284425589312666e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.969623852823601529e-01 1.969623852823601529e-01 1.969623852823601529e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.643070210714476231e-01 1.643070210714476231e-01 1.643070210714476231e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.717543814046426642e-01 1.717543814046426642e-01 1.717543814046426642e-01 --1.718750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.736120997398408750e-01 1.736120997398408750e-01 1.736120997398408750e-01 --1.718750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.270614818011013558e-01 1.270614818011013558e-01 1.270614818011013558e-01 --1.718750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 7.143275869815933488e-02 7.143275869815933488e-02 7.143275869815933488e-02 --1.718750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 6.127486796959811383e-02 6.127486796959811383e-02 6.127486796959811383e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 6.571653556450700318e-02 6.571653556450700318e-02 6.571653556450700318e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 5.925416610329706929e-02 5.925416610329706929e-02 5.925416610329706929e-02 --1.406250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 5.124868117668618384e-02 5.124868117668618384e-02 5.124868117668618384e-02 --1.406250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 6.959068563516662698e-02 6.959068563516662698e-02 6.959068563516662698e-02 --2.343750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.185166207998571281e-01 1.185166207998571281e-01 1.185166207998571281e-01 --2.343750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 7.166651150676163484e-02 7.166651150676163484e-02 7.166651150676163484e-02 --2.343750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.434995729038259504e-01 1.434995729038259504e-01 1.434995729038259504e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 9.046249960064235707e-02 9.046249960064235707e-02 9.046249960064235707e-02 --2.343750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 9.057259790065365357e-02 9.057259790065365357e-02 9.057259790065365357e-02 --2.031250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.129491600066324930e-01 1.129491600066324930e-01 1.129491600066324930e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 8.556015981036714513e-02 8.556015981036714513e-02 8.556015981036714513e-02 --2.343750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.641103102086342025e-01 1.641103102086342025e-01 1.641103102086342025e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.323853943248366194e-01 1.323853943248366194e-01 1.323853943248366194e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.287523521841491270e-01 1.287523521841491270e-01 1.287523521841491270e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.009444679037626580e-01 1.009444679037626580e-01 1.009444679037626580e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 5.452431136162801117e-02 5.452431136162801117e-02 5.452431136162801117e-02 --2.031250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 6.463136389017887229e-02 6.463136389017887229e-02 6.463136389017887229e-02 --2.031250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 7.229638673965149698e-02 7.229638673965149698e-02 7.229638673965149698e-02 --1.718750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.076777933557881844e-01 1.076777933557881844e-01 1.076777933557881844e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.105324568233501115e-01 1.105324568233501115e-01 1.105324568233501115e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.451748391174633723e-01 1.451748391174633723e-01 1.451748391174633723e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 1.077734057333732676e-01 1.077734057333732676e-01 1.077734057333732676e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.317612906420655150e-01 1.317612906420655150e-01 1.317612906420655150e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.234884473561856238e-01 1.234884473561856238e-01 1.234884473561856238e-01 --1.718750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 7.564671601195813166e-02 7.564671601195813166e-02 7.564671601195813166e-02 --1.718750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 8.589770753563218120e-02 8.589770753563218120e-02 8.589770753563218120e-02 --1.406250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.083350257245151993e-01 1.083350257245151993e-01 1.083350257245151993e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 9.371877397266178966e-02 9.371877397266178966e-02 9.371877397266178966e-02 --1.406250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 1.051588885311576377e-01 1.051588885311576377e-01 1.051588885311576377e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 9.656830772888796988e-02 9.656830772888796988e-02 9.656830772888796988e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.008568827502318299e-01 1.008568827502318299e-01 1.008568827502318299e-01 --1.718750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 4.860297837802454030e-02 4.860297837802454030e-02 4.860297837802454030e-02 --1.718750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 7.718482578022553553e-02 7.718482578022553553e-02 7.718482578022553553e-02 --1.406250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.393433807414624082e-01 1.393433807414624082e-01 1.393433807414624082e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 7.740063784715073281e-02 7.740063784715073281e-02 7.740063784715073281e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 6.874889339966717972e-02 6.874889339966717972e-02 6.874889339966717972e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 6.461231155653786307e-02 6.461231155653786307e-02 6.461231155653786307e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 6.382360529642366886e-02 6.382360529642366886e-02 6.382360529642366886e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 3.915934916094574586e-02 3.915934916094574586e-02 3.915934916094574586e-02 --1.718750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 7.268479126554074077e-02 7.268479126554074077e-02 7.268479126554074077e-02 --1.718750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 9.084020846887305711e-02 9.084020846887305711e-02 9.084020846887305711e-02 --1.406250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.194573470486946370e-01 1.194573470486946370e-01 1.194573470486946370e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.132440121084643397e-01 1.132440121084643397e-01 1.132440121084643397e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 7.229743170468967695e-02 7.229743170468967695e-02 7.229743170468967695e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.068952138262273394e-01 1.068952138262273394e-01 1.068952138262273394e-01 --2.343750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 9.862463445329464062e-02 9.862463445329464062e-02 9.862463445329464062e-02 --2.031250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.347291535999524670e-01 1.347291535999524670e-01 1.347291535999524670e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 9.048901964288870448e-02 9.048901964288870448e-02 9.048901964288870448e-02 --2.031250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.087110437849759109e-01 1.087110437849759109e-01 1.087110437849759109e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 9.363278816486407530e-02 9.363278816486407530e-02 9.363278816486407530e-02 --2.343750000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.081405883458130407e-01 1.081405883458130407e-01 1.081405883458130407e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.112499231575081182e-01 1.112499231575081182e-01 1.112499231575081182e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.117858092911855478e-01 1.117858092911855478e-01 1.117858092911855478e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.253111324609929300e-01 1.253111324609929300e-01 1.253111324609929300e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.096591157085009399e-01 1.096591157085009399e-01 1.096591157085009399e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.174746592465067546e-01 1.174746592465067546e-01 1.174746592465067546e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 6.033916912595579940e-02 6.033916912595579940e-02 6.033916912595579940e-02 --2.343750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 5.506515821429117802e-02 5.506515821429117802e-02 5.506515821429117802e-02 --2.343750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 5.949559179675215775e-02 5.949559179675215775e-02 5.949559179675215775e-02 --2.343750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 4.909329023879169251e-02 4.909329023879169251e-02 4.909329023879169251e-02 --2.031250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 7.695679579040197449e-02 7.695679579040197449e-02 7.695679579040197449e-02 --2.031250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 4.355720788256575021e-02 4.355720788256575021e-02 4.355720788256575021e-02 --2.031250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 7.461786363346285811e-02 7.461786363346285811e-02 7.461786363346285811e-02 --2.343750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 7.573593618420119966e-02 7.573593618420119966e-02 7.573593618420119966e-02 --2.343750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.104922849469519297e-01 1.104922849469519297e-01 1.104922849469519297e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.108771306984304428e-01 1.108771306984304428e-01 1.108771306984304428e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 9.550597220000497933e-02 9.550597220000497933e-02 9.550597220000497933e-02 --2.031250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.215829783210879145e-01 1.215829783210879145e-01 1.215829783210879145e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 5.968476034037885347e-02 5.968476034037885347e-02 5.968476034037885347e-02 --2.031250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 8.931489667139050348e-02 8.931489667139050348e-02 8.931489667139050348e-02 --1.718750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.282519225141801056e-01 1.282519225141801056e-01 1.282519225141801056e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.004052953995953068e-01 1.004052953995953068e-01 1.004052953995953068e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 9.262505979223056851e-02 9.262505979223056851e-02 9.262505979223056851e-02 --1.406250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 9.608214230257779154e-02 9.608214230257779154e-02 9.608214230257779154e-02 --1.406250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 7.927998683943518476e-02 7.927998683943518476e-02 7.927998683943518476e-02 --1.406250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.068180803188014255e-01 1.068180803188014255e-01 1.068180803188014255e-01 --1.718750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 3.271237797864098851e-02 3.271237797864098851e-02 3.271237797864098851e-02 --1.718750000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 6.429477199838058710e-02 6.429477199838058710e-02 6.429477199838058710e-02 --1.718750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 5.904280748388365807e-02 5.904280748388365807e-02 5.904280748388365807e-02 --1.718750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.402188091135808667e-01 1.402188091135808667e-01 1.402188091135808667e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 5.379371612089439703e-02 5.379371612089439703e-02 5.379371612089439703e-02 --1.406250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.029878265807056409e-01 1.029878265807056409e-01 1.029878265807056409e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 8.778312663925644244e-02 8.778312663925644244e-02 8.778312663925644244e-02 --1.406250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 6.637652243907232741e-02 6.637652243907232741e-02 6.637652243907232741e-02 --1.718750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 5.888740347377105500e-02 5.888740347377105500e-02 5.888740347377105500e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.193665686502198148e-01 1.193665686502198148e-01 1.193665686502198148e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 3.785203124289703014e-02 3.785203124289703014e-02 3.785203124289703014e-02 --1.406250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 9.597285512461974089e-02 9.597285512461974089e-02 9.597285512461974089e-02 --1.406250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 9.284926839273631438e-02 9.284926839273631438e-02 9.284926839273631438e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 4.546098776220845045e-02 4.546098776220845045e-02 4.546098776220845045e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 7.012218704446052109e-02 7.012218704446052109e-02 7.012218704446052109e-02 --1.093750000000000000e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 6.788940736609073989e-02 6.788940736609073989e-02 6.788940736609073989e-02 --1.093750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 6.979237041576188960e-02 6.979237041576188960e-02 6.979237041576188960e-02 --1.093750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 8.922890615679608672e-02 8.922890615679608672e-02 8.922890615679608672e-02 --7.812500000000000000e-02 -2.031250000000000000e-01 -2.343750000000000000e-01 8.445267185175014957e-02 8.445267185175014957e-02 8.445267185175014957e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 7.193048738331037084e-02 7.193048738331037084e-02 7.193048738331037084e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 6.915990325671668437e-02 6.915990325671668437e-02 6.915990325671668437e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 6.633118368447242508e-02 6.633118368447242508e-02 6.633118368447242508e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 5.283702591197809995e-02 5.283702591197809995e-02 5.283702591197809995e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 4.913654817687576615e-02 4.913654817687576615e-02 4.913654817687576615e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 8.241768326261676714e-02 8.241768326261676714e-02 8.241768326261676714e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 7.933351653723304253e-02 7.933351653723304253e-02 7.933351653723304253e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.030247881551868139e-01 1.030247881551868139e-01 1.030247881551868139e-01 --1.093750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 1.011445473921990523e-01 1.011445473921990523e-01 1.011445473921990523e-01 --7.812500000000000000e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 8.918229443759839725e-02 8.918229443759839725e-02 8.918229443759839725e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 5.949711929633722668e-02 5.949711929633722668e-02 5.949711929633722668e-02 --4.687500000000000000e-02 -2.031250000000000000e-01 -2.343750000000000000e-01 6.490131165997449492e-02 6.490131165997449492e-02 6.490131165997449492e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 2.175991530720240014e-02 2.175991530720240014e-02 2.175991530720240014e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 7.906417981366448133e-02 7.906417981366448133e-02 7.906417981366448133e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 1.052930714147581742e-01 1.052930714147581742e-01 1.052930714147581742e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 1.069225319257037649e-01 1.069225319257037649e-01 1.069225319257037649e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 1.442151391066229527e-01 1.442151391066229527e-01 1.442151391066229527e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 1.232771770864540400e-01 1.232771770864540400e-01 1.232771770864540400e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 7.928826545869634146e-02 7.928826545869634146e-02 7.928826545869634146e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 8.931087842508134145e-02 8.931087842508134145e-02 8.931087842508134145e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 1.014281933644791966e-01 1.014281933644791966e-01 1.014281933644791966e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 8.296179860214479562e-02 8.296179860214479562e-02 8.296179860214479562e-02 --1.093750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.254002975745994730e-01 1.254002975745994730e-01 1.254002975745994730e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 1.826455869908873431e-01 1.826455869908873431e-01 1.826455869908873431e-01 --1.093750000000000000e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 3.956198625607378061e-02 3.956198625607378061e-02 3.956198625607378061e-02 --7.812500000000000000e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 1.945169030723775394e-01 1.945169030723775394e-01 1.945169030723775394e-01 --7.812500000000000000e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 6.874937571248851409e-02 6.874937571248851409e-02 6.874937571248851409e-02 --7.812500000000000000e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 5.751657113541209371e-02 5.751657113541209371e-02 5.751657113541209371e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.672375545211921832e-01 1.672375545211921832e-01 1.672375545211921832e-01 --1.093750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.016483598037458830e-01 1.016483598037458830e-01 1.016483598037458830e-01 --1.093750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 8.275845903145467863e-02 8.275845903145467863e-02 8.275845903145467863e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 1.382117349046816934e-01 1.382117349046816934e-01 1.382117349046816934e-01 --7.812500000000000000e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 8.383542956649948918e-02 8.383542956649948918e-02 8.383542956649948918e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 6.976045779184224249e-02 6.976045779184224249e-02 6.976045779184224249e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 7.991189220180382191e-02 7.991189220180382191e-02 7.991189220180382191e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 6.601188236988121683e-02 6.601188236988121683e-02 6.601188236988121683e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.129957579583793503e-01 1.129957579583793503e-01 1.129957579583793503e-01 --7.812500000000000000e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 1.068903929841730355e-01 1.068903929841730355e-01 1.068903929841730355e-01 --7.812500000000000000e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 8.453384528954427379e-02 8.453384528954427379e-02 8.453384528954427379e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 5.813699002522543929e-02 5.813699002522543929e-02 5.813699002522543929e-02 --4.687500000000000000e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 1.601430713300768804e-01 1.601430713300768804e-01 1.601430713300768804e-01 --4.687500000000000000e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 2.151715465104367953e-01 2.151715465104367953e-01 2.151715465104367953e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 1.202020473889352653e-01 1.202020473889352653e-01 1.202020473889352653e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 1.532816388946176001e-01 1.532816388946176001e-01 1.532816388946176001e-01 --1.562500000000000000e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 1.447781109612737982e-01 1.447781109612737982e-01 1.447781109612737982e-01 --1.562500000000000000e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 1.269891872633502894e-01 1.269891872633502894e-01 1.269891872633502894e-01 --1.562500000000000000e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 1.958451935738765304e-01 1.958451935738765304e-01 1.958451935738765304e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 1.190203244377772418e-01 1.190203244377772418e-01 1.190203244377772418e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 5.635000665859785096e-02 5.635000665859785096e-02 5.635000665859785096e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 1.422025427444491841e-01 1.422025427444491841e-01 1.422025427444491841e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 1.028030184535373148e-01 1.028030184535373148e-01 1.028030184535373148e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 1.023064449481949495e-01 1.023064449481949495e-01 1.023064449481949495e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 1.502783234354453656e-01 1.502783234354453656e-01 1.502783234354453656e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 1.260011554031906233e-01 1.260011554031906233e-01 1.260011554031906233e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 1.942680969748925845e-01 1.942680969748925845e-01 1.942680969748925845e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 1.665085441194459059e-01 1.665085441194459059e-01 1.665085441194459059e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.121288709540860240e-01 1.121288709540860240e-01 1.121288709540860240e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 1.085768666018300938e-01 1.085768666018300938e-01 1.085768666018300938e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.129355019811906224e-01 1.129355019811906224e-01 1.129355019811906224e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.216151113939257372e-01 1.216151113939257372e-01 1.216151113939257372e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 7.351207379431823341e-02 7.351207379431823341e-02 7.351207379431823341e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 7.715564890889196892e-02 7.715564890889196892e-02 7.715564890889196892e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 1.060258506392814659e-01 1.060258506392814659e-01 1.060258506392814659e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 9.220958915685895096e-02 9.220958915685895096e-02 9.220958915685895096e-02 --1.093750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 9.999629328068707079e-02 9.999629328068707079e-02 9.999629328068707079e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 9.815053486842717501e-02 9.815053486842717501e-02 9.815053486842717501e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.002269096623312067e-01 1.002269096623312067e-01 1.002269096623312067e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 8.646108760842093066e-02 8.646108760842093066e-02 8.646108760842093066e-02 --7.812500000000000000e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 9.805250036841289818e-02 9.805250036841289818e-02 9.805250036841289818e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 9.405789467378132540e-02 9.405789467378132540e-02 9.405789467378132540e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 9.788053792408532572e-02 9.788053792408532572e-02 9.788053792408532572e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.343797626992576100e-01 1.343797626992576100e-01 1.343797626992576100e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.416949685933246994e-01 1.416949685933246994e-01 1.416949685933246994e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 7.747225356712897359e-02 7.747225356712897359e-02 7.747225356712897359e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 -2.031250000000000000e-01 1.335042707893638048e-01 1.335042707893638048e-01 1.335042707893638048e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 1.281916779619811930e-01 1.281916779619811930e-01 1.281916779619811930e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 9.241531569708698324e-02 9.241531569708698324e-02 9.241531569708698324e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.061680668864690008e-01 1.061680668864690008e-01 1.061680668864690008e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 9.352831930279255357e-02 9.352831930279255357e-02 9.352831930279255357e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.359058267380028051e-01 1.359058267380028051e-01 1.359058267380028051e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 1.198116228274387490e-01 1.198116228274387490e-01 1.198116228274387490e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 8.915416666293173031e-02 8.915416666293173031e-02 8.915416666293173031e-02 --7.812500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 1.591152989350712033e-01 1.591152989350712033e-01 1.591152989350712033e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 9.383047502498104153e-02 9.383047502498104153e-02 9.383047502498104153e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 1.455667467922605318e-01 1.455667467922605318e-01 1.455667467922605318e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 9.021658606526583579e-02 9.021658606526583579e-02 9.021658606526583579e-02 --4.687500000000000000e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 1.026029430894732780e-01 1.026029430894732780e-01 1.026029430894732780e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 8.706062897338096018e-02 8.706062897338096018e-02 8.706062897338096018e-02 --4.687500000000000000e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 8.172166034434760751e-02 8.172166034434760751e-02 8.172166034434760751e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 1.213291265944936442e-01 1.213291265944936442e-01 1.213291265944936442e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 9.856356415505143631e-02 9.856356415505143631e-02 9.856356415505143631e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 1.160181398719614398e-01 1.160181398719614398e-01 1.160181398719614398e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 -2.343750000000000000e-01 1.276173442992487306e-01 1.276173442992487306e-01 1.276173442992487306e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 1.019858400374229340e-01 1.019858400374229340e-01 1.019858400374229340e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 1.199168609101662619e-01 1.199168609101662619e-01 1.199168609101662619e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 8.342071724641166031e-02 8.342071724641166031e-02 8.342071724641166031e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 8.158261578340583742e-02 8.158261578340583742e-02 8.158261578340583742e-02 --1.562500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 7.080882507654127911e-02 7.080882507654127911e-02 7.080882507654127911e-02 --1.562500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 1.164037625706513118e-01 1.164037625706513118e-01 1.164037625706513118e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 6.000593583332024250e-02 6.000593583332024250e-02 6.000593583332024250e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 4.531223145356312598e-02 4.531223145356312598e-02 4.531223145356312598e-02 --7.812500000000000000e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 9.755027257263736151e-02 9.755027257263736151e-02 9.755027257263736151e-02 --7.812500000000000000e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 7.867869960391561668e-02 7.867869960391561668e-02 7.867869960391561668e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 6.719157062179725859e-02 6.719157062179725859e-02 6.719157062179725859e-02 --1.093750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.129756726376581061e-01 1.129756726376581061e-01 1.129756726376581061e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 7.025707144725787390e-02 7.025707144725787390e-02 7.025707144725787390e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.955996019372804595e-01 1.955996019372804595e-01 1.955996019372804595e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.970378272667113739e-01 1.970378272667113739e-01 1.970378272667113739e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 4.002412784776433058e-02 4.002412784776433058e-02 4.002412784776433058e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 5.338495938002821989e-02 5.338495938002821989e-02 5.338495938002821989e-02 --7.812500000000000000e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 5.995769929543171006e-02 5.995769929543171006e-02 5.995769929543171006e-02 --7.812500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 6.550053137614765542e-02 6.550053137614765542e-02 6.550053137614765542e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.067264841826647964e-01 1.067264841826647964e-01 1.067264841826647964e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 8.466886627195918669e-02 8.466886627195918669e-02 8.466886627195918669e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.078023304638697777e-01 1.078023304638697777e-01 1.078023304638697777e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 4.084419207704598209e-01 4.084419207704598209e-01 4.084419207704598209e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 9.652571814779960235e-02 9.652571814779960235e-02 9.652571814779960235e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 5.688183673817316655e-02 5.688183673817316655e-02 5.688183673817316655e-02 --7.812500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 6.548891305709614308e-01 6.548891305709614308e-01 6.548891305709614308e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 5.033997903916577199e-01 5.033997903916577199e-01 5.033997903916577199e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 1.216681309360475166e-01 1.216681309360475166e-01 1.216681309360475166e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 1.337243494686447820e-01 1.337243494686447820e-01 1.337243494686447820e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 9.589169322730171918e-02 9.589169322730171918e-02 9.589169322730171918e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 1.576836222240207974e-01 1.576836222240207974e-01 1.576836222240207974e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 1.662154929225323208e-01 1.662154929225323208e-01 1.662154929225323208e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.736658878339858714e-01 1.736658878339858714e-01 1.736658878339858714e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 9.594955122188361663e-02 9.594955122188361663e-02 9.594955122188361663e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.042155845777947565e-01 1.042155845777947565e-01 1.042155845777947565e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 1.968548402036187361e-01 1.968548402036187361e-01 1.968548402036187361e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 1.044341363929526811e-01 1.044341363929526811e-01 1.044341363929526811e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 1.643688443861410498e-01 1.643688443861410498e-01 1.643688443861410498e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 1.060137984033898556e-01 1.060137984033898556e-01 1.060137984033898556e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 1.011726709751941400e-01 1.011726709751941400e-01 1.011726709751941400e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 1.302520160372568347e-01 1.302520160372568347e-01 1.302520160372568347e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 9.808062503226731843e-02 9.808062503226731843e-02 9.808062503226731843e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 7.667041107022519453e-02 7.667041107022519453e-02 7.667041107022519453e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 8.450009000852137797e-02 8.450009000852137797e-02 8.450009000852137797e-02 --1.562500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 1.030794269733380786e-01 1.030794269733380786e-01 1.030794269733380786e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 2.066994346090798296e-01 2.066994346090798296e-01 2.066994346090798296e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 4.819467770014394109e-02 4.819467770014394109e-02 4.819467770014394109e-02 --4.218750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 8.820906771813567804e-02 8.820906771813567804e-02 8.820906771813567804e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 7.684595545970407393e-02 7.684595545970407393e-02 7.684595545970407393e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.041207714733472650e-01 1.041207714733472650e-01 1.041207714733472650e-01 --3.906250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 7.596742589946503532e-02 7.596742589946503532e-02 7.596742589946503532e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 9.063367426489229994e-02 9.063367426489229994e-02 9.063367426489229994e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 8.966689426828006182e-02 8.966689426828006182e-02 8.966689426828006182e-02 --3.281250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.084282269460539877e-01 1.084282269460539877e-01 1.084282269460539877e-01 --2.968750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.074423775216503535e-01 1.074423775216503535e-01 1.074423775216503535e-01 --2.968750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.262051889928277604e-01 1.262051889928277604e-01 1.262051889928277604e-01 --2.968750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 8.489148965889485587e-02 8.489148965889485587e-02 8.489148965889485587e-02 --2.656250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.102062606072120726e-01 1.102062606072120726e-01 1.102062606072120726e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.248002385534497383e-01 1.248002385534497383e-01 1.248002385534497383e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 1.284013288089936866e-01 1.284013288089936866e-01 1.284013288089936866e-01 --2.656250000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 8.017254568984560903e-02 8.017254568984560903e-02 8.017254568984560903e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 9.902560802323476241e-02 9.902560802323476241e-02 9.902560802323476241e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 5.109639783214761644e-02 5.109639783214761644e-02 5.109639783214761644e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.072278512299181114e-01 1.072278512299181114e-01 1.072278512299181114e-01 --3.281250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 5.807765770125177668e-02 5.807765770125177668e-02 5.807765770125177668e-02 --3.593750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 2.973142004495848978e-02 2.973142004495848978e-02 2.973142004495848978e-02 --3.593750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 2.911753777410009542e-02 2.911753777410009542e-02 2.911753777410009542e-02 --3.593750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 4.223789963145824222e-02 4.223789963145824222e-02 4.223789963145824222e-02 --3.593750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 4.343924538153426385e-02 4.343924538153426385e-02 4.343924538153426385e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 6.549578844179862469e-02 6.549578844179862469e-02 6.549578844179862469e-02 --3.281250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 6.534570256128512111e-02 6.534570256128512111e-02 6.534570256128512111e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 7.518260876322542530e-02 7.518260876322542530e-02 7.518260876322542530e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 7.557702775453965793e-02 7.557702775453965793e-02 7.557702775453965793e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 3.890555889609243617e-02 3.890555889609243617e-02 3.890555889609243617e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.068855721418476984e-01 1.068855721418476984e-01 1.068855721418476984e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 8.710161622257339697e-02 8.710161622257339697e-02 8.710161622257339697e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 7.452430171764140576e-02 7.452430171764140576e-02 7.452430171764140576e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.014956897091710414e-01 1.014956897091710414e-01 1.014956897091710414e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 5.099460743162023690e-02 5.099460743162023690e-02 5.099460743162023690e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 6.493290465422221769e-02 6.493290465422221769e-02 6.493290465422221769e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 7.018424354392772957e-02 7.018424354392772957e-02 7.018424354392772957e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 7.578038547633532407e-02 7.578038547633532407e-02 7.578038547633532407e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 8.919515284558911239e-02 8.919515284558911239e-02 8.919515284558911239e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 4.119076824177712176e-02 4.119076824177712176e-02 4.119076824177712176e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 8.507151678485044832e-02 8.507151678485044832e-02 8.507151678485044832e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 6.282338183420464739e-02 6.282338183420464739e-02 6.282338183420464739e-02 --2.968750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 7.156780166905715723e-02 7.156780166905715723e-02 7.156780166905715723e-02 --2.656250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 7.670216019834713572e-02 7.670216019834713572e-02 7.670216019834713572e-02 --2.656250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 8.185105997996976190e-02 8.185105997996976190e-02 8.185105997996976190e-02 --2.968750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.087881754776089394e-01 1.087881754776089394e-01 1.087881754776089394e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.017946014121316467e-01 1.017946014121316467e-01 1.017946014121316467e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.101990296416147375e-01 1.101990296416147375e-01 1.101990296416147375e-01 --2.656250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 9.494024468153812457e-02 9.494024468153812457e-02 9.494024468153812457e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.119995200070872388e-01 1.119995200070872388e-01 1.119995200070872388e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 8.425898044655945329e-02 8.425898044655945329e-02 8.425898044655945329e-02 --2.968750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 8.730574848602286331e-02 8.730574848602286331e-02 8.730574848602286331e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 5.866076873779828282e-02 5.866076873779828282e-02 5.866076873779828282e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 7.011012942891091393e-02 7.011012942891091393e-02 7.011012942891091393e-02 --2.656250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 6.044842432481877664e-02 6.044842432481877664e-02 6.044842432481877664e-02 --3.281250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 7.782864330643912698e-02 7.782864330643912698e-02 7.782864330643912698e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 8.374300355624660075e-02 8.374300355624660075e-02 8.374300355624660075e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 5.724137278366139142e-02 5.724137278366139142e-02 5.724137278366139142e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 7.103116528585816380e-02 7.103116528585816380e-02 7.103116528585816380e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 7.811872120490512272e-02 7.811872120490512272e-02 7.811872120490512272e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.149319593355663249e-01 1.149319593355663249e-01 1.149319593355663249e-01 --3.593750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 8.896289753445872639e-02 8.896289753445872639e-02 8.896289753445872639e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 5.416990877641067459e-02 5.416990877641067459e-02 5.416990877641067459e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 9.749241572917269338e-02 9.749241572917269338e-02 9.749241572917269338e-02 --3.281250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 9.707054165450600125e-02 9.707054165450600125e-02 9.707054165450600125e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.053147656324182890e-01 1.053147656324182890e-01 1.053147656324182890e-01 --3.281250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.405930719145914443e-01 1.405930719145914443e-01 1.405930719145914443e-01 --2.968750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 5.974368950684389584e-02 5.974368950684389584e-02 5.974368950684389584e-02 --2.968750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.126968878682736014e-01 1.126968878682736014e-01 1.126968878682736014e-01 --2.656250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 6.853289735248693781e-02 6.853289735248693781e-02 6.853289735248693781e-02 --2.656250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 9.839562059586945408e-02 9.839562059586945408e-02 9.839562059586945408e-02 --2.656250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.150050681011908771e-01 1.150050681011908771e-01 1.150050681011908771e-01 --2.656250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.214560525579198719e-01 1.214560525579198719e-01 1.214560525579198719e-01 --2.656250000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.463409194575113204e-01 1.463409194575113204e-01 1.463409194575113204e-01 --2.656250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.851725020248938813e-01 1.851725020248938813e-01 1.851725020248938813e-01 --2.968750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 7.082867977676128579e-02 7.082867977676128579e-02 7.082867977676128579e-02 --2.968750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 7.707012766028374651e-02 7.707012766028374651e-02 7.707012766028374651e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 7.743929909111035848e-02 7.743929909111035848e-02 7.743929909111035848e-02 --2.656250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.244837397568710896e-01 1.244837397568710896e-01 1.244837397568710896e-01 --2.968750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.661986324102319168e-01 1.661986324102319168e-01 1.661986324102319168e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.429365921026033437e-01 1.429365921026033437e-01 1.429365921026033437e-01 --2.656250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.786383213922761448e-01 1.786383213922761448e-01 1.786383213922761448e-01 --2.656250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.222852488078618238e-01 2.222852488078618238e-01 2.222852488078618238e-01 --2.656250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.987312404276936340e-01 1.987312404276936340e-01 1.987312404276936340e-01 --2.656250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.432616325294640336e-01 2.432616325294640336e-01 2.432616325294640336e-01 --3.906250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 9.265720443282148000e-02 9.265720443282148000e-02 9.265720443282148000e-02 --3.906250000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 4.698761363754212078e-02 4.698761363754212078e-02 4.698761363754212078e-02 --3.906250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.257087599081035401e-01 1.257087599081035401e-01 1.257087599081035401e-01 --3.906250000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 9.384976152190149801e-02 9.384976152190149801e-02 9.384976152190149801e-02 --3.593750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 1.072583830966234719e-01 1.072583830966234719e-01 1.072583830966234719e-01 --3.593750000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 7.016197716296738995e-02 7.016197716296738995e-02 7.016197716296738995e-02 --3.593750000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.043120045694293924e-01 1.043120045694293924e-01 1.043120045694293924e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 1.039038258140132093e-01 1.039038258140132093e-01 1.039038258140132093e-01 --3.281250000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 6.819310634202695176e-02 6.819310634202695176e-02 6.819310634202695176e-02 --3.281250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.493933679238849677e-01 1.493933679238849677e-01 1.493933679238849677e-01 --3.281250000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.040717578755346456e-01 1.040717578755346456e-01 1.040717578755346456e-01 --2.656250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.842831140437032333e-01 1.842831140437032333e-01 1.842831140437032333e-01 --2.968750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.239559712279641457e-01 1.239559712279641457e-01 1.239559712279641457e-01 --2.656250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.257086844071360676e-01 2.257086844071360676e-01 2.257086844071360676e-01 --2.656250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 2.098683560505516799e-01 2.098683560505516799e-01 2.098683560505516799e-01 --1.718750000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 1.232386181940908348e-01 1.232386181940908348e-01 1.232386181940908348e-01 --1.718750000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 1.207908940183945318e-01 1.207908940183945318e-01 1.207908940183945318e-01 --1.718750000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 1.149681120301609544e-01 1.149681120301609544e-01 1.149681120301609544e-01 --1.718750000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 1.596484575038385478e-01 1.596484575038385478e-01 1.596484575038385478e-01 --1.406250000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 2.299197837475080164e-01 2.299197837475080164e-01 2.299197837475080164e-01 --1.406250000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 1.859647554214578502e-01 1.859647554214578502e-01 1.859647554214578502e-01 --1.406250000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 2.553814483994333306e-01 2.553814483994333306e-01 2.553814483994333306e-01 --1.718750000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 1.162720083564660195e-01 1.162720083564660195e-01 1.162720083564660195e-01 --1.406250000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 1.866887734861001069e-01 1.866887734861001069e-01 1.866887734861001069e-01 --1.093750000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 1.840142087021309492e-01 1.840142087021309492e-01 1.840142087021309492e-01 --1.093750000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 1.819704987337768809e-01 1.819704987337768809e-01 1.819704987337768809e-01 --1.093750000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 2.349665548987436292e-01 2.349665548987436292e-01 2.349665548987436292e-01 --1.093750000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 2.822581307858592070e-01 2.822581307858592070e-01 2.822581307858592070e-01 --7.812500000000000000e-02 -2.656250000000000000e-01 1.562500000000000000e-02 2.593728642064948575e-01 2.593728642064948575e-01 2.593728642064948575e-01 --7.812500000000000000e-02 -2.656250000000000000e-01 4.687500000000000000e-02 2.427891866144631094e-01 2.427891866144631094e-01 2.427891866144631094e-01 --1.093750000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 1.877627483706535150e-01 1.877627483706535150e-01 1.877627483706535150e-01 --4.687500000000000000e-02 -2.968750000000000000e-01 1.562500000000000000e-02 1.761834515315428007e-01 1.761834515315428007e-01 1.761834515315428007e-01 --4.687500000000000000e-02 -2.656250000000000000e-01 1.562500000000000000e-02 2.864606595797801192e-01 2.864606595797801192e-01 2.864606595797801192e-01 --4.687500000000000000e-02 -2.656250000000000000e-01 4.687500000000000000e-02 2.221328074628598492e-01 2.221328074628598492e-01 2.221328074628598492e-01 --1.562500000000000000e-02 -2.968750000000000000e-01 1.562500000000000000e-02 2.058391740746848275e-01 2.058391740746848275e-01 2.058391740746848275e-01 --1.562500000000000000e-02 -2.656250000000000000e-01 1.562500000000000000e-02 3.001923068477755918e-01 3.001923068477755918e-01 3.001923068477755918e-01 --1.562500000000000000e-02 -2.656250000000000000e-01 4.687500000000000000e-02 2.398100664666348858e-01 2.398100664666348858e-01 2.398100664666348858e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.378527211536361430e-01 1.378527211536361430e-01 1.378527211536361430e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 1.363090240865979241e-01 1.363090240865979241e-01 1.363090240865979241e-01 --2.031250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.467087291715024611e-01 1.467087291715024611e-01 1.467087291715024611e-01 --2.031250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 1.181044972959335443e-01 1.181044972959335443e-01 1.181044972959335443e-01 --2.343750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 1.130399456463086622e-01 1.130399456463086622e-01 1.130399456463086622e-01 --1.718750000000000000e-01 -2.343750000000000000e-01 1.562500000000000000e-02 1.565249330753153700e-01 1.565249330753153700e-01 1.565249330753153700e-01 --1.718750000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.423149796231597264e-01 1.423149796231597264e-01 1.423149796231597264e-01 --1.718750000000000000e-01 -2.031250000000000000e-01 1.562500000000000000e-02 1.030890023662981748e-02 1.030890023662981748e-02 1.030890023662981748e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 8.772445910641929467e-02 8.772445910641929467e-02 8.772445910641929467e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.844043218291688269e-01 1.844043218291688269e-01 1.844043218291688269e-01 --1.406250000000000000e-01 -2.031250000000000000e-01 1.562500000000000000e-02 5.949647613862167617e-02 5.949647613862167617e-02 5.949647613862167617e-02 --1.406250000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 7.133806771789709400e-02 7.133806771789709400e-02 7.133806771789709400e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 7.812500000000000000e-02 1.843088004770691291e-01 1.843088004770691291e-01 1.843088004770691291e-01 --1.406250000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 1.350954100186362583e-01 1.350954100186362583e-01 1.350954100186362583e-01 --1.406250000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.282896757439069557e-01 1.282896757439069557e-01 1.282896757439069557e-01 --1.718750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 6.588591395484454105e-02 6.588591395484454105e-02 6.588591395484454105e-02 --1.718750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 7.858064137430724461e-02 7.858064137430724461e-02 7.858064137430724461e-02 --1.718750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 9.869052603887050468e-02 9.869052603887050468e-02 9.869052603887050468e-02 --1.718750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 9.802357213246379319e-02 9.802357213246379319e-02 9.802357213246379319e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 7.120527508586187160e-02 7.120527508586187160e-02 7.120527508586187160e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 7.592442352008685336e-02 7.592442352008685336e-02 7.592442352008685336e-02 --1.406250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 9.043115772125615015e-02 9.043115772125615015e-02 9.043115772125615015e-02 --1.718750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 8.333793526766572479e-02 8.333793526766572479e-02 8.333793526766572479e-02 --1.718750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 1.014812262115027397e-01 1.014812262115027397e-01 1.014812262115027397e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 7.772825312236548989e-02 7.772825312236548989e-02 7.772825312236548989e-02 --1.406250000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.223759961049294617e-02 1.223759961049294617e-02 1.223759961049294617e-02 --1.406250000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 4.158294153116763592e-02 4.158294153116763592e-02 4.158294153116763592e-02 --1.718750000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 9.766839683217350132e-02 9.766839683217350132e-02 9.766839683217350132e-02 --1.406250000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 1.445877771230932307e-01 1.445877771230932307e-01 1.445877771230932307e-01 --1.406250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 6.290176340169868763e-02 6.290176340169868763e-02 6.290176340169868763e-02 --1.406250000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 1.792604560427202842e-01 1.792604560427202842e-01 1.792604560427202842e-01 --1.406250000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.008825958327186079e-01 1.008825958327186079e-01 1.008825958327186079e-01 --1.718750000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 1.077822438465717014e-01 1.077822438465717014e-01 1.077822438465717014e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 1.508982683224366905e-01 1.508982683224366905e-01 1.508982683224366905e-01 --1.406250000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.459345600455019820e-01 1.459345600455019820e-01 1.459345600455019820e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.208382907629564906e-01 1.208382907629564906e-01 1.208382907629564906e-01 --1.406250000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 1.311162980938964662e-01 1.311162980938964662e-01 1.311162980938964662e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.077251978261154902e-01 1.077251978261154902e-01 1.077251978261154902e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 9.582097784407171692e-02 9.582097784407171692e-02 9.582097784407171692e-02 --2.031250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.387908118743207964e-01 1.387908118743207964e-01 1.387908118743207964e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 1.193480916185031548e-01 1.193480916185031548e-01 1.193480916185031548e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.277490799352938300e-01 1.277490799352938300e-01 1.277490799352938300e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 1.621391605167232242e-01 1.621391605167232242e-01 1.621391605167232242e-01 --2.343750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 9.218387330233762667e-02 9.218387330233762667e-02 9.218387330233762667e-02 --2.343750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 7.097730853087409753e-02 7.097730853087409753e-02 7.097730853087409753e-02 --2.343750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 7.356432123937117762e-02 7.356432123937117762e-02 7.356432123937117762e-02 --2.343750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 7.667338503971624086e-02 7.667338503971624086e-02 7.667338503971624086e-02 --2.031250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 1.244909694387183186e-01 1.244909694387183186e-01 1.244909694387183186e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 1.545825054455957359e-01 1.545825054455957359e-01 1.545825054455957359e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.146563949295568291e-01 1.146563949295568291e-01 1.146563949295568291e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.066541713699708516e-01 1.066541713699708516e-01 1.066541713699708516e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.261304838409108842e-01 1.261304838409108842e-01 1.261304838409108842e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 9.903766130601990292e-02 9.903766130601990292e-02 9.903766130601990292e-02 --2.031250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.587178365586964790e-01 1.587178365586964790e-01 1.587178365586964790e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.874505105138936090e-01 1.874505105138936090e-01 1.874505105138936090e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.284792448849302327e-01 1.284792448849302327e-01 1.284792448849302327e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.298536077992342164e-01 1.298536077992342164e-01 1.298536077992342164e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.000212030959075488e-01 1.000212030959075488e-01 1.000212030959075488e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 8.742308411955072855e-02 8.742308411955072855e-02 8.742308411955072855e-02 --2.343750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.282928887839148435e-01 1.282928887839148435e-01 1.282928887839148435e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.390622778675994486e-01 1.390622778675994486e-01 1.390622778675994486e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.532495184667747035e-01 1.532495184667747035e-01 1.532495184667747035e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.701856437528347921e-01 1.701856437528347921e-01 1.701856437528347921e-01 --1.718750000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 8.304377725603624694e-02 8.304377725603624694e-02 8.304377725603624694e-02 --1.718750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 7.405841963050169285e-02 7.405841963050169285e-02 7.405841963050169285e-02 --1.718750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 9.053000514553102840e-02 9.053000514553102840e-02 9.053000514553102840e-02 --1.718750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 6.426526889226126527e-02 6.426526889226126527e-02 6.426526889226126527e-02 --1.406250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.361146543022696553e-01 1.361146543022696553e-01 1.361146543022696553e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 4.733336392081867461e-02 4.733336392081867461e-02 4.733336392081867461e-02 --1.406250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.166945851333208856e-01 1.166945851333208856e-01 1.166945851333208856e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 6.621397806211881676e-02 6.621397806211881676e-02 6.621397806211881676e-02 --1.718750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 8.857553597374502596e-02 8.857553597374502596e-02 8.857553597374502596e-02 --1.406250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.983050815145534218e-01 1.983050815145534218e-01 1.983050815145534218e-01 --1.406250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.496535554910580212e-01 1.496535554910580212e-01 1.496535554910580212e-01 --1.406250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 9.849767246547644350e-02 9.849767246547644350e-02 9.849767246547644350e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.807393422912629069e-02 1.807393422912629069e-02 1.807393422912629069e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 7.075930887975635797e-02 7.075930887975635797e-02 7.075930887975635797e-02 --1.718750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.170665472656140793e-01 1.170665472656140793e-01 1.170665472656140793e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.303692890540614213e-01 1.303692890540614213e-01 1.303692890540614213e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.203169250370163951e-01 1.203169250370163951e-01 1.203169250370163951e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 3.685349527609525083e-02 3.685349527609525083e-02 3.685349527609525083e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 3.024830641059371786e-02 3.024830641059371786e-02 3.024830641059371786e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 8.096776267659526460e-02 8.096776267659526460e-02 8.096776267659526460e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 4.726566130790749859e-02 4.726566130790749859e-02 4.726566130790749859e-02 --1.718750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 1.315877937775941919e-01 1.315877937775941919e-01 1.315877937775941919e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.332175250376247677e-01 1.332175250376247677e-01 1.332175250376247677e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.589370433242632830e-01 1.589370433242632830e-01 1.589370433242632830e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 5.242770149803673702e-02 5.242770149803673702e-02 5.242770149803673702e-02 --1.406250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 6.375575577780613623e-02 6.375575577780613623e-02 6.375575577780613623e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 6.012130143583760411e-02 6.012130143583760411e-02 6.012130143583760411e-02 --1.406250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.640933857520574510e-02 2.640933857520574510e-02 2.640933857520574510e-02 --2.343750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 8.040554974275532230e-02 8.040554974275532230e-02 8.040554974275532230e-02 --2.343750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.315371904549842430e-01 1.315371904549842430e-01 1.315371904549842430e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.258059574296020999e-01 1.258059574296020999e-01 1.258059574296020999e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.159964485402407569e-01 1.159964485402407569e-01 1.159964485402407569e-01 --2.343750000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 9.358296457063712548e-02 9.358296457063712548e-02 9.358296457063712548e-02 --2.343750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.403810434170563171e-01 1.403810434170563171e-01 1.403810434170563171e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.473752796085687489e-01 1.473752796085687489e-01 1.473752796085687489e-01 --2.031250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.197827024141777663e-01 1.197827024141777663e-01 1.197827024141777663e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.535916003643379157e-01 1.535916003643379157e-01 1.535916003643379157e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 2.081109802395116892e-01 2.081109802395116892e-01 2.081109802395116892e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.438135875878990000e-01 1.438135875878990000e-01 1.438135875878990000e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.552538085983747873e-01 1.552538085983747873e-01 1.552538085983747873e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 1.877796043644411050e-01 1.877796043644411050e-01 1.877796043644411050e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.694895768706636552e-01 1.694895768706636552e-01 1.694895768706636552e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.799773097456465742e-01 1.799773097456465742e-01 1.799773097456465742e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.617473335612093499e-01 1.617473335612093499e-01 1.617473335612093499e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 2.258619212633081741e-01 2.258619212633081741e-01 2.258619212633081741e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.917486912453030823e-01 1.917486912453030823e-01 1.917486912453030823e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.984984985515079181e-01 1.984984985515079181e-01 1.984984985515079181e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.175305474994292387e-01 2.175305474994292387e-01 2.175305474994292387e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.902140543793321148e-01 1.902140543793321148e-01 1.902140543793321148e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.360471051899272477e-01 2.360471051899272477e-01 2.360471051899272477e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 2.275996549278587466e-01 2.275996549278587466e-01 2.275996549278587466e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.349320604781925670e-01 2.349320604781925670e-01 2.349320604781925670e-01 --1.718750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.506846609085648603e-01 1.506846609085648603e-01 1.506846609085648603e-01 --1.718750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.379274154217350057e-01 1.379274154217350057e-01 1.379274154217350057e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 2.053095314841486552e-01 2.053095314841486552e-01 2.053095314841486552e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.407143455388583375e-01 1.407143455388583375e-01 1.407143455388583375e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.757989180412741215e-01 1.757989180412741215e-01 1.757989180412741215e-01 --1.718750000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.644619807185899452e-01 1.644619807185899452e-01 1.644619807185899452e-01 --1.718750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.900639601854856031e-01 1.900639601854856031e-01 1.900639601854856031e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.888110239312424388e-01 1.888110239312424388e-01 1.888110239312424388e-01 --1.406250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.815587001425995883e-01 1.815587001425995883e-01 1.815587001425995883e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 2.126231058152432685e-01 2.126231058152432685e-01 2.126231058152432685e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.198638042459631070e-01 2.198638042459631070e-01 2.198638042459631070e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 1.562500000000000000e-02 1.038973977855574132e-01 1.038973977855574132e-01 1.038973977855574132e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.926717066431499481e-01 1.926717066431499481e-01 1.926717066431499481e-01 --1.093750000000000000e-01 -2.031250000000000000e-01 1.562500000000000000e-02 5.758201401710853762e-02 5.758201401710853762e-02 5.758201401710853762e-02 --1.093750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 6.691897775562397066e-02 6.691897775562397066e-02 6.691897775562397066e-02 --7.812500000000000000e-02 -2.343750000000000000e-01 1.562500000000000000e-02 1.753260758020481758e-01 1.753260758020481758e-01 1.753260758020481758e-01 --7.812500000000000000e-02 -2.343750000000000000e-01 4.687500000000000000e-02 2.147936184951978189e-01 2.147936184951978189e-01 2.147936184951978189e-01 --7.812500000000000000e-02 -2.031250000000000000e-01 1.562500000000000000e-02 8.064305404183733095e-02 8.064305404183733095e-02 8.064305404183733095e-02 --7.812500000000000000e-02 -2.031250000000000000e-01 4.687500000000000000e-02 1.095217263168734995e-01 1.095217263168734995e-01 1.095217263168734995e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 7.812500000000000000e-02 2.004286306467830403e-01 2.004286306467830403e-01 2.004286306467830403e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 1.586519941168774983e-01 1.586519941168774983e-01 1.586519941168774983e-01 --1.093750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.012152580964229692e-01 1.012152580964229692e-01 1.012152580964229692e-01 --1.093750000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.474700417524685836e-01 1.474700417524685836e-01 1.474700417524685836e-01 --7.812500000000000000e-02 -2.343750000000000000e-01 1.093750000000000000e-01 1.588744128807497435e-01 1.588744128807497435e-01 1.588744128807497435e-01 --7.812500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 1.895534773021680663e-01 1.895534773021680663e-01 1.895534773021680663e-01 --1.093750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 5.882702656322091883e-02 5.882702656322091883e-02 5.882702656322091883e-02 --1.093750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 5.904980186319765123e-02 5.904980186319765123e-02 5.904980186319765123e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 3.633584716597451636e-02 3.633584716597451636e-02 3.633584716597451636e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 7.812500000000000000e-02 3.718400988201266133e-02 3.718400988201266133e-02 3.718400988201266133e-02 --7.812500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 7.863955670199809789e-02 7.863955670199809789e-02 7.863955670199809789e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 1.137059716755971228e-01 1.137059716755971228e-01 1.137059716755971228e-01 --7.812500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 7.576366675813377138e-02 7.576366675813377138e-02 7.576366675813377138e-02 --4.687500000000000000e-02 -2.343750000000000000e-01 1.562500000000000000e-02 2.309017268313101612e-01 2.309017268313101612e-01 2.309017268313101612e-01 --4.687500000000000000e-02 -2.343750000000000000e-01 4.687500000000000000e-02 1.980562871318240492e-01 1.980562871318240492e-01 1.980562871318240492e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 1.562500000000000000e-02 1.014000698708044379e-01 1.014000698708044379e-01 1.014000698708044379e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 4.687500000000000000e-02 1.005298437654635613e-01 1.005298437654635613e-01 1.005298437654635613e-01 --1.562500000000000000e-02 -2.343750000000000000e-01 1.562500000000000000e-02 2.508564815709274365e-01 2.508564815709274365e-01 2.508564815709274365e-01 --1.562500000000000000e-02 -2.343750000000000000e-01 4.687500000000000000e-02 2.219587030470918376e-01 2.219587030470918376e-01 2.219587030470918376e-01 --1.562500000000000000e-02 -2.031250000000000000e-01 1.562500000000000000e-02 1.720233277257930404e-01 1.720233277257930404e-01 1.720233277257930404e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 1.953933364868050415e-01 1.953933364868050415e-01 1.953933364868050415e-01 --1.562500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 1.884096949320406555e-01 1.884096949320406555e-01 1.884096949320406555e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 1.562500000000000000e-02 9.913971236125393438e-02 9.913971236125393438e-02 9.913971236125393438e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 4.687500000000000000e-02 1.452133874979951167e-01 1.452133874979951167e-01 1.452133874979951167e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 1.240154156492992016e-01 1.240154156492992016e-01 1.240154156492992016e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 4.687500000000000000e-02 1.325114996290324698e-01 1.325114996290324698e-01 1.325114996290324698e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 1.562500000000000000e-02 1.055566155886081686e-01 1.055566155886081686e-01 1.055566155886081686e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 4.687500000000000000e-02 1.271723332995030042e-01 1.271723332995030042e-01 1.271723332995030042e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 1.320994478072708422e-01 1.320994478072708422e-01 1.320994478072708422e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 4.687500000000000000e-02 1.438416962594527004e-01 1.438416962594527004e-01 1.438416962594527004e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 7.812500000000000000e-02 7.424715203642572037e-02 7.424715203642572037e-02 7.424715203642572037e-02 --4.687500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 1.283507234821505139e-01 1.283507234821505139e-01 1.283507234821505139e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 9.447657015532522073e-02 9.447657015532522073e-02 9.447657015532522073e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 1.060081740260201827e-01 1.060081740260201827e-01 1.060081740260201827e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 7.812500000000000000e-02 1.163635936257879366e-01 1.163635936257879366e-01 1.163635936257879366e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 1.664443138114601040e-01 1.664443138114601040e-01 1.664443138114601040e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 1.622547812209498563e-01 1.622547812209498563e-01 1.622547812209498563e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 1.619231741727724661e-01 1.619231741727724661e-01 1.619231741727724661e-01 --1.093750000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 8.065912875755083811e-02 8.065912875755083811e-02 8.065912875755083811e-02 --1.093750000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.453169861791557826e-01 1.453169861791557826e-01 1.453169861791557826e-01 --7.812500000000000000e-02 -2.343750000000000000e-01 1.406250000000000000e-01 1.646370124999317064e-01 1.646370124999317064e-01 1.646370124999317064e-01 --7.812500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 2.204503172214851148e-01 2.204503172214851148e-01 2.204503172214851148e-01 --7.812500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 1.705372877081719474e-01 1.705372877081719474e-01 1.705372877081719474e-01 --1.093750000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.710414685972379834e-01 1.710414685972379834e-01 1.710414685972379834e-01 --1.093750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.048037447293061891e-01 1.048037447293061891e-01 1.048037447293061891e-01 --1.093750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 1.693940378089887899e-01 1.693940378089887899e-01 1.693940378089887899e-01 --7.812500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 2.137649391938799270e-01 2.137649391938799270e-01 2.137649391938799270e-01 --7.812500000000000000e-02 -1.406250000000000000e-01 1.406250000000000000e-01 1.339026609497993570e-01 1.339026609497993570e-01 1.339026609497993570e-01 --7.812500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 1.899058392612802404e-01 1.899058392612802404e-01 1.899058392612802404e-01 --1.093750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 6.159209787653286555e-02 6.159209787653286555e-02 6.159209787653286555e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 2.031250000000000000e-01 1.223043627162193059e-01 1.223043627162193059e-01 1.223043627162193059e-01 --7.812500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 1.030368408388656620e-01 1.030368408388656620e-01 1.030368408388656620e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 2.166479361800545400e-01 2.166479361800545400e-01 2.166479361800545400e-01 --4.687500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 1.891176379376188765e-01 1.891176379376188765e-01 1.891176379376188765e-01 --1.562500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 2.133773756403534450e-01 2.133773756403534450e-01 2.133773756403534450e-01 --1.562500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 1.860819472574730404e-01 1.860819472574730404e-01 1.860819472574730404e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 2.364738664148741953e-01 2.364738664148741953e-01 2.364738664148741953e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 2.363062104893185744e-01 2.363062104893185744e-01 2.363062104893185744e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 1.463722395641600393e-01 1.463722395641600393e-01 1.463722395641600393e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 1.406250000000000000e-01 1.734691998523418544e-01 1.734691998523418544e-01 1.734691998523418544e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 2.107101174425083656e-01 2.107101174425083656e-01 2.107101174425083656e-01 --4.687500000000000000e-02 -1.718750000000000000e-01 2.031250000000000000e-01 1.412998295373860402e-01 1.412998295373860402e-01 1.412998295373860402e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 2.031250000000000000e-01 1.456599048931296603e-01 1.456599048931296603e-01 1.456599048931296603e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 9.394539033422853735e-02 9.394539033422853735e-02 9.394539033422853735e-02 --1.562500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 6.998778472092141711e-02 6.998778472092141711e-02 6.998778472092141711e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 2.623207870027364219e-01 2.623207870027364219e-01 2.623207870027364219e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 4.687500000000000000e-02 2.267147472301210553e-01 2.267147472301210553e-01 2.267147472301210553e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.256131688426684323e-01 1.256131688426684323e-01 1.256131688426684323e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 1.082321828720061579e-01 1.082321828720061579e-01 1.082321828720061579e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 7.812500000000000000e-02 2.141765729733243750e-01 2.141765729733243750e-01 2.141765729733243750e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 1.093750000000000000e-01 1.033253011957958600e-01 1.033253011957958600e-01 1.033253011957958600e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 1.423711980036078129e-01 1.423711980036078129e-01 1.423711980036078129e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 1.093750000000000000e-01 1.536927792384056857e-01 1.536927792384056857e-01 1.536927792384056857e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 4.203327920021653896e-01 4.203327920021653896e-01 4.203327920021653896e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 2.505637374476152313e-01 2.505637374476152313e-01 2.505637374476152313e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 7.135824381895190804e-02 7.135824381895190804e-02 7.135824381895190804e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 7.534200024524038974e-02 7.534200024524038974e-02 7.534200024524038974e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 7.812500000000000000e-02 2.436201762194107612e-01 2.436201762194107612e-01 2.436201762194107612e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 1.093750000000000000e-01 1.382269949615096971e-01 1.382269949615096971e-01 1.382269949615096971e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 1.093750000000000000e-01 1.789690567989513370e-01 1.789690567989513370e-01 1.789690567989513370e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 1.562500000000000000e-02 2.214636667740378373e-01 2.214636667740378373e-01 2.214636667740378373e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 4.687500000000000000e-02 2.068647448148500101e-01 2.068647448148500101e-01 2.068647448148500101e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 1.562500000000000000e-02 4.324283654619223705e-01 4.324283654619223705e-01 4.324283654619223705e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 4.687500000000000000e-02 4.940112363767009129e-01 4.940112363767009129e-01 4.940112363767009129e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 1.562500000000000000e-02 1.537353385680636508e-01 1.537353385680636508e-01 1.537353385680636508e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 4.687500000000000000e-02 6.482277126171351322e-02 6.482277126171351322e-02 6.482277126171351322e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 1.562500000000000000e-02 2.512915934773458926e-02 2.512915934773458926e-02 2.512915934773458926e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 -1.093750000000000000e-01 7.812500000000000000e-02 3.391796536155749497e-01 3.391796536155749497e-01 3.391796536155749497e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 1.093750000000000000e-01 9.288623462527945129e-02 9.288623462527945129e-02 9.288623462527945129e-02 --4.687500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 4.289016780405558449e-01 4.289016780405558449e-01 4.289016780405558449e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 7.812500000000000000e-02 2.166375052611079488e-01 2.166375052611079488e-01 2.166375052611079488e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 1.093750000000000000e-01 1.345219288350521514e-01 1.345219288350521514e-01 1.345219288350521514e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 1.858090344985316722e-01 1.858090344985316722e-01 1.858090344985316722e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 1.093750000000000000e-01 1.326327854357606528e-01 1.326327854357606528e-01 1.326327854357606528e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 1.562500000000000000e-02 2.240992786438452400e-01 2.240992786438452400e-01 2.240992786438452400e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 4.687500000000000000e-02 4.638312325610007836e-01 4.638312325610007836e-01 4.638312325610007836e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 4.687500000000000000e-02 5.597081186823158472e-01 5.597081186823158472e-01 5.597081186823158472e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 7.812500000000000000e-02 5.162790848361614726e-01 5.162790848361614726e-01 5.162790848361614726e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 1.093750000000000000e-01 1.521437649189413821e-01 1.521437649189413821e-01 1.521437649189413821e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 7.812500000000000000e-02 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 --4.687500000000000000e-02 -1.562500000000000000e-02 1.093750000000000000e-01 6.895213116879813642e-01 6.895213116879813642e-01 6.895213116879813642e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 7.812500000000000000e-02 2.764293843016007446e-01 2.764293843016007446e-01 2.764293843016007446e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 1.093750000000000000e-01 1.277057035911436655e-01 1.277057035911436655e-01 1.277057035911436655e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 7.812500000000000000e-02 3.831103308559191123e-01 3.831103308559191123e-01 3.831103308559191123e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 1.093750000000000000e-01 1.624274090464769837e-01 1.624274090464769837e-01 1.624274090464769837e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.059294327015779386e-01 1.059294327015779386e-01 1.059294327015779386e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 9.007755618489356186e-02 9.007755618489356186e-02 9.007755618489356186e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 9.567713613410742945e-02 9.567713613410742945e-02 9.567713613410742945e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 1.231357943907698954e-01 1.231357943907698954e-01 1.231357943907698954e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 1.122678627336592405e-01 1.122678627336592405e-01 1.122678627336592405e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 8.436506874284195601e-02 8.436506874284195601e-02 8.436506874284195601e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.408982634679010471e-01 1.408982634679010471e-01 1.408982634679010471e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.163145874858752260e-01 1.163145874858752260e-01 1.163145874858752260e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 1.261939430604137047e-01 1.261939430604137047e-01 1.261939430604137047e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 3.476618592784893602e-01 3.476618592784893602e-01 3.476618592784893602e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 8.930364558124764818e-02 8.930364558124764818e-02 8.930364558124764818e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.828711502946069045e-01 1.828711502946069045e-01 1.828711502946069045e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 9.575026239868625333e-02 9.575026239868625333e-02 9.575026239868625333e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.968315655034762190e-01 1.968315655034762190e-01 1.968315655034762190e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 1.406250000000000000e-01 1.185736591691737424e-01 1.185736591691737424e-01 1.185736591691737424e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 1.515463144123043449e-01 1.515463144123043449e-01 1.515463144123043449e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 1.406250000000000000e-01 1.269417941422343599e-01 1.269417941422343599e-01 1.269417941422343599e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.894796335980620805e-01 1.894796335980620805e-01 1.894796335980620805e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.798544897997977343e-01 1.798544897997977343e-01 1.798544897997977343e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 2.295667947431552780e-01 2.295667947431552780e-01 2.295667947431552780e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.094912055727838895e-01 2.094912055727838895e-01 2.094912055727838895e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 1.387884024087556734e-01 1.387884024087556734e-01 1.387884024087556734e-01 --7.812500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 1.633202503064335731e-01 1.633202503064335731e-01 1.633202503064335731e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 1.406250000000000000e-01 1.512114510993957939e-01 1.512114510993957939e-01 1.512114510993957939e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 1.678613830672609775e-01 1.678613830672609775e-01 1.678613830672609775e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 1.101034201466358914e-01 1.101034201466358914e-01 1.101034201466358914e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 1.354544360739182440e-01 1.354544360739182440e-01 1.354544360739182440e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 1.406250000000000000e-01 1.614221478560510237e-01 1.614221478560510237e-01 1.614221478560510237e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 1.736859580091610067e-01 1.736859580091610067e-01 1.736859580091610067e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 1.683479178037144697e-01 1.683479178037144697e-01 1.683479178037144697e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 1.468589042699742775e-01 1.468589042699742775e-01 1.468589042699742775e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 1.268486143650675857e-01 1.268486143650675857e-01 1.268486143650675857e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 1.062926063315151326e-01 1.062926063315151326e-01 1.062926063315151326e-01 --4.687500000000000000e-02 -7.812500000000000000e-02 2.343750000000000000e-01 8.682836750021225014e-02 8.682836750021225014e-02 8.682836750021225014e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 1.112828637874404558e-01 1.112828637874404558e-01 1.112828637874404558e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 2.343750000000000000e-01 8.737406034827806256e-02 8.737406034827806256e-02 8.737406034827806256e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 1.616991579841121907e-01 1.616991579841121907e-01 1.616991579841121907e-01 --1.562500000000000000e-02 -7.812500000000000000e-02 2.343750000000000000e-01 1.513391329586483425e-01 1.513391329586483425e-01 1.513391329586483425e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 1.406250000000000000e-01 1.408364221150819606e-01 1.408364221150819606e-01 1.408364221150819606e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 1.380334329735286858e-01 1.380334329735286858e-01 1.380334329735286858e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 1.406250000000000000e-01 1.220673830325646886e-01 1.220673830325646886e-01 1.220673830325646886e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 1.459337569616327990e-01 1.459337569616327990e-01 1.459337569616327990e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 1.494351264790040879e-01 1.494351264790040879e-01 1.494351264790040879e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 1.406250000000000000e-01 1.823525945667257286e-01 1.823525945667257286e-01 1.823525945667257286e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 1.643624211868291995e-01 1.643624211868291995e-01 1.643624211868291995e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 1.450399196401430391e-01 1.450399196401430391e-01 1.450399196401430391e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 1.094919987568155478e-01 1.094919987568155478e-01 1.094919987568155478e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 2.031250000000000000e-01 1.564679216053765920e-01 1.564679216053765920e-01 1.564679216053765920e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 1.285202110388976304e-01 1.285202110388976304e-01 1.285202110388976304e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 1.651765576133034930e-01 1.651765576133034930e-01 1.651765576133034930e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 1.671877764880251027e-01 1.671877764880251027e-01 1.671877764880251027e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 2.031250000000000000e-01 1.248669119990394732e-01 1.248669119990394732e-01 1.248669119990394732e-01 --2.343750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.003275105304906378e-01 2.003275105304906378e-01 2.003275105304906378e-01 --2.031250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.799612548614079321e-01 1.799612548614079321e-01 1.799612548614079321e-01 --2.343750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.417400098732858105e-01 2.417400098732858105e-01 2.417400098732858105e-01 --2.343750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.916804679477839835e-01 1.916804679477839835e-01 1.916804679477839835e-01 --2.031250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.124810776208822527e-01 2.124810776208822527e-01 2.124810776208822527e-01 --2.031250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.790525431915353793e-01 1.790525431915353793e-01 1.790525431915353793e-01 --1.718750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.740961912926321520e-01 1.740961912926321520e-01 1.740961912926321520e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 2.015345233054438301e-01 2.015345233054438301e-01 2.015345233054438301e-01 --1.406250000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 8.035266374923978605e-02 8.035266374923978605e-02 8.035266374923978605e-02 --1.093750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 4.427631705696229159e-02 4.427631705696229159e-02 4.427631705696229159e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 2.656250000000000000e-01 8.834970814519342575e-02 8.834970814519342575e-02 8.834970814519342575e-02 --7.812500000000000000e-02 -1.406250000000000000e-01 2.968750000000000000e-01 1.172537327422059766e-01 1.172537327422059766e-01 1.172537327422059766e-01 --7.812500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 9.279381901205713268e-02 9.279381901205713268e-02 9.279381901205713268e-02 --4.687500000000000000e-02 -1.406250000000000000e-01 2.656250000000000000e-01 1.201434034913577420e-01 1.201434034913577420e-01 1.201434034913577420e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 2.968750000000000000e-01 1.900230253567465333e-01 1.900230253567465333e-01 1.900230253567465333e-01 --1.562500000000000000e-02 -1.718750000000000000e-01 2.656250000000000000e-01 3.280076114053809277e-02 3.280076114053809277e-02 3.280076114053809277e-02 --1.562500000000000000e-02 -1.718750000000000000e-01 2.968750000000000000e-01 8.194429188658360064e-02 8.194429188658360064e-02 8.194429188658360064e-02 --1.562500000000000000e-02 -1.406250000000000000e-01 2.656250000000000000e-01 8.197402962717016683e-02 8.197402962717016683e-02 8.197402962717016683e-02 --1.562500000000000000e-02 -1.406250000000000000e-01 2.968750000000000000e-01 1.240001528966498678e-01 1.240001528966498678e-01 1.240001528966498678e-01 --4.687500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.208631941260387421e-01 1.208631941260387421e-01 1.208631941260387421e-01 --1.562500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.585066587801461646e-01 1.585066587801461646e-01 1.585066587801461646e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 8.300680650089027612e-02 8.300680650089027612e-02 8.300680650089027612e-02 --1.093750000000000000e-01 -1.093750000000000000e-01 2.968750000000000000e-01 8.839230205460679723e-02 8.839230205460679723e-02 8.839230205460679723e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.018315635348158721e-01 1.018315635348158721e-01 1.018315635348158721e-01 --1.093750000000000000e-01 -7.812500000000000000e-02 2.968750000000000000e-01 1.193633552537082254e-01 1.193633552537082254e-01 1.193633552537082254e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 2.968750000000000000e-01 1.020605676120092259e-01 1.020605676120092259e-01 1.020605676120092259e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 2.968750000000000000e-01 1.355331485072583109e-01 1.355331485072583109e-01 1.355331485072583109e-01 --1.093750000000000000e-01 -1.093750000000000000e-01 3.281250000000000000e-01 8.577956599288549810e-02 8.577956599288549810e-02 8.577956599288549810e-02 --1.093750000000000000e-01 -7.812500000000000000e-02 3.281250000000000000e-01 1.177237029421539655e-01 1.177237029421539655e-01 1.177237029421539655e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.404685855538386208e-01 1.404685855538386208e-01 1.404685855538386208e-01 --7.812500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 7.926471559780250142e-02 7.926471559780250142e-02 7.926471559780250142e-02 --7.812500000000000000e-02 -7.812500000000000000e-02 3.281250000000000000e-01 1.521710676586801869e-01 1.521710676586801869e-01 1.521710676586801869e-01 --7.812500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 9.622196538729274606e-02 9.622196538729274606e-02 9.622196538729274606e-02 --1.093750000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 9.975121242929572973e-02 9.975121242929572973e-02 9.975121242929572973e-02 --1.093750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.949808039993826403e-01 1.949808039993826403e-01 1.949808039993826403e-01 --1.093750000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.282583485970830162e-01 1.282583485970830162e-01 1.282583485970830162e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 9.381922456630008289e-02 9.381922456630008289e-02 9.381922456630008289e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 1.067513919142232537e-01 1.067513919142232537e-01 1.067513919142232537e-01 --1.093750000000000000e-01 -4.687500000000000000e-02 3.281250000000000000e-01 9.660929013469715665e-02 9.660929013469715665e-02 9.660929013469715665e-02 --7.812500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 1.406300162168338252e-01 1.406300162168338252e-01 1.406300162168338252e-01 --7.812500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 9.003817773579679551e-02 9.003817773579679551e-02 9.003817773579679551e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 2.968750000000000000e-01 5.069727580851342286e-02 5.069727580851342286e-02 5.069727580851342286e-02 --4.687500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.293901344430518074e-01 1.293901344430518074e-01 1.293901344430518074e-01 --4.687500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 9.608616021069581181e-02 9.608616021069581181e-02 9.608616021069581181e-02 --4.687500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 9.721839872485669998e-02 9.721839872485669998e-02 9.721839872485669998e-02 --1.562500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.136143833809293707e-01 1.136143833809293707e-01 1.136143833809293707e-01 --1.562500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 8.409663293444386012e-02 8.409663293444386012e-02 8.409663293444386012e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 3.281250000000000000e-01 9.072850326484507844e-02 9.072850326484507844e-02 9.072850326484507844e-02 --1.562500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 9.405468026626459532e-02 9.405468026626459532e-02 9.405468026626459532e-02 --4.687500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 1.545262955973261687e-01 1.545262955973261687e-01 1.545262955973261687e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 9.421218608364487213e-02 9.421218608364487213e-02 9.421218608364487213e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.246652849041254979e-01 1.246652849041254979e-01 1.246652849041254979e-01 --4.687500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 1.078296482553378899e-01 1.078296482553378899e-01 1.078296482553378899e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 1.406356381743865958e-01 1.406356381743865958e-01 1.406356381743865958e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 7.913933055686381279e-02 7.913933055686381279e-02 7.913933055686381279e-02 --1.562500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.353492183131808635e-01 1.353492183131808635e-01 1.353492183131808635e-01 --1.562500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 1.197658321683228583e-01 1.197658321683228583e-01 1.197658321683228583e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 1.035342133433617140e-01 1.035342133433617140e-01 1.035342133433617140e-01 --4.687500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 8.376550729026474573e-02 8.376550729026474573e-02 8.376550729026474573e-02 --4.687500000000000000e-02 -1.562500000000000000e-02 3.281250000000000000e-01 1.047073253270119214e-01 1.047073253270119214e-01 1.047073253270119214e-01 --1.562500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 8.758060292018279847e-02 8.758060292018279847e-02 8.758060292018279847e-02 --1.562500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 6.632499381704283492e-02 6.632499381704283492e-02 6.632499381704283492e-02 --1.562500000000000000e-02 -1.562500000000000000e-02 3.281250000000000000e-01 1.065007072965700047e-01 1.065007072965700047e-01 1.065007072965700047e-01 --5.156250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 7.720033854773357407e-02 7.720033854773357407e-02 7.720033854773357407e-02 --5.156250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 9.052679059706050801e-02 9.052679059706050801e-02 9.052679059706050801e-02 --5.156250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.186194505068399047e-01 1.186194505068399047e-01 1.186194505068399047e-01 --5.156250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.375346673647305229e-01 1.375346673647305229e-01 1.375346673647305229e-01 --5.156250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.188933946316416967e-01 1.188933946316416967e-01 1.188933946316416967e-01 --5.156250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 9.659161145239932023e-02 9.659161145239932023e-02 9.659161145239932023e-02 --5.156250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.596492604508387703e-01 1.596492604508387703e-01 1.596492604508387703e-01 --5.156250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 9.547543587302367851e-02 9.547543587302367851e-02 9.547543587302367851e-02 --5.156250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.556328193876973520e-01 1.556328193876973520e-01 1.556328193876973520e-01 --5.156250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 8.614041954854706473e-02 8.614041954854706473e-02 8.614041954854706473e-02 --5.156250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.172601597036225934e-01 1.172601597036225934e-01 1.172601597036225934e-01 --5.156250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.677746735973950354e-01 1.677746735973950354e-01 1.677746735973950354e-01 --5.156250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 1.553413345536181212e-01 1.553413345536181212e-01 1.553413345536181212e-01 --3.281250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 6.791384480623616215e-02 6.791384480623616215e-02 6.791384480623616215e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 6.875411845503598407e-02 6.875411845503598407e-02 6.875411845503598407e-02 --3.281250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 3.512635343548344696e-02 3.512635343548344696e-02 3.512635343548344696e-02 --3.281250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 7.399146292523275936e-02 7.399146292523275936e-02 7.399146292523275936e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 4.259396301339305607e-02 4.259396301339305607e-02 4.259396301339305607e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 7.755680986824559087e-02 7.755680986824559087e-02 7.755680986824559087e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 8.993209691991588262e-02 8.993209691991588262e-02 8.993209691991588262e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 7.879853945828790840e-02 7.879853945828790840e-02 7.879853945828790840e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 7.143203525305566459e-02 7.143203525305566459e-02 7.143203525305566459e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 9.020131689939969721e-02 9.020131689939969721e-02 9.020131689939969721e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 8.195152539205455278e-02 8.195152539205455278e-02 8.195152539205455278e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 4.931874585408674988e-02 4.931874585408674988e-02 4.931874585408674988e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 4.411766811820783118e-02 4.411766811820783118e-02 4.411766811820783118e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 8.075075457583465177e-02 8.075075457583465177e-02 8.075075457583465177e-02 --2.656250000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 3.167831189769149125e-02 3.167831189769149125e-02 3.167831189769149125e-02 --2.656250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 8.681390136551360437e-02 8.681390136551360437e-02 8.681390136551360437e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 7.396871531641564801e-02 7.396871531641564801e-02 7.396871531641564801e-02 --2.968750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 6.124343432480247595e-02 6.124343432480247595e-02 6.124343432480247595e-02 --2.656250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 8.204877579145790356e-02 8.204877579145790356e-02 8.204877579145790356e-02 --3.281250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 7.980210080977045983e-02 7.980210080977045983e-02 7.980210080977045983e-02 --2.656250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 7.584991280086304799e-02 7.584991280086304799e-02 7.584991280086304799e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 9.704322020959564588e-02 9.704322020959564588e-02 9.704322020959564588e-02 --2.656250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 1.131877733713534395e-01 1.131877733713534395e-01 1.131877733713534395e-01 --2.656250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 7.505086740586026928e-02 7.505086740586026928e-02 7.505086740586026928e-02 --4.531250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 9.954871883474443461e-02 9.954871883474443461e-02 9.954871883474443461e-02 --4.843750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 8.839551668836198584e-02 8.839551668836198584e-02 8.839551668836198584e-02 --4.843750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.088452207443663944e-01 1.088452207443663944e-01 1.088452207443663944e-01 --4.531250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.176963885099534257e-01 1.176963885099534257e-01 1.176963885099534257e-01 --4.531250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.306134734172335055e-01 1.306134734172335055e-01 1.306134734172335055e-01 --4.531250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.274390188873200103e-01 1.274390188873200103e-01 1.274390188873200103e-01 --4.843750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 9.568918991855590583e-02 9.568918991855590583e-02 9.568918991855590583e-02 --4.843750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 9.331616673465295553e-02 9.331616673465295553e-02 9.331616673465295553e-02 --4.531250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 7.773066441728972154e-02 7.773066441728972154e-02 7.773066441728972154e-02 --4.531250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.077340359446097157e-01 1.077340359446097157e-01 1.077340359446097157e-01 --4.531250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 7.246020493679636298e-02 7.246020493679636298e-02 7.246020493679636298e-02 --4.531250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 1.167789395473625147e-01 1.167789395473625147e-01 1.167789395473625147e-01 --4.843750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.139566338436393544e-01 1.139566338436393544e-01 1.139566338436393544e-01 --4.843750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.028841733790560736e-01 1.028841733790560736e-01 1.028841733790560736e-01 --4.843750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.113760615941371546e-01 1.113760615941371546e-01 1.113760615941371546e-01 --4.218750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 9.596240854837631562e-02 9.596240854837631562e-02 9.596240854837631562e-02 --3.906250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 7.199945535937823937e-02 7.199945535937823937e-02 7.199945535937823937e-02 --3.906250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 1.066300670846294651e-01 1.066300670846294651e-01 1.066300670846294651e-01 --4.218750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 6.937605839027739807e-02 6.937605839027739807e-02 6.937605839027739807e-02 --4.218750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 9.938158088069636020e-02 9.938158088069636020e-02 9.938158088069636020e-02 --4.218750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.104255995878681978e-01 1.104255995878681978e-01 1.104255995878681978e-01 --4.218750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.329781678572325987e-01 1.329781678572325987e-01 1.329781678572325987e-01 --3.906250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 8.273916987552316915e-02 8.273916987552316915e-02 8.273916987552316915e-02 --3.906250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 7.700783534022179189e-02 7.700783534022179189e-02 7.700783534022179189e-02 --4.218750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 8.314906344389501325e-02 8.314906344389501325e-02 8.314906344389501325e-02 --4.218750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.234675613466296867e-01 1.234675613466296867e-01 1.234675613466296867e-01 --4.218750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 7.701362249972805440e-02 7.701362249972805440e-02 7.701362249972805440e-02 --4.218750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 1.277884399310327823e-01 1.277884399310327823e-01 1.277884399310327823e-01 --3.906250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 7.040296820761660079e-02 7.040296820761660079e-02 7.040296820761660079e-02 --3.906250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.182820400389055782e-01 1.182820400389055782e-01 1.182820400389055782e-01 --3.906250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 1.091159843462704421e-01 1.091159843462704421e-01 1.091159843462704421e-01 --4.218750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.522088096659711121e-01 1.522088096659711121e-01 1.522088096659711121e-01 --3.906250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.563852147532458214e-01 1.563852147532458214e-01 1.563852147532458214e-01 --4.843750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.127828533036462910e-01 1.127828533036462910e-01 1.127828533036462910e-01 --4.843750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.319347871323972576e-01 1.319347871323972576e-01 1.319347871323972576e-01 --4.843750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.356030258070228256e-01 1.356030258070228256e-01 1.356030258070228256e-01 --4.531250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.356945890734607973e-01 1.356945890734607973e-01 1.356945890734607973e-01 --4.531250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.303644696183764440e-01 1.303644696183764440e-01 1.303644696183764440e-01 --4.531250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.608881981065614641e-01 1.608881981065614641e-01 1.608881981065614641e-01 --4.843750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.014008733993264771e-01 1.014008733993264771e-01 1.014008733993264771e-01 --4.531250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.640549099196506877e-01 1.640549099196506877e-01 1.640549099196506877e-01 --4.843750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.252773942841353128e-01 1.252773942841353128e-01 1.252773942841353128e-01 --4.843750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.356624616234176628e-01 1.356624616234176628e-01 1.356624616234176628e-01 --4.843750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.356431851472444383e-01 1.356431851472444383e-01 1.356431851472444383e-01 --4.531250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.524986998126866278e-01 1.524986998126866278e-01 1.524986998126866278e-01 --4.843750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.076183368620172720e-01 1.076183368620172720e-01 1.076183368620172720e-01 --4.843750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 8.947321541580495474e-02 8.947321541580495474e-02 8.947321541580495474e-02 --4.531250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.528126793749783330e-01 1.528126793749783330e-01 1.528126793749783330e-01 --4.531250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.476860669005750359e-01 1.476860669005750359e-01 1.476860669005750359e-01 --4.218750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.293363167399501357e-01 1.293363167399501357e-01 1.293363167399501357e-01 --4.218750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.618541226542335454e-01 1.618541226542335454e-01 1.618541226542335454e-01 --3.906250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.110820060783212215e-01 1.110820060783212215e-01 1.110820060783212215e-01 --3.906250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.521309165676355823e-01 1.521309165676355823e-01 1.521309165676355823e-01 --3.906250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.811982743047880762e-01 1.811982743047880762e-01 1.811982743047880762e-01 --4.218750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.136151867874713867e-01 1.136151867874713867e-01 1.136151867874713867e-01 --4.218750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.783188232762893122e-01 1.783188232762893122e-01 1.783188232762893122e-01 --3.906250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.597030578807243084e-01 1.597030578807243084e-01 1.597030578807243084e-01 --4.218750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.515696022167635493e-01 1.515696022167635493e-01 1.515696022167635493e-01 --4.218750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.334376045012857226e-01 1.334376045012857226e-01 1.334376045012857226e-01 --3.906250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.422619736856293449e-01 1.422619736856293449e-01 1.422619736856293449e-01 --3.906250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.732660889013380445e-01 1.732660889013380445e-01 1.732660889013380445e-01 --3.906250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.174650188298917153e-01 1.174650188298917153e-01 1.174650188298917153e-01 --4.218750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.374302554932429477e-01 1.374302554932429477e-01 1.374302554932429477e-01 --3.906250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.448600266517669488e-01 1.448600266517669488e-01 1.448600266517669488e-01 --4.843750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 9.196448458429964945e-02 9.196448458429964945e-02 9.196448458429964945e-02 --4.531250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.198879405347346022e-01 1.198879405347346022e-01 1.198879405347346022e-01 --4.843750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.350110748068275024e-01 1.350110748068275024e-01 1.350110748068275024e-01 --4.843750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.653034144211240897e-01 1.653034144211240897e-01 1.653034144211240897e-01 --4.531250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.853611344936158811e-01 1.853611344936158811e-01 1.853611344936158811e-01 --4.531250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.694189261469015439e-01 1.694189261469015439e-01 1.694189261469015439e-01 --4.531250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 9.834821062813492443e-02 9.834821062813492443e-02 9.834821062813492443e-02 --4.218750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.301058261468057697e-01 1.301058261468057697e-01 1.301058261468057697e-01 --3.906250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.146081911463723846e-01 1.146081911463723846e-01 1.146081911463723846e-01 --4.218750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.713626012743695026e-01 1.713626012743695026e-01 1.713626012743695026e-01 --4.218750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.686907383675435579e-01 1.686907383675435579e-01 1.686907383675435579e-01 --4.218750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 8.913809364443404937e-02 8.913809364443404937e-02 8.913809364443404937e-02 --3.906250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.498623473747182633e-01 1.498623473747182633e-01 1.498623473747182633e-01 --3.906250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.470331712788520984e-01 1.470331712788520984e-01 1.470331712788520984e-01 --4.843750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 1.869753287252986784e-01 1.869753287252986784e-01 1.869753287252986784e-01 --4.843750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.152107363602435236e-01 1.152107363602435236e-01 1.152107363602435236e-01 --4.531250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 1.756190938159638837e-01 1.756190938159638837e-01 1.756190938159638837e-01 --4.531250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.297708735830670201e-01 1.297708735830670201e-01 1.297708735830670201e-01 --4.218750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 1.396212700456535283e-01 1.396212700456535283e-01 1.396212700456535283e-01 --3.593750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 8.354609561514161897e-02 8.354609561514161897e-02 8.354609561514161897e-02 --3.593750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 1.204575093481910775e-01 1.204575093481910775e-01 1.204575093481910775e-01 --3.281250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 6.782284745853525698e-02 6.782284745853525698e-02 6.782284745853525698e-02 --3.281250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 9.302927771296877479e-02 9.302927771296877479e-02 9.302927771296877479e-02 --3.281250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 7.578769991445824528e-02 7.578769991445824528e-02 7.578769991445824528e-02 --3.593750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 8.651011193602312077e-02 8.651011193602312077e-02 8.651011193602312077e-02 --3.593750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.213676864020203500e-01 1.213676864020203500e-01 1.213676864020203500e-01 --3.281250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 8.149179463989314476e-02 8.149179463989314476e-02 8.149179463989314476e-02 --3.281250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.055574190756181779e-01 1.055574190756181779e-01 1.055574190756181779e-01 --3.281250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 9.640357431846587055e-02 9.640357431846587055e-02 9.640357431846587055e-02 --3.593750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.193400581251474885e-01 1.193400581251474885e-01 1.193400581251474885e-01 --3.593750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 9.849445823533843625e-02 9.849445823533843625e-02 9.849445823533843625e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 8.341589499757019743e-02 8.341589499757019743e-02 8.341589499757019743e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 8.707589873532069202e-02 8.707589873532069202e-02 8.707589873532069202e-02 --3.281250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 7.758566508754335955e-02 7.758566508754335955e-02 7.758566508754335955e-02 --3.281250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 7.209350250419876982e-02 7.209350250419876982e-02 7.209350250419876982e-02 --3.593750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.414797304864338356e-01 1.414797304864338356e-01 1.414797304864338356e-01 --3.593750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.724231328340943559e-01 1.724231328340943559e-01 1.724231328340943559e-01 --3.593750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.397064035710575136e-01 1.397064035710575136e-01 1.397064035710575136e-01 --3.593750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.369563845272573910e-01 1.369563845272573910e-01 1.369563845272573910e-01 --3.281250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 9.772946780991419169e-02 9.772946780991419169e-02 9.772946780991419169e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.097740084114491171e-01 1.097740084114491171e-01 1.097740084114491171e-01 --3.281250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 5.688738415359604478e-02 5.688738415359604478e-02 5.688738415359604478e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 7.234228480596335831e-02 7.234228480596335831e-02 7.234228480596335831e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 9.161490791838163006e-02 9.161490791838163006e-02 9.161490791838163006e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 8.130774085761401093e-02 8.130774085761401093e-02 8.130774085761401093e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 7.693445090644404627e-02 7.693445090644404627e-02 7.693445090644404627e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 7.176835613909346434e-02 7.176835613909346434e-02 7.176835613909346434e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 9.063126335665355748e-02 9.063126335665355748e-02 9.063126335665355748e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 7.286484570765809632e-02 7.286484570765809632e-02 7.286484570765809632e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 8.431443570979685331e-02 8.431443570979685331e-02 8.431443570979685331e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 4.504857027182748025e-02 4.504857027182748025e-02 4.504857027182748025e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 6.787582207540673873e-02 6.787582207540673873e-02 6.787582207540673873e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 8.379042213128444494e-02 8.379042213128444494e-02 8.379042213128444494e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 8.319085639628918949e-02 8.319085639628918949e-02 8.319085639628918949e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 8.075236204540758855e-02 8.075236204540758855e-02 8.075236204540758855e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.161169558646223399e-01 1.161169558646223399e-01 1.161169558646223399e-01 --2.656250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 9.199261137646190523e-02 9.199261137646190523e-02 9.199261137646190523e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.013606969631618282e-01 1.013606969631618282e-01 1.013606969631618282e-01 --2.968750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 8.731941086310336664e-02 8.731941086310336664e-02 8.731941086310336664e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 8.423486945062540199e-02 8.423486945062540199e-02 8.423486945062540199e-02 --2.656250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 8.849034832640079173e-02 8.849034832640079173e-02 8.849034832640079173e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 8.942419289372122160e-02 8.942419289372122160e-02 8.942419289372122160e-02 --2.968750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 8.031649549656529052e-02 8.031649549656529052e-02 8.031649549656529052e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.096960742182612053e-01 1.096960742182612053e-01 1.096960742182612053e-01 --2.656250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.121899309561944086e-01 1.121899309561944086e-01 1.121899309561944086e-01 --2.656250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.020195879829225161e-01 1.020195879829225161e-01 1.020195879829225161e-01 --3.593750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 9.469675561881142623e-02 9.469675561881142623e-02 9.469675561881142623e-02 --3.593750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.074857647920117037e-01 1.074857647920117037e-01 1.074857647920117037e-01 --3.281250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 6.319470880969611792e-02 6.319470880969611792e-02 6.319470880969611792e-02 --3.281250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 8.823639216320082468e-02 8.823639216320082468e-02 8.823639216320082468e-02 --3.281250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 8.822915922276999834e-02 8.822915922276999834e-02 8.822915922276999834e-02 --3.593750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 4.426908016336333213e-02 4.426908016336333213e-02 4.426908016336333213e-02 --3.593750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 4.106966615897904987e-02 4.106966615897904987e-02 4.106966615897904987e-02 --3.593750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 5.331131219332672228e-02 5.331131219332672228e-02 5.331131219332672228e-02 --3.593750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 4.416607497403048088e-02 4.416607497403048088e-02 4.416607497403048088e-02 --3.281250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 5.411893513641123643e-02 5.411893513641123643e-02 5.411893513641123643e-02 --3.281250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 6.716359593197167299e-02 6.716359593197167299e-02 6.716359593197167299e-02 --3.593750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.205643532603994927e-01 1.205643532603994927e-01 1.205643532603994927e-01 --3.593750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.279466829849086884e-01 1.279466829849086884e-01 1.279466829849086884e-01 --3.593750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 6.569193667987241469e-02 6.569193667987241469e-02 6.569193667987241469e-02 --3.593750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 7.718916614035038759e-02 7.718916614035038759e-02 7.718916614035038759e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 8.260896795208014232e-02 8.260896795208014232e-02 8.260896795208014232e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 8.440123517550510157e-02 8.440123517550510157e-02 8.440123517550510157e-02 --3.593750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 1.179349877956249876e-01 1.179349877956249876e-01 1.179349877956249876e-01 --3.593750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 6.644059152215445185e-02 6.644059152215445185e-02 6.644059152215445185e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 3.543017611055167965e-02 3.543017611055167965e-02 3.543017611055167965e-02 --3.281250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 1.450929237475009903e-01 1.450929237475009903e-01 1.450929237475009903e-01 --3.281250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 8.980753214696447773e-02 8.980753214696447773e-02 8.980753214696447773e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 4.449511216579946776e-02 4.449511216579946776e-02 4.449511216579946776e-02 --2.968750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 5.415857237029876592e-02 5.415857237029876592e-02 5.415857237029876592e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 8.633491010328558923e-02 8.633491010328558923e-02 8.633491010328558923e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 5.205093788101571722e-02 5.205093788101571722e-02 5.205093788101571722e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 6.258469944198105650e-02 6.258469944198105650e-02 6.258469944198105650e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 6.310555511978674370e-02 6.310555511978674370e-02 6.310555511978674370e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 7.023408163059535747e-02 7.023408163059535747e-02 7.023408163059535747e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 5.984997092303936256e-02 5.984997092303936256e-02 5.984997092303936256e-02 --2.968750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 3.640034226516213750e-02 3.640034226516213750e-02 3.640034226516213750e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 5.880925918144062903e-02 5.880925918144062903e-02 5.880925918144062903e-02 --2.656250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 6.378767078363217768e-02 6.378767078363217768e-02 6.378767078363217768e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 4.436195358167280278e-02 4.436195358167280278e-02 4.436195358167280278e-02 --2.656250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 6.820090378608407999e-02 6.820090378608407999e-02 6.820090378608407999e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 9.381520654496898481e-02 9.381520654496898481e-02 9.381520654496898481e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 8.231319983681500974e-02 8.231319983681500974e-02 8.231319983681500974e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 3.656077561058626579e-02 3.656077561058626579e-02 3.656077561058626579e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 6.889921408770702249e-02 6.889921408770702249e-02 6.889921408770702249e-02 --2.656250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.299353615799132611e-02 7.299353615799132611e-02 7.299353615799132611e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 5.874277215690847098e-02 5.874277215690847098e-02 5.874277215690847098e-02 --2.968750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 9.834097859671317443e-02 9.834097859671317443e-02 9.834097859671317443e-02 --2.968750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 7.774979402109684357e-02 7.774979402109684357e-02 7.774979402109684357e-02 --2.968750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 8.052410104566558313e-02 8.052410104566558313e-02 8.052410104566558313e-02 --2.656250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 8.659369432729843719e-02 8.659369432729843719e-02 8.659369432729843719e-02 --2.656250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.085575836349541717e-01 1.085575836349541717e-01 1.085575836349541717e-01 --2.656250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.079831097938450668e-01 1.079831097938450668e-01 1.079831097938450668e-01 --3.281250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 8.275042188371041496e-02 8.275042188371041496e-02 8.275042188371041496e-02 --3.593750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.023803687062658091e-01 1.023803687062658091e-01 1.023803687062658091e-01 --3.593750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 6.221650493897432077e-02 6.221650493897432077e-02 6.221650493897432077e-02 --3.281250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 7.293783194710547202e-02 7.293783194710547202e-02 7.293783194710547202e-02 --3.281250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 3.597211635552993725e-02 3.597211635552993725e-02 3.597211635552993725e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 8.838105083544323115e-02 8.838105083544323115e-02 8.838105083544323115e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 9.238076010403825644e-02 9.238076010403825644e-02 9.238076010403825644e-02 --2.968750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 6.788820157114340559e-02 6.788820157114340559e-02 6.788820157114340559e-02 --2.656250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 8.523386232977389620e-02 8.523386232977389620e-02 8.523386232977389620e-02 --2.656250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.011196379247803340e-01 1.011196379247803340e-01 1.011196379247803340e-01 --2.656250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 8.175541679108778992e-02 8.175541679108778992e-02 8.175541679108778992e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 8.896852310355278515e-02 8.896852310355278515e-02 8.896852310355278515e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 8.892834045854199065e-02 8.892834045854199065e-02 8.892834045854199065e-02 --2.968750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 8.457483382600439192e-02 8.457483382600439192e-02 8.457483382600439192e-02 --2.968750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 9.021578242503404399e-02 9.021578242503404399e-02 9.021578242503404399e-02 --2.656250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.120806656565221798e-01 1.120806656565221798e-01 1.120806656565221798e-01 --2.656250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.103404350729895456e-01 1.103404350729895456e-01 1.103404350729895456e-01 --2.656250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.023594772163062966e-01 1.023594772163062966e-01 1.023594772163062966e-01 --2.968750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 4.920738501037884988e-02 4.920738501037884988e-02 4.920738501037884988e-02 --2.656250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 6.497856575376520505e-02 6.497856575376520505e-02 6.497856575376520505e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 7.349985592533887779e-02 7.349985592533887779e-02 7.349985592533887779e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 7.319456936019699822e-02 7.319456936019699822e-02 7.319456936019699822e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 4.011684533826013338e-02 4.011684533826013338e-02 4.011684533826013338e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 5.984370016259095426e-02 5.984370016259095426e-02 5.984370016259095426e-02 --2.656250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 9.344152968343399923e-02 9.344152968343399923e-02 9.344152968343399923e-02 --2.656250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 7.223184002769550416e-02 7.223184002769550416e-02 7.223184002769550416e-02 --2.656250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 8.988709289516931544e-02 8.988709289516931544e-02 8.988709289516931544e-02 --3.593750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 6.997243133117098113e-02 6.997243133117098113e-02 6.997243133117098113e-02 --3.593750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 6.133612736484088390e-02 6.133612736484088390e-02 6.133612736484088390e-02 --3.593750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 5.815258686193913035e-02 5.815258686193913035e-02 5.815258686193913035e-02 --3.593750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 4.888865897113593706e-02 4.888865897113593706e-02 4.888865897113593706e-02 --3.281250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 5.496843798717132579e-02 5.496843798717132579e-02 5.496843798717132579e-02 --3.281250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 6.387272381032133017e-02 6.387272381032133017e-02 6.387272381032133017e-02 --3.593750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 5.562200075150647294e-02 5.562200075150647294e-02 5.562200075150647294e-02 --3.281250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 8.540585180713033964e-02 8.540585180713033964e-02 8.540585180713033964e-02 --3.281250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 7.161265517710031780e-02 7.161265517710031780e-02 7.161265517710031780e-02 --2.968750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 7.740031633983783521e-02 7.740031633983783521e-02 7.740031633983783521e-02 --2.968750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 7.107055303905054910e-02 7.107055303905054910e-02 7.107055303905054910e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 8.048873660748583070e-02 8.048873660748583070e-02 8.048873660748583070e-02 --2.968750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 7.269387437874731683e-02 7.269387437874731683e-02 7.269387437874731683e-02 --2.968750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.080867564265071828e-01 1.080867564265071828e-01 1.080867564265071828e-01 --2.968750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 8.321577141528370414e-02 8.321577141528370414e-02 8.321577141528370414e-02 --2.656250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 1.047860678475335955e-01 1.047860678475335955e-01 1.047860678475335955e-01 --2.656250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.011164237993730786e-01 1.011164237993730786e-01 1.011164237993730786e-01 --2.656250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 7.156466674552530716e-02 7.156466674552530716e-02 7.156466674552530716e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 9.031945194928701903e-02 9.031945194928701903e-02 9.031945194928701903e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 9.920881772673001420e-02 9.920881772673001420e-02 9.920881772673001420e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 6.031127244727236408e-02 6.031127244727236408e-02 6.031127244727236408e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 8.408538111453085773e-02 8.408538111453085773e-02 8.408538111453085773e-02 --2.656250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 1.052946783940519743e-01 1.052946783940519743e-01 1.052946783940519743e-01 --2.656250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 9.359582227533788656e-02 9.359582227533788656e-02 9.359582227533788656e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 8.671746040105610120e-02 8.671746040105610120e-02 8.671746040105610120e-02 --2.968750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 6.127350128963877929e-02 6.127350128963877929e-02 6.127350128963877929e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 7.234831344670054898e-02 7.234831344670054898e-02 7.234831344670054898e-02 --2.968750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 5.765855157043765777e-02 5.765855157043765777e-02 5.765855157043765777e-02 --2.656250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 7.349591726982880602e-02 7.349591726982880602e-02 7.349591726982880602e-02 --2.656250000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 8.581814284224420497e-02 8.581814284224420497e-02 8.581814284224420497e-02 --2.656250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 8.400742203335287428e-02 8.400742203335287428e-02 8.400742203335287428e-02 --2.656250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 7.808134630577465152e-02 7.808134630577465152e-02 7.808134630577465152e-02 --2.656250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 7.034669951596068949e-02 7.034669951596068949e-02 7.034669951596068949e-02 --2.656250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 8.497266265394964879e-02 8.497266265394964879e-02 8.497266265394964879e-02 --1.406250000000000000e-01 1.562500000000000000e-02 -3.906250000000000000e-01 1.521742797450959805e-01 1.521742797450959805e-01 1.521742797450959805e-01 --1.406250000000000000e-01 1.093750000000000000e-01 -3.906250000000000000e-01 7.649349987628133174e-02 7.649349987628133174e-02 7.649349987628133174e-02 --2.343750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 5.739203656114436058e-02 5.739203656114436058e-02 5.739203656114436058e-02 --2.343750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 8.572250436927984774e-02 8.572250436927984774e-02 8.572250436927984774e-02 --2.031250000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 7.369381437613793662e-02 7.369381437613793662e-02 7.369381437613793662e-02 --2.031250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 1.049001640160657084e-01 1.049001640160657084e-01 1.049001640160657084e-01 --2.343750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 8.152555118307899806e-02 8.152555118307899806e-02 8.152555118307899806e-02 --2.343750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 1.084081404850199687e-01 1.084081404850199687e-01 1.084081404850199687e-01 --2.343750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 9.405789467378132540e-02 9.405789467378132540e-02 9.405789467378132540e-02 --2.031250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 1.386101017556054249e-01 1.386101017556054249e-01 1.386101017556054249e-01 --2.031250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 1.032618239358029100e-01 1.032618239358029100e-01 1.032618239358029100e-01 --2.031250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 1.157337419474434304e-01 1.157337419474434304e-01 1.157337419474434304e-01 --2.031250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 1.195135814034477412e-01 1.195135814034477412e-01 1.195135814034477412e-01 --2.343750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 5.491135450677581825e-02 5.491135450677581825e-02 5.491135450677581825e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 4.729235640674490232e-02 4.729235640674490232e-02 4.729235640674490232e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 9.522391252823909913e-02 9.522391252823909913e-02 9.522391252823909913e-02 --2.031250000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 7.613003095050729918e-02 7.613003095050729918e-02 7.613003095050729918e-02 --2.031250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 1.005177907062105302e-01 1.005177907062105302e-01 1.005177907062105302e-01 --2.031250000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 6.303923242796623250e-02 6.303923242796623250e-02 6.303923242796623250e-02 --2.031250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 1.065039212068658037e-01 1.065039212068658037e-01 1.065039212068658037e-01 --2.343750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 8.302288074435179577e-02 8.302288074435179577e-02 8.302288074435179577e-02 --2.031250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 8.592422908260928527e-02 8.592422908260928527e-02 8.592422908260928527e-02 --2.031250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 1.026495470339892219e-01 1.026495470339892219e-01 1.026495470339892219e-01 --2.031250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 1.019062912526975673e-01 1.019062912526975673e-01 1.019062912526975673e-01 --1.718750000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 2.147655346015572009e-01 2.147655346015572009e-01 2.147655346015572009e-01 --1.718750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 1.979920820049362873e-01 1.979920820049362873e-01 1.979920820049362873e-01 --1.406250000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 1.957047409323028064e-01 1.957047409323028064e-01 1.957047409323028064e-01 --1.406250000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 2.215166205565104185e-01 2.215166205565104185e-01 2.215166205565104185e-01 --1.406250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 2.065750504924362685e-01 2.065750504924362685e-01 2.065750504924362685e-01 --1.718750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 1.947616954173590209e-01 1.947616954173590209e-01 1.947616954173590209e-01 --1.718750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 1.741114445446350356e-01 1.741114445446350356e-01 1.741114445446350356e-01 --1.718750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 1.897605603717212597e-01 1.897605603717212597e-01 1.897605603717212597e-01 --1.718750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 1.234153462990095346e-01 1.234153462990095346e-01 1.234153462990095346e-01 --1.406250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 4.640007596933426459e-02 4.640007596933426459e-02 4.640007596933426459e-02 --1.406250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 2.010273233346207833e-01 2.010273233346207833e-01 2.010273233346207833e-01 --1.406250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 9.608535662909183095e-02 9.608535662909183095e-02 9.608535662909183095e-02 --1.718750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 8.087372590479942336e-02 8.087372590479942336e-02 8.087372590479942336e-02 --1.718750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 1.115190718117457375e-01 1.115190718117457375e-01 1.115190718117457375e-01 --1.718750000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 7.689201168528404795e-02 7.689201168528404795e-02 7.689201168528404795e-02 --1.718750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 9.395905158385869926e-02 9.395905158385869926e-02 9.395905158385869926e-02 --1.406250000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 8.581251705286292719e-02 8.581251705286292719e-02 8.581251705286292719e-02 --1.406250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 1.007636727573394675e-01 1.007636727573394675e-01 1.007636727573394675e-01 --1.406250000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 8.098383732745008390e-02 8.098383732745008390e-02 8.098383732745008390e-02 --1.718750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 1.107011784851532621e-01 1.107011784851532621e-01 1.107011784851532621e-01 --1.718750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.225035857745921525e-01 1.225035857745921525e-01 1.225035857745921525e-01 --1.718750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 9.874034647019301614e-02 9.874034647019301614e-02 9.874034647019301614e-02 --1.718750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 1.003273521306274063e-01 1.003273521306274063e-01 1.003273521306274063e-01 --1.406250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 1.064396429765208790e-01 1.064396429765208790e-01 1.064396429765208790e-01 --1.406250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.081365710396519630e-01 1.081365710396519630e-01 1.081365710396519630e-01 --1.406250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 8.443016830993708977e-02 8.443016830993708977e-02 8.443016830993708977e-02 --1.406250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 1.002469981660221721e-01 1.002469981660221721e-01 1.002469981660221721e-01 --1.718750000000000000e-01 1.406250000000000000e-01 -3.906250000000000000e-01 5.625754906761553514e-02 5.625754906761553514e-02 5.625754906761553514e-02 --1.406250000000000000e-01 1.406250000000000000e-01 -3.906250000000000000e-01 8.192419881239285107e-02 8.192419881239285107e-02 8.192419881239285107e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -3.906250000000000000e-01 5.082093630876042406e-02 5.082093630876042406e-02 5.082093630876042406e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.056026920499310962e-02 8.056026920499310962e-02 8.056026920499310962e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.032469363526061057e-02 8.032469363526061057e-02 8.032469363526061057e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 9.371073791974771083e-02 9.371073791974771083e-02 9.371073791974771083e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 6.513017971182454013e-02 6.513017971182454013e-02 6.513017971182454013e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 8.410547364898329770e-02 8.410547364898329770e-02 8.410547364898329770e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -3.593750000000000000e-01 6.107903053489444761e-02 6.107903053489444761e-02 6.107903053489444761e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.426782114325935547e-02 8.426782114325935547e-02 8.426782114325935547e-02 --1.718750000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 6.046032260094985622e-02 6.046032260094985622e-02 6.046032260094985622e-02 --1.718750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 8.891789296756329175e-02 8.891789296756329175e-02 8.891789296756329175e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 8.971430935198904111e-02 8.971430935198904111e-02 8.971430935198904111e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 9.801634007184235886e-02 9.801634007184235886e-02 9.801634007184235886e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 8.283641932285282228e-02 8.283641932285282228e-02 8.283641932285282228e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 7.071276684232825904e-02 7.071276684232825904e-02 7.071276684232825904e-02 --1.718750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 8.326560143010793003e-02 8.326560143010793003e-02 8.326560143010793003e-02 --1.718750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 8.075798818863323680e-02 8.075798818863323680e-02 8.075798818863323680e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 9.554133003782711020e-02 9.554133003782711020e-02 9.554133003782711020e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 9.493461952998712150e-02 9.493461952998712150e-02 9.493461952998712150e-02 --1.406250000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 1.057108849483232582e-01 1.057108849483232582e-01 1.057108849483232582e-01 --1.406250000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 1.238531483414467560e-01 1.238531483414467560e-01 1.238531483414467560e-01 --1.406250000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 1.137919360327515894e-01 1.137919360327515894e-01 1.137919360327515894e-01 --1.093750000000000000e-01 1.562500000000000000e-02 -3.906250000000000000e-01 1.791954331624502350e-01 1.791954331624502350e-01 1.791954331624502350e-01 --7.812500000000000000e-02 1.562500000000000000e-02 -4.218750000000000000e-01 1.431124738316695288e-01 1.431124738316695288e-01 1.431124738316695288e-01 --7.812500000000000000e-02 1.562500000000000000e-02 -3.906250000000000000e-01 2.001397156916326359e-01 2.001397156916326359e-01 2.001397156916326359e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -3.906250000000000000e-01 1.674559352059942496e-01 1.674559352059942496e-01 1.674559352059942496e-01 --1.093750000000000000e-01 1.093750000000000000e-01 -3.906250000000000000e-01 8.096535147868824667e-02 8.096535147868824667e-02 8.096535147868824667e-02 --4.687500000000000000e-02 1.562500000000000000e-02 -4.218750000000000000e-01 1.170504798224437509e-01 1.170504798224437509e-01 1.170504798224437509e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -4.218750000000000000e-01 5.717649240410729861e-02 5.717649240410729861e-02 5.717649240410729861e-02 --4.687500000000000000e-02 4.687500000000000000e-02 -3.906250000000000000e-01 1.068630748737838809e-01 1.068630748737838809e-01 1.068630748737838809e-01 --1.562500000000000000e-02 1.562500000000000000e-02 -4.218750000000000000e-01 6.675169161427962905e-02 6.675169161427962905e-02 6.675169161427962905e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -4.218750000000000000e-01 7.957407823793646862e-02 7.957407823793646862e-02 7.957407823793646862e-02 --4.687500000000000000e-02 7.812500000000000000e-02 -3.906250000000000000e-01 9.137944507810707995e-02 9.137944507810707995e-02 9.137944507810707995e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -4.218750000000000000e-01 7.402554413631470820e-02 7.402554413631470820e-02 7.402554413631470820e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -3.906250000000000000e-01 9.609178528173462075e-02 9.609178528173462075e-02 9.609178528173462075e-02 --1.093750000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 2.132971345057253776e-01 2.132971345057253776e-01 2.132971345057253776e-01 --1.093750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 2.028643029843708590e-01 2.028643029843708590e-01 2.028643029843708590e-01 --1.093750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 1.926701014081815821e-01 1.926701014081815821e-01 1.926701014081815821e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 2.091477563655868011e-01 2.091477563655868011e-01 2.091477563655868011e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -3.281250000000000000e-01 1.065103490270722375e-01 1.065103490270722375e-01 1.065103490270722375e-01 --1.093750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 1.065167768467651099e-01 1.065167768467651099e-01 1.065167768467651099e-01 --1.093750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 8.132863781477951692e-02 8.132863781477951692e-02 8.132863781477951692e-02 --7.812500000000000000e-02 4.687500000000000000e-02 -2.968750000000000000e-01 4.134845799801276089e-02 4.134845799801276089e-02 4.134845799801276089e-02 --7.812500000000000000e-02 4.687500000000000000e-02 -2.656250000000000000e-01 6.444059918146685662e-02 6.444059918146685662e-02 6.444059918146685662e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 7.925233785244777118e-02 7.925233785244777118e-02 7.925233785244777118e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 9.339893844710814297e-02 9.339893844710814297e-02 9.339893844710814297e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -3.593750000000000000e-01 9.775759258669247664e-02 9.775759258669247664e-02 9.775759258669247664e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 8.556578561739464073e-02 8.556578561739464073e-02 8.556578561739464073e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 1.477519183173441331e-01 1.477519183173441331e-01 1.477519183173441331e-01 --7.812500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 6.199446193730555332e-02 6.199446193730555332e-02 6.199446193730555332e-02 --7.812500000000000000e-02 1.093750000000000000e-01 -3.593750000000000000e-01 7.534216100300078489e-02 7.534216100300078489e-02 7.534216100300078489e-02 --7.812500000000000000e-02 1.093750000000000000e-01 -3.281250000000000000e-01 7.429256671027635595e-02 7.429256671027635595e-02 7.429256671027635595e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 9.111344356607391226e-02 9.111344356607391226e-02 9.111344356607391226e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 7.279587847342759710e-02 7.279587847342759710e-02 7.279587847342759710e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 8.732182187058785960e-02 8.732182187058785960e-02 8.732182187058785960e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 5.053992598951371346e-02 5.053992598951371346e-02 5.053992598951371346e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -2.656250000000000000e-01 4.046077563374586572e-02 4.046077563374586572e-02 4.046077563374586572e-02 --7.812500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 8.508276846683170136e-02 8.508276846683170136e-02 8.508276846683170136e-02 --7.812500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 5.719474252854599844e-02 5.719474252854599844e-02 5.719474252854599844e-02 --4.687500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 6.010811680392198764e-02 6.010811680392198764e-02 6.010811680392198764e-02 --1.562500000000000000e-02 1.562500000000000000e-02 -3.281250000000000000e-01 5.923077116741852499e-02 5.923077116741852499e-02 5.923077116741852499e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -3.281250000000000000e-01 4.279531342436471153e-02 4.279531342436471153e-02 4.279531342436471153e-02 --4.687500000000000000e-02 1.562500000000000000e-02 -2.656250000000000000e-01 7.410994329973132067e-02 7.410994329973132067e-02 7.410994329973132067e-02 --4.687500000000000000e-02 4.687500000000000000e-02 -2.656250000000000000e-01 4.669710184381004742e-02 4.669710184381004742e-02 4.669710184381004742e-02 --1.562500000000000000e-02 1.562500000000000000e-02 -2.968750000000000000e-01 4.677389097514179223e-02 4.677389097514179223e-02 4.677389097514179223e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -2.968750000000000000e-01 3.964794945712194624e-02 3.964794945712194624e-02 3.964794945712194624e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -2.656250000000000000e-01 3.193606565246299295e-02 3.193606565246299295e-02 3.193606565246299295e-02 --4.687500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 5.250778162973808449e-02 5.250778162973808449e-02 5.250778162973808449e-02 --4.687500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 6.059916249031220559e-02 6.059916249031220559e-02 6.059916249031220559e-02 --4.687500000000000000e-02 1.093750000000000000e-01 -3.593750000000000000e-01 6.768643163052474876e-02 6.768643163052474876e-02 6.768643163052474876e-02 --4.687500000000000000e-02 1.093750000000000000e-01 -3.281250000000000000e-01 8.496864419078165032e-02 8.496864419078165032e-02 8.496864419078165032e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 4.839263705087820666e-02 4.839263705087820666e-02 4.839263705087820666e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 5.002630573650940216e-02 5.002630573650940216e-02 5.002630573650940216e-02 --1.562500000000000000e-02 1.093750000000000000e-01 -3.593750000000000000e-01 3.964754738436783443e-02 3.964754738436783443e-02 3.964754738436783443e-02 --1.562500000000000000e-02 1.093750000000000000e-01 -3.281250000000000000e-01 5.542807912711653767e-02 5.542807912711653767e-02 5.542807912711653767e-02 --4.687500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 5.147372873837512131e-02 5.147372873837512131e-02 5.147372873837512131e-02 --4.687500000000000000e-02 7.812500000000000000e-02 -2.656250000000000000e-01 4.913558331604863522e-02 4.913558331604863522e-02 4.913558331604863522e-02 --4.687500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 7.415825173342241450e-02 7.415825173342241450e-02 7.415825173342241450e-02 --4.687500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 6.230718706030581588e-02 6.230718706030581588e-02 6.230718706030581588e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 5.256317838102438078e-02 5.256317838102438078e-02 5.256317838102438078e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -2.656250000000000000e-01 7.579895289489282928e-02 7.579895289489282928e-02 7.579895289489282928e-02 --1.562500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 7.079692833073983338e-02 7.079692833073983338e-02 7.079692833073983338e-02 --1.562500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 1.040034601894578165e-01 1.040034601894578165e-01 1.040034601894578165e-01 --1.093750000000000000e-01 1.406250000000000000e-01 -3.906250000000000000e-01 8.534396778519119653e-02 8.534396778519119653e-02 8.534396778519119653e-02 --1.093750000000000000e-01 1.718750000000000000e-01 -3.906250000000000000e-01 7.005587013657518791e-02 7.005587013657518791e-02 7.005587013657518791e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -3.906250000000000000e-01 5.929701660392751317e-02 5.929701660392751317e-02 5.929701660392751317e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -3.906250000000000000e-01 9.155785043332445583e-02 9.155785043332445583e-02 9.155785043332445583e-02 --1.093750000000000000e-01 1.406250000000000000e-01 -3.593750000000000000e-01 8.870813920758159610e-02 8.870813920758159610e-02 8.870813920758159610e-02 --1.093750000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 1.028062325115483844e-01 1.028062325115483844e-01 1.028062325115483844e-01 --1.093750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 7.962961710507025781e-02 7.962961710507025781e-02 7.962961710507025781e-02 --7.812500000000000000e-02 1.406250000000000000e-01 -3.593750000000000000e-01 7.198562961599740129e-02 7.198562961599740129e-02 7.198562961599740129e-02 --7.812500000000000000e-02 1.718750000000000000e-01 -3.593750000000000000e-01 7.898581399066254005e-02 7.898581399066254005e-02 7.898581399066254005e-02 --7.812500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 8.617015573818793961e-02 8.617015573818793961e-02 8.617015573818793961e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 1.289130031035534696e-01 1.289130031035534696e-01 1.289130031035534696e-01 --7.812500000000000000e-02 2.031250000000000000e-01 -3.593750000000000000e-01 6.396155508910982002e-02 6.396155508910982002e-02 6.396155508910982002e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -3.281250000000000000e-01 8.953670355573244144e-02 8.953670355573244144e-02 8.953670355573244144e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 1.347556590546372390e-01 1.347556590546372390e-01 1.347556590546372390e-01 --1.093750000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 1.221011225555556218e-01 1.221011225555556218e-01 1.221011225555556218e-01 --7.812500000000000000e-02 2.031250000000000000e-01 -2.968750000000000000e-01 9.727143434691490342e-02 9.727143434691490342e-02 9.727143434691490342e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 9.162053330204320001e-02 9.162053330204320001e-02 9.162053330204320001e-02 --4.687500000000000000e-02 1.406250000000000000e-01 -3.593750000000000000e-01 6.789398938667225158e-02 6.789398938667225158e-02 6.789398938667225158e-02 --4.687500000000000000e-02 1.718750000000000000e-01 -3.593750000000000000e-01 7.055674230280239989e-02 7.055674230280239989e-02 7.055674230280239989e-02 --1.562500000000000000e-02 1.406250000000000000e-01 -3.593750000000000000e-01 3.817144433579901242e-02 3.817144433579901242e-02 3.817144433579901242e-02 --1.562500000000000000e-02 1.406250000000000000e-01 -3.281250000000000000e-01 7.026784289756238255e-02 7.026784289756238255e-02 7.026784289756238255e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -3.593750000000000000e-01 3.779461395124789069e-02 3.779461395124789069e-02 3.779461395124789069e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -3.281250000000000000e-01 6.517680536788664214e-02 6.517680536788664214e-02 6.517680536788664214e-02 --4.687500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 5.266247434920219572e-02 5.266247434920219572e-02 5.266247434920219572e-02 --4.687500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 6.630417335042594618e-02 6.630417335042594618e-02 6.630417335042594618e-02 --1.562500000000000000e-02 1.406250000000000000e-01 -2.968750000000000000e-01 7.376888975539874771e-02 7.376888975539874771e-02 7.376888975539874771e-02 --1.562500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 9.359180424283181088e-02 9.359180424283181088e-02 9.359180424283181088e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -2.968750000000000000e-01 7.861898054879244702e-02 7.861898054879244702e-02 7.861898054879244702e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 8.224649111707937887e-02 8.224649111707937887e-02 8.224649111707937887e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -3.593750000000000000e-01 7.046542640926439782e-02 7.046542640926439782e-02 7.046542640926439782e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -3.281250000000000000e-01 9.388351288041409115e-02 9.388351288041409115e-02 9.388351288041409115e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -3.593750000000000000e-01 6.294766682781426093e-02 6.294766682781426093e-02 6.294766682781426093e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -3.281250000000000000e-01 6.796231773301963930e-02 6.796231773301963930e-02 6.796231773301963930e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -3.593750000000000000e-01 8.729208610660442458e-02 8.729208610660442458e-02 8.729208610660442458e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -3.281250000000000000e-01 8.621275080149341796e-02 8.621275080149341796e-02 8.621275080149341796e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -3.593750000000000000e-01 8.958331506961900170e-02 8.958331506961900170e-02 8.958331506961900170e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -3.281250000000000000e-01 8.153358845318532666e-02 8.153358845318532666e-02 8.153358845318532666e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -2.968750000000000000e-01 8.329132013534742973e-02 8.329132013534742973e-02 8.329132013534742973e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 6.810894212974688555e-02 6.810894212974688555e-02 6.810894212974688555e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -2.968750000000000000e-01 6.813241487019675025e-02 6.813241487019675025e-02 6.813241487019675025e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 1.321267573500292114e-01 1.321267573500292114e-01 1.321267573500292114e-01 --1.562500000000000000e-02 2.031250000000000000e-01 -2.968750000000000000e-01 7.186328776000386331e-02 7.186328776000386331e-02 7.186328776000386331e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 9.206413374649868864e-02 9.206413374649868864e-02 9.206413374649868864e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -2.968750000000000000e-01 9.082413578720681391e-02 9.082413578720681391e-02 9.082413578720681391e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 1.322231438974554585e-01 1.322231438974554585e-01 1.322231438974554585e-01 --2.343750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.142458584517454662e-01 1.142458584517454662e-01 1.142458584517454662e-01 --2.031250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.035759957077745513e-01 1.035759957077745513e-01 1.035759957077745513e-01 --2.343750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 5.203702830697561066e-02 5.203702830697561066e-02 5.203702830697561066e-02 --2.343750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 7.270970953824311411e-02 7.270970953824311411e-02 7.270970953824311411e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 9.066421242961551774e-02 9.066421242961551774e-02 9.066421242961551774e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 4.478603395784330754e-02 4.478603395784330754e-02 4.478603395784330754e-02 --2.031250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 1.118356216140506537e-01 1.118356216140506537e-01 1.118356216140506537e-01 --2.031250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 9.415593404141150979e-02 9.415593404141150979e-02 9.415593404141150979e-02 --2.343750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.044968092304020546e-01 1.044968092304020546e-01 1.044968092304020546e-01 --2.343750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.144611694293157650e-01 1.144611694293157650e-01 1.144611694293157650e-01 --2.343750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.185865128806325164e-01 1.185865128806325164e-01 1.185865128806325164e-01 --2.031250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.432257125496619876e-01 1.432257125496619876e-01 1.432257125496619876e-01 --2.031250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 8.057634393726484379e-02 8.057634393726484379e-02 8.057634393726484379e-02 --2.031250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 7.011889129640212770e-02 7.011889129640212770e-02 7.011889129640212770e-02 --1.718750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 6.930403353859117266e-02 6.930403353859117266e-02 6.930403353859117266e-02 --1.718750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 4.746708043424969353e-02 4.746708043424969353e-02 4.746708043424969353e-02 --1.718750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 8.653502592711553865e-02 8.653502592711553865e-02 8.653502592711553865e-02 --1.718750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 4.517875258575007602e-02 4.517875258575007602e-02 4.517875258575007602e-02 --1.406250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 7.153637204547896866e-02 7.153637204547896866e-02 7.153637204547896866e-02 --1.406250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 5.527387411872508594e-02 5.527387411872508594e-02 5.527387411872508594e-02 --1.718750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 4.407778470680202149e-02 4.407778470680202149e-02 4.407778470680202149e-02 --1.406250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 6.415400912495865249e-02 6.415400912495865249e-02 6.415400912495865249e-02 --1.406250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 6.377102996354053199e-02 6.377102996354053199e-02 6.377102996354053199e-02 --1.406250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 6.961801640427464632e-02 6.961801640427464632e-02 6.961801640427464632e-02 --1.406250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 6.061974325258275703e-02 6.061974325258275703e-02 6.061974325258275703e-02 --1.718750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 1.010151787838353549e-01 1.010151787838353549e-01 1.010151787838353549e-01 --1.718750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 6.063228465201872530e-02 6.063228465201872530e-02 6.063228465201872530e-02 --1.718750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 1.081116637369261141e-01 1.081116637369261141e-01 1.081116637369261141e-01 --1.718750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 2.375712420273704550e-01 2.375712420273704550e-01 2.375712420273704550e-01 --1.406250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 9.550999013691503781e-02 9.550999013691503781e-02 9.550999013691503781e-02 --1.406250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 7.923087773100966069e-02 7.923087773100966069e-02 7.923087773100966069e-02 --1.406250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 9.362475210337928289e-02 9.362475210337928289e-02 9.362475210337928289e-02 --1.406250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 8.162601700163636675e-02 8.162601700163636675e-02 8.162601700163636675e-02 --1.718750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 6.462107402278964574e-02 6.462107402278964574e-02 6.462107402278964574e-02 --1.718750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 7.289442604175695728e-02 7.289442604175695728e-02 7.289442604175695728e-02 --1.718750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 7.918651072019207426e-02 7.918651072019207426e-02 7.918651072019207426e-02 --1.718750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 8.326560143010793003e-02 8.326560143010793003e-02 8.326560143010793003e-02 --1.406250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 8.418825483798776654e-02 8.418825483798776654e-02 8.418825483798776654e-02 --1.406250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.107831288789391383e-01 1.107831288789391383e-01 1.107831288789391383e-01 --2.343750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 5.662705720373439194e-02 5.662705720373439194e-02 5.662705720373439194e-02 --2.031250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 6.623013604900744589e-02 6.623013604900744589e-02 6.623013604900744589e-02 --2.031250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 5.876246904415240169e-02 5.876246904415240169e-02 5.876246904415240169e-02 --2.343750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 2.531342212249038104e-02 2.531342212249038104e-02 2.531342212249038104e-02 --2.343750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 8.581010600014797596e-02 8.581010600014797596e-02 8.581010600014797596e-02 --2.343750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 7.569373746642113487e-02 7.569373746642113487e-02 7.569373746642113487e-02 --2.343750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 7.461746173541636273e-02 7.461746173541636273e-02 7.461746173541636273e-02 --2.031250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 7.765052901069649516e-02 7.765052901069649516e-02 7.765052901069649516e-02 --2.031250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 3.191089348128860886e-02 3.191089348128860886e-02 3.191089348128860886e-02 --2.031250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 9.623482267025121328e-02 9.623482267025121328e-02 9.623482267025121328e-02 --2.343750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 8.710563457920679487e-02 8.710563457920679487e-02 8.710563457920679487e-02 --2.343750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 7.216303301494803035e-02 7.216303301494803035e-02 7.216303301494803035e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 6.581404675541366323e-02 6.581404675541366323e-02 6.581404675541366323e-02 --2.343750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 8.462707408732920988e-02 8.462707408732920988e-02 8.462707408732920988e-02 --2.031250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.659425127651426302e-01 1.659425127651426302e-01 1.659425127651426302e-01 --2.031250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.133131053602346727e-01 1.133131053602346727e-01 1.133131053602346727e-01 --2.031250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 5.230444547692100071e-02 5.230444547692100071e-02 5.230444547692100071e-02 --2.343750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.073258745503074679e-01 1.073258745503074679e-01 1.073258745503074679e-01 --2.343750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 1.060443307308062966e-01 1.060443307308062966e-01 1.060443307308062966e-01 --2.343750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.285732260307534958e-01 1.285732260307534958e-01 1.285732260307534958e-01 --2.343750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.019914646959743931e-01 1.019914646959743931e-01 1.019914646959743931e-01 --2.031250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.255344467035036105e-01 1.255344467035036105e-01 1.255344467035036105e-01 --2.031250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 1.448953628062292776e-01 1.448953628062292776e-01 1.448953628062292776e-01 --2.031250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 8.147572009052726771e-02 8.147572009052726771e-02 8.147572009052726771e-02 --2.031250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 8.602067099792248817e-02 8.602067099792248817e-02 8.602067099792248817e-02 --1.718750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 2.801828031174942793e-02 2.801828031174942793e-02 2.801828031174942793e-02 --1.406250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 2.482891709138864214e-02 2.482891709138864214e-02 2.482891709138864214e-02 --1.406250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 7.476640500825353086e-02 7.476640500825353086e-02 7.476640500825353086e-02 --1.406250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 2.855058501994595099e-01 2.855058501994595099e-01 2.855058501994595099e-01 --1.718750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.718750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 8.315870797329338870e-02 8.315870797329338870e-02 8.315870797329338870e-02 --1.718750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 4.944602668739982859e-02 4.944602668739982859e-02 4.944602668739982859e-02 --1.406250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.249737500556666603e-01 1.249737500556666603e-01 1.249737500556666603e-01 --1.406250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.064500881924361902e-01 1.064500881924361902e-01 1.064500881924361902e-01 --1.406250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.210592074243249106e-01 1.210592074243249106e-01 1.210592074243249106e-01 --1.406250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 8.193866582631530171e-02 8.193866582631530171e-02 8.193866582631530171e-02 --1.406250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 2.010369537435881815e-01 2.010369537435881815e-01 2.010369537435881815e-01 --1.406250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.602859948889137631e-01 1.602859948889137631e-01 1.602859948889137631e-01 --2.343750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 7.413662949297231131e-02 7.413662949297231131e-02 7.413662949297231131e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.002204813400950217e-01 1.002204813400950217e-01 1.002204813400950217e-01 --2.343750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 9.354037340918472387e-02 9.354037340918472387e-02 9.354037340918472387e-02 --2.343750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.034361854032157801e-01 1.034361854032157801e-01 1.034361854032157801e-01 --2.031250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 7.230973013817283690e-02 7.230973013817283690e-02 7.230973013817283690e-02 --2.031250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 6.897855435899775955e-02 6.897855435899775955e-02 6.897855435899775955e-02 --2.343750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 6.500445108390111304e-02 6.500445108390111304e-02 6.500445108390111304e-02 --2.343750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 9.650964660189438604e-02 9.650964660189438604e-02 9.650964660189438604e-02 --2.343750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 5.830654516514748725e-02 5.830654516514748725e-02 5.830654516514748725e-02 --2.343750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 7.538612823965452903e-02 7.538612823965452903e-02 7.538612823965452903e-02 --2.031250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 6.546435644608381010e-02 6.546435644608381010e-02 6.546435644608381010e-02 --2.031250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 8.932454046168160355e-02 8.932454046168160355e-02 8.932454046168160355e-02 --2.031250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 7.279547656629736796e-02 7.279547656629736796e-02 7.279547656629736796e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 6.392160112336829625e-02 6.392160112336829625e-02 6.392160112336829625e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.456727542779006623e-01 1.456727542779006623e-01 1.456727542779006623e-01 --1.718750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 6.829881389555859939e-02 6.829881389555859939e-02 6.829881389555859939e-02 --1.406250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.074094353192747847e-01 1.074094353192747847e-01 1.074094353192747847e-01 --1.406250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 8.659369432729843719e-02 8.659369432729843719e-02 8.659369432729843719e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 1.636542603174414023e-01 1.636542603174414023e-01 1.636542603174414023e-01 --1.718750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.063239420324791629e-01 1.063239420324791629e-01 1.063239420324791629e-01 --1.718750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.362238869661399621e-01 1.362238869661399621e-01 1.362238869661399621e-01 --1.718750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 1.651091146720085057e-01 1.651091146720085057e-01 1.651091146720085057e-01 --1.406250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.962898248910145138e-01 1.962898248910145138e-01 1.962898248910145138e-01 --1.406250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.463714364846597227e-01 1.463714364846597227e-01 1.463714364846597227e-01 --1.406250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.368222544419299969e-01 1.368222544419299969e-01 1.368222544419299969e-01 --1.406250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 9.189537299610711640e-02 9.189537299610711640e-02 9.189537299610711640e-02 --1.718750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 4.273701513435625154e-02 4.273701513435625154e-02 4.273701513435625154e-02 --1.406250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 7.784520084279450414e-02 7.784520084279450414e-02 7.784520084279450414e-02 --1.406250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 7.375225099965435072e-02 7.375225099965435072e-02 7.375225099965435072e-02 --1.718750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 5.712166160883978827e-02 5.712166160883978827e-02 5.712166160883978827e-02 --1.718750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 1.696702176436405973e-01 1.696702176436405973e-01 1.696702176436405973e-01 --1.718750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 5.445926799143386426e-02 5.445926799143386426e-02 5.445926799143386426e-02 --1.406250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 1.137501589734590535e-01 1.137501589734590535e-01 1.137501589734590535e-01 --1.406250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 7.331875795261277862e-02 7.331875795261277862e-02 7.331875795261277862e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 6.369530213009776121e-02 6.369530213009776121e-02 6.369530213009776121e-02 --2.343750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 5.090881715990245443e-02 5.090881715990245443e-02 5.090881715990245443e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 5.312084224610414546e-02 5.312084224610414546e-02 5.312084224610414546e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 4.530394933747891595e-02 4.530394933747891595e-02 4.530394933747891595e-02 --2.031250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 5.699037305716578988e-02 5.699037305716578988e-02 5.699037305716578988e-02 --2.343750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.006953722629651132e-01 1.006953722629651132e-01 1.006953722629651132e-01 --2.343750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 1.084643825632671116e-01 1.084643825632671116e-01 1.084643825632671116e-01 --2.343750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 8.586073809191711870e-02 8.586073809191711870e-02 8.586073809191711870e-02 --2.343750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 8.329051642593761351e-02 8.329051642593761351e-02 8.329051642593761351e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 6.948031746427536792e-02 6.948031746427536792e-02 6.948031746427536792e-02 --2.031250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 9.420816808192104819e-02 9.420816808192104819e-02 9.420816808192104819e-02 --2.031250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 7.554133962701561900e-02 7.554133962701561900e-02 7.554133962701561900e-02 --2.031250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 6.550398809083664287e-02 6.550398809083664287e-02 6.550398809083664287e-02 --2.343750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 1.162093446910862637e-01 1.162093446910862637e-01 1.162093446910862637e-01 --2.031250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 5.360943816198530248e-02 5.360943816198530248e-02 5.360943816198530248e-02 --2.031250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 9.281310575748659419e-02 9.281310575748659419e-02 9.281310575748659419e-02 --2.031250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 5.315726392980602011e-02 5.315726392980602011e-02 5.315726392980602011e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 1.203233517537570102e-01 1.203233517537570102e-01 1.203233517537570102e-01 --1.718750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 5.397992326320264628e-02 5.397992326320264628e-02 5.397992326320264628e-02 --1.406250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 1.491990297475913607e-01 1.491990297475913607e-01 1.491990297475913607e-01 --1.406250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.036306341515858681e-01 1.036306341515858681e-01 1.036306341515858681e-01 --1.718750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 5.867130055414278983e-02 5.867130055414278983e-02 5.867130055414278983e-02 --1.718750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 7.022845475138717042e-02 7.022845475138717042e-02 7.022845475138717042e-02 --1.718750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 6.468635034676024909e-02 6.468635034676024909e-02 6.468635034676024909e-02 --1.718750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 6.403318277278512161e-02 6.403318277278512161e-02 6.403318277278512161e-02 --1.406250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.143149508431637595e-01 1.143149508431637595e-01 1.143149508431637595e-01 --1.406250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 7.284362502650901239e-02 7.284362502650901239e-02 7.284362502650901239e-02 --1.406250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 5.547278083654823277e-02 5.547278083654823277e-02 5.547278083654823277e-02 --1.718750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 6.420947824782748115e-02 6.420947824782748115e-02 6.420947824782748115e-02 --1.406250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 7.573022931129017032e-02 7.573022931129017032e-02 7.573022931129017032e-02 --1.718750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 6.972002439878095814e-02 6.972002439878095814e-02 6.972002439878095814e-02 --1.718750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 4.991293576490990480e-02 4.991293576490990480e-02 4.991293576490990480e-02 --1.718750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 7.852076149500680780e-02 7.852076149500680780e-02 7.852076149500680780e-02 --1.718750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 6.321593203602357547e-02 6.321593203602357547e-02 6.321593203602357547e-02 --1.406250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 9.861981311563895736e-02 9.861981311563895736e-02 9.861981311563895736e-02 --1.406250000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 9.008961080830980850e-02 9.008961080830980850e-02 9.008961080830980850e-02 --1.406250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 1.133572928738683233e-01 1.133572928738683233e-01 1.133572928738683233e-01 --1.406250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 9.371957757790369548e-02 9.371957757790369548e-02 9.371957757790369548e-02 --1.093750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 7.243110673379868358e-02 7.243110673379868358e-02 7.243110673379868358e-02 --1.093750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 5.808384820321755432e-02 5.808384820321755432e-02 5.808384820321755432e-02 --7.812500000000000000e-02 1.562500000000000000e-02 -2.343750000000000000e-01 8.773731774740733957e-02 8.773731774740733957e-02 8.773731774740733957e-02 --7.812500000000000000e-02 1.562500000000000000e-02 -2.031250000000000000e-01 9.025596442702260580e-02 9.025596442702260580e-02 9.025596442702260580e-02 --7.812500000000000000e-02 4.687500000000000000e-02 -2.343750000000000000e-01 8.312575582639576688e-02 8.312575582639576688e-02 8.312575582639576688e-02 --7.812500000000000000e-02 4.687500000000000000e-02 -2.031250000000000000e-01 9.488077877381799474e-02 9.488077877381799474e-02 9.488077877381799474e-02 --1.093750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 9.622035822678960681e-02 9.622035822678960681e-02 9.622035822678960681e-02 --1.093750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.006182328113592317e-01 1.006182328113592317e-01 1.006182328113592317e-01 --1.093750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 9.038695761420070807e-02 9.038695761420070807e-02 9.038695761420070807e-02 --1.093750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.042163880781976082e-01 1.042163880781976082e-01 1.042163880781976082e-01 --7.812500000000000000e-02 1.562500000000000000e-02 -1.718750000000000000e-01 1.664419051739099986e-01 1.664419051739099986e-01 1.664419051739099986e-01 --7.812500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 9.994406299790545289e-02 9.994406299790545289e-02 9.994406299790545289e-02 --7.812500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 1.298897537892972354e-01 1.298897537892972354e-01 1.298897537892972354e-01 --1.093750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 6.394169869412985596e-02 6.394169869412985596e-02 6.394169869412985596e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 5.765702403596308090e-02 5.765702403596308090e-02 5.765702403596308090e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 7.488134755053306446e-02 7.488134755053306446e-02 7.488134755053306446e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -2.343750000000000000e-01 5.657471836073342530e-02 5.657471836073342530e-02 5.657471836073342530e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 6.067979724368297023e-02 6.067979724368297023e-02 6.067979724368297023e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 9.042231770178768557e-02 9.042231770178768557e-02 9.042231770178768557e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 8.233168537588621272e-02 8.233168537588621272e-02 8.233168537588621272e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 9.237192029878256438e-02 9.237192029878256438e-02 9.237192029878256438e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -1.406250000000000000e-01 1.015905059072556432e-01 1.015905059072556432e-01 1.015905059072556432e-01 --7.812500000000000000e-02 1.093750000000000000e-01 -1.718750000000000000e-01 1.787442853113632435e-01 1.787442853113632435e-01 1.787442853113632435e-01 --7.812500000000000000e-02 1.093750000000000000e-01 -1.406250000000000000e-01 1.259722372147607794e-01 1.259722372147607794e-01 1.259722372147607794e-01 --4.687500000000000000e-02 1.562500000000000000e-02 -2.343750000000000000e-01 7.820962653223190175e-02 7.820962653223190175e-02 7.820962653223190175e-02 --4.687500000000000000e-02 4.687500000000000000e-02 -2.343750000000000000e-01 1.014289968927203495e-01 1.014289968927203495e-01 1.014289968927203495e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -2.031250000000000000e-01 1.193328279804201364e-01 1.193328279804201364e-01 1.193328279804201364e-01 --4.687500000000000000e-02 1.562500000000000000e-02 -1.718750000000000000e-01 6.880170663598110525e-02 6.880170663598110525e-02 6.880170663598110525e-02 --4.687500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 7.816566083855899794e-02 7.816566083855899794e-02 7.816566083855899794e-02 --4.687500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 1.248709284698939909e-01 1.248709284698939909e-01 1.248709284698939909e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 9.517971505416057687e-02 9.517971505416057687e-02 9.517971505416057687e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 4.727064653788053128e-02 4.727064653788053128e-02 4.727064653788053128e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 7.981423734729971298e-02 7.981423734729971298e-02 7.981423734729971298e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 1.340633015854069965e-01 1.340633015854069965e-01 1.340633015854069965e-01 --4.687500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 8.560355888295499704e-02 8.560355888295499704e-02 8.560355888295499704e-02 --4.687500000000000000e-02 7.812500000000000000e-02 -1.406250000000000000e-01 1.322207342351739978e-01 1.322207342351739978e-01 1.322207342351739978e-01 --4.687500000000000000e-02 1.093750000000000000e-01 -1.718750000000000000e-01 1.005876984246534683e-01 1.005876984246534683e-01 1.005876984246534683e-01 --4.687500000000000000e-02 1.093750000000000000e-01 -1.406250000000000000e-01 8.675041107690897868e-02 8.675041107690897868e-02 8.675041107690897868e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 1.334769617141876308e-01 1.334769617141876308e-01 1.334769617141876308e-01 --1.562500000000000000e-02 7.812500000000000000e-02 -1.406250000000000000e-01 1.135870675535669838e-01 1.135870675535669838e-01 1.135870675535669838e-01 --1.562500000000000000e-02 1.093750000000000000e-01 -1.718750000000000000e-01 1.172706035148429887e-01 1.172706035148429887e-01 1.172706035148429887e-01 --1.562500000000000000e-02 1.093750000000000000e-01 -1.406250000000000000e-01 9.704482735367914170e-02 9.704482735367914170e-02 9.704482735367914170e-02 --1.093750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 9.324785991750607350e-02 9.324785991750607350e-02 9.324785991750607350e-02 --1.093750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 8.146125299335915670e-02 8.146125299335915670e-02 8.146125299335915670e-02 --7.812500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 8.526199147504251452e-02 8.526199147504251452e-02 8.526199147504251452e-02 --7.812500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 1.382960667615024952e-01 1.382960667615024952e-01 1.382960667615024952e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -1.093750000000000000e-01 1.136184004135770420e-01 1.136184004135770420e-01 1.136184004135770420e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 1.311058560798580852e-01 1.311058560798580852e-01 1.311058560798580852e-01 --1.093750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 9.480443734138356560e-02 9.480443734138356560e-02 9.480443734138356560e-02 --1.093750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.314488353709268587e-01 1.314488353709268587e-01 1.314488353709268587e-01 --1.093750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.093750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 3.089358922636845084e-01 3.089358922636845084e-01 3.089358922636845084e-01 --7.812500000000000000e-02 1.562500000000000000e-02 -4.687500000000000000e-02 2.223863413299899117e-01 2.223863413299899117e-01 2.223863413299899117e-01 --7.812500000000000000e-02 1.562500000000000000e-02 -1.562500000000000000e-02 7.723970469871176414e-01 7.723970469871176414e-01 7.723970469871176414e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 1.262959596754549274e-01 1.262959596754549274e-01 1.262959596754549274e-01 --7.812500000000000000e-02 4.687500000000000000e-02 -1.562500000000000000e-02 4.062582149119013386e-01 4.062582149119013386e-01 4.062582149119013386e-01 --1.093750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 9.940568733781850186e-02 9.940568733781850186e-02 9.940568733781850186e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 6.438513021794413371e-02 6.438513021794413371e-02 6.438513021794413371e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.026262450651057312e-01 1.026262450651057312e-01 1.026262450651057312e-01 --1.093750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 8.784340145721367121e-02 8.784340145721367121e-02 8.784340145721367121e-02 --7.812500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 1.189199053038948461e-01 1.189199053038948461e-01 1.189199053038948461e-01 --7.812500000000000000e-02 1.093750000000000000e-01 -1.093750000000000000e-01 1.087624649216141909e-01 1.087624649216141909e-01 1.087624649216141909e-01 --1.093750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 7.411838321120520212e-02 7.411838321120520212e-02 7.411838321120520212e-02 --1.093750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 2.610368981046822801e-01 2.610368981046822801e-01 2.610368981046822801e-01 --1.093750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 5.781741499915498544e-02 5.781741499915498544e-02 5.781741499915498544e-02 --1.093750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.064091107991070595e-01 1.064091107991070595e-01 1.064091107991070595e-01 --7.812500000000000000e-02 7.812500000000000000e-02 -1.562500000000000000e-02 1.905800582984351899e-01 1.905800582984351899e-01 1.905800582984351899e-01 --7.812500000000000000e-02 1.093750000000000000e-01 -1.562500000000000000e-02 1.838536677712332978e-01 1.838536677712332978e-01 1.838536677712332978e-01 --4.687500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 1.049515875884298316e-01 1.049515875884298316e-01 1.049515875884298316e-01 --4.687500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 1.412829638028030299e-01 1.412829638028030299e-01 1.412829638028030299e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -1.093750000000000000e-01 1.118966818387183981e-01 1.118966818387183981e-01 1.118966818387183981e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 1.523870801845698120e-01 1.523870801845698120e-01 1.523870801845698120e-01 --1.562500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 4.672677220796528363e-02 4.672677220796528363e-02 4.672677220796528363e-02 --1.562500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 9.411816479098135402e-02 9.411816479098135402e-02 9.411816479098135402e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -1.093750000000000000e-01 2.425963603749418246e-02 2.425963603749418246e-02 2.425963603749418246e-02 --1.562500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 8.747532253149195580e-02 8.747532253149195580e-02 8.747532253149195580e-02 --4.687500000000000000e-02 1.562500000000000000e-02 -4.687500000000000000e-02 6.519978536702459859e-01 6.519978536702459859e-01 6.519978536702459859e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 2.160445454148297861e-01 2.160445454148297861e-01 2.160445454148297861e-01 --4.687500000000000000e-02 4.687500000000000000e-02 -1.562500000000000000e-02 3.854283815626161624e-01 3.854283815626161624e-01 3.854283815626161624e-01 --1.562500000000000000e-02 1.562500000000000000e-02 -4.687500000000000000e-02 2.304027343762567182e-01 2.304027343762567182e-01 2.304027343762567182e-01 --1.562500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 1.021770782081255907e-01 1.021770782081255907e-01 1.021770782081255907e-01 --4.687500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 1.114162330292560871e-01 1.114162330292560871e-01 1.114162330292560871e-01 --4.687500000000000000e-02 1.093750000000000000e-01 -1.093750000000000000e-01 9.907783890227396528e-02 9.907783890227396528e-02 9.907783890227396528e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 1.210656340817719834e-01 1.210656340817719834e-01 1.210656340817719834e-01 --1.562500000000000000e-02 7.812500000000000000e-02 -7.812500000000000000e-02 5.779530598814910242e-02 5.779530598814910242e-02 5.779530598814910242e-02 --1.562500000000000000e-02 1.093750000000000000e-01 -7.812500000000000000e-02 1.564149249914654205e-01 1.564149249914654205e-01 1.564149249914654205e-01 --4.687500000000000000e-02 7.812500000000000000e-02 -1.562500000000000000e-02 3.348741194257311982e-01 3.348741194257311982e-01 3.348741194257311982e-01 --4.687500000000000000e-02 1.093750000000000000e-01 -1.562500000000000000e-02 1.453788240880731220e-01 1.453788240880731220e-01 1.453788240880731220e-01 --1.562500000000000000e-02 7.812500000000000000e-02 -4.687500000000000000e-02 9.021497878477635624e-02 9.021497878477635624e-02 9.021497878477635624e-02 --1.562500000000000000e-02 7.812500000000000000e-02 -1.562500000000000000e-02 4.078831922893133011e-01 4.078831922893133011e-01 4.078831922893133011e-01 --1.562500000000000000e-02 1.093750000000000000e-01 -4.687500000000000000e-02 1.892878001804217392e-01 1.892878001804217392e-01 1.892878001804217392e-01 --1.562500000000000000e-02 1.093750000000000000e-01 -1.562500000000000000e-02 6.486332118430507832e-01 6.486332118430507832e-01 6.486332118430507832e-01 --1.093750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 9.582579934943688538e-02 9.582579934943688538e-02 9.582579934943688538e-02 --1.093750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 1.016893396219193807e-01 1.016893396219193807e-01 1.016893396219193807e-01 --7.812500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 1.136400923864549772e-01 1.136400923864549772e-01 1.136400923864549772e-01 --7.812500000000000000e-02 1.406250000000000000e-01 -1.406250000000000000e-01 1.140377775191829673e-01 1.140377775191829673e-01 1.140377775191829673e-01 --1.093750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 1.074921925337750384e-01 1.074921925337750384e-01 1.074921925337750384e-01 --1.093750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 6.878972920794813872e-02 6.878972920794813872e-02 6.878972920794813872e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 4.703232003688401913e-02 4.703232003688401913e-02 4.703232003688401913e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 7.423549693900477475e-02 7.423549693900477475e-02 7.423549693900477475e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -2.343750000000000000e-01 9.305901135656961809e-02 9.305901135656961809e-02 9.305901135656961809e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -2.031250000000000000e-01 5.856606272427336557e-02 5.856606272427336557e-02 5.856606272427336557e-02 --7.812500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 6.374731477920603240e-02 6.374731477920603240e-02 6.374731477920603240e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 7.531081323275345962e-02 7.531081323275345962e-02 7.531081323275345962e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 6.531676256283505677e-02 6.531676256283505677e-02 6.531676256283505677e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 6.184613815707572931e-02 6.184613815707572931e-02 6.184613815707572931e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 6.634083023014218650e-02 6.634083023014218650e-02 6.634083023014218650e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 3.887902184498132074e-02 3.887902184498132074e-02 3.887902184498132074e-02 --7.812500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 5.039913904851443111e-02 5.039913904851443111e-02 5.039913904851443111e-02 --4.687500000000000000e-02 1.406250000000000000e-01 -2.031250000000000000e-01 7.153195099768948351e-02 7.153195099768948351e-02 7.153195099768948351e-02 --4.687500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 9.708902380317117886e-02 9.708902380317117886e-02 9.708902380317117886e-02 --4.687500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 9.380074166649050860e-02 9.380074166649050860e-02 9.380074166649050860e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 9.297382845635271398e-02 9.297382845635271398e-02 9.297382845635271398e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 8.254708177878630759e-02 8.254708177878630759e-02 8.254708177878630759e-02 --4.687500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 5.718678322368183492e-02 5.718678322368183492e-02 5.718678322368183492e-02 --4.687500000000000000e-02 1.718750000000000000e-01 -1.718750000000000000e-01 5.890308056030701261e-02 5.890308056030701261e-02 5.890308056030701261e-02 --4.687500000000000000e-02 1.718750000000000000e-01 -1.406250000000000000e-01 5.435008505895311259e-02 5.435008505895311259e-02 5.435008505895311259e-02 --1.562500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 7.551465389970492270e-02 7.551465389970492270e-02 7.551465389970492270e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -1.718750000000000000e-01 8.145241198825453610e-02 8.145241198825453610e-02 8.145241198825453610e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -1.406250000000000000e-01 9.552606188249522512e-02 9.552606188249522512e-02 9.552606188249522512e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -2.343750000000000000e-01 7.568706604806041405e-02 7.568706604806041405e-02 7.568706604806041405e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -2.031250000000000000e-01 9.762259356844131541e-02 9.762259356844131541e-02 9.762259356844131541e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 9.178125838331718800e-02 9.178125838331718800e-02 9.178125838331718800e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -2.343750000000000000e-01 9.067465969384379265e-02 9.067465969384379265e-02 9.067465969384379265e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -2.031250000000000000e-01 1.122871448112896103e-01 1.122871448112896103e-01 1.122871448112896103e-01 --1.562500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 1.238941168510430957e-01 1.238941168510430957e-01 1.238941168510430957e-01 --1.562500000000000000e-02 2.343750000000000000e-01 -2.031250000000000000e-01 1.259923192911630574e-01 1.259923192911630574e-01 1.259923192911630574e-01 --4.687500000000000000e-02 2.031250000000000000e-01 -1.718750000000000000e-01 6.982814147790297743e-02 6.982814147790297743e-02 6.982814147790297743e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 4.813823266200139422e-02 4.813823266200139422e-02 4.813823266200139422e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 7.780854920437496602e-02 7.780854920437496602e-02 7.780854920437496602e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 5.794468238805064453e-02 5.794468238805064453e-02 5.794468238805064453e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -1.718750000000000000e-01 8.638313082923930464e-02 8.638313082923930464e-02 8.638313082923930464e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 8.553846026530319280e-02 8.553846026530319280e-02 8.553846026530319280e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 1.046390281804495392e-01 1.046390281804495392e-01 1.046390281804495392e-01 --1.562500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 9.352590848129382906e-02 9.352590848129382906e-02 9.352590848129382906e-02 --1.093750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 8.209298047959893985e-02 8.209298047959893985e-02 8.209298047959893985e-02 --7.812500000000000000e-02 1.406250000000000000e-01 -1.093750000000000000e-01 9.911480227310927316e-02 9.911480227310927316e-02 9.911480227310927316e-02 --1.093750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.109799701700175389e-01 1.109799701700175389e-01 1.109799701700175389e-01 --1.093750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 7.741719547157235870e-02 7.741719547157235870e-02 7.741719547157235870e-02 --1.093750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 1.052312026878524376e-01 1.052312026878524376e-01 1.052312026878524376e-01 --7.812500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 1.115327300776628866e-01 1.115327300776628866e-01 1.115327300776628866e-01 --7.812500000000000000e-02 1.406250000000000000e-01 -1.562500000000000000e-02 1.723524846863841442e-01 1.723524846863841442e-01 1.723524846863841442e-01 --7.812500000000000000e-02 1.718750000000000000e-01 -1.562500000000000000e-02 1.429237422808486702e-01 1.429237422808486702e-01 1.429237422808486702e-01 --1.093750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 7.715926587698469785e-02 7.715926587698469785e-02 7.715926587698469785e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 7.129851932981315366e-02 7.129851932981315366e-02 7.129851932981315366e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 6.866408668436868590e-02 6.866408668436868590e-02 6.866408668436868590e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 7.696362785801344475e-02 7.696362785801344475e-02 7.696362785801344475e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 1.038893627492565308e-01 1.038893627492565308e-01 1.038893627492565308e-01 --7.812500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 7.382234273968794891e-02 7.382234273968794891e-02 7.382234273968794891e-02 --7.812500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 8.612273856571148190e-02 8.612273856571148190e-02 8.612273856571148190e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 8.738852638225719227e-02 8.738852638225719227e-02 8.738852638225719227e-02 --1.093750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 1.023691194431114310e-01 1.023691194431114310e-01 1.023691194431114310e-01 --1.093750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 9.068269605001796907e-02 9.068269605001796907e-02 9.068269605001796907e-02 --1.093750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 7.873938312055052402e-02 7.873938312055052402e-02 7.873938312055052402e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -4.687500000000000000e-02 9.398637407614204853e-02 9.398637407614204853e-02 9.398637407614204853e-02 --7.812500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 9.387226242914978314e-02 9.387226242914978314e-02 9.387226242914978314e-02 --7.812500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 1.082128998225353467e-01 1.082128998225353467e-01 1.082128998225353467e-01 --7.812500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 9.550999013691503781e-02 9.550999013691503781e-02 9.550999013691503781e-02 --1.562500000000000000e-02 1.718750000000000000e-01 -7.812500000000000000e-02 9.892837814271983332e-02 9.892837814271983332e-02 9.892837814271983332e-02 --4.687500000000000000e-02 1.406250000000000000e-01 -1.562500000000000000e-02 2.545401542592296562e-01 2.545401542592296562e-01 2.545401542592296562e-01 --4.687500000000000000e-02 1.718750000000000000e-01 -4.687500000000000000e-02 1.601238007184425383e-01 1.601238007184425383e-01 1.601238007184425383e-01 --4.687500000000000000e-02 1.718750000000000000e-01 -1.562500000000000000e-02 2.793646559119347672e-01 2.793646559119347672e-01 2.793646559119347672e-01 --1.562500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 2.278058378256059557e-01 2.278058378256059557e-01 2.278058378256059557e-01 --1.562500000000000000e-02 1.406250000000000000e-01 -1.562500000000000000e-02 6.071094836895195579e-01 6.071094836895195579e-01 6.071094836895195579e-01 --1.562500000000000000e-02 1.718750000000000000e-01 -4.687500000000000000e-02 2.357711531175500086e-01 2.357711531175500086e-01 2.357711531175500086e-01 --1.562500000000000000e-02 1.718750000000000000e-01 -1.562500000000000000e-02 4.130188655963226152e-01 4.130188655963226152e-01 4.130188655963226152e-01 --4.687500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 6.466544906652357816e-02 6.466544906652357816e-02 6.466544906652357816e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -7.812500000000000000e-02 7.882008007046149844e-02 7.882008007046149844e-02 7.882008007046149844e-02 --4.687500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 7.674082177795274462e-02 7.674082177795274462e-02 7.674082177795274462e-02 --1.562500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 6.547617359169137508e-02 6.547617359169137508e-02 6.547617359169137508e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 8.823960680320340477e-02 8.823960680320340477e-02 8.823960680320340477e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 9.691304143287547690e-02 9.691304143287547690e-02 9.691304143287547690e-02 --4.687500000000000000e-02 2.031250000000000000e-01 -4.687500000000000000e-02 1.432730960793893171e-01 1.432730960793893171e-01 1.432730960793893171e-01 --4.687500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 1.455836116288515558e-01 1.455836116288515558e-01 1.455836116288515558e-01 --4.687500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 1.252589186098435059e-01 1.252589186098435059e-01 1.252589186098435059e-01 --4.687500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 1.084113543191202594e-01 1.084113543191202594e-01 1.084113543191202594e-01 --1.562500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 3.855420804316609384e-01 3.855420804316609384e-01 3.855420804316609384e-01 --1.562500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 9.460193129599120399e-02 9.460193129599120399e-02 9.460193129599120399e-02 --1.562500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 1.228787343075248562e-01 1.228787343075248562e-01 1.228787343075248562e-01 --4.687500000000000000e-02 2.656250000000000000e-01 -3.906250000000000000e-01 6.303296191609031318e-02 6.303296191609031318e-02 6.303296191609031318e-02 --4.687500000000000000e-02 2.968750000000000000e-01 -3.906250000000000000e-01 6.262103645004001018e-02 6.262103645004001018e-02 6.262103645004001018e-02 --1.562500000000000000e-02 2.656250000000000000e-01 -3.906250000000000000e-01 9.553891927666563477e-02 9.553891927666563477e-02 9.553891927666563477e-02 --1.562500000000000000e-02 2.968750000000000000e-01 -3.906250000000000000e-01 1.020051245794367234e-01 1.020051245794367234e-01 1.020051245794367234e-01 --1.562500000000000000e-02 3.281250000000000000e-01 -3.906250000000000000e-01 1.077669780140769057e-01 1.077669780140769057e-01 1.077669780140769057e-01 --1.562500000000000000e-02 3.593750000000000000e-01 -3.906250000000000000e-01 6.658352086115566781e-02 6.658352086115566781e-02 6.658352086115566781e-02 --7.812500000000000000e-02 2.656250000000000000e-01 -2.656250000000000000e-01 1.659674021708003044e-01 1.659674021708003044e-01 1.659674021708003044e-01 --7.812500000000000000e-02 2.968750000000000000e-01 -2.656250000000000000e-01 1.131676880985686279e-01 1.131676880985686279e-01 1.131676880985686279e-01 --7.812500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 6.595794186659112435e-02 6.595794186659112435e-02 6.595794186659112435e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -3.593750000000000000e-01 5.857080606716107141e-02 5.857080606716107141e-02 5.857080606716107141e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -3.281250000000000000e-01 5.258665565743295828e-02 5.258665565743295828e-02 5.258665565743295828e-02 --4.687500000000000000e-02 2.968750000000000000e-01 -3.593750000000000000e-01 6.924342328977757532e-02 6.924342328977757532e-02 6.924342328977757532e-02 --4.687500000000000000e-02 2.968750000000000000e-01 -3.281250000000000000e-01 6.484254704986319728e-02 6.484254704986319728e-02 6.484254704986319728e-02 --1.562500000000000000e-02 2.968750000000000000e-01 -3.593750000000000000e-01 8.474923579678869667e-02 8.474923579678869667e-02 8.474923579678869667e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -2.968750000000000000e-01 7.672972968424278395e-02 7.672972968424278395e-02 7.672972968424278395e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -2.656250000000000000e-01 1.036997356597185865e-01 1.036997356597185865e-01 1.036997356597185865e-01 --4.687500000000000000e-02 2.968750000000000000e-01 -2.968750000000000000e-01 9.388110206955878334e-02 9.388110206955878334e-02 9.388110206955878334e-02 --4.687500000000000000e-02 2.968750000000000000e-01 -2.656250000000000000e-01 6.872823433129009174e-02 6.872823433129009174e-02 6.872823433129009174e-02 --1.562500000000000000e-02 2.656250000000000000e-01 -2.968750000000000000e-01 5.111955392424600425e-02 5.111955392424600425e-02 5.111955392424600425e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -3.593750000000000000e-01 7.803054856557019303e-02 7.803054856557019303e-02 7.803054856557019303e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -3.281250000000000000e-01 1.055975934161372809e-01 1.055975934161372809e-01 1.055975934161372809e-01 --1.562500000000000000e-02 3.281250000000000000e-01 -3.593750000000000000e-01 9.862543800953656181e-02 9.862543800953656181e-02 9.862543800953656181e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -3.593750000000000000e-01 7.935899537487631217e-02 7.935899537487631217e-02 7.935899537487631217e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -3.281250000000000000e-01 8.825728732083244765e-02 8.825728732083244765e-02 8.825728732083244765e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 1.270285476308474770e-01 1.270285476308474770e-01 1.270285476308474770e-01 --4.687500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 5.344485797014276313e-02 5.344485797014276313e-02 5.344485797014276313e-02 --4.687500000000000000e-02 3.593750000000000000e-01 -2.656250000000000000e-01 3.674042841065321141e-02 3.674042841065321141e-02 3.674042841065321141e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 1.271458253463901567e-01 1.271458253463901567e-01 1.271458253463901567e-01 --1.562500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 3.595329848862549582e-02 3.595329848862549582e-02 3.595329848862549582e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -2.968750000000000000e-01 9.171214663771197484e-02 9.171214663771197484e-02 9.171214663771197484e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -2.656250000000000000e-01 3.745541684603683613e-02 3.745541684603683613e-02 3.745541684603683613e-02 --1.562500000000000000e-02 3.906250000000000000e-01 -3.593750000000000000e-01 5.123670113522045544e-02 5.123670113522045544e-02 5.123670113522045544e-02 --1.562500000000000000e-02 3.906250000000000000e-01 -3.281250000000000000e-01 8.839873132198873551e-02 8.839873132198873551e-02 8.839873132198873551e-02 --2.031250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 5.474356099965671518e-02 5.474356099965671518e-02 5.474356099965671518e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 5.195718891345710994e-02 5.195718891345710994e-02 5.195718891345710994e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 4.467756158291937008e-02 4.467756158291937008e-02 4.467756158291937008e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 8.271505842411877585e-02 8.271505842411877585e-02 8.271505842411877585e-02 --1.406250000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 3.670013925448881859e-02 3.670013925448881859e-02 3.670013925448881859e-02 --1.406250000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 7.760752753093755341e-02 7.760752753093755341e-02 7.760752753093755341e-02 --1.406250000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 7.447719919996113880e-02 7.447719919996113880e-02 7.447719919996113880e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 5.120060019407895319e-02 5.120060019407895319e-02 5.120060019407895319e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 5.858037314773446164e-02 5.858037314773446164e-02 5.858037314773446164e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 8.373175168687709002e-02 8.373175168687709002e-02 8.373175168687709002e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 7.533018454862305813e-02 7.533018454862305813e-02 7.533018454862305813e-02 --1.406250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 4.510340929571118873e-02 4.510340929571118873e-02 4.510340929571118873e-02 --1.406250000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 6.004452504282985909e-02 6.004452504282985909e-02 6.004452504282985909e-02 --1.718750000000000000e-01 3.281250000000000000e-01 -2.031250000000000000e-01 8.517760400971451096e-02 8.517760400971451096e-02 8.517760400971451096e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 5.086338928451966668e-02 5.086338928451966668e-02 5.086338928451966668e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -2.031250000000000000e-01 1.184153976786899709e-01 1.184153976786899709e-01 1.184153976786899709e-01 --1.406250000000000000e-01 3.593750000000000000e-01 -2.031250000000000000e-01 8.771963711551002130e-02 8.771963711551002130e-02 8.771963711551002130e-02 --1.718750000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 8.639840071978281688e-02 8.639840071978281688e-02 8.639840071978281688e-02 --1.718750000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 8.217013769526539113e-02 8.217013769526539113e-02 8.217013769526539113e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 8.282195247037847652e-02 8.282195247037847652e-02 8.282195247037847652e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 6.711431865294226196e-02 6.711431865294226196e-02 6.711431865294226196e-02 --1.406250000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 9.587642513845970327e-02 9.587642513845970327e-02 9.587642513845970327e-02 --1.406250000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 7.214864462515754862e-02 7.214864462515754862e-02 7.214864462515754862e-02 --2.343750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 9.937354539340169379e-02 9.937354539340169379e-02 9.937354539340169379e-02 --2.343750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 1.096221571817807411e-01 1.096221571817807411e-01 1.096221571817807411e-01 --2.031250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 5.315517350249525375e-02 5.315517350249525375e-02 5.315517350249525375e-02 --2.031250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 1.143776159840541734e-01 1.143776159840541734e-01 1.143776159840541734e-01 --2.343750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 7.909014098743717691e-02 7.909014098743717691e-02 7.909014098743717691e-02 --2.343750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 7.730675765975454639e-02 7.730675765975454639e-02 7.730675765975454639e-02 --2.031250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 6.177081047400766189e-02 6.177081047400766189e-02 6.177081047400766189e-02 --2.031250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 5.723687055331434098e-02 5.723687055331434098e-02 5.723687055331434098e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 6.465274751665130160e-02 6.465274751665130160e-02 6.465274751665130160e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 5.317929381437761643e-02 5.317929381437761643e-02 5.317929381437761643e-02 --1.406250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 5.422088238409672467e-02 5.422088238409672467e-02 5.422088238409672467e-02 --1.406250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 5.938151161430986480e-02 5.938151161430986480e-02 5.938151161430986480e-02 --1.406250000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 7.526282700696512729e-02 7.526282700696512729e-02 7.526282700696512729e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 6.509617512147511387e-02 6.509617512147511387e-02 6.509617512147511387e-02 --1.718750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 6.208498352465621067e-02 6.208498352465621067e-02 6.208498352465621067e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 6.412458635731750622e-02 6.412458635731750622e-02 6.412458635731750622e-02 --1.718750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 6.856899051720129201e-02 6.856899051720129201e-02 6.856899051720129201e-02 --1.406250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 8.772687010176556666e-02 8.772687010176556666e-02 8.772687010176556666e-02 --1.406250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 9.220798191618437278e-02 9.220798191618437278e-02 9.220798191618437278e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 6.750515979819134149e-02 6.750515979819134149e-02 6.750515979819134149e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -7.812500000000000000e-02 8.408297001005650417e-02 8.408297001005650417e-02 8.408297001005650417e-02 --1.406250000000000000e-01 3.593750000000000000e-01 -1.093750000000000000e-01 5.215923951115678664e-02 5.215923951115678664e-02 5.215923951115678664e-02 --1.406250000000000000e-01 3.593750000000000000e-01 -7.812500000000000000e-02 4.929840341543866022e-02 4.929840341543866022e-02 4.929840341543866022e-02 --1.718750000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 4.510083620451870584e-02 4.510083620451870584e-02 4.510083620451870584e-02 --1.718750000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 6.073350010538162980e-02 6.073350010538162980e-02 6.073350010538162980e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 8.804512085282603651e-02 8.804512085282603651e-02 8.804512085282603651e-02 --1.406250000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 7.791118982513778324e-02 7.791118982513778324e-02 7.791118982513778324e-02 --1.406250000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 4.944482061600344314e-02 4.944482061600344314e-02 4.944482061600344314e-02 --1.406250000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 9.917828280511102601e-02 9.917828280511102601e-02 9.917828280511102601e-02 --1.406250000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 9.364644946757466615e-02 9.364644946757466615e-02 9.364644946757466615e-02 --1.406250000000000000e-01 3.906250000000000000e-01 -7.812500000000000000e-02 5.921670204464701132e-02 5.921670204464701132e-02 5.921670204464701132e-02 --1.406250000000000000e-01 4.218750000000000000e-01 -1.093750000000000000e-01 7.480337955026754304e-02 7.480337955026754304e-02 7.480337955026754304e-02 --1.406250000000000000e-01 4.218750000000000000e-01 -7.812500000000000000e-02 8.267567637128618585e-02 8.267567637128618585e-02 8.267567637128618585e-02 --1.406250000000000000e-01 3.906250000000000000e-01 -4.687500000000000000e-02 6.788988968404675861e-02 6.788988968404675861e-02 6.788988968404675861e-02 --1.406250000000000000e-01 3.906250000000000000e-01 -1.562500000000000000e-02 6.071991360633324092e-02 6.071991360633324092e-02 6.071991360633324092e-02 --1.406250000000000000e-01 4.218750000000000000e-01 -4.687500000000000000e-02 6.494833939500710418e-02 6.494833939500710418e-02 6.494833939500710418e-02 --1.406250000000000000e-01 4.218750000000000000e-01 -1.562500000000000000e-02 4.853865387151651972e-02 4.853865387151651972e-02 4.853865387151651972e-02 --1.406250000000000000e-01 4.531250000000000000e-01 -7.812500000000000000e-02 8.477495402777869560e-02 8.477495402777869560e-02 8.477495402777869560e-02 --1.406250000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 6.891472845288668103e-02 6.891472845288668103e-02 6.891472845288668103e-02 --1.093750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 8.416173271874428929e-02 8.416173271874428929e-02 8.416173271874428929e-02 --1.093750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 5.647462324356801455e-02 5.647462324356801455e-02 5.647462324356801455e-02 --1.093750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 5.377192760587111431e-02 5.377192760587111431e-02 5.377192760587111431e-02 --7.812500000000000000e-02 2.656250000000000000e-01 -2.343750000000000000e-01 1.448776947309381169e-01 1.448776947309381169e-01 1.448776947309381169e-01 --7.812500000000000000e-02 2.968750000000000000e-01 -2.343750000000000000e-01 1.399184338465396527e-01 1.399184338465396527e-01 1.399184338465396527e-01 --1.093750000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 5.072477380353490606e-02 5.072477380353490606e-02 5.072477380353490606e-02 --1.093750000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 5.052633776894192158e-02 5.052633776894192158e-02 5.052633776894192158e-02 --1.093750000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 6.127189343085015505e-02 6.127189343085015505e-02 6.127189343085015505e-02 --7.812500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 5.935377539327672813e-02 5.935377539327672813e-02 5.935377539327672813e-02 --7.812500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 7.601412565365502083e-02 7.601412565365502083e-02 7.601412565365502083e-02 --1.093750000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 1.131982177112084847e-01 1.131982177112084847e-01 1.131982177112084847e-01 --1.093750000000000000e-01 3.593750000000000000e-01 -2.031250000000000000e-01 9.992076024541858559e-02 9.992076024541858559e-02 9.992076024541858559e-02 --7.812500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 1.048198146184661783e-01 1.048198146184661783e-01 1.048198146184661783e-01 --7.812500000000000000e-02 3.593750000000000000e-01 -2.343750000000000000e-01 7.490915879832661661e-02 7.490915879832661661e-02 7.490915879832661661e-02 --7.812500000000000000e-02 3.593750000000000000e-01 -2.031250000000000000e-01 1.149640950649030713e-01 1.149640950649030713e-01 1.149640950649030713e-01 --1.093750000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 1.042380825861838750e-01 1.042380825861838750e-01 1.042380825861838750e-01 --7.812500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 1.001055749934189193e-01 1.001055749934189193e-01 1.001055749934189193e-01 --1.562500000000000000e-02 2.656250000000000000e-01 -2.031250000000000000e-01 1.531965197328007122e-01 1.531965197328007122e-01 1.531965197328007122e-01 --1.562500000000000000e-02 2.968750000000000000e-01 -2.031250000000000000e-01 8.723422188571981761e-02 8.723422188571981761e-02 8.723422188571981761e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 1.283683951872058859e-01 1.283683951872058859e-01 1.283683951872058859e-01 --4.687500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 7.394315439139377555e-02 7.394315439139377555e-02 7.394315439139377555e-02 --1.562500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 1.270325639938071349e-01 1.270325639938071349e-01 1.270325639938071349e-01 --1.562500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 6.751352001584665086e-02 6.751352001584665086e-02 6.751352001584665086e-02 --1.562500000000000000e-02 2.968750000000000000e-01 -1.718750000000000000e-01 1.242531928953754944e-01 1.242531928953754944e-01 1.242531928953754944e-01 --1.562500000000000000e-02 2.968750000000000000e-01 -1.406250000000000000e-01 8.985253621621529241e-02 8.985253621621529241e-02 8.985253621621529241e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 5.392316068258241890e-02 5.392316068258241890e-02 5.392316068258241890e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 8.128764762444684600e-02 8.128764762444684600e-02 8.128764762444684600e-02 --4.687500000000000000e-02 3.593750000000000000e-01 -2.343750000000000000e-01 3.378093113469996661e-02 3.378093113469996661e-02 3.378093113469996661e-02 --4.687500000000000000e-02 3.593750000000000000e-01 -2.031250000000000000e-01 8.155287789814322230e-02 8.155287789814322230e-02 8.155287789814322230e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 7.188788475781926479e-02 7.188788475781926479e-02 7.188788475781926479e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -2.343750000000000000e-01 3.173653777908134327e-02 3.173653777908134327e-02 3.173653777908134327e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -2.031250000000000000e-01 3.534485175362211268e-02 3.534485175362211268e-02 3.534485175362211268e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -1.718750000000000000e-01 1.163716274163543452e-01 1.163716274163543452e-01 1.163716274163543452e-01 --4.687500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 1.098278392018264410e-01 1.098278392018264410e-01 1.098278392018264410e-01 --4.687500000000000000e-02 3.593750000000000000e-01 -1.406250000000000000e-01 9.933095729726285072e-02 9.933095729726285072e-02 9.933095729726285072e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -1.718750000000000000e-01 9.216619364758951716e-02 9.216619364758951716e-02 9.216619364758951716e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -1.406250000000000000e-01 9.666714761324522731e-02 9.666714761324522731e-02 9.666714761324522731e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 8.064385777769482455e-02 8.064385777769482455e-02 8.064385777769482455e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -1.406250000000000000e-01 6.766362148819620170e-01 6.766362148819620170e-01 6.766362148819620170e-01 --1.093750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 5.178826361123128885e-02 5.178826361123128885e-02 5.178826361123128885e-02 --1.093750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 8.678898746077952364e-02 8.678898746077952364e-02 8.678898746077952364e-02 --1.093750000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 7.570708030148294576e-02 7.570708030148294576e-02 7.570708030148294576e-02 --1.093750000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 9.860454554451360265e-02 9.860454554451360265e-02 9.860454554451360265e-02 --7.812500000000000000e-02 2.656250000000000000e-01 -1.093750000000000000e-01 8.968457447225290646e-02 8.968457447225290646e-02 8.968457447225290646e-02 --7.812500000000000000e-02 2.968750000000000000e-01 -1.093750000000000000e-01 8.646349864162733434e-02 8.646349864162733434e-02 8.646349864162733434e-02 --7.812500000000000000e-02 2.968750000000000000e-01 -7.812500000000000000e-02 1.087423785440269769e-01 1.087423785440269769e-01 1.087423785440269769e-01 --1.093750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 8.516554865029923871e-02 8.516554865029923871e-02 8.516554865029923871e-02 --1.093750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 8.907781979642927228e-02 8.907781979642927228e-02 8.907781979642927228e-02 --7.812500000000000000e-02 2.656250000000000000e-01 -4.687500000000000000e-02 9.222967966248392380e-02 9.222967966248392380e-02 9.222967966248392380e-02 --7.812500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 9.673946940291999752e-02 9.673946940291999752e-02 9.673946940291999752e-02 --7.812500000000000000e-02 2.968750000000000000e-01 -1.562500000000000000e-02 6.411276901318656296e-02 6.411276901318656296e-02 6.411276901318656296e-02 --1.093750000000000000e-01 3.281250000000000000e-01 -7.812500000000000000e-02 9.663179027019166978e-02 9.663179027019166978e-02 9.663179027019166978e-02 --1.093750000000000000e-01 3.593750000000000000e-01 -7.812500000000000000e-02 5.328212666291202299e-02 5.328212666291202299e-02 5.328212666291202299e-02 --7.812500000000000000e-02 3.281250000000000000e-01 -7.812500000000000000e-02 8.851526170428737628e-02 8.851526170428737628e-02 8.851526170428737628e-02 --1.093750000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 9.341742143922499020e-02 9.341742143922499020e-02 9.341742143922499020e-02 --1.093750000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 8.965805416483664525e-02 8.965805416483664525e-02 8.965805416483664525e-02 --1.093750000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 7.153733663768031825e-02 7.153733663768031825e-02 7.153733663768031825e-02 --1.093750000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 6.358814149663148674e-02 6.358814149663148674e-02 6.358814149663148674e-02 --7.812500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 9.660125437049300878e-02 9.660125437049300878e-02 9.660125437049300878e-02 --7.812500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 7.814886223993540437e-02 7.814886223993540437e-02 7.814886223993540437e-02 --7.812500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 7.245473897680863862e-02 7.245473897680863862e-02 7.245473897680863862e-02 --7.812500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 8.416816232420898380e-02 8.416816232420898380e-02 8.416816232420898380e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -1.093750000000000000e-01 1.060379028733676177e-01 1.060379028733676177e-01 1.060379028733676177e-01 --4.687500000000000000e-02 2.656250000000000000e-01 -7.812500000000000000e-02 1.030898726255308068e-01 1.030898726255308068e-01 1.030898726255308068e-01 --4.687500000000000000e-02 2.968750000000000000e-01 -1.093750000000000000e-01 8.640241911153909160e-02 8.640241911153909160e-02 8.640241911153909160e-02 --4.687500000000000000e-02 2.968750000000000000e-01 -7.812500000000000000e-02 1.101476094231460395e-01 1.101476094231460395e-01 1.101476094231460395e-01 --1.562500000000000000e-02 2.656250000000000000e-01 -1.093750000000000000e-01 7.523099693184297221e-02 7.523099693184297221e-02 7.523099693184297221e-02 --1.562500000000000000e-02 2.656250000000000000e-01 -7.812500000000000000e-02 9.846954794741046013e-02 9.846954794741046013e-02 9.846954794741046013e-02 --1.562500000000000000e-02 2.968750000000000000e-01 -1.093750000000000000e-01 6.503684792945198245e-02 6.503684792945198245e-02 6.503684792945198245e-02 --1.562500000000000000e-02 2.968750000000000000e-01 -7.812500000000000000e-02 9.917667570366249519e-02 9.917667570366249519e-02 9.917667570366249519e-02 --4.687500000000000000e-02 2.656250000000000000e-01 -4.687500000000000000e-02 1.146941545395396972e-01 1.146941545395396972e-01 1.146941545395396972e-01 --4.687500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 1.023474244311703418e-01 1.023474244311703418e-01 1.023474244311703418e-01 --1.562500000000000000e-02 2.656250000000000000e-01 -4.687500000000000000e-02 1.070751917226447220e-01 1.070751917226447220e-01 1.070751917226447220e-01 --1.562500000000000000e-02 2.656250000000000000e-01 -1.562500000000000000e-02 1.062299348929369863e-01 1.062299348929369863e-01 1.062299348929369863e-01 --1.562500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 1.023578701783841582e-01 1.023578701783841582e-01 1.023578701783841582e-01 --1.562500000000000000e-02 2.968750000000000000e-01 -1.562500000000000000e-02 1.047812468791147339e-01 1.047812468791147339e-01 1.047812468791147339e-01 --4.687500000000000000e-02 3.281250000000000000e-01 -1.093750000000000000e-01 6.462002895804368208e-02 6.462002895804368208e-02 6.462002895804368208e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -7.812500000000000000e-02 8.717716129382850621e-02 8.717716129382850621e-02 8.717716129382850621e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -1.093750000000000000e-01 9.490167220587440722e-02 9.490167220587440722e-02 9.490167220587440722e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -7.812500000000000000e-02 7.902318846960822152e-02 7.902318846960822152e-02 7.902318846960822152e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -1.093750000000000000e-01 1.072310651111667568e-01 1.072310651111667568e-01 1.072310651111667568e-01 --1.562500000000000000e-02 3.593750000000000000e-01 -7.812500000000000000e-02 9.533159354527302731e-02 9.533159354527302731e-02 9.533159354527302731e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 9.760732580807515713e-02 9.760732580807515713e-02 9.760732580807515713e-02 --4.687500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 7.462742880599874951e-02 7.462742880599874951e-02 7.462742880599874951e-02 --4.687500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 6.233580657382505746e-02 6.233580657382505746e-02 6.233580657382505746e-02 --4.687500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 3.903559032002499457e-02 3.903559032002499457e-02 3.903559032002499457e-02 --1.562500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 6.819366904419352227e-02 6.819366904419352227e-02 6.819366904419352227e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 5.391455785171576226e-02 5.391455785171576226e-02 5.391455785171576226e-02 --1.562500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 6.347109265964429037e-02 6.347109265964429037e-02 6.347109265964429037e-02 --1.093750000000000000e-01 3.906250000000000000e-01 -1.718750000000000000e-01 6.021375458672232478e-02 6.021375458672232478e-02 6.021375458672232478e-02 --1.093750000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 1.282181855705100126e-01 1.282181855705100126e-01 1.282181855705100126e-01 --7.812500000000000000e-02 3.906250000000000000e-01 -1.718750000000000000e-01 8.373416280187701011e-02 8.373416280187701011e-02 8.373416280187701011e-02 --7.812500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 1.270984323175449182e-01 1.270984323175449182e-01 1.270984323175449182e-01 --7.812500000000000000e-02 4.218750000000000000e-01 -1.406250000000000000e-01 8.487782686950919031e-02 8.487782686950919031e-02 8.487782686950919031e-02 --4.687500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 1.285531445985581001e-01 1.285531445985581001e-01 1.285531445985581001e-01 --4.687500000000000000e-02 4.218750000000000000e-01 -1.406250000000000000e-01 8.005206488866541126e-02 8.005206488866541126e-02 8.005206488866541126e-02 --1.562500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 1.103002631007121564e-01 1.103002631007121564e-01 1.103002631007121564e-01 --1.093750000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 8.444865336259212152e-02 8.444865336259212152e-02 8.444865336259212152e-02 --1.093750000000000000e-01 4.218750000000000000e-01 -1.093750000000000000e-01 9.365850355626791079e-02 9.365850355626791079e-02 9.365850355626791079e-02 --7.812500000000000000e-02 4.218750000000000000e-01 -1.093750000000000000e-01 8.801618901838323406e-02 8.801618901838323406e-02 8.801618901838323406e-02 --1.093750000000000000e-01 3.906250000000000000e-01 -1.562500000000000000e-02 7.243392009642746210e-02 7.243392009642746210e-02 7.243392009642746210e-02 --1.093750000000000000e-01 4.218750000000000000e-01 -1.562500000000000000e-02 3.863608679751375646e-02 3.863608679751375646e-02 3.863608679751375646e-02 --7.812500000000000000e-02 3.906250000000000000e-01 -1.562500000000000000e-02 4.346071505205312269e-02 4.346071505205312269e-02 4.346071505205312269e-02 --1.093750000000000000e-01 4.531250000000000000e-01 -1.093750000000000000e-01 5.948554245665274576e-02 5.948554245665274576e-02 5.948554245665274576e-02 --1.093750000000000000e-01 4.531250000000000000e-01 -7.812500000000000000e-02 8.996022442260991070e-02 8.996022442260991070e-02 8.996022442260991070e-02 --7.812500000000000000e-02 4.531250000000000000e-01 -1.093750000000000000e-01 6.587683007300058902e-02 6.587683007300058902e-02 6.587683007300058902e-02 --7.812500000000000000e-02 4.531250000000000000e-01 -7.812500000000000000e-02 5.572274011733529403e-02 5.572274011733529403e-02 5.572274011733529403e-02 --7.812500000000000000e-02 4.843750000000000000e-01 -7.812500000000000000e-02 2.555374325654558715e-02 2.555374325654558715e-02 2.555374325654558715e-02 --1.093750000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 5.686792799931309622e-02 5.686792799931309622e-02 5.686792799931309622e-02 --1.093750000000000000e-01 4.531250000000000000e-01 -1.562500000000000000e-02 3.821173275520069190e-02 3.821173275520069190e-02 3.821173275520069190e-02 --1.093750000000000000e-01 4.843750000000000000e-01 -4.687500000000000000e-02 3.274108844315039291e-02 3.274108844315039291e-02 3.274108844315039291e-02 --1.093750000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 3.095917053473980565e-02 3.095917053473980565e-02 3.095917053473980565e-02 --7.812500000000000000e-02 4.531250000000000000e-01 -4.687500000000000000e-02 5.627724656330397590e-02 5.627724656330397590e-02 5.627724656330397590e-02 --7.812500000000000000e-02 4.843750000000000000e-01 -4.687500000000000000e-02 3.104835985409798091e-02 3.104835985409798091e-02 3.104835985409798091e-02 --7.812500000000000000e-02 4.843750000000000000e-01 -1.562500000000000000e-02 3.414603899241121926e-02 3.414603899241121926e-02 3.414603899241121926e-02 --4.687500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 9.733893417897231115e-02 9.733893417897231115e-02 9.733893417897231115e-02 --4.687500000000000000e-02 4.218750000000000000e-01 -1.093750000000000000e-01 9.333786418206964364e-02 9.333786418206964364e-02 9.333786418206964364e-02 --4.687500000000000000e-02 4.218750000000000000e-01 -7.812500000000000000e-02 3.849125823913126382e-02 3.849125823913126382e-02 3.849125823913126382e-02 --1.562500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 1.183551457603747165e-01 1.183551457603747165e-01 1.183551457603747165e-01 --1.562500000000000000e-02 3.906250000000000000e-01 -7.812500000000000000e-02 9.827267604559357383e-02 9.827267604559357383e-02 9.827267604559357383e-02 --1.562500000000000000e-02 4.218750000000000000e-01 -1.093750000000000000e-01 7.525977260636136645e-02 7.525977260636136645e-02 7.525977260636136645e-02 --1.562500000000000000e-02 4.218750000000000000e-01 -7.812500000000000000e-02 5.528416518166458932e-02 5.528416518166458932e-02 5.528416518166458932e-02 --4.687500000000000000e-02 3.906250000000000000e-01 -4.687500000000000000e-02 3.635635371808154659e-02 3.635635371808154659e-02 3.635635371808154659e-02 --4.687500000000000000e-02 3.906250000000000000e-01 -1.562500000000000000e-02 4.782247742333404356e-02 4.782247742333404356e-02 4.782247742333404356e-02 --1.562500000000000000e-02 3.906250000000000000e-01 -4.687500000000000000e-02 7.711610338041917367e-02 7.711610338041917367e-02 7.711610338041917367e-02 --1.562500000000000000e-02 4.218750000000000000e-01 -4.687500000000000000e-02 5.494496140576081433e-02 5.494496140576081433e-02 5.494496140576081433e-02 --1.562500000000000000e-02 4.218750000000000000e-01 -1.562500000000000000e-02 5.674741229419776045e-02 5.674741229419776045e-02 5.674741229419776045e-02 --4.687500000000000000e-02 4.531250000000000000e-01 -7.812500000000000000e-02 4.983277264600547568e-02 4.983277264600547568e-02 4.983277264600547568e-02 --4.687500000000000000e-02 4.843750000000000000e-01 -7.812500000000000000e-02 3.014142291448627942e-02 3.014142291448627942e-02 3.014142291448627942e-02 --1.562500000000000000e-02 4.531250000000000000e-01 -7.812500000000000000e-02 4.657456071174521928e-02 4.657456071174521928e-02 4.657456071174521928e-02 --1.562500000000000000e-02 4.843750000000000000e-01 -7.812500000000000000e-02 1.976798146230267575e-02 1.976798146230267575e-02 1.976798146230267575e-02 --4.687500000000000000e-02 4.531250000000000000e-01 -1.562500000000000000e-02 3.970158594484221593e-02 3.970158594484221593e-02 3.970158594484221593e-02 --4.687500000000000000e-02 4.843750000000000000e-01 -4.687500000000000000e-02 3.222059910366188024e-02 3.222059910366188024e-02 3.222059910366188024e-02 --4.687500000000000000e-02 4.843750000000000000e-01 -1.562500000000000000e-02 2.890376763537210944e-02 2.890376763537210944e-02 2.890376763537210944e-02 --1.562500000000000000e-02 4.531250000000000000e-01 -4.687500000000000000e-02 5.159417194079700397e-02 5.159417194079700397e-02 5.159417194079700397e-02 --1.562500000000000000e-02 4.531250000000000000e-01 -1.562500000000000000e-02 5.622249555315792652e-02 5.622249555315792652e-02 5.622249555315792652e-02 --1.562500000000000000e-02 4.843750000000000000e-01 -4.687500000000000000e-02 2.377214873479691765e-02 2.377214873479691765e-02 2.377214873479691765e-02 --1.562500000000000000e-02 4.843750000000000000e-01 -1.562500000000000000e-02 2.507285898319983400e-02 2.507285898319983400e-02 2.507285898319983400e-02 --4.218750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.968489265967844626e-02 1.968489265967844626e-02 1.968489265967844626e-02 --3.906250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 7.701691796537868395e-02 7.701691796537868395e-02 7.701691796537868395e-02 --3.906250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 5.592783639329358680e-02 5.592783639329358680e-02 5.592783639329358680e-02 --4.218750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 3.726635686206786896e-02 3.726635686206786896e-02 3.726635686206786896e-02 --3.906250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 4.979490217791390783e-02 4.979490217791390783e-02 4.979490217791390783e-02 --4.218750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 5.738407727579838274e-02 5.738407727579838274e-02 5.738407727579838274e-02 --4.218750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 8.749139588219681518e-02 8.749139588219681518e-02 8.749139588219681518e-02 --4.218750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 3.156073409159455140e-02 3.156073409159455140e-02 3.156073409159455140e-02 --4.218750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 2.691619287520911549e-02 2.691619287520911549e-02 2.691619287520911549e-02 --3.906250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 8.745040883157653711e-02 8.745040883157653711e-02 8.745040883157653711e-02 --4.218750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 7.707912990125466435e-02 7.707912990125466435e-02 7.707912990125466435e-02 --4.218750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 9.208984963929280065e-02 9.208984963929280065e-02 9.208984963929280065e-02 --4.218750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 5.712343034475771825e-02 5.712343034475771825e-02 5.712343034475771825e-02 --4.218750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 7.456706370641223713e-02 7.456706370641223713e-02 7.456706370641223713e-02 --3.906250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 4.974907165127018249e-02 4.974907165127018249e-02 4.974907165127018249e-02 --4.218750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 4.500603381846923073e-02 4.500603381846923073e-02 4.500603381846923073e-02 --4.218750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 3.576616501716449459e-02 3.576616501716449459e-02 3.576616501716449459e-02 --4.218750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.976741842132367574e-02 1.976741842132367574e-02 1.976741842132367574e-02 --4.218750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 3.253006226883949081e-02 3.253006226883949081e-02 3.253006226883949081e-02 --3.906250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 6.146588136293081039e-02 6.146588136293081039e-02 6.146588136293081039e-02 --3.906250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 5.525280959516155194e-02 5.525280959516155194e-02 5.525280959516155194e-02 --3.906250000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 5.108425696175045161e-02 5.108425696175045161e-02 5.108425696175045161e-02 --3.906250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 4.642098199528989916e-02 4.642098199528989916e-02 4.642098199528989916e-02 --4.218750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 6.923514363685216721e-02 6.923514363685216721e-02 6.923514363685216721e-02 --3.906250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 3.708131728976180735e-02 3.708131728976180735e-02 3.708131728976180735e-02 --3.906250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 6.526298237140096270e-02 6.526298237140096270e-02 6.526298237140096270e-02 --3.906250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 3.151907515601032328e-02 3.151907515601032328e-02 3.151907515601032328e-02 --3.906250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 4.124593154707755643e-02 4.124593154707755643e-02 4.124593154707755643e-02 --3.593750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 3.174667100827777144e-02 3.174667100827777144e-02 3.174667100827777144e-02 --3.593750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 5.713645467164597119e-02 5.713645467164597119e-02 5.713645467164597119e-02 --3.593750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 3.948977387960268121e-02 3.948977387960268121e-02 3.948977387960268121e-02 --3.593750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 6.644332470650823885e-02 6.644332470650823885e-02 6.644332470650823885e-02 --3.281250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 3.981995599807416908e-02 3.981995599807416908e-02 3.981995599807416908e-02 --3.281250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 7.817418070064516278e-02 7.817418070064516278e-02 7.817418070064516278e-02 --3.593750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 4.511989315920854338e-02 4.511989315920854338e-02 4.511989315920854338e-02 --3.593750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 6.828161130694213043e-02 6.828161130694213043e-02 6.828161130694213043e-02 --3.593750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 6.252319982234563756e-02 6.252319982234563756e-02 6.252319982234563756e-02 --3.593750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 8.937677763903387196e-02 8.937677763903387196e-02 8.937677763903387196e-02 --3.281250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 7.330758500619427576e-02 7.330758500619427576e-02 7.330758500619427576e-02 --3.281250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 8.504499495677707299e-02 8.504499495677707299e-02 8.504499495677707299e-02 --3.281250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 7.988143032988062608e-02 7.988143032988062608e-02 7.988143032988062608e-02 --3.593750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 4.719852148706928097e-02 4.719852148706928097e-02 4.719852148706928097e-02 --3.593750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 4.313135198555866773e-02 4.313135198555866773e-02 4.313135198555866773e-02 --3.281250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 8.520251841344372856e-02 8.520251841344372856e-02 8.520251841344372856e-02 --3.281250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 1.090308184450909101e-01 1.090308184450909101e-01 1.090308184450909101e-01 --3.281250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 4.391712511947322428e-02 4.391712511947322428e-02 4.391712511947322428e-02 --3.593750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 5.777086547435130587e-02 5.777086547435130587e-02 5.777086547435130587e-02 --3.593750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 4.299409017283437051e-02 4.299409017283437051e-02 4.299409017283437051e-02 --3.593750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.013711428384879154e-01 1.013711428384879154e-01 1.013711428384879154e-01 --3.281250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 6.214849328090011477e-02 6.214849328090011477e-02 6.214849328090011477e-02 --3.281250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 8.385873697840684482e-02 8.385873697840684482e-02 8.385873697840684482e-02 --3.281250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 8.197483334973135194e-02 8.197483334973135194e-02 8.197483334973135194e-02 --2.968750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.103814104640432753e-01 1.103814104640432753e-01 1.103814104640432753e-01 --2.656250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 9.551079372426583836e-02 9.551079372426583836e-02 9.551079372426583836e-02 --2.656250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.199056140987317109e-01 1.199056140987317109e-01 1.199056140987317109e-01 --2.656250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 9.949648826141764546e-02 9.949648826141764546e-02 9.949648826141764546e-02 --2.968750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 6.918546570145978070e-02 6.918546570145978070e-02 6.918546570145978070e-02 --2.968750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 6.771086913234065918e-02 6.771086913234065918e-02 6.771086913234065918e-02 --2.968750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 8.064948392850813941e-02 8.064948392850813941e-02 8.064948392850813941e-02 --2.968750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 9.274319128326700967e-02 9.274319128326700967e-02 9.274319128326700967e-02 --2.656250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 1.047932992996470081e-01 1.047932992996470081e-01 1.047932992996470081e-01 --2.656250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.054192191910524184e-01 1.054192191910524184e-01 1.054192191910524184e-01 --2.968750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 1.988909491187198786e-01 1.988909491187198786e-01 1.988909491187198786e-01 --2.968750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 5.456668198365614147e-02 5.456668198365614147e-02 5.456668198365614147e-02 --2.968750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 4.016525460131614017e-02 4.016525460131614017e-02 4.016525460131614017e-02 --2.656250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 6.605545276491182893e-02 6.605545276491182893e-02 6.605545276491182893e-02 --2.656250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 5.913992478836863076e-02 5.913992478836863076e-02 5.913992478836863076e-02 --2.968750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 5.069687379097493479e-02 5.069687379097493479e-02 5.069687379097493479e-02 --2.968750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 6.933859904466223301e-02 6.933859904466223301e-02 6.933859904466223301e-02 --2.656250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 1.000887006209914970e-01 1.000887006209914970e-01 1.000887006209914970e-01 --2.656250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.036908970980340156e-01 1.036908970980340156e-01 1.036908970980340156e-01 --2.656250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.040725613773739039e-01 1.040725613773739039e-01 1.040725613773739039e-01 --2.656250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.109205161165409126e-01 1.109205161165409126e-01 1.109205161165409126e-01 --3.593750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 9.672500505018596928e-02 9.672500505018596928e-02 9.672500505018596928e-02 --3.593750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 8.182935943447210148e-02 8.182935943447210148e-02 8.182935943447210148e-02 --3.281250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 9.407878831951863030e-02 9.407878831951863030e-02 9.407878831951863030e-02 --3.281250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.223790714209180980e-01 1.223790714209180980e-01 1.223790714209180980e-01 --3.281250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 9.216780088908105295e-02 9.216780088908105295e-02 9.216780088908105295e-02 --3.281250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.125980676749016030e-01 1.125980676749016030e-01 1.125980676749016030e-01 --3.281250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.172039237737926148e-01 1.172039237737926148e-01 1.172039237737926148e-01 --3.281250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.213178799804801034e-01 1.213178799804801034e-01 1.213178799804801034e-01 --3.593750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 4.843131223675808256e-02 4.843131223675808256e-02 4.843131223675808256e-02 --3.593750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 2.678573972517324028e-02 2.678573972517324028e-02 2.678573972517324028e-02 --3.593750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 9.218628416405094672e-02 9.218628416405094672e-02 9.218628416405094672e-02 --3.593750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 6.913032154952566954e-02 6.913032154952566954e-02 6.913032154952566954e-02 --3.281250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 7.030690948881163083e-02 7.030690948881163083e-02 7.030690948881163083e-02 --3.593750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 2.770043543678430559e-02 2.770043543678430559e-02 2.770043543678430559e-02 --3.593750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 5.856871578050470289e-02 5.856871578050470289e-02 5.856871578050470289e-02 --3.281250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 7.338515255185965036e-02 7.338515255185965036e-02 7.338515255185965036e-02 --2.968750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.182828433988382388e-01 1.182828433988382388e-01 1.182828433988382388e-01 --2.968750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 9.532596842108405355e-02 9.532596842108405355e-02 9.532596842108405355e-02 --2.968750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.190982495992801565e-01 1.190982495992801565e-01 1.190982495992801565e-01 --2.656250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.494776880609697822e-01 1.494776880609697822e-01 1.494776880609697822e-01 --2.656250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.740801352347549902e-01 1.740801352347549902e-01 1.740801352347549902e-01 --2.656250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.258380888158439903e-01 1.258380888158439903e-01 1.258380888158439903e-01 --2.656250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.588294474040713444e-01 1.588294474040713444e-01 1.588294474040713444e-01 --2.968750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 1.357106527936802753e-01 1.357106527936802753e-01 1.357106527936802753e-01 --2.968750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.163997456770728134e-01 1.163997456770728134e-01 1.163997456770728134e-01 --2.968750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.401328729886082425e-01 1.401328729886082425e-01 1.401328729886082425e-01 --2.968750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.480667194674835374e-01 1.480667194674835374e-01 1.480667194674835374e-01 --2.656250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 2.009334267867274038e-01 2.009334267867274038e-01 2.009334267867274038e-01 --2.656250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.990185553324574919e-01 1.990185553324574919e-01 1.990185553324574919e-01 --2.656250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.769011354260685009e-01 1.769011354260685009e-01 1.769011354260685009e-01 --2.656250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.613964541146729326e-01 1.613964541146729326e-01 1.613964541146729326e-01 --2.968750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 9.393976511311942501e-02 9.393976511311942501e-02 9.393976511311942501e-02 --2.656250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.237728178699253750e-01 1.237728178699253750e-01 1.237728178699253750e-01 --2.656250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.033196766304760456e-01 1.033196766304760456e-01 1.033196766304760456e-01 --2.968750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.361596324759480892e-01 1.361596324759480892e-01 1.361596324759480892e-01 --2.968750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.200453957863002880e-01 1.200453957863002880e-01 1.200453957863002880e-01 --2.968750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.038371349937673577e-01 1.038371349937673577e-01 1.038371349937673577e-01 --2.968750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 8.739897407183580547e-02 8.739897407183580547e-02 8.739897407183580547e-02 --2.656250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.235053168214902686e-01 1.235053168214902686e-01 1.235053168214902686e-01 --2.656250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.156718812488248121e-01 1.156718812488248121e-01 1.156718812488248121e-01 --2.656250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.236780278103653402e-01 1.236780278103653402e-01 1.236780278103653402e-01 --3.281250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 9.258246812367554313e-02 9.258246812367554313e-02 9.258246812367554313e-02 --2.656250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 8.516876341298540432e-02 8.516876341298540432e-02 8.516876341298540432e-02 --2.656250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 6.534819461621217684e-02 6.534819461621217684e-02 6.534819461621217684e-02 --2.968750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 9.263309595358680537e-02 9.263309595358680537e-02 9.263309595358680537e-02 --2.656250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 1.209716441656551178e-01 1.209716441656551178e-01 1.209716441656551178e-01 --2.656250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 8.815441880016496035e-02 8.815441880016496035e-02 8.815441880016496035e-02 --2.656250000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 5.813345259791537906e-02 5.813345259791537906e-02 5.813345259791537906e-02 --2.656250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 6.694212929416160085e-02 6.694212929416160085e-02 6.694212929416160085e-02 --2.656250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 6.836440877909778779e-02 6.836440877909778779e-02 6.836440877909778779e-02 --2.656250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 5.104711071117360582e-02 5.104711071117360582e-02 5.104711071117360582e-02 --3.593750000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 8.517358555676489418e-02 8.517358555676489418e-02 8.517358555676489418e-02 --3.593750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 8.499034388953298491e-02 8.499034388953298491e-02 8.499034388953298491e-02 --3.593750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 4.468359229700228502e-02 4.468359229700228502e-02 4.468359229700228502e-02 --3.593750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 4.189453981899349949e-02 4.189453981899349949e-02 4.189453981899349949e-02 --3.281250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 1.035615325840844730e-01 1.035615325840844730e-01 1.035615325840844730e-01 --3.281250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 6.202822666208658575e-02 6.202822666208658575e-02 6.202822666208658575e-02 --3.593750000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 5.618937157593648091e-02 5.618937157593648091e-02 5.618937157593648091e-02 --3.593750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 4.367428569484772122e-02 4.367428569484772122e-02 4.367428569484772122e-02 --3.593750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 5.609233110783802545e-02 5.609233110783802545e-02 5.609233110783802545e-02 --3.281250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 5.434839666191192131e-02 5.434839666191192131e-02 5.434839666191192131e-02 --3.281250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 6.678754441581059853e-02 6.678754441581059853e-02 6.678754441581059853e-02 --3.281250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 7.250007428072072213e-02 7.250007428072072213e-02 7.250007428072072213e-02 --3.281250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 4.528537487987365634e-02 4.528537487987365634e-02 4.528537487987365634e-02 --3.281250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 5.085325846279374618e-02 5.085325846279374618e-02 5.085325846279374618e-02 --3.281250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 9.424915168997458070e-02 9.424915168997458070e-02 9.424915168997458070e-02 --3.281250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 8.937115209848597863e-02 8.937115209848597863e-02 8.937115209848597863e-02 --2.968750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 7.583102388048210130e-02 7.583102388048210130e-02 7.583102388048210130e-02 --2.656250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 8.415530311276575581e-02 8.415530311276575581e-02 8.415530311276575581e-02 --2.656250000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 8.431684680733449178e-02 8.431684680733449178e-02 8.431684680733449178e-02 --2.656250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 1.038684716511329292e-01 1.038684716511329292e-01 1.038684716511329292e-01 --2.656250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 9.307910165008347059e-02 9.307910165008347059e-02 9.307910165008347059e-02 --2.968750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 7.233730112927691525e-02 7.233730112927691525e-02 7.233730112927691525e-02 --2.968750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 5.355323812456717208e-02 5.355323812456717208e-02 5.355323812456717208e-02 --2.656250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 1.132978405771608160e-01 1.132978405771608160e-01 1.132978405771608160e-01 --2.656250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 7.779745725786993416e-02 7.779745725786993416e-02 7.779745725786993416e-02 --2.656250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 8.490675983254863946e-02 8.490675983254863946e-02 8.490675983254863946e-02 --2.656250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 6.352519561164134132e-02 6.352519561164134132e-02 6.352519561164134132e-02 --2.968750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 6.460756856982623197e-02 6.460756856982623197e-02 6.460756856982623197e-02 --2.968750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 8.867840395597494096e-02 8.867840395597494096e-02 8.867840395597494096e-02 --2.656250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 7.495947623378292068e-02 7.495947623378292068e-02 7.495947623378292068e-02 --2.656250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 7.270335939852086427e-02 7.270335939852086427e-02 7.270335939852086427e-02 --2.968750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 8.138972119692114426e-02 8.138972119692114426e-02 8.138972119692114426e-02 --2.656250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 5.995786008393485383e-02 5.995786008393485383e-02 5.995786008393485383e-02 --4.531250000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 6.142214769674531061e-02 6.142214769674531061e-02 6.142214769674531061e-02 --4.218750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 6.960965640530053511e-02 6.960965640530053511e-02 6.960965640530053511e-02 --4.218750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 7.626450339151705227e-02 7.626450339151705227e-02 7.626450339151705227e-02 --4.218750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 8.061653075385717682e-02 8.061653075385717682e-02 8.061653075385717682e-02 --4.218750000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 6.596389059748358763e-02 6.596389059748358763e-02 6.596389059748358763e-02 --3.906250000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 9.187206791228059999e-02 9.187206791228059999e-02 9.187206791228059999e-02 --3.906250000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 8.110278964387790390e-02 8.110278964387790390e-02 8.110278964387790390e-02 --4.218750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 7.154529452297592185e-02 7.154529452297592185e-02 7.154529452297592185e-02 --4.218750000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 5.585161878690449166e-02 5.585161878690449166e-02 5.585161878690449166e-02 --4.218750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 4.318337793070398112e-02 4.318337793070398112e-02 4.318337793070398112e-02 --3.906250000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 6.571886683095778947e-02 6.571886683095778947e-02 6.571886683095778947e-02 --3.906250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 5.451611059349793786e-02 5.451611059349793786e-02 5.451611059349793786e-02 --3.906250000000000000e-01 1.093750000000000000e-01 2.968750000000000000e-01 4.767557483109242933e-02 4.767557483109242933e-02 4.767557483109242933e-02 --3.593750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 8.779839626407072439e-02 8.779839626407072439e-02 8.779839626407072439e-02 --3.593750000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 6.442259186997500997e-02 6.442259186997500997e-02 6.442259186997500997e-02 --3.281250000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 1.131202868349252127e-01 1.131202868349252127e-01 1.131202868349252127e-01 --3.281250000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 7.787132316262042331e-02 7.787132316262042331e-02 7.787132316262042331e-02 --3.281250000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 1.378382641905074868e-01 1.378382641905074868e-01 1.378382641905074868e-01 --3.593750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 4.975309187396085436e-02 4.975309187396085436e-02 4.975309187396085436e-02 --3.593750000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 5.751086296997900277e-02 5.751086296997900277e-02 5.751086296997900277e-02 --3.593750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 5.113072995241643021e-02 5.113072995241643021e-02 5.113072995241643021e-02 --3.281250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 6.591059316846513416e-02 6.591059316846513416e-02 6.591059316846513416e-02 --3.281250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 4.715582535629415234e-02 4.715582535629415234e-02 4.715582535629415234e-02 --2.968750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 1.034707362481974702e-01 1.034707362481974702e-01 1.034707362481974702e-01 --2.656250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 6.579668285866561994e-02 6.579668285866561994e-02 6.579668285866561994e-02 --2.343750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.162519238536413868e-01 1.162519238536413868e-01 1.162519238536413868e-01 --2.031250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 5.946528298321881317e-02 5.946528298321881317e-02 5.946528298321881317e-02 --2.343750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 1.022164507162472702e-01 1.022164507162472702e-01 1.022164507162472702e-01 --2.343750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.375161945050291934e-01 1.375161945050291934e-01 1.375161945050291934e-01 --2.343750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 8.352921776918953434e-02 8.352921776918953434e-02 8.352921776918953434e-02 --2.343750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 8.098785598965303756e-02 8.098785598965303756e-02 8.098785598965303756e-02 --2.031250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 7.658939045359332287e-02 7.658939045359332287e-02 7.658939045359332287e-02 --2.031250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.421680085287249651e-01 1.421680085287249651e-01 1.421680085287249651e-01 --2.343750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 5.204892782712317034e-02 5.204892782712317034e-02 5.204892782712317034e-02 --2.343750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 7.462879525913297674e-02 7.462879525913297674e-02 7.462879525913297674e-02 --2.343750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 5.873666210110591035e-02 5.873666210110591035e-02 5.873666210110591035e-02 --2.031250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 4.161398079537519806e-02 4.161398079537519806e-02 4.161398079537519806e-02 --2.343750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 8.068886697316730860e-02 8.068886697316730860e-02 8.068886697316730860e-02 --2.343750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 6.657909954119306528e-02 6.657909954119306528e-02 6.657909954119306528e-02 --2.343750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.256677923225411331e-01 1.256677923225411331e-01 1.256677923225411331e-01 --2.343750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 9.549552556313894991e-02 9.549552556313894991e-02 9.549552556313894991e-02 --1.718750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 5.345957130827974635e-02 5.345957130827974635e-02 5.345957130827974635e-02 --1.718750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.547880725562916227e-01 1.547880725562916227e-01 1.547880725562916227e-01 --1.406250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.762179711495423795e-01 1.762179711495423795e-01 1.762179711495423795e-01 --1.406250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 2.793919155124048870e-01 2.793919155124048870e-01 2.793919155124048870e-01 --1.406250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 3.626757663835322165e-01 3.626757663835322165e-01 3.626757663835322165e-01 --1.406250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 4.112843318018465366e-01 4.112843318018465366e-01 4.112843318018465366e-01 --1.718750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 3.591372094397969894e-01 3.591372094397969894e-01 3.591372094397969894e-01 --1.718750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.331886094429071965e-01 1.331886094429071965e-01 1.331886094429071965e-01 --1.718750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 1.172191878157731876e-01 1.172191878157731876e-01 1.172191878157731876e-01 --1.406250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 2.081575231074498655e-01 2.081575231074498655e-01 2.081575231074498655e-01 --1.406250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 3.045487420886330496e-03 3.045487420886330496e-03 3.045487420886330496e-03 --1.406250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 2.031877162038938922e-01 2.031877162038938922e-01 2.031877162038938922e-01 --1.406250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 4.092162545025353204e-02 4.092162545025353204e-02 4.092162545025353204e-02 --1.406250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 3.383520539343070621e-01 3.383520539343070621e-01 3.383520539343070621e-01 --1.406250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 2.617305695415525491e-01 2.617305695415525491e-01 2.617305695415525491e-01 --1.406250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 1.644194270628419052e-01 1.644194270628419052e-01 1.644194270628419052e-01 --1.406250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 1.990634983532435232e-01 1.990634983532435232e-01 1.990634983532435232e-01 --1.406250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 4.588187969690510903e-01 4.588187969690510903e-01 4.588187969690510903e-01 --1.406250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 --1.406250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.673234616995514790e-01 1.673234616995514790e-01 1.673234616995514790e-01 --1.406250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.999174109781983733e-01 1.999174109781983733e-01 1.999174109781983733e-01 --2.343750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.739854044281173573e-01 1.739854044281173573e-01 1.739854044281173573e-01 --2.343750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.728446119717216845e-01 1.728446119717216845e-01 1.728446119717216845e-01 --2.343750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.267506148278302602e-01 1.267506148278302602e-01 1.267506148278302602e-01 --2.031250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.844075326289485728e-01 1.844075326289485728e-01 1.844075326289485728e-01 --2.031250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.916058235677747801e-01 1.916058235677747801e-01 1.916058235677747801e-01 --2.031250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.132030381753106330e-01 1.132030381753106330e-01 1.132030381753106330e-01 --2.031250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.732917788523079816e-01 1.732917788523079816e-01 1.732917788523079816e-01 --2.343750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.886665457221596010e-01 1.886665457221596010e-01 1.886665457221596010e-01 --2.343750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.640765882981539969e-01 1.640765882981539969e-01 1.640765882981539969e-01 --2.031250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 2.208811728664846485e-01 2.208811728664846485e-01 2.208811728664846485e-01 --2.031250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.952432519550338919e-01 1.952432519550338919e-01 1.952432519550338919e-01 --2.031250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 2.154772576825197405e-01 2.154772576825197405e-01 2.154772576825197405e-01 --2.031250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.664113957587480264e-01 1.664113957587480264e-01 1.664113957587480264e-01 --2.343750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 8.364816632232729976e-02 8.364816632232729976e-02 8.364816632232729976e-02 --2.343750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.080682768041156400e-01 1.080682768041156400e-01 1.080682768041156400e-01 --2.343750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 9.085065571024764086e-02 9.085065571024764086e-02 9.085065571024764086e-02 --2.343750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 9.100254237381295852e-02 9.100254237381295852e-02 9.100254237381295852e-02 --2.031250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 6.357648485497714719e-02 6.357648485497714719e-02 6.357648485497714719e-02 --2.031250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.024076883387938924e-01 1.024076883387938924e-01 1.024076883387938924e-01 --2.031250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 6.837333160837662238e-02 6.837333160837662238e-02 6.837333160837662238e-02 --2.343750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.133331905967162878e-01 1.133331905967162878e-01 1.133331905967162878e-01 --2.343750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 9.494667342568119395e-02 9.494667342568119395e-02 9.494667342568119395e-02 --2.343750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.032168273667506408e-01 1.032168273667506408e-01 1.032168273667506408e-01 --2.343750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 9.325428879688164863e-02 9.325428879688164863e-02 9.325428879688164863e-02 --2.031250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.066951486384845327e-01 1.066951486384845327e-01 1.066951486384845327e-01 --2.031250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.136513400737723528e-01 1.136513400737723528e-01 1.136513400737723528e-01 --1.718750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.242580126971394444e-01 1.242580126971394444e-01 1.242580126971394444e-01 --1.718750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.122397430288527703e-01 1.122397430288527703e-01 1.122397430288527703e-01 --1.718750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.550972252298990217e-01 1.550972252298990217e-01 1.550972252298990217e-01 --1.406250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 5.679122889899580751e-02 5.679122889899580751e-02 5.679122889899580751e-02 --1.718750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 1.783107956691084850e-01 1.783107956691084850e-01 1.783107956691084850e-01 --1.718750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.760566118777642519e-01 1.760566118777642519e-01 1.760566118777642519e-01 --1.718750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.938202440604278320e-01 1.938202440604278320e-01 1.938202440604278320e-01 --1.718750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.683045633426434040e-01 1.683045633426434040e-01 1.683045633426434040e-01 --1.406250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 1.597737171369727482e-01 1.597737171369727482e-01 1.597737171369727482e-01 --1.406250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.855136455279556562e-01 1.855136455279556562e-01 1.855136455279556562e-01 --1.406250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 2.104862370549646089e-01 2.104862370549646089e-01 2.104862370549646089e-01 --1.718750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 7.190187128263189620e-02 7.190187128263189620e-02 7.190187128263189620e-02 --1.718750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.431694947663316175e-01 1.431694947663316175e-01 1.431694947663316175e-01 --1.718750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.252332133168274630e-01 1.252332133168274630e-01 1.252332133168274630e-01 --1.718750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.283997222911621994e-01 1.283997222911621994e-01 1.283997222911621994e-01 --1.406250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 1.694325745870152444e-01 1.694325745870152444e-01 1.694325745870152444e-01 --1.406250000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 2.566870809886169780e-01 2.566870809886169780e-01 2.566870809886169780e-01 --1.406250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.491934083883972861e-01 1.491934083883972861e-01 1.491934083883972861e-01 --1.718750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.378005154412030031e-01 1.378005154412030031e-01 1.378005154412030031e-01 --1.718750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.256605627464434383e-01 1.256605627464434383e-01 1.256605627464434383e-01 --1.406250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.687798554177390720e-01 1.687798554177390720e-01 1.687798554177390720e-01 --1.406250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.246050376661533426e-01 1.246050376661533426e-01 1.246050376661533426e-01 --1.406250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.501410033906664387e-01 1.501410033906664387e-01 1.501410033906664387e-01 --1.406250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 1.861622155398141298e-01 1.861622155398141298e-01 1.861622155398141298e-01 --2.343750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 8.844775446889488468e-02 8.844775446889488468e-02 8.844775446889488468e-02 --2.343750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.240330883066273482e-01 1.240330883066273482e-01 1.240330883066273482e-01 --2.343750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.044381538839910667e-01 1.044381538839910667e-01 1.044381538839910667e-01 --2.031250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 5.685273290033539262e-02 5.685273290033539262e-02 5.685273290033539262e-02 --2.031250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 4.081041380983019273e-02 4.081041380983019273e-02 4.081041380983019273e-02 --2.031250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 7.907961184367202911e-02 7.907961184367202911e-02 7.907961184367202911e-02 --2.031250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 6.132832925543622166e-02 6.132832925543622166e-02 6.132832925543622166e-02 --2.343750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 8.553604920437528347e-02 8.553604920437528347e-02 8.553604920437528347e-02 --2.343750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 1.061793156184596548e-01 1.061793156184596548e-01 1.061793156184596548e-01 --2.343750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.019279863836113353e-01 1.019279863836113353e-01 1.019279863836113353e-01 --2.031250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 7.874091025481753936e-02 7.874091025481753936e-02 7.874091025481753936e-02 --2.031250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 4.588055947944495033e-02 4.588055947944495033e-02 4.588055947944495033e-02 --2.031250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 3.932596895019465494e-02 3.932596895019465494e-02 3.932596895019465494e-02 --2.343750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 9.891311063014991689e-02 9.891311063014991689e-02 9.891311063014991689e-02 --2.343750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 5.063094288707364193e-02 5.063094288707364193e-02 5.063094288707364193e-02 --2.343750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 8.997951184732994045e-02 8.997951184732994045e-02 8.997951184732994045e-02 --2.031250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 8.116226573613981310e-02 8.116226573613981310e-02 8.116226573613981310e-02 --2.031250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 6.732396794431465270e-02 6.732396794431465270e-02 6.732396794431465270e-02 --2.031250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 8.885038607000861344e-02 8.885038607000861344e-02 8.885038607000861344e-02 --2.343750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 6.248155691595196071e-02 6.248155691595196071e-02 6.248155691595196071e-02 --2.343750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 1.003699396993143061e-01 1.003699396993143061e-01 1.003699396993143061e-01 --2.343750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 9.933336794481871512e-02 9.933336794481871512e-02 9.933336794481871512e-02 --2.031250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 4.904633364028582881e-02 4.904633364028582881e-02 4.904633364028582881e-02 --2.031250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 3.096721285793226433e-02 3.096721285793226433e-02 3.096721285793226433e-02 --2.031250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 1.001987857487514344e-01 1.001987857487514344e-01 1.001987857487514344e-01 --1.718750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 4.688557681650333542e-02 4.688557681650333542e-02 4.688557681650333542e-02 --1.718750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 6.307621235984130215e-02 6.307621235984130215e-02 6.307621235984130215e-02 --1.718750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 4.726220380951984962e-02 4.726220380951984962e-02 4.726220380951984962e-02 --1.406250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 7.875160019387500432e-02 7.875160019387500432e-02 7.875160019387500432e-02 --1.406250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 1.443187390732081909e-01 1.443187390732081909e-01 1.443187390732081909e-01 --1.406250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.222015377188732932e-01 1.222015377188732932e-01 1.222015377188732932e-01 --1.406250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.733889189053097468e-01 1.733889189053097468e-01 1.733889189053097468e-01 --1.718750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 6.606405429767106541e-02 6.606405429767106541e-02 6.606405429767106541e-02 --1.718750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 5.754760425302768434e-02 5.754760425302768434e-02 5.754760425302768434e-02 --1.718750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 5.151473412125861379e-02 5.151473412125861379e-02 5.151473412125861379e-02 --1.718750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 5.512803031953623922e-02 5.512803031953623922e-02 5.512803031953623922e-02 --1.406250000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 9.421861488596418310e-02 9.421861488596418310e-02 9.421861488596418310e-02 --1.406250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 8.893235872393905062e-02 8.893235872393905062e-02 8.893235872393905062e-02 --1.406250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 7.728168005690695674e-02 7.728168005690695674e-02 7.728168005690695674e-02 --1.406250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 9.852499341649163800e-02 9.852499341649163800e-02 9.852499341649163800e-02 --1.718750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 1.274004619895315882e-01 1.274004619895315882e-01 1.274004619895315882e-01 --1.718750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 7.203715461267921893e-02 7.203715461267921893e-02 7.203715461267921893e-02 --1.718750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 1.538533803645528997e-01 1.538533803645528997e-01 1.538533803645528997e-01 --1.406250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 6.224198919793735157e-02 6.224198919793735157e-02 6.224198919793735157e-02 --1.406250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 1.043851229860451729e-01 1.043851229860451729e-01 1.043851229860451729e-01 --1.406250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 1.567489636714835266e-01 1.567489636714835266e-01 1.567489636714835266e-01 --1.406250000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 1.396903406486394994e-01 1.396903406486394994e-01 1.396903406486394994e-01 --2.343750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 1.451001515776267070e-01 1.451001515776267070e-01 1.451001515776267070e-01 --2.343750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 1.095699331476691629e-01 1.095699331476691629e-01 1.095699331476691629e-01 --2.343750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.073065912835959590e-01 1.073065912835959590e-01 1.073065912835959590e-01 --2.343750000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 1.475302718706722471e-01 1.475302718706722471e-01 1.475302718706722471e-01 --2.343750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 1.034361854032157801e-01 1.034361854032157801e-01 1.034361854032157801e-01 --2.343750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 1.264349269822961364e-01 1.264349269822961364e-01 1.264349269822961364e-01 --2.343750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 1.101411818935289361e-01 1.101411818935289361e-01 1.101411818935289361e-01 --2.343750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 9.168562699864087062e-02 9.168562699864087062e-02 9.168562699864087062e-02 --2.343750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 3.342571337548801147e-02 3.342571337548801147e-02 3.342571337548801147e-02 --2.343750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 9.150400741733917542e-02 9.150400741733917542e-02 9.150400741733917542e-02 --2.343750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 8.557542985709029604e-02 8.557542985709029604e-02 8.557542985709029604e-02 --2.031250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 5.272767997500507620e-02 5.272767997500507620e-02 5.272767997500507620e-02 --2.031250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.033437819076393205e-01 1.033437819076393205e-01 1.033437819076393205e-01 --2.031250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 8.505303187528535924e-02 8.505303187528535924e-02 8.505303187528535924e-02 --2.343750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.016668409007947665e-01 1.016668409007947665e-01 1.016668409007947665e-01 --2.343750000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 8.907299788663244899e-02 8.907299788663244899e-02 8.907299788663244899e-02 --2.343750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 6.618736962886793973e-02 6.618736962886793973e-02 6.618736962886793973e-02 --2.031250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 8.145080453268632725e-02 8.145080453268632725e-02 8.145080453268632725e-02 --2.031250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 8.886485183854003767e-02 8.886485183854003767e-02 8.886485183854003767e-02 --1.718750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --1.406250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 2.347307090304645294e-01 2.347307090304645294e-01 2.347307090304645294e-01 --1.406250000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 2.358786461885200303e-01 2.358786461885200303e-01 2.358786461885200303e-01 --1.406250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 1.811051573448019814e-01 1.811051573448019814e-01 1.811051573448019814e-01 --1.406250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 2.583150821155040799e-01 2.583150821155040799e-01 2.583150821155040799e-01 --1.406250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 1.407617305476789871e-01 1.407617305476789871e-01 1.407617305476789871e-01 --1.406250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 2.206396693347735249e-01 2.206396693347735249e-01 2.206396693347735249e-01 --1.406250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 2.011589388241351584e-01 2.011589388241351584e-01 2.011589388241351584e-01 --1.406250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 2.571241584177100803e-01 2.571241584177100803e-01 2.571241584177100803e-01 --1.718750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 1.155047767861983460e-01 1.155047767861983460e-01 1.155047767861983460e-01 --1.718750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.207908940183945318e-01 1.207908940183945318e-01 1.207908940183945318e-01 --1.718750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 1.756640499099677011e-01 1.756640499099677011e-01 1.756640499099677011e-01 --1.718750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.138738832783632443e-01 1.138738832783632443e-01 1.138738832783632443e-01 --1.406250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 1.280840409163949423e-01 1.280840409163949423e-01 1.280840409163949423e-01 --1.406250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.673611965993648532e-01 1.673611965993648532e-01 1.673611965993648532e-01 --1.406250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 1.917735726688115372e-01 1.917735726688115372e-01 1.917735726688115372e-01 --1.406250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.181414519262973251e-01 1.181414519262973251e-01 1.181414519262973251e-01 --1.718750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 7.467846983357288859e-02 7.467846983357288859e-02 7.467846983357288859e-02 --1.718750000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 1.233261789855090163e-01 1.233261789855090163e-01 1.233261789855090163e-01 --1.406250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.854373900469237502e-01 1.854373900469237502e-01 1.854373900469237502e-01 --1.406250000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 2.376506567869524078e-01 2.376506567869524078e-01 2.376506567869524078e-01 --1.406250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.166214779029459692e-01 1.166214779029459692e-01 1.166214779029459692e-01 --1.406250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 1.442424445371153774e-01 1.442424445371153774e-01 1.442424445371153774e-01 --1.093750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 4.768992139274427777e-01 4.768992139274427777e-01 4.768992139274427777e-01 --1.093750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 8.273939031658847920e-01 8.273939031658847920e-01 8.273939031658847920e-01 --1.093750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 7.377128379402727587e-01 7.377128379402727587e-01 7.377128379402727587e-01 --1.093750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 8.210390955818051006e-01 8.210390955818051006e-01 8.210390955818051006e-01 --7.812500000000000000e-02 1.562500000000000000e-02 1.562500000000000000e-02 5.116888241746158084e-01 5.116888241746158084e-01 5.116888241746158084e-01 --7.812500000000000000e-02 4.687500000000000000e-02 1.562500000000000000e-02 5.689140568571965373e-01 5.689140568571965373e-01 5.689140568571965373e-01 --1.093750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 7.568417329025247664e-01 7.568417329025247664e-01 7.568417329025247664e-01 --1.093750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.120870930312125452e-01 1.120870930312125452e-01 1.120870930312125452e-01 --1.093750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 3.182434923821846895e-01 3.182434923821846895e-01 3.182434923821846895e-01 --1.093750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 7.195058295354057887e-02 7.195058295354057887e-02 7.195058295354057887e-02 --7.812500000000000000e-02 1.562500000000000000e-02 1.093750000000000000e-01 1.716122810451049807e-01 1.716122810451049807e-01 1.716122810451049807e-01 --1.093750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 3.952667426006039042e-01 3.952667426006039042e-01 3.952667426006039042e-01 --1.093750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 6.954270890856940612e-01 6.954270890856940612e-01 6.954270890856940612e-01 --1.093750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 8.856910672049192468e-02 8.856910672049192468e-02 8.856910672049192468e-02 --7.812500000000000000e-02 7.812500000000000000e-02 1.562500000000000000e-02 6.314438895481661040e-01 6.314438895481661040e-01 6.314438895481661040e-01 --7.812500000000000000e-02 7.812500000000000000e-02 4.687500000000000000e-02 4.809612295925724257e-01 4.809612295925724257e-01 4.809612295925724257e-01 --7.812500000000000000e-02 1.093750000000000000e-01 1.562500000000000000e-02 2.201253687003355275e-01 2.201253687003355275e-01 2.201253687003355275e-01 --7.812500000000000000e-02 1.093750000000000000e-01 4.687500000000000000e-02 1.051693339133700361e-01 1.051693339133700361e-01 1.051693339133700361e-01 --1.093750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 1.422153926813914393e-01 1.422153926813914393e-01 1.422153926813914393e-01 --1.093750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 7.931792380611103754e-02 7.931792380611103754e-02 7.931792380611103754e-02 --1.093750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 5.685040137696249773e-02 5.685040137696249773e-02 5.685040137696249773e-02 --1.093750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 4.592108526342737751e-02 4.592108526342737751e-02 4.592108526342737751e-02 --7.812500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 7.440517891481682189e-02 7.440517891481682189e-02 7.440517891481682189e-02 --7.812500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 9.798982251070421923e-02 9.798982251070421923e-02 9.798982251070421923e-02 --7.812500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 6.017677333912457849e-02 6.017677333912457849e-02 6.017677333912457849e-02 --7.812500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 5.081715734959561109e-02 5.081715734959561109e-02 5.081715734959561109e-02 --1.562500000000000000e-02 1.562500000000000000e-02 4.687500000000000000e-02 5.555502013599029620e-01 5.555502013599029620e-01 5.555502013599029620e-01 --4.687500000000000000e-02 1.562500000000000000e-02 1.093750000000000000e-01 6.921472186966833862e-01 6.921472186966833862e-01 6.921472186966833862e-01 --4.687500000000000000e-02 4.687500000000000000e-02 1.093750000000000000e-01 1.995795387393046738e-01 1.995795387393046738e-01 1.995795387393046738e-01 --1.562500000000000000e-02 1.562500000000000000e-02 7.812500000000000000e-02 5.016016416963863245e-01 5.016016416963863245e-01 5.016016416963863245e-01 --1.562500000000000000e-02 1.562500000000000000e-02 1.093750000000000000e-01 2.142544060242833892e-01 2.142544060242833892e-01 2.142544060242833892e-01 --1.562500000000000000e-02 4.687500000000000000e-02 7.812500000000000000e-02 5.724441983994137395e-01 5.724441983994137395e-01 5.724441983994137395e-01 --1.562500000000000000e-02 4.687500000000000000e-02 1.093750000000000000e-01 3.024790838406293814e-01 3.024790838406293814e-01 3.024790838406293814e-01 --4.687500000000000000e-02 7.812500000000000000e-02 1.562500000000000000e-02 6.761886456466826845e-01 6.761886456466826845e-01 6.761886456466826845e-01 --4.687500000000000000e-02 1.093750000000000000e-01 1.562500000000000000e-02 2.358834593077297759e-01 2.358834593077297759e-01 2.358834593077297759e-01 --4.687500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 1.675627167221058200e-01 1.675627167221058200e-01 1.675627167221058200e-01 --4.687500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 --4.687500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 1.506300544109830664e-01 1.506300544109830664e-01 1.506300544109830664e-01 --1.562500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 4.337431313104633812e-01 4.337431313104633812e-01 4.337431313104633812e-01 --1.562500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 1.925625505916826463e-01 1.925625505916826463e-01 1.925625505916826463e-01 --1.562500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 3.021119855694296974e-01 3.021119855694296974e-01 3.021119855694296974e-01 --1.562500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 2.516352559568322267e-01 2.516352559568322267e-01 2.516352559568322267e-01 --1.093750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.419816841323607026e-01 1.419816841323607026e-01 1.419816841323607026e-01 --1.093750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 8.185186370375939491e-02 8.185186370375939491e-02 8.185186370375939491e-02 --1.093750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 7.567894781532022441e-02 7.567894781532022441e-02 7.567894781532022441e-02 --7.812500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 9.289507437402567958e-02 9.289507437402567958e-02 9.289507437402567958e-02 --7.812500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 7.753237535689556925e-02 7.753237535689556925e-02 7.753237535689556925e-02 --7.812500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 5.570304248588726914e-02 5.570304248588726914e-02 5.570304248588726914e-02 --1.093750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 2.455235592531751221e-01 2.455235592531751221e-01 2.455235592531751221e-01 --1.093750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 2.071239441138650883e-01 2.071239441138650883e-01 2.071239441138650883e-01 --1.093750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 9.292882613304163930e-02 9.292882613304163930e-02 9.292882613304163930e-02 --1.093750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.831689571042097453e-01 1.831689571042097453e-01 1.831689571042097453e-01 --7.812500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 1.530897191476723873e-01 1.530897191476723873e-01 1.530897191476723873e-01 --7.812500000000000000e-02 1.562500000000000000e-02 2.343750000000000000e-01 1.677441646876344228e-01 1.677441646876344228e-01 1.677441646876344228e-01 --7.812500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 8.587359703079680551e-02 8.587359703079680551e-02 8.587359703079680551e-02 --7.812500000000000000e-02 4.687500000000000000e-02 2.343750000000000000e-01 1.219051117957096475e-01 1.219051117957096475e-01 1.219051117957096475e-01 --1.093750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 1.311958180025733223e-01 1.311958180025733223e-01 1.311958180025733223e-01 --1.093750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.649091941924164528e-01 1.649091941924164528e-01 1.649091941924164528e-01 --1.093750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.242877348017051437e-01 1.242877348017051437e-01 1.242877348017051437e-01 --1.093750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.445725182726917968e-01 1.445725182726917968e-01 1.445725182726917968e-01 --7.812500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 7.344053492989711940e-02 7.344053492989711940e-02 7.344053492989711940e-02 --7.812500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 9.215253209352582131e-02 9.215253209352582131e-02 9.215253209352582131e-02 --1.093750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.445548501265024322e-01 1.445548501265024322e-01 1.445548501265024322e-01 --1.093750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 9.285810814554412707e-02 9.285810814554412707e-02 9.285810814554412707e-02 --1.093750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 1.821888394319537696e-01 1.821888394319537696e-01 1.821888394319537696e-01 --7.812500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 1.087110437849759109e-01 1.087110437849759109e-01 1.087110437849759109e-01 --7.812500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 1.550883923128531516e-01 1.550883923128531516e-01 1.550883923128531516e-01 --4.687500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 1.247560573241314752e-01 1.247560573241314752e-01 1.247560573241314752e-01 --4.687500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 4.704598925473270354e-02 4.704598925473270354e-02 4.704598925473270354e-02 --4.687500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 3.753993479809990264e-02 3.753993479809990264e-02 3.753993479809990264e-02 --1.562500000000000000e-02 1.562500000000000000e-02 1.406250000000000000e-01 1.862818151319142190e-01 1.862818151319142190e-01 1.862818151319142190e-01 --1.562500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 1.639786340970400547e-01 1.639786340970400547e-01 1.639786340970400547e-01 --1.562500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 1.402300530857621408e-01 1.402300530857621408e-01 1.402300530857621408e-01 --1.562500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 1.564181369084521878e-01 1.564181369084521878e-01 1.564181369084521878e-01 --4.687500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 1.332978460795207487e-01 1.332978460795207487e-01 1.332978460795207487e-01 --4.687500000000000000e-02 1.562500000000000000e-02 2.343750000000000000e-01 1.119191776992696508e-01 1.119191776992696508e-01 1.119191776992696508e-01 --4.687500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 1.128029386724869187e-01 1.128029386724869187e-01 1.128029386724869187e-01 --4.687500000000000000e-02 4.687500000000000000e-02 2.343750000000000000e-01 1.535016634805542179e-01 1.535016634805542179e-01 1.535016634805542179e-01 --1.562500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 1.344183162524290598e-01 1.344183162524290598e-01 1.344183162524290598e-01 --1.562500000000000000e-02 1.562500000000000000e-02 2.343750000000000000e-01 1.359154649452029018e-01 1.359154649452029018e-01 1.359154649452029018e-01 --1.562500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 1.641954178246358975e-01 1.641954178246358975e-01 1.641954178246358975e-01 --1.562500000000000000e-02 4.687500000000000000e-02 2.343750000000000000e-01 1.855361208138258944e-01 1.855361208138258944e-01 1.855361208138258944e-01 --4.687500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 5.746752913756256881e-02 5.746752913756256881e-02 5.746752913756256881e-02 --4.687500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 1.531643992709749158e-01 1.531643992709749158e-01 1.531643992709749158e-01 --4.687500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 1.722938787895006707e-01 1.722938787895006707e-01 1.722938787895006707e-01 --4.687500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 1.514162237944203793e-01 1.514162237944203793e-01 1.514162237944203793e-01 --4.687500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 1.973805256030141397e-01 1.973805256030141397e-01 1.973805256030141397e-01 --4.687500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 2.224096086385321525e-01 2.224096086385321525e-01 2.224096086385321525e-01 --1.562500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 2.408255786187818992e-01 2.408255786187818992e-01 2.408255786187818992e-01 --1.562500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 1.939863833357020062e-01 1.939863833357020062e-01 1.939863833357020062e-01 --1.562500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 2.611387438809911754e-01 2.611387438809911754e-01 2.611387438809911754e-01 --1.562500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 3.006419726521785685e-01 3.006419726521785685e-01 3.006419726521785685e-01 --1.093750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 1.892500755633182152e-01 1.892500755633182152e-01 1.892500755633182152e-01 --1.093750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.254814297092346487e-01 1.254814297092346487e-01 1.254814297092346487e-01 --1.093750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 2.105929614751326229e-01 2.105929614751326229e-01 2.105929614751326229e-01 --7.812500000000000000e-02 1.406250000000000000e-01 4.687500000000000000e-02 1.177397702508760219e-01 1.177397702508760219e-01 1.177397702508760219e-01 --7.812500000000000000e-02 1.718750000000000000e-01 1.562500000000000000e-02 1.445982173875002552e-01 1.445982173875002552e-01 1.445982173875002552e-01 --7.812500000000000000e-02 1.718750000000000000e-01 4.687500000000000000e-02 1.871029538394462788e-01 1.871029538394462788e-01 1.871029538394462788e-01 --7.812500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 1.125305806438147843e-01 1.125305806438147843e-01 1.125305806438147843e-01 --7.812500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 1.079871271076867506e-01 1.079871271076867506e-01 1.079871271076867506e-01 --7.812500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 1.007612621526394192e-01 1.007612621526394192e-01 1.007612621526394192e-01 --1.093750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 1.705019628140659327e-01 1.705019628140659327e-01 1.705019628140659327e-01 --1.093750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 1.130801162506454988e-01 1.130801162506454988e-01 1.130801162506454988e-01 --7.812500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 1.105324568233501115e-01 1.105324568233501115e-01 1.105324568233501115e-01 --4.687500000000000000e-02 1.406250000000000000e-01 1.562500000000000000e-02 4.997099043131931206e-01 4.997099043131931206e-01 4.997099043131931206e-01 --4.687500000000000000e-02 1.406250000000000000e-01 4.687500000000000000e-02 2.308295255421767000e-01 2.308295255421767000e-01 2.308295255421767000e-01 --4.687500000000000000e-02 1.718750000000000000e-01 1.562500000000000000e-02 2.753694210624825778e-01 2.753694210624825778e-01 2.753694210624825778e-01 --4.687500000000000000e-02 1.718750000000000000e-01 4.687500000000000000e-02 1.002365521447402680e-01 1.002365521447402680e-01 1.002365521447402680e-01 --1.562500000000000000e-02 1.406250000000000000e-01 1.562500000000000000e-02 6.863058149007099651e-01 6.863058149007099651e-01 6.863058149007099651e-01 --1.562500000000000000e-02 1.718750000000000000e-01 1.562500000000000000e-02 3.834402267770045114e-01 3.834402267770045114e-01 3.834402267770045114e-01 --1.562500000000000000e-02 1.718750000000000000e-01 4.687500000000000000e-02 2.032378141051079112e-02 2.032378141051079112e-02 2.032378141051079112e-02 --4.687500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 1.066630096061211008e-01 1.066630096061211008e-01 1.066630096061211008e-01 --4.687500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 1.141518605681597770e-01 1.141518605681597770e-01 1.141518605681597770e-01 --4.687500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 3.526314615828671228e-02 3.526314615828671228e-02 3.526314615828671228e-02 --4.687500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 6.689478117524376433e-02 6.689478117524376433e-02 6.689478117524376433e-02 --1.562500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 2.302246366412890322e-01 2.302246366412890322e-01 2.302246366412890322e-01 --1.562500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 2.262542383764730713e-01 2.262542383764730713e-01 2.262542383764730713e-01 --1.562500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 8.704777022424026178e-02 8.704777022424026178e-02 8.704777022424026178e-02 --1.562500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 1.177494106345868957e-01 1.177494106345868957e-01 1.177494106345868957e-01 --4.687500000000000000e-02 2.031250000000000000e-01 1.562500000000000000e-02 1.425583246154685790e-01 1.425583246154685790e-01 1.425583246154685790e-01 --4.687500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 8.183820039817241154e-02 8.183820039817241154e-02 8.183820039817241154e-02 --4.687500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 1.133476519638775409e-01 1.133476519638775409e-01 1.133476519638775409e-01 --4.687500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 8.387882956944335555e-02 8.387882956944335555e-02 8.387882956944335555e-02 --1.562500000000000000e-02 2.031250000000000000e-01 1.562500000000000000e-02 3.212733992059281785e-01 3.212733992059281785e-01 3.212733992059281785e-01 --1.562500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 1.965899897699064369e-01 1.965899897699064369e-01 1.965899897699064369e-01 --1.562500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 1.318006486749903339e-01 1.318006486749903339e-01 1.318006486749903339e-01 --1.562500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 1.084804517212693969e-01 1.084804517212693969e-01 1.084804517212693969e-01 --1.562500000000000000e-02 2.031250000000000000e-01 7.812500000000000000e-02 9.641080652406092133e-02 9.641080652406092133e-02 9.641080652406092133e-02 --1.562500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 9.208583153159280443e-02 9.208583153159280443e-02 9.208583153159280443e-02 --1.562500000000000000e-02 2.343750000000000000e-01 7.812500000000000000e-02 2.187806295084193664e-01 2.187806295084193664e-01 2.187806295084193664e-01 --1.093750000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 2.625541462447607555e-01 2.625541462447607555e-01 2.625541462447607555e-01 --1.093750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 1.841057168893965590e-01 1.841057168893965590e-01 1.841057168893965590e-01 --1.093750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 2.541584011090032846e-01 2.541584011090032846e-01 2.541584011090032846e-01 --1.093750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 2.302013715927392346e-01 2.302013715927392346e-01 2.302013715927392346e-01 --7.812500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 1.946989093570618973e-02 1.946989093570618973e-02 1.946989093570618973e-02 --7.812500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 1.295298996531320523e-01 1.295298996531320523e-01 1.295298996531320523e-01 --7.812500000000000000e-02 1.718750000000000000e-01 1.718750000000000000e-01 1.528817386539609025e-01 1.528817386539609025e-01 1.528817386539609025e-01 --1.093750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 2.069827086860537568e-01 2.069827086860537568e-01 2.069827086860537568e-01 --1.093750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 2.294199829512453270e-01 2.294199829512453270e-01 2.294199829512453270e-01 --1.093750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 2.055566984603114100e-01 2.055566984603114100e-01 2.055566984603114100e-01 --7.812500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 1.961437549459371654e-01 1.961437549459371654e-01 1.961437549459371654e-01 --7.812500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 1.922960807851578358e-01 1.922960807851578358e-01 1.922960807851578358e-01 --1.093750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 1.947721291728988224e-01 1.947721291728988224e-01 1.947721291728988224e-01 --1.093750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.802751272671576643e-01 1.802751272671576643e-01 1.802751272671576643e-01 --1.093750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 1.308166920754831875e-01 1.308166920754831875e-01 1.308166920754831875e-01 --7.812500000000000000e-02 2.031250000000000000e-01 1.406250000000000000e-01 2.106306760859800731e-01 2.106306760859800731e-01 2.106306760859800731e-01 --7.812500000000000000e-02 2.031250000000000000e-01 1.718750000000000000e-01 1.862633534615192599e-01 1.862633534615192599e-01 1.862633534615192599e-01 --7.812500000000000000e-02 2.343750000000000000e-01 1.406250000000000000e-01 1.373274498258373055e-01 1.373274498258373055e-01 1.373274498258373055e-01 --7.812500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 1.193063174442298979e-01 1.193063174442298979e-01 1.193063174442298979e-01 --1.093750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.873469660727624386e-01 1.873469660727624386e-01 1.873469660727624386e-01 --1.093750000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 2.025753967757408791e-01 2.025753967757408791e-01 2.025753967757408791e-01 --7.812500000000000000e-02 2.031250000000000000e-01 2.031250000000000000e-01 1.970249860828860167e-01 1.970249860828860167e-01 1.970249860828860167e-01 --7.812500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 1.953861131734984380e-01 1.953861131734984380e-01 1.953861131734984380e-01 --4.687500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 1.044252979119477676e-01 1.044252979119477676e-01 1.044252979119477676e-01 --4.687500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 2.041731956157591954e-01 2.041731956157591954e-01 2.041731956157591954e-01 --1.562500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 1.564205458461125631e-01 1.564205458461125631e-01 1.564205458461125631e-01 --4.687500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 2.347788408964616991e-01 2.347788408964616991e-01 2.347788408964616991e-01 --4.687500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 2.102093948540386115e-01 2.102093948540386115e-01 2.102093948540386115e-01 --1.562500000000000000e-02 1.406250000000000000e-01 2.031250000000000000e-01 2.839329153270514494e-01 2.839329153270514494e-01 2.839329153270514494e-01 --1.562500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 3.237494879988546126e-01 3.237494879988546126e-01 3.237494879988546126e-01 --1.562500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 2.984769810566221815e-01 2.984769810566221815e-01 2.984769810566221815e-01 --4.687500000000000000e-02 2.031250000000000000e-01 1.406250000000000000e-01 1.908112178105149104e-01 1.908112178105149104e-01 1.908112178105149104e-01 --4.687500000000000000e-02 2.031250000000000000e-01 1.718750000000000000e-01 1.854582599752297722e-01 1.854582599752297722e-01 1.854582599752297722e-01 --4.687500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 1.544556317323536598e-01 1.544556317323536598e-01 1.544556317323536598e-01 --1.562500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 1.462935377345459809e-01 1.462935377345459809e-01 1.462935377345459809e-01 --4.687500000000000000e-02 2.031250000000000000e-01 2.031250000000000000e-01 1.514371025497291412e-01 1.514371025497291412e-01 1.514371025497291412e-01 --4.687500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 1.815249855447023941e-01 1.815249855447023941e-01 1.815249855447023941e-01 --4.687500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 1.061029849062417874e-01 1.061029849062417874e-01 1.061029849062417874e-01 --1.562500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 1.209403141692333428e-01 1.209403141692333428e-01 1.209403141692333428e-01 --1.562500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 1.212110370689759853e-01 1.212110370689759853e-01 1.212110370689759853e-01 --1.562500000000000000e-02 2.343750000000000000e-01 2.343750000000000000e-01 9.319803608490047353e-02 9.319803608490047353e-02 9.319803608490047353e-02 --2.343750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 9.030096824545019718e-02 9.030096824545019718e-02 9.030096824545019718e-02 --2.031250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 1.106585963848479987e-01 1.106585963848479987e-01 1.106585963848479987e-01 --2.031250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.325677248601831171e-01 1.325677248601831171e-01 1.325677248601831171e-01 --1.718750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 1.475326810744653772e-01 1.475326810744653772e-01 1.475326810744653772e-01 --1.718750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 7.757875269611759494e-02 7.757875269611759494e-02 7.757875269611759494e-02 --1.718750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 1.347002385485158993e-01 1.347002385485158993e-01 1.347002385485158993e-01 --1.406250000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 6.541451540467760339e-02 6.541451540467760339e-02 6.541451540467760339e-02 --1.406250000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 1.643046123699282157e-01 1.643046123699282157e-01 1.643046123699282157e-01 --1.406250000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 4.420804900153580547e-02 4.420804900153580547e-02 4.420804900153580547e-02 --1.406250000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 2.939524508576055878e-02 2.939524508576055878e-02 2.939524508576055878e-02 --1.406250000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 4.182924500029421011e-02 4.182924500029421011e-02 4.182924500029421011e-02 --1.718750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 1.394759003270593656e-01 1.394759003270593656e-01 1.394759003270593656e-01 --1.718750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.797260504401801684e-01 1.797260504401801684e-01 1.797260504401801684e-01 --1.718750000000000000e-01 1.093750000000000000e-01 2.968750000000000000e-01 1.244226890843318917e-01 1.244226890843318917e-01 1.244226890843318917e-01 --1.406250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 9.409646755398273776e-02 9.409646755398273776e-02 9.409646755398273776e-02 --1.406250000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 2.829221140046838875e-02 2.829221140046838875e-02 2.829221140046838875e-02 --1.406250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.681672740617995709e-01 1.681672740617995709e-01 1.681672740617995709e-01 --1.406250000000000000e-01 1.093750000000000000e-01 2.968750000000000000e-01 4.769028922432690110e-02 4.769028922432690110e-02 4.769028922432690110e-02 --1.406250000000000000e-01 7.812500000000000000e-02 3.281250000000000000e-01 3.526990134845366803e-02 3.526990134845366803e-02 3.526990134845366803e-02 --1.406250000000000000e-01 1.093750000000000000e-01 3.281250000000000000e-01 4.918358512775593272e-02 4.918358512775593272e-02 4.918358512775593272e-02 --2.343750000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 9.025676806687087106e-02 9.025676806687087106e-02 9.025676806687087106e-02 --2.343750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 1.087849616585611634e-01 1.087849616585611634e-01 1.087849616585611634e-01 --2.031250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 1.365234728492353278e-01 1.365234728492353278e-01 1.365234728492353278e-01 --2.031250000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 9.914533721880329498e-02 9.914533721880329498e-02 9.914533721880329498e-02 --2.031250000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 1.537168694277608882e-01 1.537168694277608882e-01 1.537168694277608882e-01 --2.031250000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 1.454784071141782542e-01 1.454784071141782542e-01 1.454784071141782542e-01 --2.343750000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 8.085443629699162749e-02 8.085443629699162749e-02 8.085443629699162749e-02 --2.031250000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 1.531330818083429801e-01 1.531330818083429801e-01 1.531330818083429801e-01 --2.031250000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 1.243873439369535261e-01 1.243873439369535261e-01 1.243873439369535261e-01 --2.031250000000000000e-01 2.343750000000000000e-01 2.656250000000000000e-01 1.089850216496462548e-01 1.089850216496462548e-01 1.089850216496462548e-01 --1.718750000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 1.144499218552138681e-01 1.144499218552138681e-01 1.144499218552138681e-01 --1.718750000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 1.351098674746418482e-01 1.351098674746418482e-01 1.351098674746418482e-01 --1.406250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 2.190871293209831761e-01 2.190871293209831761e-01 2.190871293209831761e-01 --1.406250000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 1.541384465739050191e-01 1.541384465739050191e-01 1.541384465739050191e-01 --1.406250000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 2.481904656306951895e-01 2.481904656306951895e-01 2.481904656306951895e-01 --1.406250000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 1.615578427915767001e-01 1.615578427915767001e-01 1.615578427915767001e-01 --1.718750000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 1.517896314847889117e-01 1.517896314847889117e-01 1.517896314847889117e-01 --1.718750000000000000e-01 2.343750000000000000e-01 2.656250000000000000e-01 1.351572557844393230e-01 1.351572557844393230e-01 1.351572557844393230e-01 --1.718750000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 1.030022898075303311e-01 1.030022898075303311e-01 1.030022898075303311e-01 --1.406250000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 2.490029521701788429e-01 2.490029521701788429e-01 2.490029521701788429e-01 --1.406250000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 1.801787982703044466e-01 1.801787982703044466e-01 1.801787982703044466e-01 --1.406250000000000000e-01 2.343750000000000000e-01 2.656250000000000000e-01 1.487653808849120629e-01 1.487653808849120629e-01 1.487653808849120629e-01 --1.093750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 1.789192860236874238e-01 1.789192860236874238e-01 1.789192860236874238e-01 --1.093750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 6.721544556492037303e-02 6.721544556492037303e-02 6.721544556492037303e-02 --1.093750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 8.327363852636951447e-02 8.327363852636951447e-02 8.327363852636951447e-02 --7.812500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 6.126385413637153166e-02 6.126385413637153166e-02 6.126385413637153166e-02 --7.812500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 7.813367115968154752e-02 7.813367115968154752e-02 7.813367115968154752e-02 --7.812500000000000000e-02 4.687500000000000000e-02 2.656250000000000000e-01 6.204422470530753658e-02 6.204422470530753658e-02 6.204422470530753658e-02 --1.093750000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 8.674317800288519620e-02 8.674317800288519620e-02 8.674317800288519620e-02 --1.093750000000000000e-01 1.562500000000000000e-02 3.593750000000000000e-01 6.346289280341706196e-02 6.346289280341706196e-02 6.346289280341706196e-02 --1.093750000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 9.143891357379692331e-02 9.143891357379692331e-02 9.143891357379692331e-02 --1.093750000000000000e-01 4.687500000000000000e-02 3.593750000000000000e-01 5.902970307039601128e-02 5.902970307039601128e-02 5.902970307039601128e-02 --7.812500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 9.214128140020418078e-02 9.214128140020418078e-02 9.214128140020418078e-02 --7.812500000000000000e-02 1.562500000000000000e-02 3.593750000000000000e-01 7.437857319048593596e-02 7.437857319048593596e-02 7.437857319048593596e-02 --7.812500000000000000e-02 4.687500000000000000e-02 3.593750000000000000e-01 8.123942384438548325e-02 8.123942384438548325e-02 8.123942384438548325e-02 --1.093750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 8.610264653504215437e-02 8.610264653504215437e-02 8.610264653504215437e-02 --1.093750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 5.252603281325172319e-02 5.252603281325172319e-02 5.252603281325172319e-02 --1.093750000000000000e-01 1.093750000000000000e-01 2.968750000000000000e-01 6.066468325817673396e-02 6.066468325817673396e-02 6.066468325817673396e-02 --7.812500000000000000e-02 7.812500000000000000e-02 2.656250000000000000e-01 1.033373538344376646e-01 1.033373538344376646e-01 1.033373538344376646e-01 --7.812500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 1.418796874050290147e-01 1.418796874050290147e-01 1.418796874050290147e-01 --7.812500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 8.669415381730039005e-02 8.669415381730039005e-02 8.669415381730039005e-02 --1.093750000000000000e-01 7.812500000000000000e-02 3.593750000000000000e-01 4.274344805118562157e-02 4.274344805118562157e-02 4.274344805118562157e-02 --1.093750000000000000e-01 1.093750000000000000e-01 3.281250000000000000e-01 5.787610434438027196e-02 5.787610434438027196e-02 5.787610434438027196e-02 --1.093750000000000000e-01 1.093750000000000000e-01 3.593750000000000000e-01 6.393800074148463242e-02 6.393800074148463242e-02 6.393800074148463242e-02 --7.812500000000000000e-02 7.812500000000000000e-02 3.593750000000000000e-01 5.627981929707659425e-02 5.627981929707659425e-02 5.627981929707659425e-02 --7.812500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 6.226996559910464440e-02 6.226996559910464440e-02 6.226996559910464440e-02 --7.812500000000000000e-02 1.093750000000000000e-01 3.593750000000000000e-01 4.405615438064765937e-02 4.405615438064765937e-02 4.405615438064765937e-02 --4.687500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 1.211548039006663940e-01 1.211548039006663940e-01 1.211548039006663940e-01 --4.687500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 1.303885667938786685e-01 1.303885667938786685e-01 1.303885667938786685e-01 --4.687500000000000000e-02 4.687500000000000000e-02 2.656250000000000000e-01 9.708902380317117886e-02 9.708902380317117886e-02 9.708902380317117886e-02 --1.562500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 9.942095475691412054e-02 9.942095475691412054e-02 9.942095475691412054e-02 --4.687500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 1.459249230384893348e-01 1.459249230384893348e-01 1.459249230384893348e-01 --4.687500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 8.117753661761516193e-02 8.117753661761516193e-02 8.117753661761516193e-02 --4.687500000000000000e-02 4.687500000000000000e-02 3.593750000000000000e-01 5.639792376830184140e-02 5.639792376830184140e-02 5.639792376830184140e-02 --1.562500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 1.570420493518207561e-01 1.570420493518207561e-01 1.570420493518207561e-01 --1.562500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 1.340584823710166684e-01 1.340584823710166684e-01 1.340584823710166684e-01 --1.562500000000000000e-02 4.687500000000000000e-02 3.593750000000000000e-01 3.992433379456340053e-02 3.992433379456340053e-02 3.992433379456340053e-02 --4.687500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 1.619344151120433728e-01 1.619344151120433728e-01 1.619344151120433728e-01 --4.687500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 1.325203350251013823e-01 1.325203350251013823e-01 1.325203350251013823e-01 --1.562500000000000000e-02 7.812500000000000000e-02 2.656250000000000000e-01 1.211772971727138604e-01 1.211772971727138604e-01 1.211772971727138604e-01 --1.562500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 1.662058583445152338e-01 1.662058583445152338e-01 1.662058583445152338e-01 --1.562500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 1.314825709599303505e-01 1.314825709599303505e-01 1.314825709599303505e-01 --4.687500000000000000e-02 7.812500000000000000e-02 3.281250000000000000e-01 7.551561844422834124e-02 7.551561844422834124e-02 7.551561844422834124e-02 --4.687500000000000000e-02 7.812500000000000000e-02 3.593750000000000000e-01 3.352768684789154269e-02 3.352768684789154269e-02 3.352768684789154269e-02 --4.687500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 9.163339132035387691e-02 9.163339132035387691e-02 9.163339132035387691e-02 --1.562500000000000000e-02 7.812500000000000000e-02 3.281250000000000000e-01 7.037571808899331649e-02 7.037571808899331649e-02 7.037571808899331649e-02 --1.562500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 9.546900717113158963e-02 9.546900717113158963e-02 9.546900717113158963e-02 --1.093750000000000000e-01 4.687500000000000000e-02 3.906250000000000000e-01 4.643826966649968607e-02 4.643826966649968607e-02 4.643826966649968607e-02 --7.812500000000000000e-02 4.687500000000000000e-02 3.906250000000000000e-01 5.887429903498896111e-02 5.887429903498896111e-02 5.887429903498896111e-02 --7.812500000000000000e-02 7.812500000000000000e-02 3.906250000000000000e-01 5.180989185866951424e-02 5.180989185866951424e-02 5.180989185866951424e-02 --1.093750000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 4.173578378121691190e-01 4.173578378121691190e-01 4.173578378121691190e-01 --1.093750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 1.561427145607564571e-01 1.561427145607564571e-01 1.561427145607564571e-01 --7.812500000000000000e-02 1.406250000000000000e-01 2.656250000000000000e-01 1.320825801438694769e-01 1.320825801438694769e-01 1.320825801438694769e-01 --7.812500000000000000e-02 1.406250000000000000e-01 2.968750000000000000e-01 9.484381345769557492e-02 9.484381345769557492e-02 9.484381345769557492e-02 --1.093750000000000000e-01 1.406250000000000000e-01 3.281250000000000000e-01 4.439484119932250727e-02 4.439484119932250727e-02 4.439484119932250727e-02 --1.093750000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 2.063222692758021060e-01 2.063222692758021060e-01 2.063222692758021060e-01 --4.687500000000000000e-02 1.406250000000000000e-01 2.656250000000000000e-01 1.002711043638232630e-01 1.002711043638232630e-01 1.002711043638232630e-01 --4.687500000000000000e-02 1.406250000000000000e-01 2.968750000000000000e-01 8.664914798129395856e-02 8.664914798129395856e-02 8.664914798129395856e-02 --2.343750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 7.298718604065322635e-02 7.298718604065322635e-02 7.298718604065322635e-02 --2.031250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 5.157760900109475272e-02 5.157760900109475272e-02 5.157760900109475272e-02 --2.343750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 1.208583741208778817e-01 1.208583741208778817e-01 1.208583741208778817e-01 --2.343750000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 1.307990209081863753e-01 1.307990209081863753e-01 1.307990209081863753e-01 --2.343750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 9.402735779717824594e-02 9.402735779717824594e-02 9.402735779717824594e-02 --2.031250000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 1.683519321044768258e-01 1.683519321044768258e-01 1.683519321044768258e-01 --2.031250000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 1.164527686562458614e-01 1.164527686562458614e-01 1.164527686562458614e-01 --2.031250000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 1.346287540712076125e-01 1.346287540712076125e-01 1.346287540712076125e-01 --1.718750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 7.275030219178124646e-02 7.275030219178124646e-02 7.275030219178124646e-02 --1.718750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 6.809463340103651119e-02 6.809463340103651119e-02 6.809463340103651119e-02 --1.406250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 7.546706968928210135e-02 7.546706968928210135e-02 7.546706968928210135e-02 --1.406250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 1.036161710377180439e-01 1.036161710377180439e-01 1.036161710377180439e-01 --1.406250000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 7.489509241696924724e-02 7.489509241696924724e-02 7.489509241696924724e-02 --1.406250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 5.687371660768664183e-02 5.687371660768664183e-02 5.687371660768664183e-02 --1.718750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 1.496567676780034273e-01 1.496567676780034273e-01 1.496567676780034273e-01 --1.718750000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 2.029012187029539671e-01 2.029012187029539671e-01 2.029012187029539671e-01 --1.718750000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 1.088620932803111424e-01 1.088620932803111424e-01 1.088620932803111424e-01 --1.718750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 1.344175130535979201e-01 1.344175130535979201e-01 1.344175130535979201e-01 --1.406250000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 1.383273900000795975e-01 1.383273900000795975e-01 1.383273900000795975e-01 --1.406250000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 1.925440903624600630e-01 1.925440903624600630e-01 1.925440903624600630e-01 --1.718750000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 6.357543977668020374e-02 6.357543977668020374e-02 6.357543977668020374e-02 --1.406250000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 8.215808188518120003e-02 8.215808188518120003e-02 8.215808188518120003e-02 --2.343750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 1.009235760409402799e-01 1.009235760409402799e-01 1.009235760409402799e-01 --2.343750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 7.564615336191625461e-02 7.564615336191625461e-02 7.564615336191625461e-02 --2.031250000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 7.388463752620956504e-02 7.388463752620956504e-02 7.388463752620956504e-02 --2.031250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.112603677489503728e-01 1.112603677489503728e-01 1.112603677489503728e-01 --1.718750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 1.963757010536281433e-01 1.963757010536281433e-01 1.963757010536281433e-01 --1.718750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 1.067602301396934350e-01 1.067602301396934350e-01 1.067602301396934350e-01 --1.718750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.146234556808499033e-01 1.146234556808499033e-01 1.146234556808499033e-01 --1.406250000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 1.952617115649616375e-01 1.952617115649616375e-01 1.952617115649616375e-01 --1.093750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 1.023634948109444082e-01 1.023634948109444082e-01 1.023634948109444082e-01 --7.812500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 9.945550732628681556e-02 9.945550732628681556e-02 9.945550732628681556e-02 --1.093750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 1.469119071789790343e-01 1.469119071789790343e-01 1.469119071789790343e-01 --1.093750000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 1.176128384244543579e-01 1.176128384244543579e-01 1.176128384244543579e-01 --1.093750000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 9.446371259137953391e-02 9.446371259137953391e-02 9.446371259137953391e-02 --1.093750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 9.057179426397797550e-02 9.057179426397797550e-02 9.057179426397797550e-02 --7.812500000000000000e-02 2.656250000000000000e-01 7.812500000000000000e-02 8.211468095399139522e-02 8.211468095399139522e-02 8.211468095399139522e-02 --7.812500000000000000e-02 2.656250000000000000e-01 1.093750000000000000e-01 8.416896602485149370e-02 8.416896602485149370e-02 8.416896602485149370e-02 --7.812500000000000000e-02 2.968750000000000000e-01 7.812500000000000000e-02 9.180858161519575567e-02 9.180858161519575567e-02 9.180858161519575567e-02 --7.812500000000000000e-02 2.968750000000000000e-01 1.093750000000000000e-01 1.117247489823716827e-01 1.117247489823716827e-01 1.117247489823716827e-01 --1.093750000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 7.613597892934746703e-02 7.613597892934746703e-02 7.613597892934746703e-02 --1.093750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 7.306427160828829481e-02 7.306427160828829481e-02 7.306427160828829481e-02 --7.812500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 7.923545910571820616e-02 7.923545910571820616e-02 7.923545910571820616e-02 --7.812500000000000000e-02 3.281250000000000000e-01 4.687500000000000000e-02 1.018669185927903453e-01 1.018669185927903453e-01 1.018669185927903453e-01 --7.812500000000000000e-02 3.281250000000000000e-01 1.093750000000000000e-01 5.363749796569351747e-02 5.363749796569351747e-02 5.363749796569351747e-02 --4.687500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 6.308650242483378190e-02 6.308650242483378190e-02 6.308650242483378190e-02 --4.687500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 6.457822635768092900e-02 6.457822635768092900e-02 6.457822635768092900e-02 --1.562500000000000000e-02 2.656250000000000000e-01 1.562500000000000000e-02 1.159803808833603928e-01 1.159803808833603928e-01 1.159803808833603928e-01 --1.562500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 1.029974687322050414e-01 1.029974687322050414e-01 1.029974687322050414e-01 --1.562500000000000000e-02 2.968750000000000000e-01 1.562500000000000000e-02 8.569116064333560934e-02 8.569116064333560934e-02 8.569116064333560934e-02 --1.562500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 9.141882287070589308e-02 9.141882287070589308e-02 9.141882287070589308e-02 --4.687500000000000000e-02 2.656250000000000000e-01 7.812500000000000000e-02 1.255352499910220021e-01 1.255352499910220021e-01 1.255352499910220021e-01 --4.687500000000000000e-02 2.968750000000000000e-01 7.812500000000000000e-02 5.641191298621924671e-02 5.641191298621924671e-02 5.641191298621924671e-02 --4.687500000000000000e-02 2.968750000000000000e-01 1.093750000000000000e-01 1.177204894800244900e-01 1.177204894800244900e-01 1.177204894800244900e-01 --1.562500000000000000e-02 2.656250000000000000e-01 7.812500000000000000e-02 2.709041124570504833e-01 2.709041124570504833e-01 2.709041124570504833e-01 --1.562500000000000000e-02 2.656250000000000000e-01 1.093750000000000000e-01 2.539177994534932425e-01 2.539177994534932425e-01 2.539177994534932425e-01 --1.562500000000000000e-02 2.968750000000000000e-01 1.093750000000000000e-01 1.112579574587365255e-01 1.112579574587365255e-01 1.112579574587365255e-01 --4.687500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 8.355493639017709528e-02 8.355493639017709528e-02 8.355493639017709528e-02 --4.687500000000000000e-02 3.281250000000000000e-01 4.687500000000000000e-02 7.368915230531521143e-02 7.368915230531521143e-02 7.368915230531521143e-02 --4.687500000000000000e-02 3.593750000000000000e-01 1.562500000000000000e-02 8.284526017587200142e-02 8.284526017587200142e-02 8.284526017587200142e-02 --4.687500000000000000e-02 3.593750000000000000e-01 4.687500000000000000e-02 1.064661577527595410e-01 1.064661577527595410e-01 1.064661577527595410e-01 --1.562500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 8.840837522209829547e-02 8.840837522209829547e-02 8.840837522209829547e-02 --1.562500000000000000e-02 3.281250000000000000e-01 4.687500000000000000e-02 9.468711247243155604e-02 9.468711247243155604e-02 9.468711247243155604e-02 --1.562500000000000000e-02 3.593750000000000000e-01 1.562500000000000000e-02 1.537618377619434096e-01 1.537618377619434096e-01 1.537618377619434096e-01 --1.562500000000000000e-02 3.593750000000000000e-01 4.687500000000000000e-02 1.643311080828358250e-01 1.643311080828358250e-01 1.643311080828358250e-01 --4.687500000000000000e-02 3.281250000000000000e-01 1.093750000000000000e-01 9.423066888893275039e-02 9.423066888893275039e-02 9.423066888893275039e-02 --4.687500000000000000e-02 3.593750000000000000e-01 7.812500000000000000e-02 5.744115900176892386e-02 5.744115900176892386e-02 5.744115900176892386e-02 --1.562500000000000000e-02 3.281250000000000000e-01 7.812500000000000000e-02 8.354850673570542174e-02 8.354850673570542174e-02 8.354850673570542174e-02 --1.562500000000000000e-02 3.593750000000000000e-01 7.812500000000000000e-02 8.597968319804051573e-02 8.597968319804051573e-02 8.597968319804051573e-02 --1.562500000000000000e-02 3.593750000000000000e-01 1.093750000000000000e-01 6.261629334593599161e-02 6.261629334593599161e-02 6.261629334593599161e-02 --1.093750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 1.159755605856616217e-01 1.159755605856616217e-01 1.159755605856616217e-01 --1.093750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 7.348177026063444639e-02 7.348177026063444639e-02 7.348177026063444639e-02 --1.093750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 8.199010407695749014e-02 8.199010407695749014e-02 8.199010407695749014e-02 --7.812500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 8.261620139779139727e-02 8.261620139779139727e-02 8.261620139779139727e-02 --7.812500000000000000e-02 2.968750000000000000e-01 1.406250000000000000e-01 9.817223101213490288e-02 9.817223101213490288e-02 9.817223101213490288e-02 --7.812500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 6.682950664305463417e-02 6.682950664305463417e-02 6.682950664305463417e-02 --7.812500000000000000e-02 3.281250000000000000e-01 1.406250000000000000e-01 9.107165472896690261e-02 9.107165472896690261e-02 9.107165472896690261e-02 --4.687500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 8.584627178323198105e-02 8.584627178323198105e-02 8.584627178323198105e-02 --4.687500000000000000e-02 2.968750000000000000e-01 1.406250000000000000e-01 9.708339880185529180e-02 9.708339880185529180e-02 9.708339880185529180e-02 --4.687500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 7.438299408183526862e-02 7.438299408183526862e-02 7.438299408183526862e-02 --1.562500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 9.055411425497499056e-02 9.055411425497499056e-02 9.055411425497499056e-02 --1.562500000000000000e-02 2.968750000000000000e-01 1.406250000000000000e-01 8.283481189493650809e-02 8.283481189493650809e-02 8.283481189493650809e-02 --1.562500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 6.249538429266751627e-02 6.249538429266751627e-02 6.249538429266751627e-02 --1.562500000000000000e-02 2.656250000000000000e-01 2.031250000000000000e-01 9.202234540318837697e-02 9.202234540318837697e-02 9.202234540318837697e-02 --1.562500000000000000e-02 2.968750000000000000e-01 2.031250000000000000e-01 1.776653734296610998e-01 1.776653734296610998e-01 1.776653734296610998e-01 --1.562500000000000000e-02 2.968750000000000000e-01 2.343750000000000000e-01 1.479510783717827016e-01 1.479510783717827016e-01 1.479510783717827016e-01 --4.687500000000000000e-02 3.281250000000000000e-01 1.406250000000000000e-01 9.046169596284908687e-02 9.046169596284908687e-02 9.046169596284908687e-02 --1.562500000000000000e-02 3.281250000000000000e-01 1.718750000000000000e-01 1.375876764168604827e-01 1.375876764168604827e-01 1.375876764168604827e-01 --1.562500000000000000e-02 3.281250000000000000e-01 2.031250000000000000e-01 1.858066264406528223e-01 1.858066264406528223e-01 1.858066264406528223e-01 --1.562500000000000000e-02 3.281250000000000000e-01 2.343750000000000000e-01 1.257457110458043148e-01 1.257457110458043148e-01 1.257457110458043148e-01 --1.562500000000000000e-02 3.593750000000000000e-01 2.031250000000000000e-01 1.168512432604354306e-01 1.168512432604354306e-01 1.168512432604354306e-01 --1.093750000000000000e-01 4.218750000000000000e-01 1.562500000000000000e-02 3.278322927446690460e-02 3.278322927446690460e-02 3.278322927446690460e-02 --7.812500000000000000e-02 3.906250000000000000e-01 1.562500000000000000e-02 3.917446718694662933e-02 3.917446718694662933e-02 3.917446718694662933e-02 --7.812500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 3.956737403657376029e-02 3.956737403657376029e-02 3.956737403657376029e-02 --1.093750000000000000e-01 4.531250000000000000e-01 1.562500000000000000e-02 3.076832596917737986e-02 3.076832596917737986e-02 3.076832596917737986e-02 --1.093750000000000000e-01 4.843750000000000000e-01 1.562500000000000000e-02 2.130876852943166394e-02 2.130876852943166394e-02 2.130876852943166394e-02 --7.812500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 4.273878418654007000e-02 4.273878418654007000e-02 4.273878418654007000e-02 --7.812500000000000000e-02 4.843750000000000000e-01 1.562500000000000000e-02 2.870945989836223150e-02 2.870945989836223150e-02 2.870945989836223150e-02 --4.687500000000000000e-02 3.906250000000000000e-01 1.562500000000000000e-02 6.363171320427130073e-02 6.363171320427130073e-02 6.363171320427130073e-02 --4.687500000000000000e-02 3.906250000000000000e-01 4.687500000000000000e-02 6.796794477070339235e-02 6.796794477070339235e-02 6.796794477070339235e-02 --4.687500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 5.022570785217275041e-02 5.022570785217275041e-02 5.022570785217275041e-02 --4.687500000000000000e-02 4.218750000000000000e-01 4.687500000000000000e-02 7.374276610353744377e-02 7.374276610353744377e-02 7.374276610353744377e-02 --1.562500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 4.780816508623301347e-02 4.780816508623301347e-02 4.780816508623301347e-02 --4.687500000000000000e-02 3.906250000000000000e-01 7.812500000000000000e-02 8.093400589937460587e-02 8.093400589937460587e-02 8.093400589937460587e-02 --4.687500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 7.190974874957030416e-02 7.190974874957030416e-02 7.190974874957030416e-02 --4.687500000000000000e-02 4.218750000000000000e-01 7.812500000000000000e-02 6.786392489591260013e-02 6.786392489591260013e-02 6.786392489591260013e-02 --4.687500000000000000e-02 4.218750000000000000e-01 1.093750000000000000e-01 5.617674908587022564e-02 5.617674908587022564e-02 5.617674908587022564e-02 --1.562500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 8.615488580434219057e-02 8.615488580434219057e-02 8.615488580434219057e-02 --1.562500000000000000e-02 4.218750000000000000e-01 1.093750000000000000e-01 6.167707283181964040e-02 6.167707283181964040e-02 6.167707283181964040e-02 --4.687500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 4.624376304923973752e-02 4.624376304923973752e-02 4.624376304923973752e-02 --4.687500000000000000e-02 4.531250000000000000e-01 4.687500000000000000e-02 2.729058098133161150e-02 2.729058098133161150e-02 2.729058098133161150e-02 --4.687500000000000000e-02 4.843750000000000000e-01 1.562500000000000000e-02 2.772078333710275774e-02 2.772078333710275774e-02 2.772078333710275774e-02 --1.562500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 6.341039762560707338e-02 6.341039762560707338e-02 6.341039762560707338e-02 --1.562500000000000000e-02 4.531250000000000000e-01 4.687500000000000000e-02 8.272711415072421526e-02 8.272711415072421526e-02 8.272711415072421526e-02 --4.687500000000000000e-02 4.531250000000000000e-01 7.812500000000000000e-02 6.027493439599693192e-02 6.027493439599693192e-02 6.027493439599693192e-02 --1.562500000000000000e-02 4.531250000000000000e-01 7.812500000000000000e-02 9.060876154296521046e-02 9.060876154296521046e-02 9.060876154296521046e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.266574348292445751e-01 1.266574348292445751e-01 1.266574348292445751e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 1.012658804942263152e-01 1.012658804942263152e-01 1.012658804942263152e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 1.641255653539704373e-01 1.641255653539704373e-01 1.641255653539704373e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 1.311620822933478314e-01 1.311620822933478314e-01 1.311620822933478314e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 1.817601847069037213e-01 1.817601847069037213e-01 1.817601847069037213e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 1.324480453923854995e-01 1.324480453923854995e-01 1.324480453923854995e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 1.308383794118543886e-01 1.308383794118543886e-01 1.308383794118543886e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 1.494873246424326396e-01 1.494873246424326396e-01 1.494873246424326396e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 8.159386795334536147e-02 8.159386795334536147e-02 8.159386795334536147e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -3.906250000000000000e-01 7.157648299515072254e-02 7.157648299515072254e-02 7.157648299515072254e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 -3.593750000000000000e-01 2.122417881421698790e-03 2.122417881421698790e-03 2.122417881421698790e-03 -4.687500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 8.897254136694292270e-02 8.897254136694292270e-02 8.897254136694292270e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 1.158928120969127951e-01 1.158928120969127951e-01 1.158928120969127951e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 1.050680939979450473e-01 1.050680939979450473e-01 1.050680939979450473e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 -3.593750000000000000e-01 5.105611586440241684e-02 5.105611586440241684e-02 5.105611586440241684e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 6.751159073492637996e-02 6.751159073492637996e-02 6.751159073492637996e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 -3.593750000000000000e-01 6.310016891533903882e-02 6.310016891533903882e-02 6.310016891533903882e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 5.516477269077692258e-02 5.516477269077692258e-02 5.516477269077692258e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -3.593750000000000000e-01 8.321416399492877203e-02 8.321416399492877203e-02 8.321416399492877203e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 9.104674214267841070e-02 9.104674214267841070e-02 9.104674214267841070e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 8.151108409487139994e-02 8.151108409487139994e-02 8.151108409487139994e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 7.551762791191855839e-02 7.551762791191855839e-02 7.551762791191855839e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 7.970123084096694677e-02 7.970123084096694677e-02 7.970123084096694677e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 4.902583032240746819e-02 4.902583032240746819e-02 4.902583032240746819e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 -3.906250000000000000e-01 7.507015840517539118e-02 7.507015840517539118e-02 7.507015840517539118e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 -4.218750000000000000e-01 5.521486127924194603e-02 5.521486127924194603e-02 5.521486127924194603e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 1.068494158151019474e-01 1.068494158151019474e-01 1.068494158151019474e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -3.906250000000000000e-01 8.208012093646946394e-02 8.208012093646946394e-02 8.208012093646946394e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 8.585350493790860904e-02 8.585350493790860904e-02 8.585350493790860904e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 -4.218750000000000000e-01 5.579027481709843833e-02 5.579027481709843833e-02 5.579027481709843833e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 9.005826878366000876e-02 9.005826878366000876e-02 9.005826878366000876e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 -4.218750000000000000e-01 6.830781711802944023e-02 6.830781711802944023e-02 6.830781711802944023e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 -3.906250000000000000e-01 1.126446658299966735e-01 1.126446658299966735e-01 1.126446658299966735e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 1.084997347066141843e-01 1.084997347066141843e-01 1.084997347066141843e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -3.906250000000000000e-01 1.050166705000656620e-01 1.050166705000656620e-01 1.050166705000656620e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -3.906250000000000000e-01 6.175360648954482390e-02 6.175360648954482390e-02 6.175360648954482390e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 -3.906250000000000000e-01 7.536482784464486329e-02 7.536482784464486329e-02 7.536482784464486329e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 -3.906250000000000000e-01 6.057592873280422119e-02 6.057592873280422119e-02 6.057592873280422119e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 -3.906250000000000000e-01 9.184072658200366501e-02 9.184072658200366501e-02 9.184072658200366501e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 8.157055988530081958e-02 8.157055988530081958e-02 8.157055988530081958e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 1.032626274457310867e-01 1.032626274457310867e-01 1.032626274457310867e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -3.281250000000000000e-01 7.745995592277710173e-02 7.745995592277710173e-02 7.745995592277710173e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 8.624570168405489012e-02 8.624570168405489012e-02 8.624570168405489012e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 -3.281250000000000000e-01 9.171455751356094588e-02 9.171455751356094588e-02 9.171455751356094588e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 -2.968750000000000000e-01 1.214448059616491798e-01 1.214448059616491798e-01 1.214448059616491798e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 1.283475104444523340e-01 1.283475104444523340e-01 1.283475104444523340e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -2.968750000000000000e-01 1.127804430590434587e-01 1.127804430590434587e-01 1.127804430590434587e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 1.183021240349405034e-01 1.183021240349405034e-01 1.183021240349405034e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -2.968750000000000000e-01 1.111985036106867136e-01 1.111985036106867136e-01 1.111985036106867136e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 1.192219656800471012e-01 1.192219656800471012e-01 1.192219656800471012e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 1.080433694802469813e-01 1.080433694802469813e-01 1.080433694802469813e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -3.593750000000000000e-01 9.640518147532690929e-02 9.640518147532690929e-02 9.640518147532690929e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 -3.281250000000000000e-01 6.467517620146560897e-02 6.467517620146560897e-02 6.467517620146560897e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 9.623000118938034031e-02 9.623000118938034031e-02 9.623000118938034031e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 -2.656250000000000000e-01 1.116942188105956163e-01 1.116942188105956163e-01 1.116942188105956163e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 7.705308770139344954e-02 7.705308770139344954e-02 7.705308770139344954e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 7.632133058980983265e-02 7.632133058980983265e-02 7.632133058980983265e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 9.566990386256081502e-02 9.566990386256081502e-02 9.566990386256081502e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 -2.656250000000000000e-01 1.139036092193735777e-01 1.139036092193735777e-01 1.139036092193735777e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 7.772077810765713746e-02 7.772077810765713746e-02 7.772077810765713746e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 1.669083766335139607e-01 1.669083766335139607e-01 1.669083766335139607e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -3.593750000000000000e-01 2.303081813222456614e-02 2.303081813222456614e-02 2.303081813222456614e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 5.998503333711813212e-02 5.998503333711813212e-02 5.998503333711813212e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 4.113801729054704370e-02 4.113801729054704370e-02 4.113801729054704370e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 -2.656250000000000000e-01 8.218781954676396273e-02 8.218781954676396273e-02 8.218781954676396273e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 -2.656250000000000000e-01 1.051195174629742379e-01 1.051195174629742379e-01 1.051195174629742379e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 6.598567581094347267e-02 6.598567581094347267e-02 6.598567581094347267e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 7.119739754994641734e-02 7.119739754994641734e-02 7.119739754994641734e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 -3.593750000000000000e-01 9.624526921112307176e-02 9.624526921112307176e-02 9.624526921112307176e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 -3.281250000000000000e-01 8.433613558499868101e-02 8.433613558499868101e-02 8.433613558499868101e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 -3.593750000000000000e-01 7.313878490741039518e-02 7.313878490741039518e-02 7.313878490741039518e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 -3.281250000000000000e-01 5.032878568756096738e-02 5.032878568756096738e-02 5.032878568756096738e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -3.593750000000000000e-01 4.503707176207451951e-02 4.503707176207451951e-02 4.503707176207451951e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 6.222623237000497742e-02 6.222623237000497742e-02 6.222623237000497742e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 6.696841592879067273e-02 6.696841592879067273e-02 6.696841592879067273e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 -2.968750000000000000e-01 9.565383214571486492e-02 9.565383214571486492e-02 9.565383214571486492e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 -2.656250000000000000e-01 1.043714635066640278e-01 1.043714635066640278e-01 1.043714635066640278e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -2.968750000000000000e-01 5.444037404831943150e-02 5.444037404831943150e-02 5.444037404831943150e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 -2.656250000000000000e-01 6.900106222312082926e-02 6.900106222312082926e-02 6.900106222312082926e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 6.649975690363239822e-02 6.649975690363239822e-02 6.649975690363239822e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 9.174027351809171948e-02 9.174027351809171948e-02 9.174027351809171948e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 6.435876234940678120e-02 6.435876234940678120e-02 6.435876234940678120e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 5.537413152744747463e-02 5.537413152744747463e-02 5.537413152744747463e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -3.906250000000000000e-01 8.691918261972704507e-02 8.691918261972704507e-02 8.691918261972704507e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 -3.593750000000000000e-01 7.295945450973741198e-02 7.295945450973741198e-02 7.295945450973741198e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 7.267064411373565236e-02 7.267064411373565236e-02 7.267064411373565236e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -3.593750000000000000e-01 9.662375450823484924e-02 9.662375450823484924e-02 9.662375450823484924e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 1.086250739987733582e-01 1.086250739987733582e-01 1.086250739987733582e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 9.005344693262469502e-02 9.005344693262469502e-02 9.005344693262469502e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 5.927354128558294522e-02 5.927354128558294522e-02 5.927354128558294522e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 6.544779636154444968e-02 6.544779636154444968e-02 6.544779636154444968e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 5.808778761331952895e-02 5.808778761331952895e-02 5.808778761331952895e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 8.069529685617675419e-02 8.069529685617675419e-02 8.069529685617675419e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 9.271988644502592025e-02 9.271988644502592025e-02 9.271988644502592025e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 6.205467568658659672e-02 6.205467568658659672e-02 6.205467568658659672e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 5.626607125000426118e-02 5.626607125000426118e-02 5.626607125000426118e-02 -2.031250000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 6.347181617633640416e-02 6.347181617633640416e-02 6.347181617633640416e-02 -2.031250000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 5.536898600189615188e-02 5.536898600189615188e-02 5.536898600189615188e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 5.123436944909200152e-02 5.123436944909200152e-02 5.123436944909200152e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 5.520272103032211608e-02 5.520272103032211608e-02 5.520272103032211608e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 6.648038346150419997e-02 6.648038346150419997e-02 6.648038346150419997e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 7.512312825031146335e-02 7.512312825031146335e-02 7.512312825031146335e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 -3.906250000000000000e-01 6.429187796119385789e-02 6.429187796119385789e-02 6.429187796119385789e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 6.633464036347262727e-02 6.633464036347262727e-02 6.633464036347262727e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 5.378857049426507414e-02 5.378857049426507414e-02 5.378857049426507414e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 -3.593750000000000000e-01 7.964754063866744116e-02 7.964754063866744116e-02 7.964754063866744116e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 5.627322666660616868e-02 5.627322666660616868e-02 5.627322666660616868e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 -3.593750000000000000e-01 4.192196041055079592e-02 4.192196041055079592e-02 4.192196041055079592e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 -3.281250000000000000e-01 5.557070643694678180e-02 5.557070643694678180e-02 5.557070643694678180e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 6.653729795871725361e-02 6.653729795871725361e-02 6.653729795871725361e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 6.138991018127312738e-02 6.138991018127312738e-02 6.138991018127312738e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 7.059251302509471360e-02 7.059251302509471360e-02 7.059251302509471360e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 4.836650515799101324e-02 4.836650515799101324e-02 4.836650515799101324e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 5.582492652794002891e-02 5.582492652794002891e-02 5.582492652794002891e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 5.187751024536185751e-02 5.187751024536185751e-02 5.187751024536185751e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 4.846958537539620276e-02 4.846958537539620276e-02 4.846958537539620276e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 -3.593750000000000000e-01 5.433424628544761270e-02 5.433424628544761270e-02 5.433424628544761270e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 8.177309873373203586e-02 8.177309873373203586e-02 8.177309873373203586e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 7.901892858364031880e-02 7.901892858364031880e-02 7.901892858364031880e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 -3.593750000000000000e-01 3.507231180189804981e-02 3.507231180189804981e-02 3.507231180189804981e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 -3.281250000000000000e-01 5.841885816444966628e-02 5.841885816444966628e-02 5.841885816444966628e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 7.451152134442019792e-02 7.451152134442019792e-02 7.451152134442019792e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 9.004942872321973490e-02 9.004942872321973490e-02 9.004942872321973490e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 6.964896446986418299e-02 6.964896446986418299e-02 6.964896446986418299e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 4.934061598000166055e-02 4.934061598000166055e-02 4.934061598000166055e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 6.242166505331672721e-02 6.242166505331672721e-02 6.242166505331672721e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 7.324102958095862759e-02 7.324102958095862759e-02 7.324102958095862759e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 8.557703723026943710e-02 8.557703723026943710e-02 8.557703723026943710e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.151512854331204899e-01 1.151512854331204899e-01 1.151512854331204899e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 6.494062202497587200e-02 6.494062202497587200e-02 6.494062202497587200e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 5.874518402091425534e-02 5.874518402091425534e-02 5.874518402091425534e-02 -2.343750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 1.019585202616306169e-01 1.019585202616306169e-01 1.019585202616306169e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.285756358022651369e-01 1.285756358022651369e-01 1.285756358022651369e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.195184014891578633e-01 1.195184014891578633e-01 1.195184014891578633e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 8.653743695810615921e-02 8.653743695810615921e-02 8.653743695810615921e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.181237779747581762e-01 1.181237779747581762e-01 1.181237779747581762e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 5.216760132361903529e-02 5.216760132361903529e-02 5.216760132361903529e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 1.157192810091674517e-01 1.157192810091674517e-01 1.157192810091674517e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 1.199048107550027553e-01 1.199048107550027553e-01 1.199048107550027553e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 1.500149257162576577e-01 1.500149257162576577e-01 1.500149257162576577e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 7.452285488304272176e-02 7.452285488304272176e-02 7.452285488304272176e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 8.518965936732339483e-02 8.518965936732339483e-02 8.518965936732339483e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 7.375562697937014522e-02 7.375562697937014522e-02 7.375562697937014522e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 1.024703627548588375e-01 1.024703627548588375e-01 1.024703627548588375e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 8.580528389451916316e-02 8.580528389451916316e-02 8.580528389451916316e-02 -1.093750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.289475430093335317e-01 1.289475430093335317e-01 1.289475430093335317e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.159908248607110226e-01 1.159908248607110226e-01 1.159908248607110226e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.126157428403548738e-01 1.126157428403548738e-01 1.126157428403548738e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 5.160912682518106059e-02 5.160912682518106059e-02 5.160912682518106059e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 9.616892907341699492e-02 9.616892907341699492e-02 9.616892907341699492e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.132496359800150565e-01 1.132496359800150565e-01 1.132496359800150565e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 1.505634023122571774e-01 1.505634023122571774e-01 1.505634023122571774e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 1.293403329876871843e-01 1.293403329876871843e-01 1.293403329876871843e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 1.785989862655870952e-01 1.785989862655870952e-01 1.785989862655870952e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.040926489208720968e-01 1.040926489208720968e-01 1.040926489208720968e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 8.216451165079018126e-02 8.216451165079018126e-02 8.216451165079018126e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 1.732387933194176055e-01 1.732387933194176055e-01 1.732387933194176055e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.676381862796020306e-01 1.676381862796020306e-01 1.676381862796020306e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 1.290415236081244588e-01 1.290415236081244588e-01 1.290415236081244588e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 1.921853189794185679e-01 1.921853189794185679e-01 1.921853189794185679e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 9.615205387530154080e-02 9.615205387530154080e-02 9.615205387530154080e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 1.546860920631249192e-01 1.546860920631249192e-01 1.546860920631249192e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 1.458903904205257618e-01 1.458903904205257618e-01 1.458903904205257618e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 1.077404636665379167e-01 1.077404636665379167e-01 1.077404636665379167e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 1.808868137056671710e-01 1.808868137056671710e-01 1.808868137056671710e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 1.523702167740463853e-01 1.523702167740463853e-01 1.523702167740463853e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 7.930490306955755020e-02 7.930490306955755020e-02 7.930490306955755020e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 7.495682371799802790e-02 7.495682371799802790e-02 7.495682371799802790e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 8.642331474546849357e-02 8.642331474546849357e-02 8.642331474546849357e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 1.108353521255531771e-01 1.108353521255531771e-01 1.108353521255531771e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.504549921541930291e-01 1.504549921541930291e-01 1.504549921541930291e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 9.221119639748355523e-02 9.221119639748355523e-02 9.221119639748355523e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.398493634393734308e-01 1.398493634393734308e-01 1.398493634393734308e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.086588191594611008e-01 1.086588191594611008e-01 1.086588191594611008e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 1.613868189595473734e-01 1.613868189595473734e-01 1.613868189595473734e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 1.457313795698270131e-01 1.457313795698270131e-01 1.457313795698270131e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 1.455579128288189972e-01 1.455579128288189972e-01 1.455579128288189972e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.354729094070379614e-01 1.354729094070379614e-01 1.354729094070379614e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 8.505785402601924450e-02 8.505785402601924450e-02 8.505785402601924450e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 4.494966695243429039e-02 4.494966695243429039e-02 4.494966695243429039e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 7.742989500644205381e-02 7.742989500644205381e-02 7.742989500644205381e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 9.858284951738818802e-02 9.858284951738818802e-02 9.858284951738818802e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 7.794735915911765733e-02 7.794735915911765733e-02 7.794735915911765733e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 1.106553826405150820e-01 1.106553826405150820e-01 1.106553826405150820e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 9.057500881065039255e-02 9.057500881065039255e-02 9.057500881065039255e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 4.439500408144468890e-01 4.439500408144468890e-01 4.439500408144468890e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 6.584797065395774085e-02 6.584797065395774085e-02 6.584797065395774085e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 -2.343750000000000000e-01 1.162543339942479492e-01 1.162543339942479492e-01 1.162543339942479492e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 1.190163076748177173e-01 1.190163076748177173e-01 1.190163076748177173e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 1.092726572309032640e-01 1.092726572309032640e-01 1.092726572309032640e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 1.214094595060022097e-01 1.214094595060022097e-01 1.214094595060022097e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 9.378145515780114683e-02 9.378145515780114683e-02 9.378145515780114683e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 1.028335519994673514e-01 1.028335519994673514e-01 1.028335519994673514e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 1.270277443582386590e-01 1.270277443582386590e-01 1.270277443582386590e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 1.361805151908865585e-01 1.361805151908865585e-01 1.361805151908865585e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 1.375507307175588001e-01 1.375507307175588001e-01 1.375507307175588001e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -2.343750000000000000e-01 1.110193383704523584e-01 1.110193383704523584e-01 1.110193383704523584e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -2.031250000000000000e-01 1.212327269948143410e-01 1.212327269948143410e-01 1.212327269948143410e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -2.343750000000000000e-01 1.343869914918945641e-01 1.343869914918945641e-01 1.343869914918945641e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 1.874874333056398001e-01 1.874874333056398001e-01 1.874874333056398001e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 -2.343750000000000000e-01 1.170898450525248158e-01 1.170898450525248158e-01 1.170898450525248158e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 -2.031250000000000000e-01 1.351709100380215911e-01 1.351709100380215911e-01 1.351709100380215911e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -2.343750000000000000e-01 9.561445642584259774e-02 9.561445642584259774e-02 9.561445642584259774e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 1.362311155930667761e-01 1.362311155930667761e-01 1.362311155930667761e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 1.301564303697095304e-01 1.301564303697095304e-01 1.301564303697095304e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 1.703012528940480719e-01 1.703012528940480719e-01 1.703012528940480719e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 1.218022862880789869e-01 1.218022862880789869e-01 1.218022862880789869e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 1.163804645850650965e-01 1.163804645850650965e-01 1.163804645850650965e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 1.653612225203774933e-01 1.653612225203774933e-01 1.653612225203774933e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 1.334472430041770685e-01 1.334472430041770685e-01 1.334472430041770685e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 9.890427154259910647e-02 9.890427154259910647e-02 9.890427154259910647e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 9.153293799756787030e-02 9.153293799756787030e-02 9.153293799756787030e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 1.448752854476400009e-01 1.448752854476400009e-01 1.448752854476400009e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 9.250692812774054252e-02 9.250692812774054252e-02 9.250692812774054252e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.435092102013575399e-01 1.435092102013575399e-01 1.435092102013575399e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 1.501329729714315775e-01 1.501329729714315775e-01 1.501329729714315775e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 1.877563270387629935e-01 1.877563270387629935e-01 1.877563270387629935e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 1.819913695614185367e-01 1.819913695614185367e-01 1.819913695614185367e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 1.938940837806771567e-01 1.938940837806771567e-01 1.938940837806771567e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.691371254837306659e-01 1.691371254837306659e-01 1.691371254837306659e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.578899843757921584e-01 1.578899843757921584e-01 1.578899843757921584e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 1.922904624363618031e-01 1.922904624363618031e-01 1.922904624363618031e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.398180407933230784e-01 1.398180407933230784e-01 1.398180407933230784e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 -2.343750000000000000e-01 1.309090640231744263e-01 1.309090640231744263e-01 1.309090640231744263e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -2.343750000000000000e-01 1.049379282052224915e-01 1.049379282052224915e-01 1.049379282052224915e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -2.031250000000000000e-01 1.312399956956545877e-01 1.312399956956545877e-01 1.312399956956545877e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.349026436903222048e-01 1.349026436903222048e-01 1.349026436903222048e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.193633552537082254e-01 1.193633552537082254e-01 1.193633552537082254e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.582818301177228992e-01 1.582818301177228992e-01 1.582818301177228992e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 1.868380713011021377e-01 1.868380713011021377e-01 1.868380713011021377e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 1.700451463090014992e-01 1.700451463090014992e-01 1.700451463090014992e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 1.471937856993192628e-01 1.471937856993192628e-01 1.471937856993192628e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 9.877248866757762369e-02 9.877248866757762369e-02 9.877248866757762369e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 2.045062335674764364e-01 2.045062335674764364e-01 2.045062335674764364e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.880637477281171810e-01 1.880637477281171810e-01 1.880637477281171810e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.758944494975017148e-01 1.758944494975017148e-01 1.758944494975017148e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 6.619243407455276118e-02 6.619243407455276118e-02 6.619243407455276118e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 1.724263441120600648e-01 1.724263441120600648e-01 1.724263441120600648e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 1.558520345589007872e-01 1.558520345589007872e-01 1.558520345589007872e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 1.921106750677847308e-01 1.921106750677847308e-01 1.921106750677847308e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 1.670657398893194701e-01 1.670657398893194701e-01 1.670657398893194701e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 8.415369571118191949e-02 8.415369571118191949e-02 8.415369571118191949e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 9.294088032925361398e-02 9.294088032925361398e-02 9.294088032925361398e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 7.836547547954601789e-02 7.836547547954601789e-02 7.836547547954601789e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 8.206163533961534362e-02 8.206163533961534362e-02 8.206163533961534362e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 6.571701789548943518e-02 6.571701789548943518e-02 6.571701789548943518e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 1.592638449757019792e-01 1.592638449757019792e-01 1.592638449757019792e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 1.686674555183428348e-01 1.686674555183428348e-01 1.686674555183428348e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 1.031067463684897101e-01 1.031067463684897101e-01 1.031067463684897101e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 8.063260547488788899e-02 8.063260547488788899e-02 8.063260547488788899e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 6.438239696368645848e-02 6.438239696368645848e-02 6.438239696368645848e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 1.019191476272832131e-01 1.019191476272832131e-01 1.019191476272832131e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 1.740070801309969439e-01 1.740070801309969439e-01 1.740070801309969439e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 1.234314124711256150e-01 1.234314124711256150e-01 1.234314124711256150e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 1.780796002382014631e-01 1.780796002382014631e-01 1.780796002382014631e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 1.805157298537483912e-02 1.805157298537483912e-02 1.805157298537483912e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 1.267731065354453235e-01 1.267731065354453235e-01 1.267731065354453235e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 -1.562500000000000000e-02 1.440553218422574722e-01 1.440553218422574722e-01 1.440553218422574722e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 2.003684401166783424e-01 2.003684401166783424e-01 2.003684401166783424e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 1.699881444189762225e-01 1.699881444189762225e-01 1.699881444189762225e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 1.961220852062280084e-01 1.961220852062280084e-01 1.961220852062280084e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 1.512748905390719767e-01 1.512748905390719767e-01 1.512748905390719767e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.417415498988763012e-01 1.417415498988763012e-01 1.417415498988763012e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 5.770421679868197734e-02 5.770421679868197734e-02 5.770421679868197734e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.414749117162500958e-01 1.414749117162500958e-01 1.414749117162500958e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.080586352602978112e-01 1.080586352602978112e-01 1.080586352602978112e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.106184245714330189e-01 1.106184245714330189e-01 1.106184245714330189e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 1.301797243663831427e-01 1.301797243663831427e-01 1.301797243663831427e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 1.680018843246564031e-01 1.680018843246564031e-01 1.680018843246564031e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 6.469856955422441380e-02 6.469856955422441380e-02 6.469856955422441380e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.522385214465171721e-01 1.522385214465171721e-01 1.522385214465171721e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.696421179944763158e-01 1.696421179944763158e-01 1.696421179944763158e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 7.994468491648662467e-02 7.994468491648662467e-02 7.994468491648662467e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 1.137822951748444222e-01 1.137822951748444222e-01 1.137822951748444222e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 8.236463784801797972e-02 8.236463784801797972e-02 8.236463784801797972e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 8.561802523528191933e-02 8.561802523528191933e-02 8.561802523528191933e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 9.574624447377552694e-02 9.574624447377552694e-02 9.574624447377552694e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 8.525234719777415038e-02 8.525234719777415038e-02 8.525234719777415038e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 1.071812499373588634e-01 1.071812499373588634e-01 1.071812499373588634e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 1.188660805965520706e-01 1.188660805965520706e-01 1.188660805965520706e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 1.186829156510357391e-01 1.186829156510357391e-01 1.186829156510357391e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 9.619223291260946274e-02 9.619223291260946274e-02 9.619223291260946274e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.545664454929621956e-01 1.545664454929621956e-01 1.545664454929621956e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.501795493918113567e-01 1.501795493918113567e-01 1.501795493918113567e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.962175925337505400e-01 1.962175925337505400e-01 1.962175925337505400e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 7.577990320566216353e-02 7.577990320566216353e-02 7.577990320566216353e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 5.832752849332530076e-02 5.832752849332530076e-02 5.832752849332530076e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 8.541228131318820416e-02 8.541228131318820416e-02 8.541228131318820416e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 7.173893615595122730e-02 7.173893615595122730e-02 7.173893615595122730e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 7.422327917990267920e-02 7.422327917990267920e-02 7.422327917990267920e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 9.595678346829193683e-02 9.595678346829193683e-02 9.595678346829193683e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 8.648278690464171470e-02 8.648278690464171470e-02 8.648278690464171470e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.016676444266524648e-01 1.016676444266524648e-01 1.016676444266524648e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 1.100905650798097157e-01 1.100905650798097157e-01 1.100905650798097157e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.165805056898417680e-01 1.165805056898417680e-01 1.165805056898417680e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 2.026876462593805994e-02 2.026876462593805994e-02 2.026876462593805994e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.077059146551136021e-01 1.077059146551136021e-01 1.077059146551136021e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 5.938022529702526031e-02 5.938022529702526031e-02 5.938022529702526031e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 1.078553591094323361e-01 1.078553591094323361e-01 1.078553591094323361e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 9.574142296364274163e-02 9.574142296364274163e-02 9.574142296364274163e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 1.213106500135085475e-01 1.213106500135085475e-01 1.213106500135085475e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 7.203482352930197508e-02 7.203482352930197508e-02 7.203482352930197508e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 8.354931044253802175e-02 8.354931044253802175e-02 8.354931044253802175e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 9.872990025328841346e-02 9.872990025328841346e-02 9.872990025328841346e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 7.970219533529988853e-02 7.970219533529988853e-02 7.970219533529988853e-02 -2.031250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 7.405150693601854350e-02 7.405150693601854350e-02 7.405150693601854350e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 7.495433196067886883e-02 7.495433196067886883e-02 7.495433196067886883e-02 -2.031250000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 7.325967796653384823e-02 7.325967796653384823e-02 7.325967796653384823e-02 -2.031250000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 9.822365888492481933e-02 9.822365888492481933e-02 9.822365888492481933e-02 -2.031250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 8.849034832640079173e-02 8.849034832640079173e-02 8.849034832640079173e-02 -2.343750000000000000e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 7.171136495977373237e-02 7.171136495977373237e-02 7.171136495977373237e-02 -2.343750000000000000e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 6.865805776755649903e-02 6.865805776755649903e-02 6.865805776755649903e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 8.684122628441946767e-02 8.684122628441946767e-02 8.684122628441946767e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.189930104457621735e-01 1.189930104457621735e-01 1.189930104457621735e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 6.809125718378633563e-02 6.809125718378633563e-02 6.809125718378633563e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 7.041454347644265921e-02 7.041454347644265921e-02 7.041454347644265921e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 7.251824054781680351e-02 7.251824054781680351e-02 7.251824054781680351e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 5.371363726913921943e-02 5.371363726913921943e-02 5.371363726913921943e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 7.160855566396244487e-02 7.160855566396244487e-02 7.160855566396244487e-02 -2.031250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 8.686855119406272641e-02 8.686855119406272641e-02 8.686855119406272641e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 6.358581016843929679e-02 6.358581016843929679e-02 6.358581016843929679e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 4.102455438034192242e-02 4.102455438034192242e-02 4.102455438034192242e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 9.091012459679842506e-02 9.091012459679842506e-02 9.091012459679842506e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.324817805623907940e-01 1.324817805623907940e-01 1.324817805623907940e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 6.192862068325744040e-02 6.192862068325744040e-02 6.192862068325744040e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 9.309678110422293928e-02 9.309678110422293928e-02 9.309678110422293928e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.160253703145568416e-01 1.160253703145568416e-01 1.160253703145568416e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.062652880181296916e-01 1.062652880181296916e-01 1.062652880181296916e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.053661889397661394e-01 1.053661889397661394e-01 1.053661889397661394e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.089336006552517333e-01 1.089336006552517333e-01 1.089336006552517333e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.027082036844029350e-01 1.027082036844029350e-01 1.027082036844029350e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.260373031241020514e-01 1.260373031241020514e-01 1.260373031241020514e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 4.949820935871140914e-02 4.949820935871140914e-02 4.949820935871140914e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 7.086493267828675169e-02 7.086493267828675169e-02 7.086493267828675169e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 4.329571204373789534e-02 4.329571204373789534e-02 4.329571204373789534e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 8.374219985134892519e-02 8.374219985134892519e-02 8.374219985134892519e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 7.496285216282423669e-02 7.496285216282423669e-02 7.496285216282423669e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 7.668150317211333555e-02 7.668150317211333555e-02 7.668150317211333555e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.142338074471684617e-01 1.142338074471684617e-01 1.142338074471684617e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.771363481059488043e-01 1.771363481059488043e-01 1.771363481059488043e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 5.470762243105540407e-02 5.470762243105540407e-02 5.470762243105540407e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.064902620872086453e-01 1.064902620872086453e-01 1.064902620872086453e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.048093691908755093e-01 1.048093691908755093e-01 1.048093691908755093e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.170536933113345140e-01 1.170536933113345140e-01 1.170536933113345140e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 9.393574709780831700e-02 9.393574709780831700e-02 9.393574709780831700e-02 -2.343750000000000000e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 8.668611706271141248e-02 8.668611706271141248e-02 8.668611706271141248e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.265441727890974088e-01 1.265441727890974088e-01 1.265441727890974088e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.193103341926925326e-01 1.193103341926925326e-01 1.193103341926925326e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 7.636039424174445589e-02 7.636039424174445589e-02 7.636039424174445589e-02 -2.031250000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.283932962195511451e-01 1.283932962195511451e-01 1.283932962195511451e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.278575206933463548e-01 1.278575206933463548e-01 1.278575206933463548e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.274542809875872651e-01 1.274542809875872651e-01 1.274542809875872651e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.439557370546967752e-01 1.439557370546967752e-01 1.439557370546967752e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.858299043304328380e-01 1.858299043304328380e-01 1.858299043304328380e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 5.396247641195203726e-02 5.396247641195203726e-02 5.396247641195203726e-02 -2.031250000000000000e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 1.140401877261189023e-01 1.140401877261189023e-01 1.140401877261189023e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.179293642515780310e-01 1.179293642515780310e-01 1.179293642515780310e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.252645416415965052e-01 1.252645416415965052e-01 1.252645416415965052e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.559042285592478205e-01 1.559042285592478205e-01 1.559042285592478205e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.528118763597627605e-01 1.528118763597627605e-01 1.528118763597627605e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.153344584190603012e-01 1.153344584190603012e-01 1.153344584190603012e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.160936577960001159e-01 1.160936577960001159e-01 1.160936577960001159e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 9.574865522874247137e-02 9.574865522874247137e-02 9.574865522874247137e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 1.435453500568508178e-01 1.435453500568508178e-01 1.435453500568508178e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.083020838876350839e-01 1.083020838876350839e-01 1.083020838876350839e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 8.973038225537162405e-02 8.973038225537162405e-02 8.973038225537162405e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 9.565061780196040808e-02 9.565061780196040808e-02 9.565061780196040808e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 1.194918910141160723e-01 1.194918910141160723e-01 1.194918910141160723e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.528680874058349626e-01 1.528680874058349626e-01 1.528680874058349626e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.143840431752291414e-01 1.143840431752291414e-01 1.143840431752291414e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.394582310615914145e-01 1.394582310615914145e-01 1.394582310615914145e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.205490898530619387e-01 1.205490898530619387e-01 1.205490898530619387e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.063046585256406940e-01 1.063046585256406940e-01 1.063046585256406940e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.711915982833374927e-01 1.711915982833374927e-01 1.711915982833374927e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 9.461398524154759904e-02 9.461398524154759904e-02 9.461398524154759904e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.493660642414962325e-01 1.493660642414962325e-01 1.493660642414962325e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 6.138669446829871784e-02 6.138669446829871784e-02 6.138669446829871784e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.129371088078251484e-01 1.129371088078251484e-01 1.129371088078251484e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 9.878052421492181101e-02 9.878052421492181101e-02 9.878052421492181101e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 4.538588596292632282e-02 4.538588596292632282e-02 4.538588596292632282e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 7.660884183924025759e-02 7.660884183924025759e-02 7.660884183924025759e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 6.206649333303793786e-02 6.206649333303793786e-02 6.206649333303793786e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 8.972073851372740216e-02 8.972073851372740216e-02 8.972073851372740216e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.519992208483775253e-01 1.519992208483775253e-01 1.519992208483775253e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 6.821424786384429340e-02 6.821424786384429340e-02 6.821424786384429340e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 8.027437955521066204e-02 8.027437955521066204e-02 8.027437955521066204e-02 -2.343750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 8.025862625849851384e-02 8.025862625849851384e-02 8.025862625849851384e-02 -2.343750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 8.651011193602312077e-02 8.651011193602312077e-02 8.651011193602312077e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 6.746070593392808346e-02 6.746070593392808346e-02 6.746070593392808346e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 6.717653824657965345e-02 6.717653824657965345e-02 6.717653824657965345e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 5.075484469963011114e-02 5.075484469963011114e-02 5.075484469963011114e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.143486936173950946e-01 1.143486936173950946e-01 1.143486936173950946e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.004310086264093571e-01 1.004310086264093571e-01 1.004310086264093571e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 6.118531018709646302e-02 6.118531018709646302e-02 6.118531018709646302e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.397610174833260055e-01 1.397610174833260055e-01 1.397610174833260055e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 7.031076791654547464e-02 7.031076791654547464e-02 7.031076791654547464e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.163033401708621906e-01 1.163033401708621906e-01 1.163033401708621906e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.082362001734109014e-01 1.082362001734109014e-01 1.082362001734109014e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.086483742302794125e-01 1.086483742302794125e-01 1.086483742302794125e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.100423585609672794e-01 1.100423585609672794e-01 1.100423585609672794e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 9.192671430507842745e-02 9.192671430507842745e-02 9.192671430507842745e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 8.825889464041450361e-02 8.825889464041450361e-02 8.825889464041450361e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 6.143034776096704258e-02 6.143034776096704258e-02 6.143034776096704258e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 6.317766591177947921e-02 6.317766591177947921e-02 6.317766591177947921e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 7.534891282882626162e-02 7.534891282882626162e-02 7.534891282882626162e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 6.559313912301190097e-02 6.559313912301190097e-02 6.559313912301190097e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.658124454231844902e-01 1.658124454231844902e-01 1.658124454231844902e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.473817041642215553e-01 1.473817041642215553e-01 1.473817041642215553e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 2.427980099082470145e-01 2.427980099082470145e-01 2.427980099082470145e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.588920778825709534e-01 1.588920778825709534e-01 1.588920778825709534e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 2.539137894198119083e-01 2.539137894198119083e-01 2.539137894198119083e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 5.735617957244765891e-02 5.735617957244765891e-02 5.735617957244765891e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 6.040396656129841391e-02 6.040396656129841391e-02 6.040396656129841391e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 8.579563968235877358e-02 8.579563968235877358e-02 8.579563968235877358e-02 -1.718750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.278671598647612151e-01 1.278671598647612151e-01 1.278671598647612151e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.262148283622095690e-01 1.262148283622095690e-01 1.262148283622095690e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.421198212262108629e-01 1.421198212262108629e-01 1.421198212262108629e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.140835714385653454e-01 1.140835714385653454e-01 1.140835714385653454e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 4.185907798437780297e-02 4.185907798437780297e-02 4.185907798437780297e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.063850064403447510e-01 1.063850064403447510e-01 1.063850064403447510e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.125627173323457270e-01 1.125627173323457270e-01 1.125627173323457270e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.229486225989538661e-01 1.229486225989538661e-01 1.229486225989538661e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.264815171239304370e-01 1.264815171239304370e-01 1.264815171239304370e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.878967935569279546e-01 1.878967935569279546e-01 1.878967935569279546e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.938282701202644620e-01 1.938282701202644620e-01 1.938282701202644620e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.384591081006844859e-01 1.384591081006844859e-01 1.384591081006844859e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.055148342527804928e-01 1.055148342527804928e-01 1.055148342527804928e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.573977656062585107e-01 1.573977656062585107e-01 1.573977656062585107e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.036434902506110506e-01 1.036434902506110506e-01 1.036434902506110506e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.687991239561628665e-01 1.687991239561628665e-01 1.687991239561628665e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.175308949870982334e-01 1.175308949870982334e-01 1.175308949870982334e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 9.038374306001470404e-02 9.038374306001470404e-02 9.038374306001470404e-02 -2.343750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.154485396293756794e-01 1.154485396293756794e-01 1.154485396293756794e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 7.292191645120213450e-02 7.292191645120213450e-02 7.292191645120213450e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 7.621499055234384756e-02 7.621499055234384756e-02 7.621499055234384756e-02 -2.031250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.412082726499389318e-01 1.412082726499389318e-01 1.412082726499389318e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.003876175513969543e-01 1.003876175513969543e-01 1.003876175513969543e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 3.339362548165750177e-02 3.339362548165750177e-02 3.339362548165750177e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 7.591276866564342085e-02 7.591276866564342085e-02 7.591276866564342085e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 8.022446731370026785e-02 8.022446731370026785e-02 8.022446731370026785e-02 -2.031250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.235013002824426609e-01 1.235013002824426609e-01 1.235013002824426609e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.162382663888702761e-01 1.162382663888702761e-01 1.162382663888702761e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.500823813118541961e-01 1.500823813118541961e-01 1.500823813118541961e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 6.043805352866656044e-02 6.043805352866656044e-02 6.043805352866656044e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.054409133746793681e-01 1.054409133746793681e-01 1.054409133746793681e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.151392345641640835e-01 1.151392345641640835e-01 1.151392345641640835e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.101106511208084643e-01 1.101106511208084643e-01 1.101106511208084643e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 -3.281250000000000000e-01 7.878399150425648145e-02 7.878399150425648145e-02 7.878399150425648145e-02 -2.656250000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 9.459871691021043416e-02 9.459871691021043416e-02 9.459871691021043416e-02 -2.656250000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.107734876604786339e-01 1.107734876604786339e-01 1.107734876604786339e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 5.796132441328403356e-02 5.796132441328403356e-02 5.796132441328403356e-02 -2.968750000000000000e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 8.658726491567049488e-02 8.658726491567049488e-02 8.658726491567049488e-02 -2.656250000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 7.128421116837380112e-02 7.128421116837380112e-02 7.128421116837380112e-02 -2.656250000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 8.216451165079018126e-02 8.216451165079018126e-02 8.216451165079018126e-02 -2.968750000000000000e-01 -1.718750000000000000e-01 -3.281250000000000000e-01 6.683786693091919862e-02 6.683786693091919862e-02 6.683786693091919862e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 -3.281250000000000000e-01 6.508315208308261546e-02 6.508315208308261546e-02 6.508315208308261546e-02 -2.968750000000000000e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 7.708081782132233939e-02 7.708081782132233939e-02 7.708081782132233939e-02 -2.968750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 7.403993219044528729e-02 7.403993219044528729e-02 7.403993219044528729e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 8.517037079427139390e-02 8.517037079427139390e-02 8.517037079427139390e-02 -3.281250000000000000e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 1.512524056800958749e-01 1.512524056800958749e-01 1.512524056800958749e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 1.870724522582542237e-01 1.870724522582542237e-01 1.870724522582542237e-01 -3.593750000000000000e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 7.784391482067709589e-02 7.784391482067709589e-02 7.784391482067709589e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 1.136336651358303695e-01 1.136336651358303695e-01 1.136336651358303695e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 6.856087156619747325e-02 6.856087156619747325e-02 6.856087156619747325e-02 -2.968750000000000000e-01 -1.093750000000000000e-01 -3.281250000000000000e-01 9.642125304208226666e-02 9.642125304208226666e-02 9.642125304208226666e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 9.937434894216370940e-02 9.937434894216370940e-02 9.937434894216370940e-02 -2.656250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 8.928435799448244947e-02 8.928435799448244947e-02 8.928435799448244947e-02 -2.968750000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 1.595946600374432700e-01 1.595946600374432700e-01 1.595946600374432700e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 1.087921927512336823e-01 1.087921927512336823e-01 1.087921927512336823e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 1.345227320328408749e-01 1.345227320328408749e-01 1.345227320328408749e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 6.245052570142269749e-02 6.245052570142269749e-02 6.245052570142269749e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 4.228880038760182009e-02 4.228880038760182009e-02 4.228880038760182009e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 3.986900875443005060e-02 3.986900875443005060e-02 3.986900875443005060e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 6.994807490054262555e-02 6.994807490054262555e-02 6.994807490054262555e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 7.314939520976775078e-02 7.314939520976775078e-02 7.314939520976775078e-02 -3.281250000000000000e-01 -1.093750000000000000e-01 -2.968750000000000000e-01 1.609259360247842219e-01 1.609259360247842219e-01 1.609259360247842219e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 2.315386998413632436e-01 2.315386998413632436e-01 2.315386998413632436e-01 -3.281250000000000000e-01 -7.812500000000000000e-02 -2.968750000000000000e-01 1.553533794023885806e-01 1.553533794023885806e-01 1.553533794023885806e-01 -3.281250000000000000e-01 -7.812500000000000000e-02 -2.656250000000000000e-01 2.306754959088050116e-01 2.306754959088050116e-01 2.306754959088050116e-01 -3.593750000000000000e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 2.075372168108410020e-01 2.075372168108410020e-01 2.075372168108410020e-01 -3.593750000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 1.102424154253968391e-01 1.102424154253968391e-01 1.102424154253968391e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 1.494399447724376884e-01 1.494399447724376884e-01 1.494399447724376884e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.807391103196583915e-01 1.807391103196583915e-01 1.807391103196583915e-01 -3.593750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 1.155529800321826450e-01 1.155529800321826450e-01 1.155529800321826450e-01 -3.593750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 5.197302815491573746e-02 5.197302815491573746e-02 5.197302815491573746e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 1.516659654738851670e-01 1.516659654738851670e-01 1.516659654738851670e-01 -3.593750000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.625847810669865945e-01 1.625847810669865945e-01 1.625847810669865945e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 8.586957861260986757e-02 8.586957861260986757e-02 8.586957861260986757e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 1.204036856695122615e-01 1.204036856695122615e-01 1.204036856695122615e-01 -4.218750000000000000e-01 -1.562500000000000000e-02 -3.281250000000000000e-01 9.701750590001859131e-02 9.701750590001859131e-02 9.701750590001859131e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 9.435603041277235148e-02 9.435603041277235148e-02 9.435603041277235148e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 1.018187071462523519e-01 1.018187071462523519e-01 1.018187071462523519e-01 -3.906250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 1.362801096029577497e-01 1.362801096029577497e-01 1.362801096029577497e-01 -4.218750000000000000e-01 -4.687500000000000000e-02 -2.968750000000000000e-01 7.698918782340759270e-02 7.698918782340759270e-02 7.698918782340759270e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 9.989183268121627768e-02 9.989183268121627768e-02 9.989183268121627768e-02 -4.218750000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 1.275522796677258930e-01 1.275522796677258930e-01 1.275522796677258930e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 -2.656250000000000000e-01 9.374529294156724868e-02 9.374529294156724868e-02 9.374529294156724868e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 9.207538445060862997e-02 9.207538445060862997e-02 9.207538445060862997e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.181767998177278983e-01 1.181767998177278983e-01 1.181767998177278983e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.058804202056100735e-01 1.058804202056100735e-01 1.058804202056100735e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 9.767723605550451826e-02 9.767723605550451826e-02 9.767723605550451826e-02 -2.656250000000000000e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.138168415770203085e-01 1.138168415770203085e-01 1.138168415770203085e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.019986963992790541e-01 1.019986963992790541e-01 1.019986963992790541e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 1.450479505677497727e-01 1.450479505677497727e-01 1.450479505677497727e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.156517965961844918e-01 1.156517965961844918e-01 1.156517965961844918e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.347669037903535261e-01 1.347669037903535261e-01 1.347669037903535261e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 1.812351999659800872e-01 1.812351999659800872e-01 1.812351999659800872e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.546933190314547513e-01 1.546933190314547513e-01 1.546933190314547513e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.141494503645692632e-01 1.141494503645692632e-01 1.141494503645692632e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 8.561320311812267714e-02 8.561320311812267714e-02 8.561320311812267714e-02 -2.656250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 8.673514125319335688e-02 8.673514125319335688e-02 8.673514125319335688e-02 -2.968750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.825492608321807597e-01 1.825492608321807597e-01 1.825492608321807597e-01 -2.968750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 1.933033641211225895e-01 1.933033641211225895e-01 1.933033641211225895e-01 -2.968750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.120493321976359369e-01 1.120493321976359369e-01 1.120493321976359369e-01 -3.281250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 8.549023903307020888e-02 8.549023903307020888e-02 8.549023903307020888e-02 -3.281250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 1.116283378741061288e-01 1.116283378741061288e-01 1.116283378741061288e-01 -3.593750000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.039174853727899278e-01 1.039174853727899278e-01 1.039174853727899278e-01 -3.593750000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 1.432144689961349637e-01 1.432144689961349637e-01 1.432144689961349637e-01 -3.281250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 9.602508798554382219e-02 9.602508798554382219e-02 9.602508798554382219e-02 -3.593750000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.283667886687167581e-01 1.283667886687167581e-01 1.283667886687167581e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.071555388678553100e-01 1.071555388678553100e-01 1.071555388678553100e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 9.746429085967717176e-02 9.746429085967717176e-02 9.746429085967717176e-02 -3.281250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 1.641841772012644918e-01 1.641841772012644918e-01 1.641841772012644918e-01 -3.593750000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.450423289185110154e-01 1.450423289185110154e-01 1.450423289185110154e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.175911475226955466e-01 1.175911475226955466e-01 1.175911475226955466e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 2.308784619785546888e-01 2.308784619785546888e-01 2.308784619785546888e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 2.453567242770256229e-01 2.453567242770256229e-01 2.453567242770256229e-01 -3.593750000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.304857586618229370e-01 1.304857586618229370e-01 1.304857586618229370e-01 -3.593750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 9.734777343850033182e-02 9.734777343850033182e-02 9.734777343850033182e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.433509977540431135e-01 1.433509977540431135e-01 1.433509977540431135e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.016451456994787034e-01 1.016451456994787034e-01 1.016451456994787034e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.256147754161252295e-01 1.256147754161252295e-01 1.256147754161252295e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.121361017462196297e-01 1.121361017462196297e-01 1.121361017462196297e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.089697560453716241e-01 1.089697560453716241e-01 1.089697560453716241e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.080980048902387552e-01 1.080980048902387552e-01 1.080980048902387552e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 8.025340195023057677e-02 8.025340195023057677e-02 8.025340195023057677e-02 -2.656250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 8.135998324035974283e-02 8.135998324035974283e-02 8.135998324035974283e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 9.740563038596350420e-02 9.740563038596350420e-02 9.740563038596350420e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 9.062001245059606025e-02 9.062001245059606025e-02 9.062001245059606025e-02 -2.656250000000000000e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.151408413468042180e-01 1.151408413468042180e-01 1.151408413468042180e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 9.054607788595712969e-02 9.054607788595712969e-02 9.054607788595712969e-02 -2.656250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.407328176642559103e-01 1.407328176642559103e-01 1.407328176642559103e-01 -2.968750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 8.359512171901016531e-02 8.359512171901016531e-02 8.359512171901016531e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 5.037477669161166682e-02 5.037477669161166682e-02 5.037477669161166682e-02 -3.281250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.038861487345150575e-01 1.038861487345150575e-01 1.038861487345150575e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 8.752836457659947389e-02 8.752836457659947389e-02 8.752836457659947389e-02 -3.593750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 9.787973436040350861e-02 9.787973436040350861e-02 9.787973436040350861e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.314624902538968076e-01 1.314624902538968076e-01 1.314624902538968076e-01 -3.593750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.181302048666729443e-01 1.181302048666729443e-01 1.181302048666729443e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.229863783173423125e-01 1.229863783173423125e-01 1.229863783173423125e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 6.272152587805178425e-02 6.272152587805178425e-02 6.272152587805178425e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.770994205634965346e-01 1.770994205634965346e-01 1.770994205634965346e-01 -3.593750000000000000e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 6.935314870671849263e-02 6.935314870671849263e-02 6.935314870671849263e-02 -2.968750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 7.673607950619491802e-02 7.673607950619491802e-02 7.673607950619491802e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.081847787004168587e-01 1.081847787004168587e-01 1.081847787004168587e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.441292072501759725e-01 1.441292072501759725e-01 1.441292072501759725e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.317564712897646984e-01 1.317564712897646984e-01 1.317564712897646984e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.717535785784624347e-01 1.717535785784624347e-01 1.717535785784624347e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 3.653938451634607815e-02 3.653938451634607815e-02 3.653938451634607815e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 5.661829386680887477e-02 5.661829386680887477e-02 5.661829386680887477e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 8.665879209112523074e-02 8.665879209112523074e-02 8.665879209112523074e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 7.493592510576871368e-02 7.493592510576871368e-02 7.493592510576871368e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 7.007299196165536759e-02 7.007299196165536759e-02 7.007299196165536759e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 5.298826074607145692e-02 5.298826074607145692e-02 5.298826074607145692e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 5.551515095907478409e-02 5.551515095907478409e-02 5.551515095907478409e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.423334513810763646e-01 1.423334513810763646e-01 1.423334513810763646e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 5.987947564834088243e-02 5.987947564834088243e-02 5.987947564834088243e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 8.562043629375316878e-02 8.562043629375316878e-02 8.562043629375316878e-02 -3.281250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 2.301588526935172130e-01 2.301588526935172130e-01 2.301588526935172130e-01 -3.281250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 1.172127608510835639e-01 1.172127608510835639e-01 1.172127608510835639e-01 -3.593750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.617666037839567139e-01 1.617666037839567139e-01 1.617666037839567139e-01 -3.593750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 9.345679823436207900e-02 9.345679823436207900e-02 9.345679823436207900e-02 -3.281250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.936661435563971079e-01 1.936661435563971079e-01 1.936661435563971079e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.790814423072509542e-01 1.790814423072509542e-01 1.790814423072509542e-01 -3.281250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 9.700304159727089759e-02 9.700304159727089759e-02 9.700304159727089759e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 8.978342281377889311e-02 8.978342281377889311e-02 8.978342281377889311e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.612174006266393067e-01 1.612174006266393067e-01 1.612174006266393067e-01 -3.281250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 6.493724567536669767e-02 6.493724567536669767e-02 6.493724567536669767e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.205619432489033749e-01 1.205619432489033749e-01 1.205619432489033749e-01 -3.593750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 4.436002374550111066e-02 4.436002374550111066e-02 4.436002374550111066e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 4.904376067519312932e-02 4.904376067519312932e-02 4.904376067519312932e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 8.610264653504215437e-02 8.610264653504215437e-02 8.610264653504215437e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 7.438862067048697402e-02 7.438862067048697402e-02 7.438862067048697402e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 7.892649704002592526e-02 7.892649704002592526e-02 7.892649704002592526e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 6.168438855224801787e-02 6.168438855224801787e-02 6.168438855224801787e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 5.473825463482403370e-02 5.473825463482403370e-02 5.473825463482403370e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 9.077189954958496398e-02 9.077189954958496398e-02 9.077189954958496398e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 5.851131327171796292e-02 5.851131327171796292e-02 5.851131327171796292e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 8.619667719535324679e-02 8.619667719535324679e-02 8.619667719535324679e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 8.172648269473886673e-02 8.172648269473886673e-02 8.172648269473886673e-02 -2.656250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 6.196343053490294822e-02 6.196343053490294822e-02 6.196343053490294822e-02 -2.968750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 9.082654668966591571e-02 9.082654668966591571e-02 9.082654668966591571e-02 -2.968750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 6.681326838912957089e-02 6.681326838912957089e-02 6.681326838912957089e-02 -2.968750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 7.250554023762842415e-02 7.250554023762842415e-02 7.250554023762842415e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 7.377451638699819569e-02 7.377451638699819569e-02 7.377451638699819569e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.062861784938944620e-01 1.062861784938944620e-01 1.062861784938944620e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 7.062016498828799227e-02 7.062016498828799227e-02 7.062016498828799227e-02 -2.656250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.816181020187846162e-01 1.816181020187846162e-01 1.816181020187846162e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 8.665155900886462037e-02 8.665155900886462037e-02 8.665155900886462037e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 7.490755121202044564e-02 7.490755121202044564e-02 7.490755121202044564e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 7.468964258961359459e-02 7.468964258961359459e-02 7.468964258961359459e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 9.738714831004775807e-02 9.738714831004775807e-02 9.738714831004775807e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 1.020244091168459322e-01 1.020244091168459322e-01 1.020244091168459322e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.200590526048270629e-01 1.200590526048270629e-01 1.200590526048270629e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.230883989996821581e-01 1.230883989996821581e-01 1.230883989996821581e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.095835917444848567e-01 1.095835917444848567e-01 1.095835917444848567e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 8.483924956927714478e-02 8.483924956927714478e-02 8.483924956927714478e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 2.466809673749230658e-01 2.466809673749230658e-01 2.466809673749230658e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.020758345273088813e-01 1.020758345273088813e-01 1.020758345273088813e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.942287694890511285e-01 1.942287694890511285e-01 1.942287694890511285e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 2.426576392105591062e-01 2.426576392105591062e-01 2.426576392105591062e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.199618481401645287e-01 1.199618481401645287e-01 1.199618481401645287e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.070229660352325501e-01 1.070229660352325501e-01 1.070229660352325501e-01 -3.281250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 8.640402646817826882e-02 8.640402646817826882e-02 8.640402646817826882e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.309243254652087685e-01 1.309243254652087685e-01 1.309243254652087685e-01 -3.593750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.312126858518902761e-01 1.312126858518902761e-01 1.312126858518902761e-01 -3.593750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.801627434262912941e-01 1.801627434262912941e-01 1.801627434262912941e-01 -3.593750000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 8.299314339144255037e-02 8.299314339144255037e-02 8.299314339144255037e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 5.660502826320577829e-02 5.660502826320577829e-02 5.660502826320577829e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 8.929641273674586432e-02 8.929641273674586432e-02 8.929641273674586432e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.157208877802232833e-01 1.157208877802232833e-01 1.157208877802232833e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 8.242411300746103897e-02 8.242411300746103897e-02 8.242411300746103897e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 9.503587219769556171e-02 9.503587219769556171e-02 9.503587219769556171e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 6.335291818031395239e-02 6.335291818031395239e-02 6.335291818031395239e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 6.096270158670458184e-02 6.096270158670458184e-02 6.096270158670458184e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.171179630622316420e-01 1.171179630622316420e-01 1.171179630622316420e-01 -3.281250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.257657931787496131e-01 1.257657931787496131e-01 1.257657931787496131e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.153392787551699439e-01 1.153392787551699439e-01 1.153392787551699439e-01 -3.593750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 8.559230727378927539e-02 8.559230727378927539e-02 8.559230727378927539e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.046559015985233793e-01 1.046559015985233793e-01 1.046559015985233793e-01 -3.593750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 9.626294796952492017e-02 9.626294796952492017e-02 9.626294796952492017e-02 -3.906250000000000000e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.082249517290006791e-01 1.082249517290006791e-01 1.082249517290006791e-01 -3.906250000000000000e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 1.470861740730505518e-01 1.470861740730505518e-01 1.470861740730505518e-01 -3.906250000000000000e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.291877154324855004e-01 1.291877154324855004e-01 1.291877154324855004e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.393546248359730511e-01 1.393546248359730511e-01 1.393546248359730511e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 1.651580910992714313e-01 1.651580910992714313e-01 1.651580910992714313e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 1.117504585917338533e-01 1.117504585917338533e-01 1.117504585917338533e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.178787523374850432e-01 1.178787523374850432e-01 1.178787523374850432e-01 -4.218750000000000000e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 9.769170023704397410e-02 9.769170023704397410e-02 9.769170023704397410e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 1.067730857386376131e-01 1.067730857386376131e-01 1.067730857386376131e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.452977120160263980e-01 1.452977120160263980e-01 1.452977120160263980e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.149865900677889408e-01 1.149865900677889408e-01 1.149865900677889408e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 1.052818225588562917e-01 1.052818225588562917e-01 1.052818225588562917e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.104681818114921499e-01 1.104681818114921499e-01 1.104681818114921499e-01 -4.218750000000000000e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 9.682866618730226471e-02 9.682866618730226471e-02 9.682866618730226471e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 1.355668823836948533e-01 1.355668823836948533e-01 1.355668823836948533e-01 -4.218750000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.203016615827377789e-01 1.203016615827377789e-01 1.203016615827377789e-01 -4.531250000000000000e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.021513655393508913e-01 1.021513655393508913e-01 1.021513655393508913e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.177196861144765433e-01 1.177196861144765433e-01 1.177196861144765433e-01 -3.906250000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 6.855894231039240394e-02 6.855894231039240394e-02 6.855894231039240394e-02 -3.906250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.095281538959794465e-01 1.095281538959794465e-01 1.095281538959794465e-01 -4.218750000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.093843366906117609e-01 1.093843366906117609e-01 1.093843366906117609e-01 -4.218750000000000000e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 5.419861158471936391e-02 5.419861158471936391e-02 5.419861158471936391e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 9.093101906001549439e-02 9.093101906001549439e-02 9.093101906001549439e-02 -4.531250000000000000e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 8.221594975703848396e-02 8.221594975703848396e-02 8.221594975703848396e-02 -4.531250000000000000e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.131652778654946290e-01 1.131652778654946290e-01 1.131652778654946290e-01 -4.531250000000000000e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.019842329920375434e-01 1.019842329920375434e-01 1.019842329920375434e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.074263081563294336e-01 1.074263081563294336e-01 1.074263081563294336e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 8.849436661367332535e-02 8.849436661367332535e-02 8.849436661367332535e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 6.804680364336210263e-02 6.804680364336210263e-02 6.804680364336210263e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 9.628544820187905084e-02 9.628544820187905084e-02 9.628544820187905084e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 1.695867215145339668e-01 1.695867215145339668e-01 1.695867215145339668e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 -2.343750000000000000e-01 7.260400777996608990e-02 7.260400777996608990e-02 7.260400777996608990e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 9.735259485236767707e-02 9.735259485236767707e-02 9.735259485236767707e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.761095955549283332e-01 1.761095955549283332e-01 1.761095955549283332e-01 -4.218750000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.579662659710557859e-01 1.579662659710557859e-01 1.579662659710557859e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.824545399969804971e-01 1.824545399969804971e-01 1.824545399969804971e-01 -3.906250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 7.230201347423262370e-02 7.230201347423262370e-02 7.230201347423262370e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 7.591550152822799935e-02 7.591550152822799935e-02 7.591550152822799935e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 6.504609268447128501e-02 6.504609268447128501e-02 6.504609268447128501e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 7.363176058365779320e-02 7.363176058365779320e-02 7.363176058365779320e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 9.744179095701969995e-02 9.744179095701969995e-02 9.744179095701969995e-02 -4.218750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 9.382083177476920055e-02 9.382083177476920055e-02 9.382083177476920055e-02 -4.531250000000000000e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 1.216359978843854911e-01 1.216359978843854911e-01 1.216359978843854911e-01 -4.531250000000000000e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.088508449234078107e-01 1.088508449234078107e-01 1.088508449234078107e-01 -4.531250000000000000e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.447042261492941517e-01 1.447042261492941517e-01 1.447042261492941517e-01 -4.531250000000000000e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 9.716214878447164416e-02 9.716214878447164416e-02 9.716214878447164416e-02 -4.531250000000000000e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 1.309580612741295669e-01 1.309580612741295669e-01 1.309580612741295669e-01 -4.531250000000000000e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.677923366451302134e-01 1.677923366451302134e-01 1.677923366451302134e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 -2.343750000000000000e-01 9.883596946969239183e-02 9.883596946969239183e-02 9.883596946969239183e-02 -4.531250000000000000e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 8.975770618377953980e-02 8.975770618377953980e-02 8.975770618377953980e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.239141994461692153e-01 1.239141994461692153e-01 1.239141994461692153e-01 -4.531250000000000000e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 7.593527458995240342e-02 7.593527458995240342e-02 7.593527458995240342e-02 -4.531250000000000000e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.091674052240975551e-01 1.091674052240975551e-01 1.091674052240975551e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.018669185927903453e-01 1.018669185927903453e-01 1.018669185927903453e-01 -4.531250000000000000e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 9.637544906835249225e-02 9.637544906835249225e-02 9.637544906835249225e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.060186192979524489e-01 1.060186192979524489e-01 1.060186192979524489e-01 -4.843750000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 9.279622985547528180e-02 9.279622985547528180e-02 9.279622985547528180e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 8.347376196471625875e-02 8.347376196471625875e-02 8.347376196471625875e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 8.158583068927871551e-02 8.158583068927871551e-02 8.158583068927871551e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.880982622491425837e-01 1.880982622491425837e-01 1.880982622491425837e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.299556197738970242e-01 1.299556197738970242e-01 1.299556197738970242e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 1.153392787551699439e-01 1.153392787551699439e-01 1.153392787551699439e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 6.249602742640998632e-02 6.249602742640998632e-02 6.249602742640998632e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.267345493185234317e-01 1.267345493185234317e-01 1.267345493185234317e-01 -3.906250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 9.561204566687230011e-02 9.561204566687230011e-02 9.561204566687230011e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 9.942979378769978283e-02 9.942979378769978283e-02 9.942979378769978283e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.488456864061905027e-01 1.488456864061905027e-01 1.488456864061905027e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.028624785059844698e-01 1.028624785059844698e-01 1.028624785059844698e-01 -3.906250000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 8.411994027068125934e-02 8.411994027068125934e-02 8.411994027068125934e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 8.156011143882350989e-02 8.156011143882350989e-02 8.156011143882350989e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 7.444086754630827030e-02 7.444086754630827030e-02 7.444086754630827030e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.020951190477692033e-01 1.020951190477692033e-01 1.020951190477692033e-01 -4.218750000000000000e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 1.380462835763855145e-01 1.380462835763855145e-01 1.380462835763855145e-01 -4.218750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.282069399194702697e-01 1.282069399194702697e-01 1.282069399194702697e-01 -4.218750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.600410976244695804e-01 1.600410976244695804e-01 1.600410976244695804e-01 -3.906250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.304648744686991435e-01 1.304648744686991435e-01 1.304648744686991435e-01 -3.906250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 9.376136503967193170e-02 9.376136503967193170e-02 9.376136503967193170e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.178442076794183474e-01 1.178442076794183474e-01 1.178442076794183474e-01 -3.906250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 9.846151236900672898e-02 9.846151236900672898e-02 9.846151236900672898e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.431325516301735490e-01 1.431325516301735490e-01 1.431325516301735490e-01 -4.218750000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.027789130143526714e-01 1.027789130143526714e-01 1.027789130143526714e-01 -4.218750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.832877584349583699e-01 1.832877584349583699e-01 1.832877584349583699e-01 -4.218750000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.271795627397550033e-01 1.271795627397550033e-01 1.271795627397550033e-01 -4.531250000000000000e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 8.421316954809249244e-02 8.421316954809249244e-02 8.421316954809249244e-02 -4.531250000000000000e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 8.100151943967018320e-02 8.100151943967018320e-02 8.100151943967018320e-02 -4.531250000000000000e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.716058584240593987e-01 1.716058584240593987e-01 1.716058584240593987e-01 -4.843750000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.362383442193619565e-01 1.362383442193619565e-01 1.362383442193619565e-01 -4.531250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.143229848383009450e-01 1.143229848383009450e-01 1.143229848383009450e-01 -4.531250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.115712945806575929e-01 1.115712945806575929e-01 1.115712945806575929e-01 -4.843750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.100134346357901638e-01 1.100134346357901638e-01 1.100134346357901638e-01 -4.843750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.123474012740657002e-01 1.123474012740657002e-01 1.123474012740657002e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.318681195437938214e-01 1.318681195437938214e-01 1.318681195437938214e-01 -4.531250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 8.849275929879553415e-02 8.849275929879553415e-02 8.849275929879553415e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.353813458882925647e-01 1.353813458882925647e-01 1.353813458882925647e-01 -4.843750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 9.421379328426393585e-02 9.421379328426393585e-02 9.421379328426393585e-02 -4.843750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 9.432227925248516665e-02 9.432227925248516665e-02 9.432227925248516665e-02 -4.843750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 7.331256862277754638e-02 7.331256862277754638e-02 7.331256862277754638e-02 -4.531250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.388438200988184323e-01 1.388438200988184323e-01 1.388438200988184323e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 9.307186914498785657e-02 9.307186914498785657e-02 9.307186914498785657e-02 -5.156250000000000000e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 9.716777378026383860e-02 9.716777378026383860e-02 9.716777378026383860e-02 -5.156250000000000000e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 9.194037589748725592e-02 9.194037589748725592e-02 9.194037589748725592e-02 -5.156250000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 9.332018478090704783e-02 9.332018478090704783e-02 9.332018478090704783e-02 -5.156250000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 9.036686664841762917e-02 9.036686664841762917e-02 9.036686664841762917e-02 -5.468750000000000000e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 5.689453951493998740e-02 5.689453951493998740e-02 5.689453951493998740e-02 -5.468750000000000000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 9.322857327629706370e-02 9.322857327629706370e-02 9.322857327629706370e-02 -5.156250000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 7.637936341567599929e-02 7.637936341567599929e-02 7.637936341567599929e-02 -5.156250000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 9.959773518811997073e-02 9.959773518811997073e-02 9.959773518811997073e-02 -5.156250000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 6.854688446055805240e-02 6.854688446055805240e-02 6.854688446055805240e-02 -5.468750000000000000e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 5.992505922171116606e-02 5.992505922171116606e-02 5.992505922171116606e-02 -5.468750000000000000e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 4.218313906636216720e-02 4.218313906636216720e-02 4.218313906636216720e-02 -5.468750000000000000e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 5.531334998582974893e-02 5.531334998582974893e-02 5.531334998582974893e-02 -5.468750000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 6.703200221741083265e-02 6.703200221741083265e-02 6.703200221741083265e-02 -5.468750000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 7.070585386037769871e-02 7.070585386037769871e-02 7.070585386037769871e-02 -5.781250000000000000e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 5.914249743060123049e-02 5.914249743060123049e-02 5.914249743060123049e-02 -5.781250000000000000e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 8.570401960930092156e-02 8.570401960930092156e-02 8.570401960930092156e-02 -5.781250000000000000e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 7.382161931608897942e-02 7.382161931608897942e-02 7.382161931608897942e-02 -5.781250000000000000e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.242178476735339154e-01 1.242178476735339154e-01 1.242178476735339154e-01 -1.562500000000000000e-02 -2.968750000000000000e-01 1.562500000000000000e-02 1.962224080262416903e-01 1.962224080262416903e-01 1.962224080262416903e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 1.562500000000000000e-02 2.649109564585936938e-01 2.649109564585936938e-01 2.649109564585936938e-01 -1.562500000000000000e-02 -2.656250000000000000e-01 4.687500000000000000e-02 1.816245238406071771e-01 1.816245238406071771e-01 1.816245238406071771e-01 -1.093750000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 7.095327393755346268e-02 7.095327393755346268e-02 7.095327393755346268e-02 -1.406250000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 5.651417891919825742e-02 5.651417891919825742e-02 5.651417891919825742e-02 -1.718750000000000000e-01 -3.281250000000000000e-01 1.562500000000000000e-02 6.886722072415150941e-02 6.886722072415150941e-02 6.886722072415150941e-02 -1.718750000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 -1.718750000000000000e-01 -3.281250000000000000e-01 7.812500000000000000e-02 9.185197731735489368e-02 9.185197731735489368e-02 9.185197731735489368e-02 -1.718750000000000000e-01 -3.281250000000000000e-01 1.093750000000000000e-01 7.415447387027773729e-02 7.415447387027773729e-02 7.415447387027773729e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 8.189124615986528855e-02 8.189124615986528855e-02 8.189124615986528855e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 7.783860997921211722e-02 7.783860997921211722e-02 7.783860997921211722e-02 -1.718750000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 7.319706117201858764e-02 7.319706117201858764e-02 7.319706117201858764e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 7.054058518482285434e-02 7.054058518482285434e-02 7.054058518482285434e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 7.879170754651088071e-02 7.879170754651088071e-02 7.879170754651088071e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 7.812500000000000000e-02 7.612014444418493953e-02 7.612014444418493953e-02 7.612014444418493953e-02 -1.406250000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 6.112083495341769090e-02 6.112083495341769090e-02 6.112083495341769090e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 9.857722462053086776e-02 9.857722462053086776e-02 9.857722462053086776e-02 -1.718750000000000000e-01 -2.968750000000000000e-01 7.812500000000000000e-02 1.088211171154602891e-01 1.088211171154602891e-01 1.088211171154602891e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 9.331214868818035746e-02 9.331214868818035746e-02 9.331214868818035746e-02 -1.718750000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 6.133114300633930871e-02 6.133114300633930871e-02 6.133114300633930871e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 1.562500000000000000e-02 5.867620468190840738e-02 5.867620468190840738e-02 5.867620468190840738e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 8.443981268576292165e-02 8.443981268576292165e-02 8.443981268576292165e-02 -2.343750000000000000e-01 -3.281250000000000000e-01 1.562500000000000000e-02 6.234320262623178205e-02 6.234320262623178205e-02 6.234320262623178205e-02 -2.343750000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 9.713322022838448422e-02 9.713322022838448422e-02 9.713322022838448422e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 7.812500000000000000e-02 7.988464530371483519e-02 7.988464530371483519e-02 7.988464530371483519e-02 -2.031250000000000000e-01 -3.281250000000000000e-01 1.093750000000000000e-01 1.055959864428938355e-01 1.055959864428938355e-01 1.055959864428938355e-01 -2.343750000000000000e-01 -3.281250000000000000e-01 7.812500000000000000e-02 1.104031033096745801e-01 1.104031033096745801e-01 1.104031033096745801e-01 -2.343750000000000000e-01 -3.281250000000000000e-01 1.093750000000000000e-01 1.153360651977837076e-01 1.153360651977837076e-01 1.153360651977837076e-01 -2.031250000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 6.139151803770320770e-02 6.139151803770320770e-02 6.139151803770320770e-02 -2.031250000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 7.163524268691212615e-02 7.163524268691212615e-02 7.163524268691212615e-02 -2.343750000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 6.178881837905059876e-02 6.178881837905059876e-02 6.178881837905059876e-02 -2.343750000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 7.030096107903052727e-02 7.030096107903052727e-02 7.030096107903052727e-02 -2.343750000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 8.002851525136120414e-02 8.002851525136120414e-02 8.002851525136120414e-02 -2.031250000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 1.185350980225116924e-01 1.185350980225116924e-01 1.185350980225116924e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 1.239382985536963550e-01 1.239382985536963550e-01 1.239382985536963550e-01 -2.343750000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 1.153328516402869625e-01 1.153328516402869625e-01 1.153328516402869625e-01 -2.343750000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 1.294592138300912909e-01 1.294592138300912909e-01 1.294592138300912909e-01 -1.406250000000000000e-01 -2.968750000000000000e-01 1.406250000000000000e-01 9.425397328955580079e-02 9.425397328955580079e-02 9.425397328955580079e-02 -1.406250000000000000e-01 -2.656250000000000000e-01 1.406250000000000000e-01 1.161539114079427476e-01 1.161539114079427476e-01 1.161539114079427476e-01 -1.406250000000000000e-01 -2.656250000000000000e-01 1.718750000000000000e-01 1.009766092205924837e-01 1.009766092205924837e-01 1.009766092205924837e-01 -1.718750000000000000e-01 -2.968750000000000000e-01 1.406250000000000000e-01 1.103878379744684113e-01 1.103878379744684113e-01 1.103878379744684113e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 1.406250000000000000e-01 1.462084111791120966e-01 1.462084111791120966e-01 1.462084111791120966e-01 -1.718750000000000000e-01 -2.656250000000000000e-01 1.718750000000000000e-01 1.253737890376318276e-01 1.253737890376318276e-01 1.253737890376318276e-01 -2.031250000000000000e-01 -3.281250000000000000e-01 1.406250000000000000e-01 7.675794218043695272e-02 7.675794218043695272e-02 7.675794218043695272e-02 -2.343750000000000000e-01 -3.281250000000000000e-01 1.406250000000000000e-01 7.606034311172815698e-02 7.606034311172815698e-02 7.606034311172815698e-02 -2.031250000000000000e-01 -2.968750000000000000e-01 1.406250000000000000e-01 1.167050290179591360e-01 1.167050290179591360e-01 1.167050290179591360e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.406250000000000000e-01 1.600435064536546992e-01 1.600435064536546992e-01 1.600435064536546992e-01 -2.031250000000000000e-01 -2.656250000000000000e-01 1.718750000000000000e-01 1.149183016467055229e-01 1.149183016467055229e-01 1.149183016467055229e-01 -2.343750000000000000e-01 -2.968750000000000000e-01 1.406250000000000000e-01 8.965725051900791387e-02 8.965725051900791387e-02 8.965725051900791387e-02 -2.343750000000000000e-01 -2.656250000000000000e-01 1.406250000000000000e-01 1.204277858285953545e-01 1.204277858285953545e-01 1.204277858285953545e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 1.562500000000000000e-02 2.324412033431178803e-01 2.324412033431178803e-01 2.324412033431178803e-01 -1.562500000000000000e-02 -2.343750000000000000e-01 4.687500000000000000e-02 1.858315097019015150e-01 1.858315097019015150e-01 1.858315097019015150e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.562500000000000000e-02 1.585090676552733668e-01 1.585090676552733668e-01 1.585090676552733668e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 1.446118700388894507e-01 1.446118700388894507e-01 1.446118700388894507e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 1.163635936257879366e-01 1.163635936257879366e-01 1.163635936257879366e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 1.026559751621450023e-01 1.026559751621450023e-01 1.026559751621450023e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 4.687500000000000000e-02 1.526841968377539160e-01 1.526841968377539160e-01 1.526841968377539160e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 1.174481480980224118e-01 1.174481480980224118e-01 1.174481480980224118e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 4.687500000000000000e-02 1.720201164317411435e-01 1.720201164317411435e-01 1.720201164317411435e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 1.097804359703999783e-01 1.097804359703999783e-01 1.097804359703999783e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 2.071295614268916785e-01 2.071295614268916785e-01 2.071295614268916785e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 1.177759216837998557e-01 1.177759216837998557e-01 1.177759216837998557e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 1.003514583043523534e-01 1.003514583043523534e-01 1.003514583043523534e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 1.901803434083136346e-01 1.901803434083136346e-01 1.901803434083136346e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 1.291459463669223928e-01 1.291459463669223928e-01 1.291459463669223928e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 1.093750000000000000e-01 1.107927700962621359e-01 1.107927700962621359e-01 1.107927700962621359e-01 -1.093750000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 5.508726797557893240e-02 5.508726797557893240e-02 5.508726797557893240e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.148259113376893237e-01 1.148259113376893237e-01 1.148259113376893237e-01 -1.093750000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 9.594231897484302440e-02 9.594231897484302440e-02 9.594231897484302440e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 1.562500000000000000e-02 7.607561496162194847e-02 7.607561496162194847e-02 7.607561496162194847e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 4.687500000000000000e-02 8.554328238692437969e-02 8.554328238692437969e-02 8.554328238692437969e-02 -7.812500000000000000e-02 -1.406250000000000000e-01 1.562500000000000000e-02 1.052850365178433362e-01 1.052850365178433362e-01 1.052850365178433362e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.150267597001823627e-01 1.150267597001823627e-01 1.150267597001823627e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 1.265674678316555668e-01 1.265674678316555668e-01 1.265674678316555668e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.010987461074271815e-01 1.010987461074271815e-01 1.010987461074271815e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 7.812500000000000000e-02 9.339893844710814297e-02 9.339893844710814297e-02 9.339893844710814297e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 1.093750000000000000e-01 1.801507022911744416e-01 1.801507022911744416e-01 1.801507022911744416e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 7.812500000000000000e-02 1.192926604979283600e-01 1.192926604979283600e-01 1.192926604979283600e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 1.093750000000000000e-01 1.907140987908594876e-01 1.907140987908594876e-01 1.907140987908594876e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 9.650402156007087395e-02 9.650402156007087395e-02 9.650402156007087395e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.039520360110792463e-01 1.039520360110792463e-01 1.039520360110792463e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 8.962671197206757701e-02 8.962671197206757701e-02 8.962671197206757701e-02 -1.093750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.517342227112047914e-01 1.517342227112047914e-01 1.517342227112047914e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 1.668120316311124118e-01 1.668120316311124118e-01 1.668120316311124118e-01 -1.562500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 1.325323832909028055e-01 1.325323832909028055e-01 1.325323832909028055e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 1.258364822468286404e-01 1.258364822468286404e-01 1.258364822468286404e-01 -4.687500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 1.130552104783136835e-01 1.130552104783136835e-01 1.130552104783136835e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.406250000000000000e-01 1.349219203439445958e-01 1.349219203439445958e-01 1.349219203439445958e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 1.562808273427618300e-01 1.562808273427618300e-01 1.562808273427618300e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.406250000000000000e-01 1.303178817252638455e-01 1.303178817252638455e-01 1.303178817252638455e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 1.366608161385039211e-01 1.366608161385039211e-01 1.366608161385039211e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 1.718750000000000000e-01 1.268421881695645514e-01 1.268421881695645514e-01 1.268421881695645514e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 2.031250000000000000e-01 1.097145534667657713e-01 1.097145534667657713e-01 1.097145534667657713e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 2.343750000000000000e-01 1.167516247944101054e-01 1.167516247944101054e-01 1.167516247944101054e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 2.031250000000000000e-01 1.205683699460540353e-01 1.205683699460540353e-01 1.205683699460540353e-01 -1.562500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 1.002703008240176941e-01 1.002703008240176941e-01 1.002703008240176941e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 2.031250000000000000e-01 1.171999069201462990e-01 1.171999069201462990e-01 1.171999069201462990e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 2.343750000000000000e-01 5.240141011211932320e-02 5.240141011211932320e-02 5.240141011211932320e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 2.031250000000000000e-01 1.171059124878335717e-01 1.171059124878335717e-01 1.171059124878335717e-01 -4.687500000000000000e-02 -1.406250000000000000e-01 2.343750000000000000e-01 4.950407890206114103e-02 4.950407890206114103e-02 4.950407890206114103e-02 -7.812500000000000000e-02 -2.343750000000000000e-01 1.718750000000000000e-01 6.591959665819366321e-02 6.591959665819366321e-02 6.591959665819366321e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 1.406250000000000000e-01 9.064572880498447671e-02 9.064572880498447671e-02 9.064572880498447671e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 1.718750000000000000e-01 8.576027756126079760e-02 8.576027756126079760e-02 8.576027756126079760e-02 -1.093750000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 7.072281478014204315e-02 7.072281478014204315e-02 7.072281478014204315e-02 -1.093750000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 8.439159079505481609e-02 8.439159079505481609e-02 8.439159079505481609e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 5.300739623378734888e-02 5.300739623378734888e-02 5.300739623378734888e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 2.031250000000000000e-01 3.900310258753589970e-02 3.900310258753589970e-02 3.900310258753589970e-02 -7.812500000000000000e-02 -2.031250000000000000e-01 2.343750000000000000e-01 3.862177282611326673e-02 3.862177282611326673e-02 3.862177282611326673e-02 -1.093750000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 7.187550587751692643e-02 7.187550587751692643e-02 7.187550587751692643e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 6.298705853864015880e-02 6.298705853864015880e-02 6.298705853864015880e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 4.972430707513905007e-02 4.972430707513905007e-02 4.972430707513905007e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 1.406250000000000000e-01 1.808563097677190756e-01 1.808563097677190756e-01 1.808563097677190756e-01 -7.812500000000000000e-02 -1.718750000000000000e-01 1.718750000000000000e-01 9.610303542263240462e-02 9.610303542263240462e-02 9.610303542263240462e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 2.031250000000000000e-01 1.134520950939721107e-01 1.134520950939721107e-01 1.134520950939721107e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.562500000000000000e-02 7.175002893773756163e-02 7.175002893773756163e-02 7.175002893773756163e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 7.812500000000000000e-02 1.881921737778975978e-01 1.881921737778975978e-01 1.881921737778975978e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.093750000000000000e-01 1.616935374982381712e-01 1.616935374982381712e-01 1.616935374982381712e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 1.112724191989186429e-01 1.112724191989186429e-01 1.112724191989186429e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 -4.687500000000000000e-02 4.687500000000000000e-02 1.257368749057218016e-01 1.257368749057218016e-01 1.257368749057218016e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.562500000000000000e-02 8.080651292532583518e-01 8.080651292532583518e-01 8.080651292532583518e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 4.687500000000000000e-02 3.765962107896211886e-01 3.765962107896211886e-01 3.765962107896211886e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.562500000000000000e-02 2.380214927610704162e-02 2.380214927610704162e-02 2.380214927610704162e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 4.687500000000000000e-02 1.437686136930043102e-01 1.437686136930043102e-01 1.437686136930043102e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 1.562500000000000000e-02 1.990033068018454421e-01 1.990033068018454421e-01 1.990033068018454421e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 4.687500000000000000e-02 1.357227005817311649e-01 1.357227005817311649e-01 1.357227005817311649e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 7.812500000000000000e-02 2.224360852228243479e-01 2.224360852228243479e-01 2.224360852228243479e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.093750000000000000e-01 1.934703070732783359e-01 1.934703070732783359e-01 1.934703070732783359e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.562500000000000000e-02 1.837846350724676170e-01 1.837846350724676170e-01 1.837846350724676170e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 4.687500000000000000e-02 2.905146652352935122e-01 2.905146652352935122e-01 2.905146652352935122e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.554304663918436857e-01 1.554304663918436857e-01 1.554304663918436857e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 9.922569228368623151e-02 9.922569228368623151e-02 9.922569228368623151e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 7.812500000000000000e-02 2.490406487798463298e-01 2.490406487798463298e-01 2.490406487798463298e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 5.893081693671558402e-02 5.893081693671558402e-02 5.893081693671558402e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 8.885279703159626452e-02 8.885279703159626452e-02 8.885279703159626452e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 6.291036527163232361e-02 6.291036527163232361e-02 6.291036527163232361e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 1.562500000000000000e-02 1.721060185035248047e-01 1.721060185035248047e-01 1.721060185035248047e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 4.687500000000000000e-02 2.322743412363207083e-01 2.322743412363207083e-01 2.322743412363207083e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 1.562500000000000000e-02 1.015109567316618000e-01 1.015109567316618000e-01 1.015109567316618000e-01 -7.812500000000000000e-02 -1.562500000000000000e-02 4.687500000000000000e-02 1.659778396612154594e-01 1.659778396612154594e-01 1.659778396612154594e-01 -1.093750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.717519729260601202e-01 1.717519729260601202e-01 1.717519729260601202e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.457370011709193391e-01 1.457370011709193391e-01 1.457370011709193391e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.925376694121739285e-01 1.925376694121739285e-01 1.925376694121739285e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 7.812500000000000000e-02 1.534446498682421334e-01 1.534446498682421334e-01 1.534446498682421334e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 1.093750000000000000e-01 5.182661555532443176e-02 5.182661555532443176e-02 5.182661555532443176e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 8.471387321576052953e-02 8.471387321576052953e-02 8.471387321576052953e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 4.918607768335212654e-02 4.918607768335212654e-02 4.918607768335212654e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.467336245280571605e-01 1.467336245280571605e-01 1.467336245280571605e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.370543716338775142e-01 1.370543716338775142e-01 1.370543716338775142e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.406250000000000000e-01 1.217163304894682690e-01 1.217163304894682690e-01 1.217163304894682690e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 9.683348763229632228e-02 9.683348763229632228e-02 9.683348763229632228e-02 -1.562500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 1.335131060764083166e-01 1.335131060764083166e-01 1.335131060764083166e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 1.422210145281627702e-01 1.422210145281627702e-01 1.422210145281627702e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 1.406250000000000000e-01 2.113689159726069577e-01 2.113689159726069577e-01 2.113689159726069577e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 1.930320810850380542e-01 1.930320810850380542e-01 1.930320810850380542e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 1.406250000000000000e-01 4.378436763080691824e-02 4.378436763080691824e-02 4.378436763080691824e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 7.918723409557076875e-02 7.918723409557076875e-02 7.918723409557076875e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 1.558062644076678160e-01 1.558062644076678160e-01 1.558062644076678160e-01 -1.562500000000000000e-02 -1.093750000000000000e-01 2.343750000000000000e-01 1.287780563527993472e-01 1.287780563527993472e-01 1.287780563527993472e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 1.894483302682501702e-01 1.894483302682501702e-01 1.894483302682501702e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 2.343750000000000000e-01 1.611427279780167088e-01 1.611427279780167088e-01 1.611427279780167088e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 1.926893642257949402e-01 1.926893642257949402e-01 1.926893642257949402e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 2.343750000000000000e-01 1.171870529871732319e-01 1.171870529871732319e-01 1.171870529871732319e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 1.062114548440448447e-01 1.062114548440448447e-01 1.062114548440448447e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 2.343750000000000000e-01 1.206358502351772832e-01 1.206358502351772832e-01 1.206358502351772832e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 1.397401356977232834e-01 1.397401356977232834e-01 1.397401356977232834e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 6.774808807643878383e-02 6.774808807643878383e-02 6.774808807643878383e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 2.932020871292090672e-02 2.932020871292090672e-02 2.932020871292090672e-02 -1.562500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 1.667349555461286048e-01 1.667349555461286048e-01 1.667349555461286048e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 1.906129664639596988e-01 1.906129664639596988e-01 1.906129664639596988e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 2.031250000000000000e-01 1.103942654843800553e-01 1.103942654843800553e-01 1.103942654843800553e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 1.048760592052133261e-01 1.048760592052133261e-01 1.048760592052133261e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 6.282161322359219868e-02 6.282161322359219868e-02 6.282161322359219868e-02 -4.687500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 1.456831944014970459e-01 1.456831944014970459e-01 1.456831944014970459e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 2.031250000000000000e-01 3.745983976676659638e-02 3.745983976676659638e-02 3.745983976676659638e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 1.061994026359571602e-01 1.061994026359571602e-01 1.061994026359571602e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 1.718750000000000000e-01 2.815502051523234850e-01 2.815502051523234850e-01 2.815502051523234850e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 1.718750000000000000e-01 1.479109251746920928e-01 1.479109251746920928e-01 1.479109251746920928e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 8.673674860320310098e-02 8.673674860320310098e-02 8.673674860320310098e-02 -1.093750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 1.488288222533651894e-01 1.488288222533651894e-01 1.488288222533651894e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 8.253904460992603220e-02 8.253904460992603220e-02 8.253904460992603220e-02 -1.093750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 4.604700453342679828e-02 4.604700453342679828e-02 4.604700453342679828e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 2.031250000000000000e-01 6.889977678493505731e-02 6.889977678493505731e-02 6.889977678493505731e-02 -7.812500000000000000e-02 -7.812500000000000000e-02 2.031250000000000000e-01 9.320928663044678042e-02 9.320928663044678042e-02 9.320928663044678042e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 1.406250000000000000e-01 9.039017216825827317e-02 9.039017216825827317e-02 9.039017216825827317e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 1.718750000000000000e-01 5.234352079172945732e-02 5.234352079172945732e-02 5.234352079172945732e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 1.406250000000000000e-01 7.047507245926454278e-02 7.047507245926454278e-02 7.047507245926454278e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 1.718750000000000000e-01 6.568003917741353781e-02 6.568003917741353781e-02 6.568003917741353781e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 6.038692307219857558e-02 6.038692307219857558e-02 6.038692307219857558e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 7.183724387177278792e-02 7.183724387177278792e-02 7.183724387177278792e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 1.661616998471522055e-01 1.661616998471522055e-01 1.661616998471522055e-01 -1.093750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 7.479485933121596264e-02 7.479485933121596264e-02 7.479485933121596264e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 2.031250000000000000e-01 7.060320404688355533e-02 7.060320404688355533e-02 7.060320404688355533e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 2.343750000000000000e-01 7.985595165768548387e-02 7.985595165768548387e-02 7.985595165768548387e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 2.343750000000000000e-01 6.251009597573359278e-02 6.251009597573359278e-02 6.251009597573359278e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 8.141302931735580617e-02 8.141302931735580617e-02 8.141302931735580617e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 9.413905842106674859e-02 9.413905842106674859e-02 9.413905842106674859e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 8.862214804449172756e-02 8.862214804449172756e-02 8.862214804449172756e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 6.420312743715805848e-02 6.420312743715805848e-02 6.420312743715805848e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 7.812500000000000000e-02 6.818506773911303664e-02 6.818506773911303664e-02 6.818506773911303664e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 8.252136283561793684e-02 8.252136283561793684e-02 8.252136283561793684e-02 -1.718750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 9.831928249852953106e-02 9.831928249852953106e-02 9.831928249852953106e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.104304202180785704e-01 1.104304202180785704e-01 1.104304202180785704e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 5.339307986263782529e-02 5.339307986263782529e-02 5.339307986263782529e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 7.410930025882134231e-02 7.410930025882134231e-02 7.410930025882134231e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 9.161972967583502381e-02 9.161972967583502381e-02 9.161972967583502381e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 8.204797206963539147e-02 8.204797206963539147e-02 8.204797206963539147e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 9.735741626596390585e-02 9.735741626596390585e-02 9.735741626596390585e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.094654849777476485e-01 1.094654849777476485e-01 1.094654849777476485e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 8.511089766494502051e-02 8.511089766494502051e-02 8.511089766494502051e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 9.859731353611593530e-02 9.859731353611593530e-02 9.859731353611593530e-02 -1.718750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.028528363383069549e-01 1.028528363383069549e-01 1.028528363383069549e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.119248016634290938e-01 1.119248016634290938e-01 1.119248016634290938e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 9.005907242546518088e-02 9.005907242546518088e-02 9.005907242546518088e-02 -1.718750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.378824382363485757e-01 1.378824382363485757e-01 1.378824382363485757e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.562500000000000000e-02 7.982211403955710716e-02 7.982211403955710716e-02 7.982211403955710716e-02 -2.031250000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.124422046841697942e-01 1.124422046841697942e-01 1.124422046841697942e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 1.129499634198352087e-01 1.129499634198352087e-01 1.129499634198352087e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 1.562500000000000000e-02 9.108612009811686838e-02 9.108612009811686838e-02 9.108612009811686838e-02 -2.343750000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.202912181649914702e-01 1.202912181649914702e-01 1.202912181649914702e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 1.034353818950031201e-01 1.034353818950031201e-01 1.034353818950031201e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.095442228414977015e-01 1.095442228414977015e-01 1.095442228414977015e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 9.853945744562074560e-02 9.853945744562074560e-02 9.853945744562074560e-02 -2.343750000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 1.305323464577246295e-01 1.305323464577246295e-01 1.305323464577246295e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.011574038884921617e-01 1.011574038884921617e-01 1.011574038884921617e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.191777813873263481e-01 1.191777813873263481e-01 1.191777813873263481e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.035430519222593077e-01 1.035430519222593077e-01 1.035430519222593077e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 1.063898273126820948e-01 1.063898273126820948e-01 1.063898273126820948e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.034699327403477143e-01 1.034699327403477143e-01 1.034699327403477143e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 1.090284080880999373e-01 1.090284080880999373e-01 1.090284080880999373e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 7.510890114813768836e-02 7.510890114813768836e-02 7.510890114813768836e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 8.115262096741286679e-02 8.115262096741286679e-02 8.115262096741286679e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 5.178142940542523193e-02 5.178142940542523193e-02 5.178142940542523193e-02 -2.031250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.147174530134538878e-01 1.147174530134538878e-01 1.147174530134538878e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.230691195105641789e-01 1.230691195105641789e-01 1.230691195105641789e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 9.121550467316603961e-02 9.121550467316603961e-02 9.121550467316603961e-02 -2.031250000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.203225484141813573e-01 1.203225484141813573e-01 1.203225484141813573e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 9.689295209671575093e-02 9.689295209671575093e-02 9.689295209671575093e-02 -2.343750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.069827924064768315e-01 1.069827924064768315e-01 1.069827924064768315e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 7.916617583207585795e-02 7.916617583207585795e-02 7.916617583207585795e-02 -2.343750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.188371598434002918e-01 1.188371598434002918e-01 1.188371598434002918e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 8.353404001125652734e-02 8.353404001125652734e-02 8.353404001125652734e-02 -1.406250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 1.303692890540614213e-01 1.303692890540614213e-01 1.303692890540614213e-01 -1.718750000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 1.617979178860993184e-01 1.617979178860993184e-01 1.617979178860993184e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.269008271845331326e-01 1.269008271845331326e-01 1.269008271845331326e-01 -1.406250000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 9.721920229514387224e-02 9.721920229514387224e-02 9.721920229514387224e-02 -1.406250000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 1.316167099476577007e-01 1.316167099476577007e-01 1.316167099476577007e-01 -1.406250000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 4.547867768331501775e-02 4.547867768331501775e-02 4.547867768331501775e-02 -1.718750000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 1.051130895316475244e-01 1.051130895316475244e-01 1.051130895316475244e-01 -1.718750000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 1.615353608062357893e-01 1.615353608062357893e-01 1.615353608062357893e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.604947591814822327e-01 1.604947591814822327e-01 1.604947591814822327e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.012875757978327490e-01 1.012875757978327490e-01 1.012875757978327490e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.227743034141094841e-01 1.227743034141094841e-01 1.227743034141094841e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 1.583187662982575572e-01 1.583187662982575572e-01 1.583187662982575572e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 1.411199281860846255e-01 1.411199281860846255e-01 1.411199281860846255e-01 -1.406250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 9.127095514163670320e-02 9.127095514163670320e-02 9.127095514163670320e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 1.998949397094559599e-01 1.998949397094559599e-01 1.998949397094559599e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 1.420636026701275756e-01 1.420636026701275756e-01 1.420636026701275756e-01 -1.718750000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 1.465368706934629117e-01 1.465368706934629117e-01 1.465368706934629117e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 1.593593960677125998e-01 1.593593960677125998e-01 1.593593960677125998e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 1.831537055693177041e-01 1.831537055693177041e-01 1.831537055693177041e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 1.373515449159183333e-01 1.373515449159183333e-01 1.373515449159183333e-01 -2.031250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 1.471239184658175991e-01 1.471239184658175991e-01 1.471239184658175991e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 1.167492146687006960e-01 1.167492146687006960e-01 1.167492146687006960e-01 -2.031250000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.525243963957962079e-01 1.525243963957962079e-01 1.525243963957962079e-01 -2.343750000000000000e-01 -2.343750000000000000e-01 1.406250000000000000e-01 1.260421228190036214e-01 1.260421228190036214e-01 1.260421228190036214e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 1.233358186998366468e-01 1.233358186998366468e-01 1.233358186998366468e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 6.552239710377555371e-02 6.552239710377555371e-02 6.552239710377555371e-02 -2.031250000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 1.070379827954178430e-02 1.070379827954178430e-02 1.070379827954178430e-02 -2.031250000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 1.320110933407025455e-01 1.320110933407025455e-01 1.320110933407025455e-01 -2.343750000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 8.791974949512378068e-02 8.791974949512378068e-02 8.791974949512378068e-02 -2.343750000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 1.122445635503650507e-01 1.122445635503650507e-01 1.122445635503650507e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 1.080465833289185051e-01 1.080465833289185051e-01 1.080465833289185051e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.699857358875190017e-01 1.699857358875190017e-01 1.699857358875190017e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.199618481401645287e-01 1.199618481401645287e-01 1.199618481401645287e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 1.791239882087240498e-01 1.791239882087240498e-01 1.791239882087240498e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 1.258509413667404930e-01 1.258509413667404930e-01 1.258509413667404930e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.601559184019235860e-01 1.601559184019235860e-01 1.601559184019235860e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.378936825350569051e-01 1.378936825350569051e-01 1.378936825350569051e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 1.508324194808747243e-01 1.508324194808747243e-01 1.508324194808747243e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 1.596195514069575772e-01 1.596195514069575772e-01 1.596195514069575772e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 1.751623063649762890e-01 1.751623063649762890e-01 1.751623063649762890e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 1.436738471892945734e-01 1.436738471892945734e-01 1.436738471892945734e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 1.684354295150688741e-01 1.684354295150688741e-01 1.684354295150688741e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 7.158998727830931386e-02 7.158998727830931386e-02 7.158998727830931386e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.769565268699247185e-01 1.769565268699247185e-01 1.769565268699247185e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 7.236334485563460095e-02 7.236334485563460095e-02 7.236334485563460095e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 6.533943222917042160e-02 6.533943222917042160e-02 6.533943222917042160e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 9.220235657359725223e-02 9.220235657359725223e-02 9.220235657359725223e-02 -1.718750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 8.406368117167828391e-02 8.406368117167828391e-02 8.406368117167828391e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 6.826191675006583470e-02 6.826191675006583470e-02 6.826191675006583470e-02 -1.406250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 8.101196795869113065e-02 8.101196795869113065e-02 8.101196795869113065e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 8.072744626353371700e-02 8.072744626353371700e-02 8.072744626353371700e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 7.937450772317773684e-02 7.937450772317773684e-02 7.937450772317773684e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.044968092304020546e-01 1.044968092304020546e-01 1.044968092304020546e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.914637582660776161e-01 1.914637582660776161e-01 1.914637582660776161e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.441099328024740833e-01 1.441099328024740833e-01 1.441099328024740833e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.565048586186782165e-01 1.565048586186782165e-01 1.565048586186782165e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.591602642519887867e-01 1.591602642519887867e-01 1.591602642519887867e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 2.015248929560355673e-01 2.015248929560355673e-01 2.015248929560355673e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.111888624420024757e-01 1.111888624420024757e-01 1.111888624420024757e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 9.581937067554058274e-02 9.581937067554058274e-02 9.581937067554058274e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 7.903918313379579286e-02 7.903918313379579286e-02 7.903918313379579286e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 2.304629024408808013e-01 2.304629024408808013e-01 2.304629024408808013e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.455011007188387939e-01 2.455011007188387939e-01 2.455011007188387939e-01 -2.031250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 9.951657694746958438e-02 9.951657694746958438e-02 9.951657694746958438e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 1.032513783059530316e-01 1.032513783059530316e-01 1.032513783059530316e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 8.627383047557490858e-02 8.627383047557490858e-02 8.627383047557490858e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 1.204767894631474379e-01 1.204767894631474379e-01 1.204767894631474379e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 9.792875173061058036e-02 9.792875173061058036e-02 9.792875173061058036e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 8.221193115617796143e-02 8.221193115617796143e-02 8.221193115617796143e-02 -2.343750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 9.384654710606915584e-02 9.384654710606915584e-02 9.384654710606915584e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 8.601584890489624713e-02 8.601584890489624713e-02 8.601584890489624713e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.023715299996366263e-01 1.023715299996366263e-01 1.023715299996366263e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 9.941372282190291676e-02 9.941372282190291676e-02 9.941372282190291676e-02 -2.031250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 2.275587391927091085e-01 2.275587391927091085e-01 2.275587391927091085e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 6.512784842829785759e-02 6.512784842829785759e-02 6.512784842829785759e-02 -2.343750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.059985322353186599e-01 1.059985322353186599e-01 1.059985322353186599e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 1.415897589936090661e-01 1.415897589936090661e-01 1.415897589936090661e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 2.730153226507008313e-01 2.730153226507008313e-01 2.730153226507008313e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 9.803964337593194800e-02 9.803964337593194800e-02 9.803964337593194800e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.090613496275891769e-01 1.090613496275891769e-01 1.090613496275891769e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.142683536554690849e-01 1.142683536554690849e-01 1.142683536554690849e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 2.523097599148679260e-01 2.523097599148679260e-01 2.523097599148679260e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.073917590099987135e-01 1.073917590099987135e-01 1.073917590099987135e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 1.407657462251034886e-01 1.407657462251034886e-01 1.407657462251034886e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 2.346328408141280242e-01 2.346328408141280242e-01 2.346328408141280242e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 8.198126312996743825e-02 8.198126312996743825e-02 8.198126312996743825e-02 -1.406250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.157988161375110986e-01 1.157988161375110986e-01 1.157988161375110986e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 9.076948864548829710e-02 9.076948864548829710e-02 9.076948864548829710e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 1.476692025046779100e-01 1.476692025046779100e-01 1.476692025046779100e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.252637383513752478e-01 1.252637383513752478e-01 1.252637383513752478e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.530134329286318429e-01 1.530134329286318429e-01 1.530134329286318429e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 1.701246277502385384e-01 1.701246277502385384e-01 1.701246277502385384e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 2.381175177280299149e-01 2.381175177280299149e-01 2.381175177280299149e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.278189639961204438e-01 1.278189639961204438e-01 1.278189639961204438e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.022943921551142665e-01 1.022943921551142665e-01 1.022943921551142665e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 1.280583365259961026e-01 1.280583365259961026e-01 1.280583365259961026e-01 -1.718750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.727105417045541325e-01 1.727105417045541325e-01 1.727105417045541325e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.520337508444036256e-01 1.520337508444036256e-01 1.520337508444036256e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.333500547137602688e-01 1.333500547137602688e-01 1.333500547137602688e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.061383380872188004e-01 1.061383380872188004e-01 1.061383380872188004e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.531459299996241197e-01 1.531459299996241197e-01 1.531459299996241197e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 1.754456915037586884e-01 1.754456915037586884e-01 1.754456915037586884e-01 -1.406250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 9.941613346697888987e-02 9.941613346697888987e-02 9.941613346697888987e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.105276361992356821e-01 1.105276361992356821e-01 1.105276361992356821e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.381049144258236216e-01 1.381049144258236216e-01 1.381049144258236216e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.151810109021822737e-01 1.151810109021822737e-01 1.151810109021822737e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 9.758643307866558814e-02 9.758643307866558814e-02 9.758643307866558814e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 1.672455832333394066e-01 1.672455832333394066e-01 1.672455832333394066e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.956750451995432072e-01 1.956750451995432072e-01 1.956750451995432072e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.745441540153176152e-01 1.745441540153176152e-01 1.745441540153176152e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 1.591723085290384088e-01 1.591723085290384088e-01 1.591723085290384088e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 1.596492604508387703e-01 1.596492604508387703e-01 1.596492604508387703e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 2.062099218134776923e-01 2.062099218134776923e-01 2.062099218134776923e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 8.364254038120753909e-02 8.364254038120753909e-02 8.364254038120753909e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.391088606974488218e-01 1.391088606974488218e-01 1.391088606974488218e-01 -2.343750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 8.247153235984068520e-02 8.247153235984068520e-02 8.247153235984068520e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 8.490997460557543619e-02 8.490997460557543619e-02 8.490997460557543619e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 7.968234282478932340e-02 7.968234282478932340e-02 7.968234282478932340e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 9.766678970054631925e-02 9.766678970054631925e-02 9.766678970054631925e-02 -2.343750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.182659728384785336e-01 1.182659728384785336e-01 1.182659728384785336e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.231566804864531323e-01 1.231566804864531323e-01 1.231566804864531323e-01 -1.562500000000000000e-02 -1.718750000000000000e-01 2.656250000000000000e-01 8.859321641755082966e-02 8.859321641755082966e-02 8.859321641755082966e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 2.968750000000000000e-01 9.306624386280326622e-02 9.306624386280326622e-02 9.306624386280326622e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 2.656250000000000000e-01 5.842866645043968271e-02 5.842866645043968271e-02 5.842866645043968271e-02 -4.687500000000000000e-02 -1.718750000000000000e-01 2.968750000000000000e-01 8.700758661990251608e-02 8.700758661990251608e-02 8.700758661990251608e-02 -1.562500000000000000e-02 -1.718750000000000000e-01 3.281250000000000000e-01 8.684444098015015046e-02 8.684444098015015046e-02 8.684444098015015046e-02 -1.562500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.344632953744604731e-01 1.344632953744604731e-01 1.344632953744604731e-01 -4.687500000000000000e-02 -1.718750000000000000e-01 3.281250000000000000e-01 7.951251122900357404e-02 7.951251122900357404e-02 7.951251122900357404e-02 -4.687500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.317588809659512028e-01 1.317588809659512028e-01 1.317588809659512028e-01 -7.812500000000000000e-02 -2.031250000000000000e-01 2.656250000000000000e-01 3.273288545433601648e-02 3.273288545433601648e-02 3.273288545433601648e-02 -1.093750000000000000e-01 -2.031250000000000000e-01 2.656250000000000000e-01 6.809961734053884830e-02 6.809961734053884830e-02 6.809961734053884830e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 2.656250000000000000e-01 6.243340225407564142e-02 6.243340225407564142e-02 6.243340225407564142e-02 -7.812500000000000000e-02 -1.718750000000000000e-01 2.968750000000000000e-01 1.190966428956908851e-01 1.190966428956908851e-01 1.190966428956908851e-01 -1.093750000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 8.137525408428887552e-02 8.137525408428887552e-02 8.137525408428887552e-02 -1.093750000000000000e-01 -1.718750000000000000e-01 2.968750000000000000e-01 1.561860755759935382e-01 1.561860755759935382e-01 1.561860755759935382e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 1.049644434763763040e-01 1.049644434763763040e-01 1.049644434763763040e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 2.968750000000000000e-01 1.792195157168231801e-01 1.792195157168231801e-01 1.792195157168231801e-01 -7.812500000000000000e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.427815909906706704e-01 1.427815909906706704e-01 1.427815909906706704e-01 -1.093750000000000000e-01 -1.406250000000000000e-01 3.281250000000000000e-01 1.568437147753351524e-01 1.568437147753351524e-01 1.568437147753351524e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 2.968750000000000000e-01 6.046868355070356832e-02 6.046868355070356832e-02 6.046868355070356832e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 2.656250000000000000e-01 7.916786370835811326e-02 7.916786370835811326e-02 7.916786370835811326e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 2.968750000000000000e-01 6.034841442078733159e-02 6.034841442078733159e-02 6.034841442078733159e-02 -1.562500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.341267545481143464e-01 1.341267545481143464e-01 1.341267545481143464e-01 -1.562500000000000000e-02 -7.812500000000000000e-02 3.281250000000000000e-01 8.398089985449690154e-02 8.398089985449690154e-02 8.398089985449690154e-02 -4.687500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.167162762768171325e-01 1.167162762768171325e-01 1.167162762768171325e-01 -4.687500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 9.600740917487525505e-02 9.600740917487525505e-02 9.600740917487525505e-02 -4.687500000000000000e-02 -7.812500000000000000e-02 3.281250000000000000e-01 1.363291035829951037e-01 1.363291035829951037e-01 1.363291035829951037e-01 -4.687500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 1.107678636158386659e-01 1.107678636158386659e-01 1.107678636158386659e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 1.553316986733069838e-01 1.553316986733069838e-01 1.553316986733069838e-01 -1.562500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 1.029958617070443200e-01 1.029958617070443200e-01 1.029958617070443200e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.425037126020535505e-01 1.425037126020535505e-01 1.425037126020535505e-01 -1.562500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 1.289764601283492351e-01 1.289764601283492351e-01 1.289764601283492351e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 1.267899753120436679e-01 1.267899753120436679e-01 1.267899753120436679e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 9.484863502163901061e-02 9.484863502163901061e-02 9.484863502163901061e-02 -4.687500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.582962834077761283e-01 1.582962834077761283e-01 1.582962834077761283e-01 -4.687500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 1.220087404946344767e-01 1.220087404946344767e-01 1.220087404946344767e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 1.057590940625837972e-01 1.057590940625837972e-01 1.057590940625837972e-01 -4.687500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 1.042895065817116274e-01 1.042895065817116274e-01 1.042895065817116274e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 2.656250000000000000e-01 1.104834471314539296e-01 1.104834471314539296e-01 1.104834471314539296e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 3.760282060017400285e-02 3.760282060017400285e-02 3.760282060017400285e-02 -7.812500000000000000e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.093730884067234260e-01 1.093730884067234260e-01 1.093730884067234260e-01 -7.812500000000000000e-02 -1.093750000000000000e-01 3.593750000000000000e-01 1.197240582109344031e-01 1.197240582109344031e-01 1.197240582109344031e-01 -7.812500000000000000e-02 -7.812500000000000000e-02 3.593750000000000000e-01 1.117665270934020544e-01 1.117665270934020544e-01 1.117665270934020544e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 3.281250000000000000e-01 1.414476053464655270e-01 1.414476053464655270e-01 1.414476053464655270e-01 -1.093750000000000000e-01 -1.093750000000000000e-01 3.593750000000000000e-01 1.034032415604341643e-01 1.034032415604341643e-01 1.034032415604341643e-01 -1.093750000000000000e-01 -7.812500000000000000e-02 3.593750000000000000e-01 1.175252714148061484e-01 1.175252714148061484e-01 1.175252714148061484e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 2.656250000000000000e-01 7.008577303998664298e-02 7.008577303998664298e-02 7.008577303998664298e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 2.968750000000000000e-01 7.827545446377286165e-02 7.827545446377286165e-02 7.827545446377286165e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 2.656250000000000000e-01 9.122595186580731430e-02 9.122595186580731430e-02 9.122595186580731430e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 2.968750000000000000e-01 3.638554538912785324e-02 3.638554538912785324e-02 3.638554538912785324e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 4.868105217870061924e-02 4.868105217870061924e-02 4.868105217870061924e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 8.277694446820345331e-02 8.277694446820345331e-02 8.277694446820345331e-02 -7.812500000000000000e-02 -4.687500000000000000e-02 3.281250000000000000e-01 1.039263239095819247e-01 1.039263239095819247e-01 1.039263239095819247e-01 -7.812500000000000000e-02 -4.687500000000000000e-02 3.593750000000000000e-01 5.510045343032434623e-02 5.510045343032434623e-02 5.510045343032434623e-02 -7.812500000000000000e-02 -1.562500000000000000e-02 3.281250000000000000e-01 4.505114336469152880e-02 4.505114336469152880e-02 4.505114336469152880e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 3.281250000000000000e-01 5.100682871873336854e-02 5.100682871873336854e-02 5.100682871873336854e-02 -1.093750000000000000e-01 -4.687500000000000000e-02 3.593750000000000000e-01 8.993932970725193599e-02 8.993932970725193599e-02 8.993932970725193599e-02 -1.093750000000000000e-01 -1.562500000000000000e-02 3.281250000000000000e-01 4.539698237878690007e-02 4.539698237878690007e-02 4.539698237878690007e-02 -1.406250000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 7.375860105660742017e-02 7.375860105660742017e-02 7.375860105660742017e-02 -1.406250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 2.341434979466302801e-01 2.341434979466302801e-01 2.341434979466302801e-01 -1.406250000000000000e-01 -1.406250000000000000e-01 2.968750000000000000e-01 1.592228944729608964e-01 1.592228944729608964e-01 1.592228944729608964e-01 -1.718750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 1.936524992267049661e-01 1.936524992267049661e-01 1.936524992267049661e-01 -2.031250000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 1.390550494950238691e-01 1.390550494950238691e-01 1.390550494950238691e-01 -2.031250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 1.955113171788509241e-01 1.955113171788509241e-01 1.955113171788509241e-01 -2.343750000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 1.461698632753277161e-01 1.461698632753277161e-01 1.461698632753277161e-01 -2.343750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 2.197482663020811355e-01 2.197482663020811355e-01 2.197482663020811355e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 3.011365219806441118e-01 3.011365219806441118e-01 3.011365219806441118e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 2.968750000000000000e-01 1.372125964639235862e-01 1.372125964639235862e-01 1.372125964639235862e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.215918149173972479e-01 1.215918149173972479e-01 1.215918149173972479e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 2.968750000000000000e-01 9.768045031829158953e-02 9.768045031829158953e-02 9.768045031829158953e-02 -1.718750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 1.992601237740170284e-01 1.992601237740170284e-01 1.992601237740170284e-01 -1.718750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.704048192753007673e-01 1.704048192753007673e-01 1.704048192753007673e-01 -1.406250000000000000e-01 -1.093750000000000000e-01 3.281250000000000000e-01 1.211507872442895428e-01 1.211507872442895428e-01 1.211507872442895428e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 3.281250000000000000e-01 1.381378440622456349e-01 1.381378440622456349e-01 1.381378440622456349e-01 -1.406250000000000000e-01 -7.812500000000000000e-02 3.593750000000000000e-01 9.732929134927573167e-02 9.732929134927573167e-02 9.732929134927573167e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 7.143573286126522759e-02 7.143573286126522759e-02 7.143573286126522759e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 2.968750000000000000e-01 4.402672426211620693e-02 4.402672426211620693e-02 4.402672426211620693e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.245721024903309743e-01 1.245721024903309743e-01 1.245721024903309743e-01 -1.406250000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.011477615164649291e-01 1.011477615164649291e-01 1.011477615164649291e-01 -1.718750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 1.256509233106537782e-01 1.256509233106537782e-01 1.256509233106537782e-01 -1.718750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 9.089164102866340023e-02 9.089164102866340023e-02 9.089164102866340023e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 2.968750000000000000e-01 8.136962798422833765e-02 8.136962798422833765e-02 8.136962798422833765e-02 -1.406250000000000000e-01 -4.687500000000000000e-02 3.281250000000000000e-01 7.618959109705633614e-02 7.618959109705633614e-02 7.618959109705633614e-02 -1.406250000000000000e-01 -1.562500000000000000e-02 3.281250000000000000e-01 9.978335422283259037e-02 9.978335422283259037e-02 9.978335422283259037e-02 -1.718750000000000000e-01 -1.562500000000000000e-02 3.281250000000000000e-01 6.984108336388426819e-02 6.984108336388426819e-02 6.984108336388426819e-02 -2.031250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 1.748845397928440459e-01 1.748845397928440459e-01 1.748845397928440459e-01 -2.031250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.492913805923741233e-01 1.492913805923741233e-01 1.492913805923741233e-01 -2.343750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 1.934293739776412613e-01 1.934293739776412613e-01 1.934293739776412613e-01 -2.343750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.858876976828397198e-01 1.858876976828397198e-01 1.858876976828397198e-01 -2.031250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 1.126334180019250703e-01 1.126334180019250703e-01 1.126334180019250703e-01 -2.031250000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 8.196599240106322570e-02 8.196599240106322570e-02 8.196599240106322570e-02 -2.343750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 1.597512346530731153e-01 1.597512346530731153e-01 1.597512346530731153e-01 -2.343750000000000000e-01 -1.562500000000000000e-02 2.656250000000000000e-01 9.245951468981278287e-02 9.245951468981278287e-02 9.245951468981278287e-02 -2.656250000000000000e-01 -3.281250000000000000e-01 4.687500000000000000e-02 9.347206678241033739e-02 9.347206678241033739e-02 9.347206678241033739e-02 -2.656250000000000000e-01 -3.281250000000000000e-01 7.812500000000000000e-02 9.962666285806615063e-02 9.962666285806615063e-02 9.962666285806615063e-02 -2.656250000000000000e-01 -3.281250000000000000e-01 1.093750000000000000e-01 7.719688233554182488e-02 7.719688233554182488e-02 7.719688233554182488e-02 -2.656250000000000000e-01 -2.968750000000000000e-01 1.562500000000000000e-02 6.484230588174212662e-02 6.484230588174212662e-02 6.484230588174212662e-02 -2.656250000000000000e-01 -2.968750000000000000e-01 4.687500000000000000e-02 1.101733195364972967e-01 1.101733195364972967e-01 1.101733195364972967e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 1.562500000000000000e-02 4.807760646578777830e-02 4.807760646578777830e-02 4.807760646578777830e-02 -2.656250000000000000e-01 -2.656250000000000000e-01 4.687500000000000000e-02 8.618381830811114308e-02 8.618381830811114308e-02 8.618381830811114308e-02 -2.656250000000000000e-01 -2.968750000000000000e-01 7.812500000000000000e-02 7.865000552778751708e-02 7.865000552778751708e-02 7.865000552778751708e-02 -2.656250000000000000e-01 -2.968750000000000000e-01 1.093750000000000000e-01 8.937115209848597863e-02 8.937115209848597863e-02 8.937115209848597863e-02 -2.656250000000000000e-01 -2.656250000000000000e-01 7.812500000000000000e-02 1.085503525211953257e-01 1.085503525211953257e-01 1.085503525211953257e-01 -2.656250000000000000e-01 -2.656250000000000000e-01 1.093750000000000000e-01 1.242331103848671597e-01 1.242331103848671597e-01 1.242331103848671597e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.008416156036232025e-01 1.008416156036232025e-01 1.008416156036232025e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 7.029830840965334282e-02 7.029830840965334282e-02 7.029830840965334282e-02 -2.968750000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 1.462766730467693066e-01 1.462766730467693066e-01 1.462766730467693066e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 7.812500000000000000e-02 1.157024099112240051e-01 1.157024099112240051e-01 1.157024099112240051e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 1.093750000000000000e-01 1.223107892741866626e-01 1.223107892741866626e-01 1.223107892741866626e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.009227725076334292e-01 1.009227725076334292e-01 1.009227725076334292e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.250709484651415793e-01 1.250709484651415793e-01 1.250709484651415793e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.069402083380723706e-01 1.069402083380723706e-01 1.069402083380723706e-01 -2.968750000000000000e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.236804377285028872e-01 1.236804377285028872e-01 1.236804377285028872e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 6.637025218729578069e-02 6.637025218729578069e-02 6.637025218729578069e-02 -2.656250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 7.390521489024073909e-02 7.390521489024073909e-02 7.390521489024073909e-02 -2.656250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.068478088668797371e-01 1.068478088668797371e-01 1.068478088668797371e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 6.605778402154205420e-02 6.605778402154205420e-02 6.605778402154205420e-02 -2.968750000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 8.514384899878535418e-02 8.514384899878535418e-02 8.514384899878535418e-02 -2.968750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 1.075387936462281341e-01 1.075387936462281341e-01 1.075387936462281341e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 9.899105526923319964e-02 9.899105526923319964e-02 9.899105526923319964e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 7.480466562098739280e-02 7.480466562098739280e-02 7.480466562098739280e-02 -3.281250000000000000e-01 -2.031250000000000000e-01 4.687500000000000000e-02 9.860615265739068602e-02 9.860615265739068602e-02 9.860615265739068602e-02 -3.281250000000000000e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.272566767285816247e-01 1.272566767285816247e-01 1.272566767285816247e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.009701809582573134e-01 1.009701809582573134e-01 1.009701809582573134e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 1.245174782665642993e-01 1.245174782665642993e-01 1.245174782665642993e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 6.106962453772158544e-02 6.106962453772158544e-02 6.106962453772158544e-02 -3.593750000000000000e-01 -1.718750000000000000e-01 4.687500000000000000e-02 8.550390171847384313e-02 8.550390171847384313e-02 8.550390171847384313e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 6.161774311848438462e-02 6.161774311848438462e-02 6.161774311848438462e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 5.072364815481397032e-02 5.072364815481397032e-02 5.072364815481397032e-02 -3.281250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.212455802814559197e-01 1.212455802814559197e-01 1.212455802814559197e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 8.442936461190388153e-02 8.442936461190388153e-02 8.442936461190388153e-02 -3.593750000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.001192351970800337e-01 1.001192351970800337e-01 1.001192351970800337e-01 -3.593750000000000000e-01 -1.718750000000000000e-01 1.093750000000000000e-01 9.091414276321696519e-02 9.091414276321696519e-02 9.091414276321696519e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.081646921786026255e-01 1.081646921786026255e-01 1.081646921786026255e-01 -2.656250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 4.308029094023117789e-02 4.308029094023117789e-02 4.308029094023117789e-02 -2.656250000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 1.042171915786102715e-01 1.042171915786102715e-01 1.042171915786102715e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 5.044529081988130548e-02 5.044529081988130548e-02 5.044529081988130548e-02 -2.968750000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 4.666952206461810054e-02 4.666952206461810054e-02 4.666952206461810054e-02 -2.968750000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 9.960737774591842120e-02 9.960737774591842120e-02 9.960737774591842120e-02 -2.656250000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 4.351692213990573238e-02 4.351692213990573238e-02 4.351692213990573238e-02 -2.656250000000000000e-01 -2.343750000000000000e-01 2.343750000000000000e-01 3.334304078091653717e-02 3.334304078091653717e-02 3.334304078091653717e-02 -2.656250000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 1.960498526983480705e-01 1.960498526983480705e-01 1.960498526983480705e-01 -2.656250000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 5.822590803316204933e-02 5.822590803316204933e-02 5.822590803316204933e-02 -2.968750000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 4.720977846693028002e-02 4.720977846693028002e-02 4.720977846693028002e-02 -2.968750000000000000e-01 -2.343750000000000000e-01 2.343750000000000000e-01 3.865691442550911461e-02 3.865691442550911461e-02 3.865691442550911461e-02 -2.968750000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 3.901138535226731513e-02 3.901138535226731513e-02 3.901138535226731513e-02 -2.656250000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 7.775686715076282618e-02 7.775686715076282618e-02 7.775686715076282618e-02 -2.656250000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 7.334705202582404715e-02 7.334705202582404715e-02 7.334705202582404715e-02 -2.656250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.022927851158920987e-01 1.022927851158920987e-01 1.022927851158920987e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 7.610310428408981198e-02 7.610310428408981198e-02 7.610310428408981198e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 1.082908354524361738e-01 1.082908354524361738e-01 1.082908354524361738e-01 -2.656250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 1.124076576917303893e-01 1.124076576917303893e-01 1.124076576917303893e-01 -2.968750000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 9.514757142139715351e-02 9.514757142139715351e-02 9.514757142139715351e-02 -2.968750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 2.088219597345408740e-01 2.088219597345408740e-01 2.088219597345408740e-01 -3.281250000000000000e-01 -2.343750000000000000e-01 1.718750000000000000e-01 8.827416417493172407e-02 8.827416417493172407e-02 8.827416417493172407e-02 -3.281250000000000000e-01 -2.031250000000000000e-01 1.406250000000000000e-01 1.020581570461670112e-01 1.020581570461670112e-01 1.020581570461670112e-01 -3.281250000000000000e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.349958141400112444e-01 1.349958141400112444e-01 1.349958141400112444e-01 -3.281250000000000000e-01 -2.343750000000000000e-01 2.031250000000000000e-01 4.894011835657838955e-02 4.894011835657838955e-02 4.894011835657838955e-02 -3.281250000000000000e-01 -2.031250000000000000e-01 2.031250000000000000e-01 1.153786448225290195e-01 1.153786448225290195e-01 1.153786448225290195e-01 -3.281250000000000000e-01 -2.031250000000000000e-01 2.343750000000000000e-01 9.486470689933379496e-02 9.486470689933379496e-02 9.486470689933379496e-02 -3.281250000000000000e-01 -1.718750000000000000e-01 1.406250000000000000e-01 9.023748070860000692e-02 9.023748070860000692e-02 9.023748070860000692e-02 -3.281250000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.294278871386751739e-01 1.294278871386751739e-01 1.294278871386751739e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 8.274720702439147813e-02 8.274720702439147813e-02 8.274720702439147813e-02 -3.281250000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 5.859725622831771230e-02 5.859725622831771230e-02 5.859725622831771230e-02 -3.593750000000000000e-01 -1.718750000000000000e-01 1.718750000000000000e-01 6.257971516083137009e-02 6.257971516083137009e-02 6.257971516083137009e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 1.406250000000000000e-01 8.643858462836742640e-02 8.643858462836742640e-02 8.643858462836742640e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 6.736866304466176958e-02 6.736866304466176958e-02 6.736866304466176958e-02 -3.281250000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 1.067658544644887186e-01 1.067658544644887186e-01 1.067658544644887186e-01 -3.281250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 1.140658965955797938e-01 1.140658965955797938e-01 1.140658965955797938e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 9.590294339617896902e-02 9.590294339617896902e-02 9.590294339617896902e-02 -3.281250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 9.601865932757160105e-02 9.601865932757160105e-02 9.601865932757160105e-02 -3.593750000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 1.044164594299719084e-01 1.044164594299719084e-01 1.044164594299719084e-01 -3.593750000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 9.134408541118078928e-02 9.134408541118078928e-02 9.134408541118078928e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 8.950295037365690876e-02 8.950295037365690876e-02 8.950295037365690876e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.463698303256171784e-01 1.463698303256171784e-01 1.463698303256171784e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 9.270783221570308430e-02 9.270783221570308430e-02 9.270783221570308430e-02 -2.656250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 2.084223354643264803e-01 2.084223354643264803e-01 2.084223354643264803e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 1.989776250595348128e-01 1.989776250595348128e-01 1.989776250595348128e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.517518892808381592e-01 1.517518892808381592e-01 1.517518892808381592e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 6.433737864481479940e-02 6.433737864481479940e-02 6.433737864481479940e-02 -2.968750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 7.274306785899592454e-02 7.274306785899592454e-02 7.274306785899592454e-02 -2.968750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 6.400625205743272483e-02 6.400625205743272483e-02 6.400625205743272483e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 2.370570496164033092e-01 2.370570496164033092e-01 2.370570496164033092e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.856605374613901904e-01 1.856605374613901904e-01 1.856605374613901904e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.142426448507026238e-01 1.142426448507026238e-01 1.142426448507026238e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.607565167213571289e-01 1.607565167213571289e-01 1.607565167213571289e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 9.773107494027148678e-02 9.773107494027148678e-02 9.773107494027148678e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 6.953505945288340762e-02 6.953505945288340762e-02 6.953505945288340762e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.351821547157001646e-01 1.351821547157001646e-01 1.351821547157001646e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 6.995522910040108400e-02 6.995522910040108400e-02 6.995522910040108400e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 8.928837624211617696e-02 8.928837624211617696e-02 8.928837624211617696e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 9.705848807701226988e-02 9.705848807701226988e-02 9.705848807701226988e-02 -2.968750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 8.544523252359216559e-02 8.544523252359216559e-02 8.544523252359216559e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 5.607255316873403089e-02 5.607255316873403089e-02 5.607255316873403089e-02 -2.968750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 4.816404300486588214e-02 4.816404300486588214e-02 4.816404300486588214e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 3.891215294986935525e-02 3.891215294986935525e-02 3.891215294986935525e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 4.528079157150715489e-02 4.528079157150715489e-02 4.528079157150715489e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 4.683218634004503167e-02 4.683218634004503167e-02 4.683218634004503167e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 3.481513103029158090e-02 3.481513103029158090e-02 3.481513103029158090e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 6.506265285169450518e-02 6.506265285169450518e-02 6.506265285169450518e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 8.857232134718269478e-02 8.857232134718269478e-02 8.857232134718269478e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 7.383777577517221247e-02 7.383777577517221247e-02 7.383777577517221247e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 9.183429758967312506e-02 9.183429758967312506e-02 9.183429758967312506e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 8.869528072175476840e-02 8.869528072175476840e-02 8.869528072175476840e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.173493337403371389e-01 1.173493337403371389e-01 1.173493337403371389e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.023876003745956970e-01 1.023876003745956970e-01 1.023876003745956970e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 7.320903794393840425e-02 7.320903794393840425e-02 7.320903794393840425e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 8.356699199093098329e-02 8.356699199093098329e-02 8.356699199093098329e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 6.529891622525715866e-02 6.529891622525715866e-02 6.529891622525715866e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 9.016595671468140283e-02 9.016595671468140283e-02 9.016595671468140283e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 7.395175508092087513e-02 7.395175508092087513e-02 7.395175508092087513e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 6.999630544906458585e-02 6.999630544906458585e-02 6.999630544906458585e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 8.252940000624457706e-02 8.252940000624457706e-02 8.252940000624457706e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 7.079741063128361378e-02 7.079741063128361378e-02 7.079741063128361378e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 4.625863852024419270e-02 4.625863852024419270e-02 4.625863852024419270e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 5.623881634276030328e-02 5.623881634276030328e-02 5.623881634276030328e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 8.673996330310837499e-02 8.673996330310837499e-02 8.673996330310837499e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 4.803241821026988517e-02 4.803241821026988517e-02 4.803241821026988517e-02 -2.656250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 1.733616233650794591e-01 1.733616233650794591e-01 1.733616233650794591e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.796040328586351875e-01 1.796040328586351875e-01 1.796040328586351875e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.358094446024434299e-01 1.358094446024434299e-01 1.358094446024434299e-01 -2.656250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.653114433262859728e-01 1.653114433262859728e-01 1.653114433262859728e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.779158364060072772e-01 1.779158364060072772e-01 1.779158364060072772e-01 -2.968750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.878076976795726161e-01 1.878076976795726161e-01 1.878076976795726161e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.320641060322871874e-01 1.320641060322871874e-01 1.320641060322871874e-01 -2.968750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.746300533922123255e-01 1.746300533922123255e-01 1.746300533922123255e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.498005129118056833e-01 1.498005129118056833e-01 1.498005129118056833e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 7.382169969647926766e-02 7.382169969647926766e-02 7.382169969647926766e-02 -2.656250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.257119730511852274e-01 1.257119730511852274e-01 1.257119730511852274e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.493050324473993995e-01 1.493050324473993995e-01 1.493050324473993995e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.487581533840551251e-01 1.487581533840551251e-01 1.487581533840551251e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 4.108277349813165003e-02 4.108277349813165003e-02 4.108277349813165003e-02 -2.656250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.537128543967085648e-01 1.537128543967085648e-01 1.537128543967085648e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.345197306780729685e-01 2.345197306780729685e-01 2.345197306780729685e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.380157633912647008e-01 1.380157633912647008e-01 1.380157633912647008e-01 -2.656250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.464123935292051537e-01 1.464123935292051537e-01 1.464123935292051537e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.749495661572773586e-01 1.749495661572773586e-01 1.749495661572773586e-01 -2.968750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.796891240863524863e-01 1.796891240863524863e-01 1.796891240863524863e-01 -2.968750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.353371704691840871e-01 1.353371704691840871e-01 1.353371704691840871e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 6.832445699977686415e-02 6.832445699977686415e-02 6.832445699977686415e-02 -3.281250000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 5.093342056489340991e-02 5.093342056489340991e-02 5.093342056489340991e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 9.819312358942224039e-02 9.819312358942224039e-02 9.819312358942224039e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 6.921512777336795430e-02 6.921512777336795430e-02 6.921512777336795430e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 9.214851398895634871e-02 9.214851398895634871e-02 9.214851398895634871e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 4.309178972965056059e-02 4.309178972965056059e-02 4.309178972965056059e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 8.189928339342139596e-02 8.189928339342139596e-02 8.189928339342139596e-02 -3.281250000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 5.521301210236297108e-02 5.521301210236297108e-02 5.521301210236297108e-02 -3.281250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 6.592417879097889344e-02 6.592417879097889344e-02 6.592417879097889344e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 7.985056657451775064e-02 7.985056657451775064e-02 7.985056657451775064e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 7.988319856549196130e-02 7.988319856549196130e-02 7.988319856549196130e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 6.880138509430373805e-02 6.880138509430373805e-02 6.880138509430373805e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.126792127206472233e-01 1.126792127206472233e-01 1.126792127206472233e-01 -3.281250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 8.698588746522499526e-02 8.698588746522499526e-02 8.698588746522499526e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 1.104513096123666410e-01 1.104513096123666410e-01 1.104513096123666410e-01 -3.281250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.018387952524755780e-01 1.018387952524755780e-01 1.018387952524755780e-01 -3.593750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.013148958014403189e-01 1.013148958014403189e-01 1.013148958014403189e-01 -3.281250000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 8.967010885110794638e-02 8.967010885110794638e-02 8.967010885110794638e-02 -3.281250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 9.619223291260946274e-02 9.619223291260946274e-02 9.619223291260946274e-02 -3.281250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 9.058947426909573497e-02 9.058947426909573497e-02 9.058947426909573497e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 9.747955864720488084e-02 9.747955864720488084e-02 9.747955864720488084e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 9.475140009304872102e-02 9.475140009304872102e-02 9.475140009304872102e-02 -3.593750000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 8.947964459680934901e-02 8.947964459680934901e-02 8.947964459680934901e-02 -3.906250000000000000e-01 -1.406250000000000000e-01 1.562500000000000000e-02 5.551426657344198795e-02 5.551426657344198795e-02 5.551426657344198795e-02 -3.906250000000000000e-01 -1.406250000000000000e-01 4.687500000000000000e-02 8.737566768550539265e-02 8.737566768550539265e-02 8.737566768550539265e-02 -3.906250000000000000e-01 -1.718750000000000000e-01 7.812500000000000000e-02 7.695084787226233458e-02 7.695084787226233458e-02 7.695084787226233458e-02 -3.906250000000000000e-01 -1.406250000000000000e-01 7.812500000000000000e-02 1.284728188196530285e-01 1.284728188196530285e-01 1.284728188196530285e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.134858382300900914e-01 1.134858382300900914e-01 1.134858382300900914e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 6.494817861645932333e-02 6.494817861645932333e-02 6.494817861645932333e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 1.718750000000000000e-01 5.708990475284760058e-02 5.708990475284760058e-02 5.708990475284760058e-02 -3.906250000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 7.808552586525550898e-02 7.808552586525550898e-02 7.808552586525550898e-02 -3.906250000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 8.797841688555455009e-02 8.797841688555455009e-02 8.797841688555455009e-02 -3.906250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 9.317633859977392241e-02 9.317633859977392241e-02 9.317633859977392241e-02 -3.906250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 1.054409133746793681e-01 1.054409133746793681e-01 1.054409133746793681e-01 -4.218750000000000000e-01 -1.718750000000000000e-01 2.031250000000000000e-01 5.169258467727860101e-02 5.169258467727860101e-02 5.169258467727860101e-02 -4.218750000000000000e-01 -1.718750000000000000e-01 2.343750000000000000e-01 6.949952941459544564e-02 6.949952941459544564e-02 6.949952941459544564e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 9.336518688531093846e-02 9.336518688531093846e-02 9.336518688531093846e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 1.159458354101791377e-01 1.159458354101791377e-01 1.159458354101791377e-01 -4.531250000000000000e-01 -1.406250000000000000e-01 2.031250000000000000e-01 4.687407856929230732e-02 4.687407856929230732e-02 4.687407856929230732e-02 -4.531250000000000000e-01 -1.406250000000000000e-01 2.343750000000000000e-01 7.152246583981360095e-02 7.152246583981360095e-02 7.152246583981360095e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 1.562500000000000000e-02 7.708282724993752166e-02 7.708282724993752166e-02 7.708282724993752166e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 4.687500000000000000e-02 5.785005592795281620e-02 5.785005592795281620e-02 5.785005592795281620e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 6.833337983348658495e-02 6.833337983348658495e-02 6.833337983348658495e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 7.434441174906454564e-02 7.434441174906454564e-02 7.434441174906454564e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 9.761134364004357689e-02 9.761134364004357689e-02 9.761134364004357689e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 9.652491457056810997e-02 9.652491457056810997e-02 9.652491457056810997e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.074761231784038401e-01 1.074761231784038401e-01 1.074761231784038401e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.074865682597557492e-01 1.074865682597557492e-01 1.074865682597557492e-01 -3.906250000000000000e-01 -7.812500000000000000e-02 7.812500000000000000e-02 7.103679210892593909e-02 7.103679210892593909e-02 7.103679210892593909e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 9.080163402746189993e-02 9.080163402746189993e-02 9.080163402746189993e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 1.093750000000000000e-01 7.476905753031640178e-02 7.476905753031640178e-02 7.476905753031640178e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 8.735236129242346381e-02 8.735236129242346381e-02 8.735236129242346381e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.662861464594391769e-01 1.662861464594391769e-01 1.662861464594391769e-01 -3.906250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 5.190404300939191473e-02 5.190404300939191473e-02 5.190404300939191473e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 8.686774752036954816e-02 8.686774752036954816e-02 8.686774752036954816e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 3.695602732466200802e-02 3.695602732466200802e-02 3.695602732466200802e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 5.450187984681883341e-02 5.450187984681883341e-02 5.450187984681883341e-02 -4.531250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.181454687329351882e-01 1.181454687329351882e-01 1.181454687329351882e-01 -4.531250000000000000e-01 -7.812500000000000000e-02 4.687500000000000000e-02 8.037645441324235696e-02 8.037645441324235696e-02 8.037645441324235696e-02 -4.843750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.203715521128322641e-01 1.203715521128322641e-01 1.203715521128322641e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.239222324828196109e-01 1.239222324828196109e-01 1.239222324828196109e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.185423282389286709e-01 1.185423282389286709e-01 1.185423282389286709e-01 -4.843750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.177084389958914096e-01 1.177084389958914096e-01 1.177084389958914096e-01 -4.843750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.719735526535577375e-01 1.719735526535577375e-01 1.719735526535577375e-01 -4.843750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.188548336382264092e-01 1.188548336382264092e-01 1.188548336382264092e-01 -4.843750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.566566213866172341e-01 1.566566213866172341e-01 1.566566213866172341e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 7.812500000000000000e-02 7.728891398161573389e-02 7.728891398161573389e-02 7.728891398161573389e-02 -4.531250000000000000e-01 -4.687500000000000000e-02 1.093750000000000000e-01 8.685810343558592050e-02 8.685810343558592050e-02 8.685810343558592050e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.309765356396866143e-01 1.309765356396866143e-01 1.309765356396866143e-01 -4.843750000000000000e-01 -1.562500000000000000e-02 1.093750000000000000e-01 5.432234710330369198e-02 5.432234710330369198e-02 5.432234710330369198e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 1.058627435603961831e-01 1.058627435603961831e-01 1.058627435603961831e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 5.782778613313902666e-02 5.782778613313902666e-02 5.782778613313902666e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 1.406250000000000000e-01 8.459492623822187363e-02 8.459492623822187363e-02 8.459492623822187363e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 1.718750000000000000e-01 5.471542118220562578e-02 5.471542118220562578e-02 5.471542118220562578e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.101749264182989158e-01 1.101749264182989158e-01 1.101749264182989158e-01 -4.218750000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 9.874516780062556065e-02 9.874516780062556065e-02 9.874516780062556065e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 7.899650389716186827e-02 7.899650389716186827e-02 7.899650389716186827e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 5.925633676710623937e-02 5.925633676710623937e-02 5.925633676710623937e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 8.274559959469274251e-02 8.274559959469274251e-02 8.274559959469274251e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 2.031250000000000000e-01 6.370719992606159454e-02 6.370719992606159454e-02 6.370719992606159454e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 2.343750000000000000e-01 7.234123984152558695e-02 7.234123984152558695e-02 7.234123984152558695e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 8.173693111962772317e-02 8.173693111962772317e-02 8.173693111962772317e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.110217486678149040e-01 1.110217486678149040e-01 1.110217486678149040e-01 -4.218750000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.050496136821801180e-01 1.050496136821801180e-01 1.050496136821801180e-01 -4.218750000000000000e-01 -1.562500000000000000e-02 1.718750000000000000e-01 8.109877098741584411e-02 8.109877098741584411e-02 8.109877098741584411e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 8.735155762358098874e-02 8.735155762358098874e-02 8.735155762358098874e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 7.708347026708163574e-02 7.708347026708163574e-02 7.708347026708163574e-02 -3.906250000000000000e-01 -1.562500000000000000e-02 2.343750000000000000e-01 8.225693947441814480e-02 8.225693947441814480e-02 8.225693947441814480e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 2.031250000000000000e-01 7.233810494811300507e-02 7.233810494811300507e-02 7.233810494811300507e-02 -4.218750000000000000e-01 -4.687500000000000000e-02 2.343750000000000000e-01 6.207171882239188171e-02 6.207171882239188171e-02 6.207171882239188171e-02 -4.218750000000000000e-01 -1.562500000000000000e-02 2.031250000000000000e-01 7.208699155155763594e-02 7.208699155155763594e-02 7.208699155155763594e-02 -4.531250000000000000e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.073186433258255662e-01 1.073186433258255662e-01 1.073186433258255662e-01 -4.531250000000000000e-01 -7.812500000000000000e-02 1.718750000000000000e-01 4.527564540036813773e-02 4.527564540036813773e-02 4.527564540036813773e-02 -4.531250000000000000e-01 -1.093750000000000000e-01 2.031250000000000000e-01 4.008837874802217982e-02 4.008837874802217982e-02 4.008837874802217982e-02 -4.531250000000000000e-01 -1.093750000000000000e-01 2.343750000000000000e-01 5.788904815311263913e-02 5.788904815311263913e-02 5.788904815311263913e-02 -4.531250000000000000e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.140506319553343251e-01 1.140506319553343251e-01 1.140506319553343251e-01 -4.531250000000000000e-01 -4.687500000000000000e-02 1.718750000000000000e-01 8.320130463100447460e-02 8.320130463100447460e-02 8.320130463100447460e-02 -4.531250000000000000e-01 -1.562500000000000000e-02 1.406250000000000000e-01 9.342626112960827900e-02 9.342626112960827900e-02 9.342626112960827900e-02 -2.656250000000000000e-01 -1.718750000000000000e-01 2.656250000000000000e-01 1.393602468826480034e-01 1.393602468826480034e-01 1.393602468826480034e-01 -2.656250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 2.103907466643042123e-01 2.103907466643042123e-01 2.103907466643042123e-01 -3.281250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 7.267779807148229410e-02 7.267779807148229410e-02 7.267779807148229410e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 9.294811284610676738e-02 9.294811284610676738e-02 9.294811284610676738e-02 -3.593750000000000000e-01 -1.406250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.656250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 2.043770310559001602e-01 2.043770310559001602e-01 2.043770310559001602e-01 -2.656250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.581121852498821645e-01 2.581121852498821645e-01 2.581121852498821645e-01 -2.656250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.842343568079040428e-01 2.842343568079040428e-01 2.842343568079040428e-01 -3.281250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 6.889149709664442456e-02 6.889149709664442456e-02 6.889149709664442456e-02 -3.281250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 4.630897387741451238e-02 4.630897387741451238e-02 4.630897387741451238e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 9.063849608115305545e-02 9.063849608115305545e-02 9.063849608115305545e-02 -3.593750000000000000e-01 -1.093750000000000000e-01 2.968750000000000000e-01 6.886931074325872149e-02 6.886931074325872149e-02 6.886931074325872149e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 9.487515361812712267e-02 9.487515361812712267e-02 9.487515361812712267e-02 -3.593750000000000000e-01 -7.812500000000000000e-02 2.968750000000000000e-01 6.813844382639863695e-02 6.813844382639863695e-02 6.813844382639863695e-02 -3.593750000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 1.150163155977008828e-01 1.150163155977008828e-01 1.150163155977008828e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 1.078151858963001253e-01 1.078151858963001253e-01 1.078151858963001253e-01 -3.906250000000000000e-01 -1.406250000000000000e-01 2.968750000000000000e-01 7.624770439593263338e-02 7.624770439593263338e-02 7.624770439593263338e-02 -4.218750000000000000e-01 -1.406250000000000000e-01 2.656250000000000000e-01 8.963796301703143288e-02 8.963796301703143288e-02 8.963796301703143288e-02 -3.906250000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 1.051355872890441800e-01 1.051355872890441800e-01 1.051355872890441800e-01 -3.906250000000000000e-01 -1.093750000000000000e-01 2.968750000000000000e-01 7.951789633479859620e-02 7.951789633479859620e-02 7.951789633479859620e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 9.273113705743586677e-02 9.273113705743586677e-02 9.273113705743586677e-02 -3.906250000000000000e-01 -7.812500000000000000e-02 2.968750000000000000e-01 6.360872149433179079e-02 6.360872149433179079e-02 6.360872149433179079e-02 -4.218750000000000000e-01 -1.093750000000000000e-01 2.656250000000000000e-01 8.158824186857231708e-02 8.158824186857231708e-02 8.158824186857231708e-02 -4.218750000000000000e-01 -7.812500000000000000e-02 2.656250000000000000e-01 8.929319813898675684e-02 8.929319813898675684e-02 8.929319813898675684e-02 -3.906250000000000000e-01 -4.687500000000000000e-02 2.656250000000000000e-01 9.987576180773066747e-02 9.987576180773066747e-02 9.987576180773066747e-02 -5.156250000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.164551787908357783e-01 1.164551787908357783e-01 1.164551787908357783e-01 -5.468750000000000000e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.194452968246886571e-01 1.194452968246886571e-01 1.194452968246886571e-01 -5.156250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.469030733632364361e-01 1.469030733632364361e-01 1.469030733632364361e-01 -5.156250000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 9.557829503348930222e-02 9.557829503348930222e-02 9.557829503348930222e-02 -5.156250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.140891952514298952e-01 1.140891952514298952e-01 1.140891952514298952e-01 -5.156250000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.099226455808901687e-01 1.099226455808901687e-01 1.099226455808901687e-01 -5.468750000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.557412225689883412e-01 1.557412225689883412e-01 1.557412225689883412e-01 -5.468750000000000000e-01 -4.687500000000000000e-02 4.687500000000000000e-02 9.205609752831150905e-02 9.205609752831150905e-02 9.205609752831150905e-02 -5.468750000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.506613728479542225e-01 1.506613728479542225e-01 1.506613728479542225e-01 -5.468750000000000000e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.024767908973310965e-01 1.024767908973310965e-01 1.024767908973310965e-01 -5.781250000000000000e-01 -4.687500000000000000e-02 1.562500000000000000e-02 8.941053087404306210e-02 8.941053087404306210e-02 8.941053087404306210e-02 -5.781250000000000000e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.188106491438814527e-01 1.188106491438814527e-01 1.188106491438814527e-01 -1.562500000000000000e-02 1.562500000000000000e-02 -4.218750000000000000e-01 6.657411550749747775e-02 6.657411550749747775e-02 6.657411550749747775e-02 -1.562500000000000000e-02 1.562500000000000000e-02 -3.906250000000000000e-01 9.101298959409012679e-02 9.101298959409012679e-02 9.101298959409012679e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -4.218750000000000000e-01 6.985378409470235916e-02 6.985378409470235916e-02 6.985378409470235916e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -3.906250000000000000e-01 7.159625712329548142e-02 7.159625712329548142e-02 7.159625712329548142e-02 -4.687500000000000000e-02 4.687500000000000000e-02 -3.906250000000000000e-01 6.531386856241036543e-02 6.531386856241036543e-02 6.531386856241036543e-02 -1.562500000000000000e-02 7.812500000000000000e-02 -4.218750000000000000e-01 7.211399994424823323e-02 7.211399994424823323e-02 7.211399994424823323e-02 -1.562500000000000000e-02 7.812500000000000000e-02 -3.906250000000000000e-01 7.827215904967245452e-02 7.827215904967245452e-02 7.827215904967245452e-02 -4.687500000000000000e-02 7.812500000000000000e-02 -3.906250000000000000e-01 7.051180782236489419e-02 7.051180782236489419e-02 7.051180782236489419e-02 -1.562500000000000000e-02 1.562500000000000000e-02 -3.593750000000000000e-01 8.942338924557431679e-02 8.942338924557431679e-02 8.942338924557431679e-02 -1.562500000000000000e-02 1.562500000000000000e-02 -3.281250000000000000e-01 5.594238848082636051e-02 5.594238848082636051e-02 5.594238848082636051e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 6.492856363284350840e-02 6.492856363284350840e-02 6.492856363284350840e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -3.281250000000000000e-01 5.982593300534777558e-02 5.982593300534777558e-02 5.982593300534777558e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -3.593750000000000000e-01 7.042523452188072242e-02 7.042523452188072242e-02 7.042523452188072242e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -3.281250000000000000e-01 4.424157996179689523e-02 4.424157996179689523e-02 4.424157996179689523e-02 -4.687500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 4.949282224320925710e-02 4.949282224320925710e-02 4.949282224320925710e-02 -4.687500000000000000e-02 4.687500000000000000e-02 -3.281250000000000000e-01 4.813308667363247473e-02 4.813308667363247473e-02 4.813308667363247473e-02 -1.562500000000000000e-02 1.562500000000000000e-02 -2.968750000000000000e-01 2.926881720174854401e-02 2.926881720174854401e-02 2.926881720174854401e-02 -1.562500000000000000e-02 1.562500000000000000e-02 -2.656250000000000000e-01 6.183190870687384905e-02 6.183190870687384905e-02 6.183190870687384905e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -2.968750000000000000e-01 6.266549298847629013e-02 6.266549298847629013e-02 6.266549298847629013e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -2.968750000000000000e-01 8.399858130803899980e-02 8.399858130803899980e-02 8.399858130803899980e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -2.656250000000000000e-01 1.492970019447228680e-01 1.492970019447228680e-01 1.492970019447228680e-01 -4.687500000000000000e-02 4.687500000000000000e-02 -2.968750000000000000e-01 5.919370907295976036e-02 5.919370907295976036e-02 5.919370907295976036e-02 -1.562500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 6.216979717526353172e-02 6.216979717526353172e-02 6.216979717526353172e-02 -1.562500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 5.968829769948132830e-02 5.968829769948132830e-02 5.968829769948132830e-02 -1.562500000000000000e-02 1.093750000000000000e-01 -3.593750000000000000e-01 3.910249570796253682e-02 3.910249570796253682e-02 3.910249570796253682e-02 -4.687500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 5.320100208888541016e-02 5.320100208888541016e-02 5.320100208888541016e-02 -4.687500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 5.525280959516155194e-02 5.525280959516155194e-02 5.525280959516155194e-02 -1.562500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 8.857714328698694517e-02 8.857714328698694517e-02 8.857714328698694517e-02 -1.562500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 8.505062079982787793e-02 8.505062079982787793e-02 8.505062079982787793e-02 -1.562500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 7.844295777315918317e-02 7.844295777315918317e-02 7.844295777315918317e-02 -4.687500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 9.409325314800712214e-02 9.409325314800712214e-02 9.409325314800712214e-02 -4.687500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 9.613839299805948535e-02 9.613839299805948535e-02 9.613839299805948535e-02 -7.812500000000000000e-02 1.562500000000000000e-02 -3.593750000000000000e-01 4.225470572985830925e-02 4.225470572985830925e-02 4.225470572985830925e-02 -7.812500000000000000e-02 1.562500000000000000e-02 -3.281250000000000000e-01 5.603203249785197737e-02 5.603203249785197737e-02 5.603203249785197737e-02 -7.812500000000000000e-02 4.687500000000000000e-02 -3.593750000000000000e-01 4.898168786736682712e-02 4.898168786736682712e-02 4.898168786736682712e-02 -1.093750000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 4.887032655711806561e-02 4.887032655711806561e-02 4.887032655711806561e-02 -1.093750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 7.586373788019766529e-02 7.586373788019766529e-02 7.586373788019766529e-02 -1.093750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 4.456539021856276150e-02 4.456539021856276150e-02 4.456539021856276150e-02 -1.093750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 6.496618581033222761e-02 6.496618581033222761e-02 6.496618581033222761e-02 -1.093750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 5.404496702094296195e-02 5.404496702094296195e-02 5.404496702094296195e-02 -7.812500000000000000e-02 7.812500000000000000e-02 -3.593750000000000000e-01 4.735137505763899191e-02 4.735137505763899191e-02 4.735137505763899191e-02 -7.812500000000000000e-02 7.812500000000000000e-02 -3.281250000000000000e-01 6.042808470007769023e-02 6.042808470007769023e-02 6.042808470007769023e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 3.750511437761375882e-02 3.750511437761375882e-02 3.750511437761375882e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 5.646513631034013464e-02 5.646513631034013464e-02 5.646513631034013464e-02 -7.812500000000000000e-02 7.812500000000000000e-02 -2.968750000000000000e-01 8.115744335192977277e-02 8.115744335192977277e-02 8.115744335192977277e-02 -7.812500000000000000e-02 7.812500000000000000e-02 -2.656250000000000000e-01 1.259939258570665355e-01 1.259939258570665355e-01 1.259939258570665355e-01 -7.812500000000000000e-02 1.093750000000000000e-01 -2.968750000000000000e-01 7.308155355544410092e-02 7.308155355544410092e-02 7.308155355544410092e-02 -7.812500000000000000e-02 1.093750000000000000e-01 -2.656250000000000000e-01 8.822353360197741912e-02 8.822353360197741912e-02 8.822353360197741912e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 5.460414820768279276e-02 5.460414820768279276e-02 5.460414820768279276e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.069193180321302145e-01 1.069193180321302145e-01 1.069193180321302145e-01 -1.093750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 9.451273204286922414e-02 9.451273204286922414e-02 9.451273204286922414e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -3.906250000000000000e-01 8.974404422073556375e-02 8.974404422073556375e-02 8.974404422073556375e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -3.906250000000000000e-01 5.709577374237059105e-02 5.709577374237059105e-02 5.709577374237059105e-02 -1.562500000000000000e-02 1.406250000000000000e-01 -2.968750000000000000e-01 6.607860455192128557e-02 6.607860455192128557e-02 6.607860455192128557e-02 -1.562500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 1.158486259758300663e-01 1.158486259758300663e-01 1.158486259758300663e-01 -1.562500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 7.800137200093811007e-02 7.800137200093811007e-02 7.800137200093811007e-02 -4.687500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 1.092421261285930478e-01 1.092421261285930478e-01 1.092421261285930478e-01 -4.687500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 6.471939043637199573e-02 6.471939043637199573e-02 6.471939043637199573e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -3.593750000000000000e-01 7.280656920241206087e-02 7.280656920241206087e-02 7.280656920241206087e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -3.281250000000000000e-01 6.855725421152723820e-02 6.855725421152723820e-02 6.855725421152723820e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -3.593750000000000000e-01 9.697330941123911974e-02 9.697330941123911974e-02 9.697330941123911974e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -3.281250000000000000e-01 8.572491542462003233e-02 8.572491542462003233e-02 8.572491542462003233e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -3.593750000000000000e-01 6.086703356269862475e-02 6.086703356269862475e-02 6.086703356269862475e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -3.281250000000000000e-01 6.567489431094432339e-02 6.567489431094432339e-02 6.567489431094432339e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 6.626655179860506395e-02 6.626655179860506395e-02 6.626655179860506395e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -2.968750000000000000e-01 7.797026639556846328e-02 7.797026639556846328e-02 7.797026639556846328e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 1.146483609676954146e-01 1.146483609676954146e-01 1.146483609676954146e-01 -4.687500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 6.179758115280357955e-02 6.179758115280357955e-02 6.179758115280357955e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -2.968750000000000000e-01 8.558266303611676562e-02 8.558266303611676562e-02 8.558266303611676562e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 8.394232212419124040e-02 8.394232212419124040e-02 8.394232212419124040e-02 -7.812500000000000000e-02 1.406250000000000000e-01 -2.968750000000000000e-01 8.900066920510807389e-02 8.900066920510807389e-02 8.900066920510807389e-02 -7.812500000000000000e-02 1.406250000000000000e-01 -2.656250000000000000e-01 1.304198931112521553e-01 1.304198931112521553e-01 1.304198931112521553e-01 -7.812500000000000000e-02 1.718750000000000000e-01 -2.968750000000000000e-01 8.373175168687709002e-02 8.373175168687709002e-02 8.373175168687709002e-02 -7.812500000000000000e-02 1.718750000000000000e-01 -2.656250000000000000e-01 9.480524093579938139e-02 9.480524093579938139e-02 9.480524093579938139e-02 -1.093750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 9.975523015420122153e-02 9.975523015420122153e-02 9.975523015420122153e-02 -1.093750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 8.876921698722983756e-02 8.876921698722983756e-02 8.876921698722983756e-02 -7.812500000000000000e-02 2.031250000000000000e-01 -2.656250000000000000e-01 8.730414114738081766e-02 8.730414114738081766e-02 8.730414114738081766e-02 -7.812500000000000000e-02 2.343750000000000000e-01 -2.656250000000000000e-01 1.183471121678531940e-01 1.183471121678531940e-01 1.183471121678531940e-01 -1.093750000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 8.102161274427943649e-02 8.102161274427943649e-02 8.102161274427943649e-02 -1.093750000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 1.308078564923199627e-01 1.308078564923199627e-01 1.308078564923199627e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 1.397224664902863567e-01 1.397224664902863567e-01 1.397224664902863567e-01 -1.406250000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 7.459246367393811139e-02 7.459246367393811139e-02 7.459246367393811139e-02 -1.406250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 6.609612916406035210e-02 6.609612916406035210e-02 6.609612916406035210e-02 -1.406250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 6.478104915611518355e-02 6.478104915611518355e-02 6.478104915611518355e-02 -1.406250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 6.835138626970242715e-02 6.835138626970242715e-02 6.835138626970242715e-02 -1.406250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 5.137306445491334611e-02 5.137306445491334611e-02 5.137306445491334611e-02 -1.718750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 5.018446060023787347e-02 5.018446060023787347e-02 5.018446060023787347e-02 -1.718750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 7.650788748906096892e-02 7.650788748906096892e-02 7.650788748906096892e-02 -1.718750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 7.002942374229079170e-02 7.002942374229079170e-02 7.002942374229079170e-02 -1.718750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 1.016467527516194264e-01 1.016467527516194264e-01 1.016467527516194264e-01 -1.406250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 6.589628404877435897e-02 6.589628404877435897e-02 6.589628404877435897e-02 -1.406250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.122509909119440430e-01 1.122509909119440430e-01 1.122509909119440430e-01 -1.406250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 2.776336523670119849e-01 2.776336523670119849e-01 2.776336523670119849e-01 -1.718750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 9.762580783341141821e-02 9.762580783341141821e-02 9.762580783341141821e-02 -1.718750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.008102777672841704e-01 1.008102777672841704e-01 1.008102777672841704e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 1.127025117780692670e-01 1.127025117780692670e-01 1.127025117780692670e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 9.512989241790413553e-02 9.512989241790413553e-02 9.512989241790413553e-02 -2.031250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 1.088580760101767048e-01 1.088580760101767048e-01 1.088580760101767048e-01 -2.031250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 1.013108781544385661e-01 1.013108781544385661e-01 1.013108781544385661e-01 -2.343750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 8.794144839793253954e-02 8.794144839793253954e-02 8.794144839793253954e-02 -2.031250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 1.094968194429654512e-01 1.094968194429654512e-01 1.094968194429654512e-01 -2.343750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 1.125185293823084270e-01 1.125185293823084270e-01 1.125185293823084270e-01 -2.031250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 1.017062136586160820e-01 1.017062136586160820e-01 1.017062136586160820e-01 -2.031250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.012184722178639806e-01 1.012184722178639806e-01 1.012184722178639806e-01 -2.343750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 1.154107803734472082e-01 1.154107803734472082e-01 1.154107803734472082e-01 -2.343750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.319709321874524277e-01 1.319709321874524277e-01 1.319709321874524277e-01 -2.343750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 1.288599883356099096e-01 1.288599883356099096e-01 1.288599883356099096e-01 -2.343750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 1.123923927368625925e-01 1.123923927368625925e-01 1.123923927368625925e-01 -1.718750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.653261489605265644e-02 8.653261489605265644e-02 8.653261489605265644e-02 -1.718750000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 5.250504797194379542e-02 5.250504797194379542e-02 5.250504797194379542e-02 -1.718750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 8.701321232571875008e-02 8.701321232571875008e-02 8.701321232571875008e-02 -1.406250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 1.075998571320335301e-01 1.075998571320335301e-01 1.075998571320335301e-01 -1.406250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 1.440207884218303591e-01 1.440207884218303591e-01 1.440207884218303591e-01 -1.406250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 9.320848302010788233e-02 9.320848302010788233e-02 9.320848302010788233e-02 -1.406250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 1.082474486162484650e-01 1.082474486162484650e-01 1.082474486162484650e-01 -1.718750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 1.143703853933552284e-01 1.143703853933552284e-01 1.143703853933552284e-01 -1.718750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 8.638313082923930464e-02 8.638313082923930464e-02 8.638313082923930464e-02 -1.718750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 8.697945808492082986e-02 8.697945808492082986e-02 8.697945808492082986e-02 -1.718750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 1.626112773462865257e-01 1.626112773462865257e-01 1.626112773462865257e-01 -1.406250000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 7.752811539199140622e-02 7.752811539199140622e-02 7.752811539199140622e-02 -1.406250000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 1.346432116110705679e-01 1.346432116110705679e-01 1.346432116110705679e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -3.593750000000000000e-01 5.527427611339363195e-02 5.527427611339363195e-02 5.527427611339363195e-02 -1.718750000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 9.775437832698735674e-02 9.775437832698735674e-02 9.775437832698735674e-02 -1.718750000000000000e-01 2.343750000000000000e-01 -3.593750000000000000e-01 5.920842135979336590e-02 5.920842135979336590e-02 5.920842135979336590e-02 -1.718750000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 1.202695279853091270e-01 1.202695279853091270e-01 1.202695279853091270e-01 -1.406250000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 1.107686670508062077e-01 1.107686670508062077e-01 1.107686670508062077e-01 -1.406250000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 8.780562924324566976e-02 8.780562924324566976e-02 8.780562924324566976e-02 -1.406250000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 1.411962256833090568e-01 1.411962256833090568e-01 1.411962256833090568e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 1.480819776551932088e-01 1.480819776551932088e-01 1.480819776551932088e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 9.497158480438799844e-02 9.497158480438799844e-02 9.497158480438799844e-02 -1.718750000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 8.704375186469892611e-02 8.704375186469892611e-02 8.704375186469892611e-02 -1.718750000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 8.249725131893846652e-02 8.249725131893846652e-02 8.249725131893846652e-02 -1.718750000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 1.220713996431809778e-01 1.220713996431809778e-01 1.220713996431809778e-01 -2.031250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 9.141962649893871362e-02 9.141962649893871362e-02 9.141962649893871362e-02 -2.031250000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 5.180273604511535790e-02 5.180273604511535790e-02 5.180273604511535790e-02 -2.031250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 1.096245675210012760e-01 1.096245675210012760e-01 1.096245675210012760e-01 -2.343750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.158824186857231708e-02 8.158824186857231708e-02 8.158824186857231708e-02 -2.343750000000000000e-01 1.718750000000000000e-01 -3.593750000000000000e-01 5.325237831523722126e-02 5.325237831523722126e-02 5.325237831523722126e-02 -2.343750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 9.716938092185925524e-02 9.716938092185925524e-02 9.716938092185925524e-02 -2.031250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 8.848874101142488457e-02 8.848874101142488457e-02 8.848874101142488457e-02 -2.031250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 5.663397139550360726e-02 5.663397139550360726e-02 5.663397139550360726e-02 -2.343750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 1.568284582492041057e-01 1.568284582492041057e-01 1.568284582492041057e-01 -2.343750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 7.765294030795019675e-02 7.765294030795019675e-02 7.765294030795019675e-02 -2.031250000000000000e-01 2.031250000000000000e-01 -3.593750000000000000e-01 4.478000325143925708e-02 4.478000325143925708e-02 4.478000325143925708e-02 -2.031250000000000000e-01 2.343750000000000000e-01 -3.593750000000000000e-01 5.928608289486995975e-02 5.928608289486995975e-02 5.928608289486995975e-02 -2.343750000000000000e-01 2.031250000000000000e-01 -3.593750000000000000e-01 5.478874548592274629e-02 5.478874548592274629e-02 5.478874548592274629e-02 -2.343750000000000000e-01 2.343750000000000000e-01 -3.593750000000000000e-01 7.148532902448369308e-02 7.148532902448369308e-02 7.148532902448369308e-02 -2.343750000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 1.348881861970788743e-01 1.348881861970788743e-01 1.348881861970788743e-01 -2.031250000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 7.710251964766033639e-02 7.710251964766033639e-02 7.710251964766033639e-02 -2.343750000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 7.176248821981161263e-02 7.176248821981161263e-02 7.176248821981161263e-02 -1.562500000000000000e-02 1.562500000000000000e-02 -2.031250000000000000e-01 1.157080336109315710e-01 1.157080336109315710e-01 1.157080336109315710e-01 -4.687500000000000000e-02 1.562500000000000000e-02 -2.343750000000000000e-01 8.576027756126079760e-02 8.576027756126079760e-02 8.576027756126079760e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -2.031250000000000000e-01 1.276848186763642479e-01 1.276848186763642479e-01 1.276848186763642479e-01 -4.687500000000000000e-02 4.687500000000000000e-02 -2.031250000000000000e-01 1.440978862703222174e-01 1.440978862703222174e-01 1.440978862703222174e-01 -1.562500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 3.590295665212949600e-02 3.590295665212949600e-02 3.590295665212949600e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 8.456760055638699869e-02 8.456760055638699869e-02 8.456760055638699869e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 2.502491484266122237e-04 2.502491484266122237e-04 2.502491484266122237e-04 -4.687500000000000000e-02 1.562500000000000000e-02 -1.718750000000000000e-01 1.284495243287717137e-01 1.284495243287717137e-01 1.284495243287717137e-01 -4.687500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 1.122228712012406510e-01 1.122228712012406510e-01 1.122228712012406510e-01 -4.687500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 1.184828797736243999e-01 1.184828797736243999e-01 1.184828797736243999e-01 -4.687500000000000000e-02 4.687500000000000000e-02 -1.406250000000000000e-01 8.828139711133438372e-02 8.828139711133438372e-02 8.828139711133438372e-02 -1.562500000000000000e-02 1.093750000000000000e-01 -2.031250000000000000e-01 1.818500900070359472e-01 1.818500900070359472e-01 1.818500900070359472e-01 -4.687500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 1.579397681619524596e-01 1.579397681619524596e-01 1.579397681619524596e-01 -4.687500000000000000e-02 1.093750000000000000e-01 -2.343750000000000000e-01 7.605222491667126827e-02 7.605222491667126827e-02 7.605222491667126827e-02 -4.687500000000000000e-02 1.093750000000000000e-01 -2.031250000000000000e-01 1.649661996809963782e-01 1.649661996809963782e-01 1.649661996809963782e-01 -1.562500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 1.249094865799558196e-01 1.249094865799558196e-01 1.249094865799558196e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -1.718750000000000000e-01 1.561226400087501742e-01 1.561226400087501742e-01 1.561226400087501742e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -1.406250000000000000e-01 9.469273764128767479e-02 9.469273764128767479e-02 9.469273764128767479e-02 -4.687500000000000000e-02 7.812500000000000000e-02 -1.718750000000000000e-01 1.435019822283215285e-01 1.435019822283215285e-01 1.435019822283215285e-01 -7.812500000000000000e-02 1.562500000000000000e-02 -2.031250000000000000e-01 1.274092979469071962e-01 1.274092979469071962e-01 1.274092979469071962e-01 -7.812500000000000000e-02 4.687500000000000000e-02 -2.031250000000000000e-01 9.904248261863549119e-02 9.904248261863549119e-02 9.904248261863549119e-02 -1.093750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 9.802035788338490929e-02 9.802035788338490929e-02 9.802035788338490929e-02 -1.093750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 1.281338431494150609e-01 1.281338431494150609e-01 1.281338431494150609e-01 -1.093750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 8.939124331291971315e-02 8.939124331291971315e-02 8.939124331291971315e-02 -7.812500000000000000e-02 1.562500000000000000e-02 -1.718750000000000000e-01 1.165242692849445399e-01 1.165242692849445399e-01 1.165242692849445399e-01 -7.812500000000000000e-02 1.562500000000000000e-02 -1.406250000000000000e-01 7.472492919742838857e-02 7.472492919742838857e-02 7.472492919742838857e-02 -7.812500000000000000e-02 4.687500000000000000e-02 -1.718750000000000000e-01 7.216874014089728895e-02 7.216874014089728895e-02 7.216874014089728895e-02 -1.093750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 1.048157971464860061e-01 1.048157971464860061e-01 1.048157971464860061e-01 -1.093750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.065963210730047905e-01 1.065963210730047905e-01 1.065963210730047905e-01 -1.093750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 7.476150186119442931e-02 7.476150186119442931e-02 7.476150186119442931e-02 -7.812500000000000000e-02 7.812500000000000000e-02 -2.343750000000000000e-01 7.114048634926321835e-02 7.114048634926321835e-02 7.114048634926321835e-02 -7.812500000000000000e-02 7.812500000000000000e-02 -2.031250000000000000e-01 7.661028863632640684e-02 7.661028863632640684e-02 7.661028863632640684e-02 -7.812500000000000000e-02 1.093750000000000000e-01 -2.343750000000000000e-01 7.795555753922729647e-02 7.795555753922729647e-02 7.795555753922729647e-02 -7.812500000000000000e-02 1.093750000000000000e-01 -2.031250000000000000e-01 8.510848659120384685e-02 8.510848659120384685e-02 8.510848659120384685e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 8.013605585983599178e-02 8.013605585983599178e-02 8.013605585983599178e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 6.383727166173809586e-02 6.383727166173809586e-02 6.383727166173809586e-02 -1.093750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 8.556739299074861416e-02 8.556739299074861416e-02 8.556739299074861416e-02 -1.093750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 9.491694047969997938e-02 9.491694047969997938e-02 9.491694047969997938e-02 -1.093750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.575567534010336168e-01 1.575567534010336168e-01 1.575567534010336168e-01 -1.093750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.023120695843503791e-01 1.023120695843503791e-01 1.023120695843503791e-01 -1.562500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 4.898024057333599801e-02 4.898024057333599801e-02 4.898024057333599801e-02 -1.562500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 5.951070600188348297e-02 5.951070600188348297e-02 5.951070600188348297e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 7.446289160379668259e-02 7.446289160379668259e-02 7.446289160379668259e-02 -4.687500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 5.499505013107451601e-02 5.499505013107451601e-02 5.499505013107451601e-02 -4.687500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 1.918490195188906622e-01 1.918490195188906622e-01 1.918490195188906622e-01 -1.562500000000000000e-02 1.562500000000000000e-02 -4.687500000000000000e-02 1.012449887148662853e-01 1.012449887148662853e-01 1.012449887148662853e-01 -1.562500000000000000e-02 1.562500000000000000e-02 -1.562500000000000000e-02 3.014667541993162891e-01 3.014667541993162891e-01 3.014667541993162891e-01 -1.562500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 9.911399872173713710e-02 9.911399872173713710e-02 9.911399872173713710e-02 -4.687500000000000000e-02 4.687500000000000000e-02 -4.687500000000000000e-02 1.869287736018127866e-01 1.869287736018127866e-01 1.869287736018127866e-01 -1.562500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 1.029267595943387098e-01 1.029267595943387098e-01 1.029267595943387098e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -1.093750000000000000e-01 1.317877970745240379e-01 1.317877970745240379e-01 1.317877970745240379e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -7.812500000000000000e-02 1.641311856699468885e-01 1.641311856699468885e-01 1.641311856699468885e-01 -4.687500000000000000e-02 7.812500000000000000e-02 -7.812500000000000000e-02 7.369578874346803810e-01 7.369578874346803810e-01 7.369578874346803810e-01 -1.562500000000000000e-02 7.812500000000000000e-02 -4.687500000000000000e-02 2.283152757936874333e-01 2.283152757936874333e-01 2.283152757936874333e-01 -1.562500000000000000e-02 7.812500000000000000e-02 -1.562500000000000000e-02 2.083420893876253011e-01 2.083420893876253011e-01 2.083420893876253011e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -4.687500000000000000e-02 5.378031303616620518e-01 5.378031303616620518e-01 5.378031303616620518e-01 -1.562500000000000000e-02 1.093750000000000000e-01 -1.562500000000000000e-02 6.028757589804837336e-01 6.028757589804837336e-01 6.028757589804837336e-01 -4.687500000000000000e-02 7.812500000000000000e-02 -4.687500000000000000e-02 9.460434208524695632e-02 9.460434208524695632e-02 9.460434208524695632e-02 -4.687500000000000000e-02 1.093750000000000000e-01 -4.687500000000000000e-02 5.418916405465322716e-01 5.418916405465322716e-01 5.418916405465322716e-01 -7.812500000000000000e-02 1.562500000000000000e-02 -1.093750000000000000e-01 9.405307306246699084e-02 9.405307306246699084e-02 9.405307306246699084e-02 -7.812500000000000000e-02 1.562500000000000000e-02 -7.812500000000000000e-02 8.659851638569113219e-02 8.659851638569113219e-02 8.659851638569113219e-02 -7.812500000000000000e-02 4.687500000000000000e-02 -1.093750000000000000e-01 5.495126890623830418e-01 5.495126890623830418e-01 5.495126890623830418e-01 -7.812500000000000000e-02 4.687500000000000000e-02 -7.812500000000000000e-02 6.873236839004849275e-01 6.873236839004849275e-01 6.873236839004849275e-01 -1.093750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.021810958118720691e-01 1.021810958118720691e-01 1.021810958118720691e-01 -1.093750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 5.124458914687406441e-01 5.124458914687406441e-01 5.124458914687406441e-01 -1.093750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.630665302367190206e-01 1.630665302367190206e-01 1.630665302367190206e-01 -1.093750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 3.914558014885638482e-01 3.914558014885638482e-01 3.914558014885638482e-01 -7.812500000000000000e-02 7.812500000000000000e-02 -1.093750000000000000e-01 6.621491851603438228e-01 6.621491851603438228e-01 6.621491851603438228e-01 -7.812500000000000000e-02 7.812500000000000000e-02 -7.812500000000000000e-02 7.101521550668429272e-01 7.101521550668429272e-01 7.101521550668429272e-01 -7.812500000000000000e-02 1.093750000000000000e-01 -7.812500000000000000e-02 5.163038660969172522e-01 5.163038660969172522e-01 5.163038660969172522e-01 -1.093750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 8.883204224898458845e-01 8.883204224898458845e-01 8.883204224898458845e-01 -1.093750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 7.494937717373659769e-01 7.494937717373659769e-01 7.494937717373659769e-01 -1.093750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.099934580577247356e-01 7.099934580577247356e-01 7.099934580577247356e-01 -1.093750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 5.335689537863390619e-01 5.335689537863390619e-01 5.335689537863390619e-01 -1.562500000000000000e-02 1.406250000000000000e-01 -2.031250000000000000e-01 7.822039691787695259e-02 7.822039691787695259e-02 7.822039691787695259e-02 -1.562500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 6.037494439136891627e-02 6.037494439136891627e-02 6.037494439136891627e-02 -4.687500000000000000e-02 1.406250000000000000e-01 -2.343750000000000000e-01 1.084201923622385849e-01 1.084201923622385849e-01 1.084201923622385849e-01 -4.687500000000000000e-02 1.406250000000000000e-01 -2.031250000000000000e-01 9.364323504361932171e-02 9.364323504361932171e-02 9.364323504361932171e-02 -4.687500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 6.925411449082161108e-02 6.925411449082161108e-02 6.925411449082161108e-02 -4.687500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 1.028568539083085653e-01 1.028568539083085653e-01 1.028568539083085653e-01 -1.562500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 7.439288080164517536e-02 7.439288080164517536e-02 7.439288080164517536e-02 -1.562500000000000000e-02 1.406250000000000000e-01 -1.406250000000000000e-01 8.021152709788570423e-02 8.021152709788570423e-02 8.021152709788570423e-02 -1.562500000000000000e-02 1.718750000000000000e-01 -1.718750000000000000e-01 9.391003179501908327e-02 9.391003179501908327e-02 9.391003179501908327e-02 -1.562500000000000000e-02 1.718750000000000000e-01 -1.406250000000000000e-01 1.000027216208359965e-01 1.000027216208359965e-01 1.000027216208359965e-01 -4.687500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 8.043086749329102225e-02 8.043086749329102225e-02 8.043086749329102225e-02 -4.687500000000000000e-02 1.406250000000000000e-01 -1.406250000000000000e-01 8.478540205675832997e-02 8.478540205675832997e-02 8.478540205675832997e-02 -4.687500000000000000e-02 1.718750000000000000e-01 -1.718750000000000000e-01 6.367833972874827053e-02 6.367833972874827053e-02 6.367833972874827053e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -2.343750000000000000e-01 6.049561545020676334e-02 6.049561545020676334e-02 6.049561545020676334e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -2.031250000000000000e-01 5.579188278543969343e-02 5.579188278543969343e-02 5.579188278543969343e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 2.040488075934248913e-01 2.040488075934248913e-01 2.040488075934248913e-01 -1.562500000000000000e-02 2.343750000000000000e-01 -2.031250000000000000e-01 1.765045636851602651e-01 1.765045636851602651e-01 1.765045636851602651e-01 -1.562500000000000000e-02 2.031250000000000000e-01 -1.718750000000000000e-01 6.175521433870653082e-02 6.175521433870653082e-02 6.175521433870653082e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 1.005547534154894174e-01 1.005547534154894174e-01 1.005547534154894174e-01 -1.562500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 1.159474421767104080e-01 1.159474421767104080e-01 1.159474421767104080e-01 -1.562500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 8.356699199093098329e-02 8.356699199093098329e-02 8.356699199093098329e-02 -4.687500000000000000e-02 2.031250000000000000e-01 -1.406250000000000000e-01 8.468654757432511615e-02 8.468654757432511615e-02 8.468654757432511615e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 4.166938504809593324e-02 4.166938504809593324e-02 4.166938504809593324e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 7.692633279958814574e-02 7.692633279958814574e-02 7.692633279958814574e-02 -7.812500000000000000e-02 1.406250000000000000e-01 -2.343750000000000000e-01 9.838919212729302366e-02 9.838919212729302366e-02 9.838919212729302366e-02 -7.812500000000000000e-02 1.406250000000000000e-01 -2.031250000000000000e-01 1.405183801212502581e-01 1.405183801212502581e-01 1.405183801212502581e-01 -7.812500000000000000e-02 1.718750000000000000e-01 -2.343750000000000000e-01 7.466440341188246288e-02 7.466440341188246288e-02 7.466440341188246288e-02 -7.812500000000000000e-02 1.718750000000000000e-01 -2.031250000000000000e-01 1.606079734366697154e-01 1.606079734366697154e-01 1.606079734366697154e-01 -7.812500000000000000e-02 1.406250000000000000e-01 -1.718750000000000000e-01 7.547261582336048380e-02 7.547261582336048380e-02 7.547261582336048380e-02 -7.812500000000000000e-02 1.406250000000000000e-01 -1.406250000000000000e-01 1.182507089950784462e-01 1.182507089950784462e-01 1.182507089950784462e-01 -1.093750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.152452821490634743e-01 1.152452821490634743e-01 1.152452821490634743e-01 -1.093750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.380832290481230906e-01 1.380832290481230906e-01 1.380832290481230906e-01 -1.093750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.005226119301284304e-01 1.005226119301284304e-01 1.005226119301284304e-01 -1.093750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 1.173429067860440461e-01 1.173429067860440461e-01 1.173429067860440461e-01 -7.812500000000000000e-02 2.343750000000000000e-01 -2.343750000000000000e-01 1.382302076046826589e-01 1.382302076046826589e-01 1.382302076046826589e-01 -1.093750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 1.621247079170118344e-01 1.621247079170118344e-01 1.621247079170118344e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 1.800768499563602520e-01 1.800768499563602520e-01 1.800768499563602520e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 2.132955296822083568e-01 2.132955296822083568e-01 2.132955296822083568e-01 -7.812500000000000000e-02 2.343750000000000000e-01 -1.718750000000000000e-01 9.873472158432913814e-02 9.873472158432913814e-02 9.873472158432913814e-02 -7.812500000000000000e-02 2.343750000000000000e-01 -1.406250000000000000e-01 7.302898427209593424e-02 7.302898427209593424e-02 7.302898427209593424e-02 -1.093750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 4.623290797406198055e-02 4.623290797406198055e-02 4.623290797406198055e-02 -1.093750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 1.553003820543031877e-01 1.553003820543031877e-01 1.553003820543031877e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 7.295656078421330903e-02 7.295656078421330903e-02 7.295656078421330903e-02 -1.562500000000000000e-02 1.406250000000000000e-01 -1.093750000000000000e-01 1.084740240584607662e-01 1.084740240584607662e-01 1.084740240584607662e-01 -1.562500000000000000e-02 1.406250000000000000e-01 -7.812500000000000000e-02 1.439717991255381468e-01 1.439717991255381468e-01 1.439717991255381468e-01 -1.562500000000000000e-02 1.718750000000000000e-01 -1.093750000000000000e-01 1.045859974149086213e-01 1.045859974149086213e-01 1.045859974149086213e-01 -1.562500000000000000e-02 1.718750000000000000e-01 -7.812500000000000000e-02 1.284961133037896830e-01 1.284961133037896830e-01 1.284961133037896830e-01 -4.687500000000000000e-02 1.406250000000000000e-01 -1.093750000000000000e-01 1.170906484243619955e-01 1.170906484243619955e-01 1.170906484243619955e-01 -4.687500000000000000e-02 1.718750000000000000e-01 -1.093750000000000000e-01 1.107301021630820587e-01 1.107301021630820587e-01 1.107301021630820587e-01 -1.562500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 3.139063840763666735e-01 3.139063840763666735e-01 3.139063840763666735e-01 -1.562500000000000000e-02 1.406250000000000000e-01 -1.562500000000000000e-02 7.715412202931498653e-01 7.715412202931498653e-01 7.715412202931498653e-01 -1.562500000000000000e-02 1.718750000000000000e-01 -1.562500000000000000e-02 5.488534573326504518e-01 5.488534573326504518e-01 5.488534573326504518e-01 -4.687500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 6.266773846558802985e-01 6.266773846558802985e-01 6.266773846558802985e-01 -4.687500000000000000e-02 1.718750000000000000e-01 -4.687500000000000000e-02 7.107733830613049975e-01 7.107733830613049975e-01 7.107733830613049975e-01 -1.562500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 1.063367977011549087e-01 1.063367977011549087e-01 1.063367977011549087e-01 -1.562500000000000000e-02 2.031250000000000000e-01 -7.812500000000000000e-02 1.079035669386979590e-01 1.079035669386979590e-01 1.079035669386979590e-01 -1.562500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 8.984449977711822521e-02 8.984449977711822521e-02 8.984449977711822521e-02 -1.562500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 8.365218485145003990e-02 8.365218485145003990e-02 8.365218485145003990e-02 -4.687500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 9.415191603687839139e-02 9.415191603687839139e-02 9.415191603687839139e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 7.961852540962688352e-02 7.961852540962688352e-02 7.961852540962688352e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 7.787325219513166474e-02 7.787325219513166474e-02 7.787325219513166474e-02 -1.562500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 4.242400035109711309e-01 4.242400035109711309e-01 4.242400035109711309e-01 -1.562500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 8.039574413563305155e-02 8.039574413563305155e-02 8.039574413563305155e-02 -4.687500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 3.443653772756071763e-01 3.443653772756071763e-01 3.443653772756071763e-01 -4.687500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 8.111002322502518236e-02 8.111002322502518236e-02 8.111002322502518236e-02 -4.687500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 1.526432429858897155e-01 1.526432429858897155e-01 1.526432429858897155e-01 -7.812500000000000000e-02 1.406250000000000000e-01 -1.093750000000000000e-01 1.269233188501550369e-01 1.269233188501550369e-01 1.269233188501550369e-01 -7.812500000000000000e-02 1.718750000000000000e-01 -1.093750000000000000e-01 1.013462334412254390e-01 1.013462334412254390e-01 1.013462334412254390e-01 -1.093750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 3.645691267798553681e-01 3.645691267798553681e-01 3.645691267798553681e-01 -1.093750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 3.458201718894182153e-01 3.458201718894182153e-01 3.458201718894182153e-01 -1.093750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 8.992325684561219834e-02 8.992325684561219834e-02 8.992325684561219834e-02 -1.093750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 2.765592729362295055e-01 2.765592729362295055e-01 2.765592729362295055e-01 -7.812500000000000000e-02 1.406250000000000000e-01 -4.687500000000000000e-02 5.104137052891141169e-01 5.104137052891141169e-01 5.104137052891141169e-01 -7.812500000000000000e-02 1.718750000000000000e-01 -4.687500000000000000e-02 2.271608125263924194e-01 2.271608125263924194e-01 2.271608125263924194e-01 -1.093750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 2.663319056423266162e-01 2.663319056423266162e-01 2.663319056423266162e-01 -1.093750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.986068439914101535e-01 1.986068439914101535e-01 1.986068439914101535e-01 -7.812500000000000000e-02 2.031250000000000000e-01 -1.093750000000000000e-01 8.535361205149458175e-02 8.535361205149458175e-02 8.535361205149458175e-02 -7.812500000000000000e-02 2.343750000000000000e-01 -1.093750000000000000e-01 9.030579008163301669e-02 9.030579008163301669e-02 9.030579008163301669e-02 -7.812500000000000000e-02 2.343750000000000000e-01 -7.812500000000000000e-02 7.034838757727993053e-02 7.034838757727993053e-02 7.034838757727993053e-02 -1.093750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 3.856580356521363551e-02 3.856580356521363551e-02 3.856580356521363551e-02 -1.093750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.322713371278747829e-01 1.322713371278747829e-01 1.322713371278747829e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 8.493408539919078404e-02 8.493408539919078404e-02 8.493408539919078404e-02 -1.093750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 7.515873618427523772e-02 7.515873618427523772e-02 7.515873618427523772e-02 -7.812500000000000000e-02 2.031250000000000000e-01 -4.687500000000000000e-02 1.341026584922267728e-01 1.341026584922267728e-01 1.341026584922267728e-01 -7.812500000000000000e-02 2.031250000000000000e-01 -1.562500000000000000e-02 1.650376572082269400e-01 1.650376572082269400e-01 1.650376572082269400e-01 -7.812500000000000000e-02 2.343750000000000000e-01 -4.687500000000000000e-02 9.620187587857120803e-02 9.620187587857120803e-02 9.620187587857120803e-02 -7.812500000000000000e-02 2.343750000000000000e-01 -1.562500000000000000e-02 1.041818375534327712e-01 1.041818375534327712e-01 1.041818375534327712e-01 -1.093750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 9.642286019859014345e-02 9.642286019859014345e-02 9.642286019859014345e-02 -1.093750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 1.168472263891807278e-01 1.168472263891807278e-01 1.168472263891807278e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 1.011212449874179659e-01 1.011212449874179659e-01 1.011212449874179659e-01 -1.093750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 8.376148876678439492e-02 8.376148876678439492e-02 8.376148876678439492e-02 -1.406250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.035446589365081188e-01 1.035446589365081188e-01 1.035446589365081188e-01 -1.406250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 1.129130064047949994e-01 1.129130064047949994e-01 1.129130064047949994e-01 -1.406250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 5.954841110762000567e-02 5.954841110762000567e-02 5.954841110762000567e-02 -1.406250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 8.694088179239541081e-02 8.694088179239541081e-02 8.694088179239541081e-02 -1.406250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 9.213726329507282431e-02 9.213726329507282431e-02 9.213726329507282431e-02 -1.406250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.428040782171440537e-01 1.428040782171440537e-01 1.428040782171440537e-01 -1.406250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.394244988167309129e-01 1.394244988167309129e-01 1.394244988167309129e-01 -1.406250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 2.473635335903115184e-01 2.473635335903115184e-01 2.473635335903115184e-01 -1.718750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 9.815214199039122567e-02 9.815214199039122567e-02 9.815214199039122567e-02 -1.718750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 7.807523771845462091e-02 7.807523771845462091e-02 7.807523771845462091e-02 -1.718750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.118163394282055412e-01 1.118163394282055412e-01 1.118163394282055412e-01 -1.718750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.399087961188552887e-01 1.399087961188552887e-01 1.399087961188552887e-01 -1.406250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 6.850331541475503105e-02 6.850331541475503105e-02 6.850331541475503105e-02 -1.406250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 6.499657294083688308e-02 6.499657294083688308e-02 6.499657294083688308e-02 -1.718750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 1.172987214613586265e-01 1.172987214613586265e-01 1.172987214613586265e-01 -1.406250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.245423804908187548e-01 1.245423804908187548e-01 1.245423804908187548e-01 -1.406250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 4.992293671495165452e-01 4.992293671495165452e-01 4.992293671495165452e-01 -1.406250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.311909986164173647e-01 1.311909986164173647e-01 1.311909986164173647e-01 -1.406250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.905929005109856522e-01 1.905929005109856522e-01 1.905929005109856522e-01 -1.718750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 1.077878680999213856e-01 1.077878680999213856e-01 1.077878680999213856e-01 -1.718750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.290800797194580629e-01 1.290800797194580629e-01 1.290800797194580629e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.685614783265106109e-01 1.685614783265106109e-01 1.685614783265106109e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.465111721979022452e-01 1.465111721979022452e-01 1.465111721979022452e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.127941011108083980e-01 1.127941011108083980e-01 1.127941011108083980e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 1.058675644640279939e-01 1.058675644640279939e-01 1.058675644640279939e-01 -2.343750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.028801558104008584e-01 1.028801558104008584e-01 1.028801558104008584e-01 -2.343750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 8.534075302950576425e-02 8.534075302950576425e-02 8.534075302950576425e-02 -2.343750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 1.013928381137092910e-01 1.013928381137092910e-01 1.013928381137092910e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 1.664154101561352295e-01 1.664154101561352295e-01 1.664154101561352295e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 9.760009371005491652e-02 9.760009371005491652e-02 9.760009371005491652e-02 -2.031250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.500269713624745593e-01 1.500269713624745593e-01 1.500269713624745593e-01 -2.031250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.172007102909023019e-01 1.172007102909023019e-01 1.172007102909023019e-01 -2.343750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 8.071217529664502510e-02 8.071217529664502510e-02 8.071217529664502510e-02 -2.343750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 7.312946070117011532e-02 7.312946070117011532e-02 7.312946070117011532e-02 -2.343750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 7.645749064422398267e-02 7.645749064422398267e-02 7.645749064422398267e-02 -2.343750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 6.450587565186542693e-02 6.450587565186542693e-02 6.450587565186542693e-02 -2.343750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 9.129988580566893164e-02 9.129988580566893164e-02 9.129988580566893164e-02 -2.343750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 1.049764958694648920e-01 1.049764958694648920e-01 1.049764958694648920e-01 -2.343750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 9.826303332780990385e-02 9.826303332780990385e-02 9.826303332780990385e-02 -2.031250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 8.748978854726369159e-02 8.748978854726369159e-02 8.748978854726369159e-02 -2.031250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 8.148616854798219900e-02 8.148616854798219900e-02 8.148616854798219900e-02 -2.031250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.890646628263037143e-01 1.890646628263037143e-01 1.890646628263037143e-01 -2.031250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 1.311050528479391353e-01 1.311050528479391353e-01 1.311050528479391353e-01 -2.343750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 7.022274748778163656e-02 7.022274748778163656e-02 7.022274748778163656e-02 -2.343750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 5.308393813917419018e-02 5.308393813917419018e-02 5.308393813917419018e-02 -2.343750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 9.452478600177197099e-02 9.452478600177197099e-02 9.452478600177197099e-02 -2.343750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 6.884077393913880238e-02 6.884077393913880238e-02 6.884077393913880238e-02 -1.406250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 7.151194524496897742e-01 7.151194524496897742e-01 7.151194524496897742e-01 -1.718750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.867810813076470899e-01 1.867810813076470899e-01 1.867810813076470899e-01 -1.718750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.787081612637220762e-01 1.787081612637220762e-01 1.787081612637220762e-01 -1.718750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 8.104466340477191055e-01 8.104466340477191055e-01 8.104466340477191055e-01 -1.406250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 2.568426647860071466e-01 2.568426647860071466e-01 2.568426647860071466e-01 -1.406250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 2.106964760030376471e-01 2.106964760030376471e-01 2.106964760030376471e-01 -1.406250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 5.692383985682427650e-01 5.692383985682427650e-01 5.692383985682427650e-01 -1.718750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.916210735005005883e-01 1.916210735005005883e-01 1.916210735005005883e-01 -1.718750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 4.249074598314681039e-01 4.249074598314681039e-01 4.249074598314681039e-01 -1.718750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 6.612442577743425642e-02 6.612442577743425642e-02 6.612442577743425642e-02 -1.406250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 8.603146000122260384e-01 8.603146000122260384e-01 8.603146000122260384e-01 -1.406250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.821419919825433054e-01 7.821419919825433054e-01 7.821419919825433054e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 5.302648945160904903e-01 5.302648945160904903e-01 5.302648945160904903e-01 -1.406250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 6.021027727415368958e-01 6.021027727415368958e-01 6.021027727415368958e-01 -1.718750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 8.712347673256273239e-01 8.712347673256273239e-01 8.712347673256273239e-01 -1.718750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 5.692368008290381587e-01 5.692368008290381587e-01 5.692368008290381587e-01 -1.718750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 4.772343239855363906e-01 4.772343239855363906e-01 4.772343239855363906e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.509962384503623634e-01 1.509962384503623634e-01 1.509962384503623634e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.770873789698824419e-01 1.770873789698824419e-01 1.770873789698824419e-01 -2.031250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.174393110465863227e-01 1.174393110465863227e-01 1.174393110465863227e-01 -2.031250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 2.357575159266331599e-01 2.357575159266331599e-01 2.357575159266331599e-01 -2.343750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.012739157925411360e-01 1.012739157925411360e-01 1.012739157925411360e-01 -2.343750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 9.708420237349082993e-02 9.708420237349082993e-02 9.708420237349082993e-02 -2.343750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.035526940072171304e-01 1.035526940072171304e-01 1.035526940072171304e-01 -2.031250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.235366458190799571e-01 1.235366458190799571e-01 1.235366458190799571e-01 -2.031250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 2.540693785803317395e-01 2.540693785803317395e-01 2.540693785803317395e-01 -2.031250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 1.361323243020656215e-01 1.361323243020656215e-01 1.361323243020656215e-01 -2.343750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.468500704484120012e-01 1.468500704484120012e-01 1.468500704484120012e-01 -2.343750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.182466921937127269e-01 1.182466921937127269e-01 1.182466921937127269e-01 -2.343750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.001296812335941699e-01 1.001296812335941699e-01 1.001296812335941699e-01 -2.343750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 1.198678569345674599e-01 1.198678569345674599e-01 1.198678569345674599e-01 -2.031250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 6.706520211804860299e-02 6.706520211804860299e-02 6.706520211804860299e-02 -2.031250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 1.588936837916432310e-01 1.588936837916432310e-01 1.588936837916432310e-01 -2.031250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.540332532452247105e-01 1.540332532452247105e-01 1.540332532452247105e-01 -2.343750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 4.072316523520676940e-02 4.072316523520676940e-02 4.072316523520676940e-02 -2.343750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 7.780099382069442793e-02 7.780099382069442793e-02 7.780099382069442793e-02 -2.343750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.281999289771055872e-02 7.281999289771055872e-02 7.281999289771055872e-02 -2.343750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.171115360894380009e-01 1.171115360894380009e-01 1.171115360894380009e-01 -2.031250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 3.893332852209080985e-01 3.893332852209080985e-01 3.893332852209080985e-01 -2.031250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 4.423721993144377196e-01 4.423721993144377196e-01 4.423721993144377196e-01 -2.031250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 5.742415633001781705e-01 5.742415633001781705e-01 5.742415633001781705e-01 -2.343750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.042943275796144459e-01 1.042943275796144459e-01 1.042943275796144459e-01 -1.406250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 7.638121210612687506e-02 7.638121210612687506e-02 7.638121210612687506e-02 -1.406250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 2.103722905252941311e-01 2.103722905252941311e-01 2.103722905252941311e-01 -1.718750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 1.432080441077048238e-01 1.432080441077048238e-01 1.432080441077048238e-01 -1.406250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 9.562651021968184006e-02 9.562651021968184006e-02 9.562651021968184006e-02 -1.406250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.792050661850608795e-01 1.792050661850608795e-01 1.792050661850608795e-01 -1.406250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 9.365127110327582660e-02 9.365127110327582660e-02 9.365127110327582660e-02 -1.718750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.916555864954817556e-01 1.916555864954817556e-01 1.916555864954817556e-01 -1.718750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 6.757308654152835437e-02 6.757308654152835437e-02 6.757308654152835437e-02 -1.406250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 2.316550230832696011e-01 2.316550230832696011e-01 2.316550230832696011e-01 -1.406250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 1.460823273418845603e-01 1.460823273418845603e-01 1.460823273418845603e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 1.391401836195824415e-01 1.391401836195824415e-01 1.391401836195824415e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 1.627381381990130882e-01 1.627381381990130882e-01 1.627381381990130882e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 1.014265863079549662e-01 1.014265863079549662e-01 1.014265863079549662e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 8.501766942778654634e-02 8.501766942778654634e-02 8.501766942778654634e-02 -1.718750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 1.213893762856449315e-01 1.213893762856449315e-01 1.213893762856449315e-01 -1.718750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 5.680674559919149380e-02 5.680674559919149380e-02 5.680674559919149380e-02 -1.406250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 5.714192167243838799e-02 5.714192167243838799e-02 5.714192167243838799e-02 -1.406250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 4.700932358276274647e-02 4.700932358276274647e-02 4.700932358276274647e-02 -1.406250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 5.932547639849083954e-02 5.932547639849083954e-02 5.932547639849083954e-02 -1.406250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 1.394477901301646450e-01 1.394477901301646450e-01 1.394477901301646450e-01 -1.718750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 6.190795986347488733e-02 6.190795986347488733e-02 6.190795986347488733e-02 -1.718750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 1.303243076431554459e-01 1.303243076431554459e-01 1.303243076431554459e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 5.577982302202552645e-02 5.577982302202552645e-02 5.577982302202552645e-02 -2.343750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.793808686451986434e-01 1.793808686451986434e-01 1.793808686451986434e-01 -2.343750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 1.012883793274783201e-01 1.012883793274783201e-01 1.012883793274783201e-01 -2.031250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.867345260717589994e-01 1.867345260717589994e-01 1.867345260717589994e-01 -2.031250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.938346909675501828e-01 1.938346909675501828e-01 1.938346909675501828e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.157690908967272669e-01 1.157690908967272669e-01 1.157690908967272669e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 8.609862812829546797e-02 8.609862812829546797e-02 8.609862812829546797e-02 -2.343750000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.792379790036426057e-01 1.792379790036426057e-01 1.792379790036426057e-01 -2.343750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.614317830069456339e-01 1.614317830069456339e-01 1.614317830069456339e-01 -2.031250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 5.119698205877768610e-02 5.119698205877768610e-02 5.119698205877768610e-02 -2.031250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 5.678825419447487699e-02 5.678825419447487699e-02 5.678825419447487699e-02 -2.031250000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 5.503500853003216037e-02 5.503500853003216037e-02 5.503500853003216037e-02 -2.031250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 5.962880573035725384e-02 5.962880573035725384e-02 5.962880573035725384e-02 -2.343750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 6.055414205445514009e-02 6.055414205445514009e-02 6.055414205445514009e-02 -2.343750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 3.863005563010269566e-02 3.863005563010269566e-02 3.863005563010269566e-02 -2.343750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 7.526443458617240734e-02 7.526443458617240734e-02 7.526443458617240734e-02 -2.031250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 5.404713782530150279e-02 5.404713782530150279e-02 5.404713782530150279e-02 -2.031250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 1.253729857485013366e-01 1.253729857485013366e-01 1.253729857485013366e-01 -2.031250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 1.703293523129842391e-01 1.703293523129842391e-01 1.703293523129842391e-01 -2.343750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 1.024856295923963351e-01 1.024856295923963351e-01 1.024856295923963351e-01 -2.343750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 1.434256869176956661e-01 1.434256869176956661e-01 1.434256869176956661e-01 -2.343750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 1.857544518356625818e-01 1.857544518356625818e-01 1.857544518356625818e-01 -1.406250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 4.061997791535005287e-01 4.061997791535005287e-01 4.061997791535005287e-01 -1.406250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 1.168295521533274234e-01 1.168295521533274234e-01 1.168295521533274234e-01 -1.406250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.764106385128435261e-01 1.764106385128435261e-01 1.764106385128435261e-01 -1.718750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 3.791754970631889821e-01 3.791754970631889821e-01 3.791754970631889821e-01 -1.718750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 3.589297609144894707e-01 3.589297609144894707e-01 3.589297609144894707e-01 -1.718750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 1.354142766394987318e-01 1.354142766394987318e-01 1.354142766394987318e-01 -1.718750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.504541891154271560e-01 1.504541891154271560e-01 1.504541891154271560e-01 -1.406250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 3.612124662119823859e-01 3.612124662119823859e-01 3.612124662119823859e-01 -1.406250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.873285046467662307e-01 1.873285046467662307e-01 1.873285046467662307e-01 -1.406250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 1.942400059155389158e-01 1.942400059155389158e-01 1.942400059155389158e-01 -1.718750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 3.711851264000279316e-01 3.711851264000279316e-01 3.711851264000279316e-01 -1.718750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 2.982813995316141442e-01 2.982813995316141442e-01 2.982813995316141442e-01 -1.718750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 2.816768785998216007e-01 2.816768785998216007e-01 2.816768785998216007e-01 -1.406250000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.181414519262973251e-01 1.181414519262973251e-01 1.181414519262973251e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 1.187728914658463392e-01 1.187728914658463392e-01 1.187728914658463392e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 1.052400410803232544e-01 1.052400410803232544e-01 1.052400410803232544e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.438200124279719605e-01 1.438200124279719605e-01 1.438200124279719605e-01 -1.718750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 5.623656519955754635e-02 5.623656519955754635e-02 5.623656519955754635e-02 -1.406250000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 1.083727883014256876e-01 1.083727883014256876e-01 1.083727883014256876e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 1.273137089019339419e-01 1.273137089019339419e-01 1.273137089019339419e-01 -1.406250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 1.502140801688278127e-01 1.502140801688278127e-01 1.502140801688278127e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 1.827154233838163278e-01 1.827154233838163278e-01 1.827154233838163278e-01 -1.718750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 2.337616480022724763e-01 2.337616480022724763e-01 2.337616480022724763e-01 -1.718750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 1.141711421942665644e-01 1.141711421942665644e-01 1.141711421942665644e-01 -2.031250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 3.405095636354260047e-01 3.405095636354260047e-01 3.405095636354260047e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 1.249641105375877276e-01 1.249641105375877276e-01 1.249641105375877276e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.275506731329404397e-01 1.275506731329404397e-01 1.275506731329404397e-01 -2.343750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.812119207467715876e-01 1.812119207467715876e-01 1.812119207467715876e-01 -2.343750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 1.616630262823716413e-01 1.616630262823716413e-01 1.616630262823716413e-01 -2.343750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.435003760119932248e-01 1.435003760119932248e-01 1.435003760119932248e-01 -2.031250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.641761481836244152e-01 1.641761481836244152e-01 1.641761481836244152e-01 -2.031250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 2.985875966266778314e-01 2.985875966266778314e-01 2.985875966266778314e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 2.063615908505465613e-01 2.063615908505465613e-01 2.063615908505465613e-01 -2.031250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 2.116947022900025066e-01 2.116947022900025066e-01 2.116947022900025066e-01 -2.343750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.918329670035141543e-01 1.918329670035141543e-01 1.918329670035141543e-01 -2.343750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 2.074481426808694740e-01 2.074481426808694740e-01 2.074481426808694740e-01 -2.031250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 1.099676383996751050e-01 1.099676383996751050e-01 1.099676383996751050e-01 -2.031250000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.012787369711483781e-01 1.012787369711483781e-01 1.012787369711483781e-01 -2.031250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 9.931649341042865509e-02 9.931649341042865509e-02 9.931649341042865509e-02 -2.343750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 9.063769244511775403e-02 9.063769244511775403e-02 9.063769244511775403e-02 -2.343750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 6.648440284821553747e-02 6.648440284821553747e-02 6.648440284821553747e-02 -2.031250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 1.442247763184400233e-01 1.442247763184400233e-01 1.442247763184400233e-01 -1.562500000000000000e-02 2.656250000000000000e-01 -3.906250000000000000e-01 8.656074358726083273e-02 8.656074358726083273e-02 8.656074358726083273e-02 -1.562500000000000000e-02 2.968750000000000000e-01 -3.906250000000000000e-01 8.079897864882019942e-02 8.079897864882019942e-02 8.079897864882019942e-02 -4.687500000000000000e-02 2.656250000000000000e-01 -3.906250000000000000e-01 6.781078949838020842e-02 6.781078949838020842e-02 6.781078949838020842e-02 -4.687500000000000000e-02 2.968750000000000000e-01 -3.906250000000000000e-01 8.012182964409483854e-02 8.012182964409483854e-02 8.012182964409483854e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -3.906250000000000000e-01 7.567131185310567443e-02 7.567131185310567443e-02 7.567131185310567443e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -3.906250000000000000e-01 7.807925652596171828e-02 7.807925652596171828e-02 7.807925652596171828e-02 -4.687500000000000000e-02 3.281250000000000000e-01 -3.906250000000000000e-01 6.420047456672049735e-02 6.420047456672049735e-02 6.420047456672049735e-02 -4.687500000000000000e-02 3.593750000000000000e-01 -3.906250000000000000e-01 6.888651320619684770e-02 6.888651320619684770e-02 6.888651320619684770e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -3.906250000000000000e-01 6.076179860491301432e-02 6.076179860491301432e-02 6.076179860491301432e-02 -4.687500000000000000e-02 2.656250000000000000e-01 -3.593750000000000000e-01 8.560034413764219807e-02 8.560034413764219807e-02 8.560034413764219807e-02 -4.687500000000000000e-02 2.656250000000000000e-01 -3.281250000000000000e-01 6.814583934539547583e-02 6.814583934539547583e-02 6.814583934539547583e-02 -4.687500000000000000e-02 2.968750000000000000e-01 -3.593750000000000000e-01 1.040846139040711021e-01 1.040846139040711021e-01 1.040846139040711021e-01 -4.687500000000000000e-02 2.968750000000000000e-01 -3.281250000000000000e-01 8.699633520708997814e-02 8.699633520708997814e-02 8.699633520708997814e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -3.281250000000000000e-01 9.338286627658455574e-02 9.338286627658455574e-02 9.338286627658455574e-02 -4.687500000000000000e-02 3.593750000000000000e-01 -3.593750000000000000e-01 8.262263112678834565e-02 8.262263112678834565e-02 8.262263112678834565e-02 -4.687500000000000000e-02 3.593750000000000000e-01 -3.281250000000000000e-01 8.248519555788898228e-02 8.248519555788898228e-02 8.248519555788898228e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 9.437772757975319837e-02 9.437772757975319837e-02 9.437772757975319837e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 3.905673950515856779e-02 3.905673950515856779e-02 3.905673950515856779e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -2.968750000000000000e-01 1.084418857366969274e-01 1.084418857366969274e-01 1.084418857366969274e-01 -4.687500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 9.197975341554305573e-02 9.197975341554305573e-02 9.197975341554305573e-02 -4.687500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 6.999775236506800002e-02 6.999775236506800002e-02 6.999775236506800002e-02 -4.687500000000000000e-02 3.593750000000000000e-01 -2.968750000000000000e-01 7.837327193778174939e-02 7.837327193778174939e-02 7.837327193778174939e-02 -7.812500000000000000e-02 2.656250000000000000e-01 -3.281250000000000000e-01 6.923425940202232454e-02 6.923425940202232454e-02 6.923425940202232454e-02 -7.812500000000000000e-02 2.968750000000000000e-01 -3.593750000000000000e-01 9.256478855651768811e-02 9.256478855651768811e-02 9.256478855651768811e-02 -7.812500000000000000e-02 2.968750000000000000e-01 -3.281250000000000000e-01 1.147166496179010814e-01 1.147166496179010814e-01 1.147166496179010814e-01 -1.093750000000000000e-01 2.968750000000000000e-01 -3.281250000000000000e-01 1.215942248980436818e-01 1.215942248980436818e-01 1.215942248980436818e-01 -7.812500000000000000e-02 2.656250000000000000e-01 -2.968750000000000000e-01 7.880561249575405991e-02 7.880561249575405991e-02 7.880561249575405991e-02 -7.812500000000000000e-02 2.656250000000000000e-01 -2.656250000000000000e-01 1.005828772046537256e-01 1.005828772046537256e-01 1.005828772046537256e-01 -7.812500000000000000e-02 2.968750000000000000e-01 -2.968750000000000000e-01 1.047941027942801973e-01 1.047941027942801973e-01 1.047941027942801973e-01 -7.812500000000000000e-02 2.968750000000000000e-01 -2.656250000000000000e-01 8.458287079149709453e-02 8.458287079149709453e-02 8.458287079149709453e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 1.332882075587314419e-01 1.332882075587314419e-01 1.332882075587314419e-01 -1.093750000000000000e-01 2.656250000000000000e-01 -2.656250000000000000e-01 1.424531161447546157e-01 1.424531161447546157e-01 1.424531161447546157e-01 -1.093750000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 1.278213737902239022e-01 1.278213737902239022e-01 1.278213737902239022e-01 -1.093750000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 1.278527011071969310e-01 1.278527011071969310e-01 1.278527011071969310e-01 -7.812500000000000000e-02 3.281250000000000000e-01 -3.593750000000000000e-01 8.731941086310336664e-02 8.731941086310336664e-02 8.731941086310336664e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -3.281250000000000000e-01 9.603071306085259051e-02 9.603071306085259051e-02 9.603071306085259051e-02 -7.812500000000000000e-02 3.593750000000000000e-01 -3.593750000000000000e-01 5.851460949532459599e-02 5.851460949532459599e-02 5.851460949532459599e-02 -7.812500000000000000e-02 3.593750000000000000e-01 -3.281250000000000000e-01 6.903257322233236071e-02 6.903257322233236071e-02 6.903257322233236071e-02 -1.093750000000000000e-01 3.281250000000000000e-01 -3.281250000000000000e-01 5.962382126609912930e-02 5.962382126609912930e-02 5.962382126609912930e-02 -1.093750000000000000e-01 3.593750000000000000e-01 -3.281250000000000000e-01 1.042268335827757353e-01 1.042268335827757353e-01 1.042268335827757353e-01 -7.812500000000000000e-02 3.281250000000000000e-01 -2.968750000000000000e-01 1.079790924798206403e-01 1.079790924798206403e-01 1.079790924798206403e-01 -7.812500000000000000e-02 3.281250000000000000e-01 -2.656250000000000000e-01 9.724491654025595178e-02 9.724491654025595178e-02 9.724491654025595178e-02 -1.093750000000000000e-01 3.281250000000000000e-01 -2.968750000000000000e-01 1.452928934745136569e-01 1.452928934745136569e-01 1.452928934745136569e-01 -1.093750000000000000e-01 3.281250000000000000e-01 -2.656250000000000000e-01 1.442793871636339487e-01 1.442793871636339487e-01 1.442793871636339487e-01 -1.093750000000000000e-01 3.593750000000000000e-01 -2.968750000000000000e-01 1.224312871410883491e-01 1.224312871410883491e-01 1.224312871410883491e-01 -1.093750000000000000e-01 3.593750000000000000e-01 -2.656250000000000000e-01 1.106674341811060697e-01 1.106674341811060697e-01 1.106674341811060697e-01 -1.562500000000000000e-02 3.906250000000000000e-01 -3.906250000000000000e-01 5.738110259317943940e-02 5.738110259317943940e-02 5.738110259317943940e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -3.906250000000000000e-01 4.638487889320144775e-02 4.638487889320144775e-02 4.638487889320144775e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -3.593750000000000000e-01 7.898412611056097876e-02 7.898412611056097876e-02 7.898412611056097876e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -3.281250000000000000e-01 9.940729443469244198e-02 9.940729443469244198e-02 9.940729443469244198e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -3.593750000000000000e-01 6.941809965225073653e-02 6.941809965225073653e-02 6.941809965225073653e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -3.281250000000000000e-01 7.878543826224559954e-02 7.878543826224559954e-02 7.878543826224559954e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -2.968750000000000000e-01 8.963635572498242221e-02 8.963635572498242221e-02 8.963635572498242221e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -2.968750000000000000e-01 8.055625052143225440e-02 8.055625052143225440e-02 8.055625052143225440e-02 -1.718750000000000000e-01 2.656250000000000000e-01 -3.906250000000000000e-01 8.289348299343198001e-02 8.289348299343198001e-02 8.289348299343198001e-02 -1.718750000000000000e-01 2.968750000000000000e-01 -3.906250000000000000e-01 1.082828008549179682e-01 1.082828008549179682e-01 1.082828008549179682e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -3.906250000000000000e-01 8.519608889064046731e-02 8.519608889064046731e-02 8.519608889064046731e-02 -2.031250000000000000e-01 2.656250000000000000e-01 -3.906250000000000000e-01 8.880377413149410926e-02 8.880377413149410926e-02 8.880377413149410926e-02 -2.031250000000000000e-01 2.968750000000000000e-01 -3.906250000000000000e-01 1.034667187088506579e-01 1.034667187088506579e-01 1.034667187088506579e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -3.906250000000000000e-01 7.817554709352400599e-02 7.817554709352400599e-02 7.817554709352400599e-02 -2.343750000000000000e-01 2.968750000000000000e-01 -3.906250000000000000e-01 9.132158379685707816e-02 9.132158379685707816e-02 9.132158379685707816e-02 -2.031250000000000000e-01 3.281250000000000000e-01 -3.906250000000000000e-01 9.987094054505006591e-02 9.987094054505006591e-02 9.987094054505006591e-02 -2.031250000000000000e-01 3.593750000000000000e-01 -3.906250000000000000e-01 7.389002300871277962e-02 7.389002300871277962e-02 7.389002300871277962e-02 -2.343750000000000000e-01 3.281250000000000000e-01 -3.906250000000000000e-01 9.592624731241525260e-02 9.592624731241525260e-02 9.592624731241525260e-02 -1.406250000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 1.242821117016816163e-01 1.242821117016816163e-01 1.242821117016816163e-01 -1.406250000000000000e-01 2.968750000000000000e-01 -3.593750000000000000e-01 1.074937994691445575e-01 1.074937994691445575e-01 1.074937994691445575e-01 -1.406250000000000000e-01 2.968750000000000000e-01 -3.281250000000000000e-01 1.253681660135142206e-01 1.253681660135142206e-01 1.253681660135142206e-01 -1.718750000000000000e-01 2.656250000000000000e-01 -3.593750000000000000e-01 1.112700089090658401e-01 1.112700089090658401e-01 1.112700089090658401e-01 -1.718750000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 1.530110238889544616e-01 1.530110238889544616e-01 1.530110238889544616e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -3.593750000000000000e-01 1.102705358283196657e-01 1.102705358283196657e-01 1.102705358283196657e-01 -1.406250000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 1.202406077366482834e-01 1.202406077366482834e-01 1.202406077366482834e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -3.593750000000000000e-01 1.079967686600562110e-01 1.079967686600562110e-01 1.079967686600562110e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -3.281250000000000000e-01 1.282912822639180050e-01 1.282912822639180050e-01 1.282912822639180050e-01 -1.406250000000000000e-01 3.593750000000000000e-01 -3.593750000000000000e-01 9.809267845662636431e-02 9.809267845662636431e-02 9.809267845662636431e-02 -1.406250000000000000e-01 3.593750000000000000e-01 -3.281250000000000000e-01 1.394831286618060662e-01 1.394831286618060662e-01 1.394831286618060662e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -3.593750000000000000e-01 1.110064834499718961e-01 1.110064834499718961e-01 1.110064834499718961e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -3.281250000000000000e-01 1.046398316766412734e-01 1.046398316766412734e-01 1.046398316766412734e-01 -1.406250000000000000e-01 3.593750000000000000e-01 -2.968750000000000000e-01 1.512251026286181577e-01 1.512251026286181577e-01 1.512251026286181577e-01 -1.406250000000000000e-01 3.593750000000000000e-01 -2.656250000000000000e-01 1.384912344339735701e-01 1.384912344339735701e-01 1.384912344339735701e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -2.656250000000000000e-01 1.348809574494918562e-01 1.348809574494918562e-01 1.348809574494918562e-01 -2.031250000000000000e-01 2.656250000000000000e-01 -3.593750000000000000e-01 9.826544400736418605e-02 9.826544400736418605e-02 9.826544400736418605e-02 -2.343750000000000000e-01 2.656250000000000000e-01 -3.593750000000000000e-01 1.145680213050108698e-01 1.145680213050108698e-01 1.145680213050108698e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 1.416981810980198486e-01 1.416981810980198486e-01 1.416981810980198486e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -3.593750000000000000e-01 1.251062933122000786e-01 1.251062933122000786e-01 1.251062933122000786e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 1.479085159822254580e-01 1.479085159822254580e-01 1.479085159822254580e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 1.459787296462289330e-01 1.459787296462289330e-01 1.459787296462289330e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 1.355893716267767557e-01 1.355893716267767557e-01 1.355893716267767557e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -2.656250000000000000e-01 6.357624368307877860e-02 6.357624368307877860e-02 6.357624368307877860e-02 -2.343750000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 1.760301200260974419e-01 1.760301200260974419e-01 1.760301200260974419e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.031250000000000000e-01 3.593750000000000000e-01 -3.593750000000000000e-01 1.112820603575899459e-01 1.112820603575899459e-01 1.112820603575899459e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -3.593750000000000000e-01 1.167492146687006960e-01 1.167492146687006960e-01 1.167492146687006960e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -3.281250000000000000e-01 1.325741505983810686e-01 1.325741505983810686e-01 1.325741505983810686e-01 -2.343750000000000000e-01 3.593750000000000000e-01 -3.593750000000000000e-01 1.011702603827486502e-01 1.011702603827486502e-01 1.011702603827486502e-01 -2.343750000000000000e-01 3.593750000000000000e-01 -3.281250000000000000e-01 1.097241948121421978e-01 1.097241948121421978e-01 1.097241948121421978e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -2.968750000000000000e-01 1.343444219259527228e-01 1.343444219259527228e-01 1.343444219259527228e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -2.656250000000000000e-01 1.301990021516401252e-01 1.301990021516401252e-01 1.301990021516401252e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -2.968750000000000000e-01 1.479735641534129509e-01 1.479735641534129509e-01 1.479735641534129509e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -2.656250000000000000e-01 1.298744921510303907e-01 1.298744921510303907e-01 1.298744921510303907e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -2.968750000000000000e-01 1.342496443209055534e-01 1.342496443209055534e-01 1.342496443209055534e-01 -2.343750000000000000e-01 3.593750000000000000e-01 -2.968750000000000000e-01 1.139759155165341875e-01 1.139759155165341875e-01 1.139759155165341875e-01 -1.406250000000000000e-01 3.906250000000000000e-01 -3.281250000000000000e-01 1.055485807180132352e-01 1.055485807180132352e-01 1.055485807180132352e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -3.281250000000000000e-01 1.284776383686546120e-01 1.284776383686546120e-01 1.284776383686546120e-01 -1.406250000000000000e-01 3.906250000000000000e-01 -2.968750000000000000e-01 1.346480307904535101e-01 1.346480307904535101e-01 1.346480307904535101e-01 -1.406250000000000000e-01 3.906250000000000000e-01 -2.656250000000000000e-01 1.067168424780644553e-01 1.067168424780644553e-01 1.067168424780644553e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -2.968750000000000000e-01 1.451370938102911901e-01 1.451370938102911901e-01 1.451370938102911901e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -2.656250000000000000e-01 1.229285397628035320e-01 1.229285397628035320e-01 1.229285397628035320e-01 -2.031250000000000000e-01 3.906250000000000000e-01 -3.593750000000000000e-01 8.248278440545872559e-02 8.248278440545872559e-02 8.248278440545872559e-02 -2.031250000000000000e-01 3.906250000000000000e-01 -3.281250000000000000e-01 1.293242679955004248e-01 1.293242679955004248e-01 1.293242679955004248e-01 -2.031250000000000000e-01 3.906250000000000000e-01 -2.968750000000000000e-01 1.301925762237224615e-01 1.301925762237224615e-01 1.301925762237224615e-01 -1.562500000000000000e-02 2.968750000000000000e-01 -2.031250000000000000e-01 5.746656437664100087e-02 5.746656437664100087e-02 5.746656437664100087e-02 -4.687500000000000000e-02 2.968750000000000000e-01 -2.343750000000000000e-01 5.485861255088219507e-02 5.485861255088219507e-02 5.485861255088219507e-02 -1.562500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 1.246733178657832980e-01 1.246733178657832980e-01 1.246733178657832980e-01 -1.562500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 4.226620463727376320e-02 4.226620463727376320e-02 4.226620463727376320e-02 -1.562500000000000000e-02 2.968750000000000000e-01 -1.718750000000000000e-01 3.383963801656001552e-02 3.383963801656001552e-02 3.383963801656001552e-02 -1.562500000000000000e-02 2.968750000000000000e-01 -1.406250000000000000e-01 4.249545873499706305e-02 4.249545873499706305e-02 4.249545873499706305e-02 -4.687500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 4.545294688768751479e-02 4.545294688768751479e-02 4.545294688768751479e-02 -4.687500000000000000e-02 2.968750000000000000e-01 -1.406250000000000000e-01 2.121980971127015309e-02 2.121980971127015309e-02 2.121980971127015309e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 4.773797027248517788e-02 4.773797027248517788e-02 4.773797027248517788e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 7.015032147372736449e-02 7.015032147372736449e-02 7.015032147372736449e-02 -4.687500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 2.031861111787111318e-01 2.031861111787111318e-01 2.031861111787111318e-01 -4.687500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 4.503248843954484049e-02 4.503248843954484049e-02 4.503248843954484049e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -1.718750000000000000e-01 3.521087383430353268e-02 3.521087383430353268e-02 3.521087383430353268e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -1.406250000000000000e-01 7.751525511918973266e-02 7.751525511918973266e-02 7.751525511918973266e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 8.962590832594363732e-02 8.962590832594363732e-02 8.962590832594363732e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -1.406250000000000000e-01 1.047129497953218219e-01 1.047129497953218219e-01 1.047129497953218219e-01 -4.687500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 8.201100085688857455e-02 8.201100085688857455e-02 8.201100085688857455e-02 -7.812500000000000000e-02 2.656250000000000000e-01 -2.343750000000000000e-01 2.192580305418716513e-01 2.192580305418716513e-01 2.192580305418716513e-01 -7.812500000000000000e-02 2.656250000000000000e-01 -2.031250000000000000e-01 1.906555062677540158e-01 1.906555062677540158e-01 1.906555062677540158e-01 -7.812500000000000000e-02 2.968750000000000000e-01 -2.343750000000000000e-01 8.908023075121927759e-02 8.908023075121927759e-02 8.908023075121927759e-02 -7.812500000000000000e-02 2.968750000000000000e-01 -2.031250000000000000e-01 9.712357737403203017e-02 9.712357737403203017e-02 9.712357737403203017e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 1.323685267213854100e-01 1.323685267213854100e-01 1.323685267213854100e-01 -1.093750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 9.434156563152841513e-02 9.434156563152841513e-02 9.434156563152841513e-02 -1.093750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 1.128953313046481138e-01 1.128953313046481138e-01 1.128953313046481138e-01 -1.093750000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 1.020244091168459322e-01 1.020244091168459322e-01 1.020244091168459322e-01 -7.812500000000000000e-02 2.656250000000000000e-01 -1.718750000000000000e-01 8.329292755416084493e-02 8.329292755416084493e-02 8.329292755416084493e-02 -7.812500000000000000e-02 2.656250000000000000e-01 -1.406250000000000000e-01 9.297704290705328944e-02 9.297704290705328944e-02 9.297704290705328944e-02 -7.812500000000000000e-02 2.968750000000000000e-01 -1.718750000000000000e-01 8.488827488512945552e-02 8.488827488512945552e-02 8.488827488512945552e-02 -7.812500000000000000e-02 2.968750000000000000e-01 -1.406250000000000000e-01 6.915877786587748544e-02 6.915877786587748544e-02 6.915877786587748544e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 9.990549292116844560e-02 9.990549292116844560e-02 9.990549292116844560e-02 -1.093750000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 9.615044671340186588e-02 9.615044671340186588e-02 9.615044671340186588e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -2.343750000000000000e-01 6.898683403831132321e-02 6.898683403831132321e-02 6.898683403831132321e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -2.031250000000000000e-01 7.548202013679508604e-02 7.548202013679508604e-02 7.548202013679508604e-02 -1.093750000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 1.086572122473607044e-01 1.086572122473607044e-01 1.086572122473607044e-01 -7.812500000000000000e-02 3.281250000000000000e-01 -1.718750000000000000e-01 4.286776406796499045e-02 4.286776406796499045e-02 4.286776406796499045e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -1.406250000000000000e-01 8.306547747395913450e-02 8.306547747395913450e-02 8.306547747395913450e-02 -7.812500000000000000e-02 3.593750000000000000e-01 -1.718750000000000000e-01 8.516715603164945469e-02 8.516715603164945469e-02 8.516715603164945469e-02 -7.812500000000000000e-02 3.593750000000000000e-01 -1.406250000000000000e-01 7.706257220725835910e-02 7.706257220725835910e-02 7.706257220725835910e-02 -1.093750000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 9.784277042213182507e-02 9.784277042213182507e-02 9.784277042213182507e-02 -1.093750000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 8.351716216277539628e-02 8.351716216277539628e-02 8.351716216277539628e-02 -1.562500000000000000e-02 2.656250000000000000e-01 -4.687500000000000000e-02 8.042604506524114738e-02 8.042604506524114738e-02 8.042604506524114738e-02 -1.562500000000000000e-02 2.656250000000000000e-01 -1.562500000000000000e-02 1.204060956857489900e-01 1.204060956857489900e-01 1.204060956857489900e-01 -1.562500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 5.893933883594070638e-02 5.893933883594070638e-02 5.893933883594070638e-02 -1.562500000000000000e-02 2.968750000000000000e-01 -1.562500000000000000e-02 1.279796167793232353e-01 1.279796167793232353e-01 1.279796167793232353e-01 -4.687500000000000000e-02 2.656250000000000000e-01 -1.562500000000000000e-02 1.016933572500219179e-01 1.016933572500219179e-01 1.016933572500219179e-01 -4.687500000000000000e-02 2.968750000000000000e-01 -4.687500000000000000e-02 4.752400838334246841e-02 4.752400838334246841e-02 4.752400838334246841e-02 -4.687500000000000000e-02 2.968750000000000000e-01 -1.562500000000000000e-02 7.874002612445502036e-02 7.874002612445502036e-02 7.874002612445502036e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -1.093750000000000000e-01 5.831410237975664240e-02 5.831410237975664240e-02 5.831410237975664240e-02 -1.562500000000000000e-02 3.281250000000000000e-01 -7.812500000000000000e-02 8.007320329444959917e-02 8.007320329444959917e-02 8.007320329444959917e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -1.093750000000000000e-01 8.315710055181620153e-02 8.315710055181620153e-02 8.315710055181620153e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -7.812500000000000000e-02 1.111278016801368895e-01 1.111278016801368895e-01 1.111278016801368895e-01 -1.562500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 1.064058968850238596e-01 1.064058968850238596e-01 1.064058968850238596e-01 -1.562500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.562500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 7.995778592377592031e-02 7.995778592377592031e-02 7.995778592377592031e-02 -1.562500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 6.997733477010073533e-02 6.997733477010073533e-02 6.997733477010073533e-02 -4.687500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 6.565696766425910269e-02 6.565696766425910269e-02 6.565696766425910269e-02 -4.687500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 2.605738582135677661e-02 2.605738582135677661e-02 2.605738582135677661e-02 -4.687500000000000000e-02 3.593750000000000000e-01 -4.687500000000000000e-02 5.346817418779748615e-02 5.346817418779748615e-02 5.346817418779748615e-02 -4.687500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 5.426920276157683187e-02 5.426920276157683187e-02 5.426920276157683187e-02 -7.812500000000000000e-02 2.656250000000000000e-01 -1.093750000000000000e-01 8.361521437589976291e-02 8.361521437589976291e-02 8.361521437589976291e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 9.809830338737830779e-02 9.809830338737830779e-02 9.809830338737830779e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 5.400991254246022277e-02 5.400991254246022277e-02 5.400991254246022277e-02 -1.093750000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 9.606205275894223738e-02 9.606205275894223738e-02 9.606205275894223738e-02 -1.093750000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 5.606515653986975101e-02 5.606515653986975101e-02 5.606515653986975101e-02 -1.093750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 8.767704284999187914e-02 8.767704284999187914e-02 8.767704284999187914e-02 -1.093750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 6.917155908944304377e-02 6.917155908944304377e-02 6.917155908944304377e-02 -1.093750000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 8.560677362813934321e-02 8.560677362813934321e-02 8.560677362813934321e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -4.687500000000000000e-02 4.414163031958764916e-02 4.414163031958764916e-02 4.414163031958764916e-02 -7.812500000000000000e-02 3.281250000000000000e-01 -1.562500000000000000e-02 3.246395563238455018e-02 3.246395563238455018e-02 3.246395563238455018e-02 -7.812500000000000000e-02 3.593750000000000000e-01 -1.562500000000000000e-02 6.069756421238130945e-02 6.069756421238130945e-02 6.069756421238130945e-02 -1.093750000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 1.276655402886693880e-01 1.276655402886693880e-01 1.276655402886693880e-01 -1.093750000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 4.348877839552842128e-02 4.348877839552842128e-02 4.348877839552842128e-02 -1.093750000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 4.851380851710753589e-02 4.851380851710753589e-02 4.851380851710753589e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -1.718750000000000000e-01 6.479399185399872807e-02 6.479399185399872807e-02 6.479399185399872807e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 1.024060813018525945e-01 1.024060813018525945e-01 1.024060813018525945e-01 -4.687500000000000000e-02 3.906250000000000000e-01 -1.718750000000000000e-01 7.754957596762424021e-02 7.754957596762424021e-02 7.754957596762424021e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 9.722080943569412492e-02 9.722080943569412492e-02 9.722080943569412492e-02 -7.812500000000000000e-02 3.906250000000000000e-01 -1.718750000000000000e-01 6.952211751767491121e-02 6.952211751767491121e-02 6.952211751767491121e-02 -7.812500000000000000e-02 3.906250000000000000e-01 -1.406250000000000000e-01 1.027837341027566798e-01 1.027837341027566798e-01 1.027837341027566798e-01 -1.093750000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 9.003174859942522645e-02 9.003174859942522645e-02 9.003174859942522645e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 8.340705420725604002e-02 8.340705420725604002e-02 8.340705420725604002e-02 -1.562500000000000000e-02 3.906250000000000000e-01 -7.812500000000000000e-02 1.255521190271629006e-01 1.255521190271629006e-01 1.255521190271629006e-01 -4.687500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 1.623133944311480892e-01 1.623133944311480892e-01 1.623133944311480892e-01 -4.687500000000000000e-02 3.906250000000000000e-01 -7.812500000000000000e-02 1.059390745005426571e-01 1.059390745005426571e-01 1.059390745005426571e-01 -1.562500000000000000e-02 3.906250000000000000e-01 -4.687500000000000000e-02 7.047016905065245362e-02 7.047016905065245362e-02 7.047016905065245362e-02 -1.562500000000000000e-02 4.218750000000000000e-01 -4.687500000000000000e-02 6.300402108571732940e-02 6.300402108571732940e-02 6.300402108571732940e-02 -1.562500000000000000e-02 4.218750000000000000e-01 -1.562500000000000000e-02 6.167634929898740959e-02 6.167634929898740959e-02 6.167634929898740959e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -4.687500000000000000e-02 6.148131676886133684e-02 6.148131676886133684e-02 6.148131676886133684e-02 -4.687500000000000000e-02 3.906250000000000000e-01 -1.562500000000000000e-02 5.700749766301767968e-02 5.700749766301767968e-02 5.700749766301767968e-02 -4.687500000000000000e-02 4.218750000000000000e-01 -4.687500000000000000e-02 6.366603997577777174e-02 6.366603997577777174e-02 6.366603997577777174e-02 -4.687500000000000000e-02 4.218750000000000000e-01 -1.562500000000000000e-02 5.213246562506428095e-02 5.213246562506428095e-02 5.213246562506428095e-02 -4.687500000000000000e-02 4.531250000000000000e-01 -1.562500000000000000e-02 7.434835036305441347e-02 7.434835036305441347e-02 7.434835036305441347e-02 -7.812500000000000000e-02 3.906250000000000000e-01 -1.093750000000000000e-01 2.211780366796617381e-01 2.211780366796617381e-01 2.211780366796617381e-01 -7.812500000000000000e-02 3.906250000000000000e-01 -7.812500000000000000e-02 1.614173302801620857e-01 1.614173302801620857e-01 1.614173302801620857e-01 -7.812500000000000000e-02 4.218750000000000000e-01 -7.812500000000000000e-02 1.011566003575384981e-01 1.011566003575384981e-01 1.011566003575384981e-01 -1.093750000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 1.237519319341922608e-01 1.237519319341922608e-01 1.237519319341922608e-01 -1.093750000000000000e-01 3.906250000000000000e-01 -7.812500000000000000e-02 1.414845492563110985e-01 1.414845492563110985e-01 1.414845492563110985e-01 -1.093750000000000000e-01 4.218750000000000000e-01 -7.812500000000000000e-02 1.447122571103920119e-01 1.447122571103920119e-01 1.447122571103920119e-01 -7.812500000000000000e-02 4.218750000000000000e-01 -4.687500000000000000e-02 7.376479035212953062e-02 7.376479035212953062e-02 7.376479035212953062e-02 -7.812500000000000000e-02 4.218750000000000000e-01 -1.562500000000000000e-02 4.552555595542392974e-02 4.552555595542392974e-02 4.552555595542392974e-02 -1.093750000000000000e-01 4.531250000000000000e-01 -7.812500000000000000e-02 1.469689254208853268e-01 1.469689254208853268e-01 1.469689254208853268e-01 -7.812500000000000000e-02 4.531250000000000000e-01 -4.687500000000000000e-02 9.257443195726235141e-02 9.257443195726235141e-02 9.257443195726235141e-02 -7.812500000000000000e-02 4.531250000000000000e-01 -1.562500000000000000e-02 8.915738126624593585e-02 8.915738126624593585e-02 8.915738126624593585e-02 -7.812500000000000000e-02 4.843750000000000000e-01 -4.687500000000000000e-02 8.061733448999748586e-02 8.061733448999748586e-02 8.061733448999748586e-02 -7.812500000000000000e-02 4.843750000000000000e-01 -1.562500000000000000e-02 1.024213481515880292e-01 1.024213481515880292e-01 1.024213481515880292e-01 -1.093750000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 1.334681264231738496e-01 1.334681264231738496e-01 1.334681264231738496e-01 -1.093750000000000000e-01 4.843750000000000000e-01 -4.687500000000000000e-02 1.174746592465067546e-01 1.174746592465067546e-01 1.174746592465067546e-01 -1.093750000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 1.360190755997486567e-01 1.360190755997486567e-01 1.360190755997486567e-01 -1.406250000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 1.333926248058404374e-01 1.333926248058404374e-01 1.333926248058404374e-01 -1.406250000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 1.246130706338265393e-01 1.246130706338265393e-01 1.246130706338265393e-01 -1.406250000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 8.856991037717219795e-02 8.856991037717219795e-02 8.856991037717219795e-02 -1.718750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 1.299676684237786317e-01 1.299676684237786317e-01 1.299676684237786317e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 1.394759003270593656e-01 1.394759003270593656e-01 1.394759003270593656e-01 -1.406250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 1.453362603376855411e-01 1.453362603376855411e-01 1.453362603376855411e-01 -1.718750000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 1.185945464492492024e-01 1.185945464492492024e-01 1.185945464492492024e-01 -1.718750000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 1.836200801446473685e-01 1.836200801446473685e-01 1.836200801446473685e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 1.431261267352016697e-01 1.431261267352016697e-01 1.431261267352016697e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 1.749110320217286685e-01 1.749110320217286685e-01 1.749110320217286685e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 1.158558564336775731e-01 1.158558564336775731e-01 1.158558564336775731e-01 -1.406250000000000000e-01 3.593750000000000000e-01 -2.343750000000000000e-01 1.169548784691758353e-01 1.169548784691758353e-01 1.169548784691758353e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 1.160711631026306451e-01 1.160711631026306451e-01 1.160711631026306451e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -2.343750000000000000e-01 1.046342072032197673e-01 1.046342072032197673e-01 1.046342072032197673e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 1.165403368332221662e-01 1.165403368332221662e-01 1.165403368332221662e-01 -1.406250000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 1.097989151995277940e-01 1.097989151995277940e-01 1.097989151995277940e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 1.324930256159217723e-01 1.324930256159217723e-01 1.324930256159217723e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 1.559202882448405270e-01 1.559202882448405270e-01 1.559202882448405270e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 1.233912470348376561e-01 1.233912470348376561e-01 1.233912470348376561e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 1.377659793358972373e-01 1.377659793358972373e-01 1.377659793358972373e-01 -2.031250000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 1.085551732637674988e-01 1.085551732637674988e-01 1.085551732637674988e-01 -2.031250000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 1.195200081843423023e-01 1.195200081843423023e-01 1.195200081843423023e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 1.339034641537704406e-01 1.339034641537704406e-01 1.339034641537704406e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 1.456052949850162870e-01 1.456052949850162870e-01 1.456052949850162870e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 7.109651679235592936e-02 7.109651679235592936e-02 7.109651679235592936e-02 -2.343750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 1.251777862508396399e-01 1.251777862508396399e-01 1.251777862508396399e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 7.963090309864437333e-02 7.963090309864437333e-02 7.963090309864437333e-02 -2.343750000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 1.681182994663408536e-01 1.681182994663408536e-01 1.681182994663408536e-01 -2.031250000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 1.487107730846455034e-01 1.487107730846455034e-01 1.487107730846455034e-01 -2.031250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 1.809951828653380279e-01 1.809951828653380279e-01 1.809951828653380279e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 1.697633478392388540e-01 1.697633478392388540e-01 1.697633478392388540e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 1.742800329268182069e-01 1.742800329268182069e-01 1.742800329268182069e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 1.772206391719882701e-01 1.772206391719882701e-01 1.772206391719882701e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 1.980001076486037903e-01 1.980001076486037903e-01 1.980001076486037903e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 1.833487644555310825e-01 1.833487644555310825e-01 1.833487644555310825e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -2.343750000000000000e-01 1.140506319553343251e-01 1.140506319553343251e-01 1.140506319553343251e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -2.031250000000000000e-01 1.347918028424206216e-01 1.347918028424206216e-01 1.347918028424206216e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -2.031250000000000000e-01 7.330380710308703751e-02 7.330380710308703751e-02 7.330380710308703751e-02 -2.343750000000000000e-01 3.281250000000000000e-01 -2.031250000000000000e-01 1.237607682922801933e-01 1.237607682922801933e-01 1.237607682922801933e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 1.181205645286082795e-01 1.181205645286082795e-01 1.181205645286082795e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 1.268349586989967470e-01 1.268349586989967470e-01 1.268349586989967470e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 1.830220606216142465e-01 1.830220606216142465e-01 1.830220606216142465e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 1.689452435556337007e-01 1.689452435556337007e-01 1.689452435556337007e-01 -2.343750000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 1.280117472974719728e-01 1.280117472974719728e-01 1.280117472974719728e-01 -2.343750000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 1.553381225936426302e-01 1.553381225936426302e-01 1.553381225936426302e-01 -1.406250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 1.222047510020278921e-01 1.222047510020278921e-01 1.222047510020278921e-01 -1.406250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 5.034173071059459825e-02 5.034173071059459825e-02 5.034173071059459825e-02 -1.406250000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 1.108867719044887429e-01 1.108867719044887429e-01 1.108867719044887429e-01 -1.406250000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 9.070841238435238540e-02 9.070841238435238540e-02 9.070841238435238540e-02 -1.718750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 1.354921859240085791e-01 1.354921859240085791e-01 1.354921859240085791e-01 -1.718750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 5.636303111071025440e-02 5.636303111071025440e-02 5.636303111071025440e-02 -1.718750000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 1.539585739284159427e-01 1.539585739284159427e-01 1.539585739284159427e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 5.704785704829218318e-02 5.704785704829218318e-02 5.704785704829218318e-02 -1.406250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 4.333527419937011765e-02 4.333527419937011765e-02 4.333527419937011765e-02 -1.406250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 6.687613131431563440e-02 6.687613131431563440e-02 6.687613131431563440e-02 -1.406250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 3.965269391549719469e-02 3.965269391549719469e-02 3.965269391549719469e-02 -1.406250000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 8.374862949034124482e-02 8.374862949034124482e-02 8.374862949034124482e-02 -1.718750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 1.188781309072940440e-01 1.188781309072940440e-01 1.188781309072940440e-01 -1.718750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 1.305010201841368955e-01 1.305010201841368955e-01 1.305010201841368955e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 1.110466550696246057e-01 1.110466550696246057e-01 1.110466550696246057e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 1.333452354566461995e-01 1.333452354566461995e-01 1.333452354566461995e-01 -1.718750000000000000e-01 3.281250000000000000e-01 -7.812500000000000000e-02 7.883237750691642065e-02 7.883237750691642065e-02 7.883237750691642065e-02 -1.718750000000000000e-01 3.593750000000000000e-01 -1.093750000000000000e-01 1.079670405365259489e-01 1.079670405365259489e-01 1.079670405365259489e-01 -1.718750000000000000e-01 3.593750000000000000e-01 -7.812500000000000000e-02 7.800868623714435346e-02 7.800868623714435346e-02 7.800868623714435346e-02 -1.406250000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 1.015993446996886346e-01 1.015993446996886346e-01 1.015993446996886346e-01 -1.406250000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 3.072336926100385085e-02 3.072336926100385085e-02 3.072336926100385085e-02 -1.406250000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 7.917630308925606430e-02 7.917630308925606430e-02 7.917630308925606430e-02 -1.406250000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 5.820870329065543775e-02 5.820870329065543775e-02 5.820870329065543775e-02 -1.718750000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 7.688509923426133097e-02 7.688509923426133097e-02 7.688509923426133097e-02 -1.718750000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 5.873071283581280527e-02 5.873071283581280527e-02 5.873071283581280527e-02 -1.718750000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 8.552961970822620108e-02 8.552961970822620108e-02 8.552961970822620108e-02 -1.718750000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 9.396949842023127886e-02 9.396949842023127886e-02 9.396949842023127886e-02 -2.031250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 5.114648895353535174e-02 5.114648895353535174e-02 5.114648895353535174e-02 -2.031250000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 1.299178673259086259e-01 1.299178673259086259e-01 1.299178673259086259e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 9.984281650703590028e-02 9.984281650703590028e-02 9.984281650703590028e-02 -2.343750000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 7.765382445025904856e-02 7.765382445025904856e-02 7.765382445025904856e-02 -2.343750000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 7.826042415936898533e-02 7.826042415936898533e-02 7.826042415936898533e-02 -2.343750000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 1.034627011693032145e-01 1.034627011693032145e-01 1.034627011693032145e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 1.225477682408668556e-01 1.225477682408668556e-01 1.225477682408668556e-01 -2.031250000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 1.558825479786081214e-01 1.558825479786081214e-01 1.558825479786081214e-01 -2.343750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 1.214865790255715283e-01 1.214865790255715283e-01 1.214865790255715283e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 1.237551451554258081e-01 1.237551451554258081e-01 1.237551451554258081e-01 -2.343750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 1.232313883997053772e-01 1.232313883997053772e-01 1.232313883997053772e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 1.548603421188422813e-01 1.548603421188422813e-01 1.548603421188422813e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -1.093750000000000000e-01 1.454133569255944558e-01 1.454133569255944558e-01 1.454133569255944558e-01 -2.343750000000000000e-01 3.281250000000000000e-01 -1.093750000000000000e-01 1.192420494414472704e-01 1.192420494414472704e-01 1.192420494414472704e-01 -2.343750000000000000e-01 3.593750000000000000e-01 -1.093750000000000000e-01 1.174955468118854263e-01 1.174955468118854263e-01 1.174955468118854263e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -4.687500000000000000e-02 1.300712867382864679e-01 1.300712867382864679e-01 1.300712867382864679e-01 -2.031250000000000000e-01 3.281250000000000000e-01 -1.562500000000000000e-02 1.012249004603607838e-01 1.012249004603607838e-01 1.012249004603607838e-01 -2.031250000000000000e-01 3.593750000000000000e-01 -4.687500000000000000e-02 7.941115864821772508e-02 7.941115864821772508e-02 7.941115864821772508e-02 -2.031250000000000000e-01 3.593750000000000000e-01 -1.562500000000000000e-02 9.259452237178135425e-02 9.259452237178135425e-02 9.259452237178135425e-02 -1.406250000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 1.026792771224177697e-01 1.026792771224177697e-01 1.026792771224177697e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -1.718750000000000000e-01 9.936872410062540240e-02 9.936872410062540240e-02 9.936872410062540240e-02 -1.718750000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 1.473784918864592952e-01 1.473784918864592952e-01 1.473784918864592952e-01 -2.031250000000000000e-01 3.906250000000000000e-01 -1.718750000000000000e-01 1.204984795869350200e-01 1.204984795869350200e-01 1.204984795869350200e-01 -2.031250000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 1.515198144886875375e-01 1.515198144886875375e-01 1.515198144886875375e-01 -2.343750000000000000e-01 3.906250000000000000e-01 -1.718750000000000000e-01 9.237111668007966236e-02 9.237111668007966236e-02 9.237111668007966236e-02 -2.343750000000000000e-01 3.906250000000000000e-01 -1.406250000000000000e-01 1.158976323995693225e-01 1.158976323995693225e-01 1.158976323995693225e-01 -1.406250000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 1.061761016951967840e-01 1.061761016951967840e-01 1.061761016951967840e-01 -1.406250000000000000e-01 3.906250000000000000e-01 -7.812500000000000000e-02 8.102884633272527948e-02 8.102884633272527948e-02 8.102884633272527948e-02 -1.406250000000000000e-01 4.218750000000000000e-01 -7.812500000000000000e-02 1.507424795126638406e-01 1.507424795126638406e-01 1.507424795126638406e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 1.147785110509951245e-01 1.147785110509951245e-01 1.147785110509951245e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -7.812500000000000000e-02 8.024753464977218975e-02 8.024753464977218975e-02 8.024753464977218975e-02 -1.718750000000000000e-01 4.218750000000000000e-01 -7.812500000000000000e-02 1.240354982141294582e-01 1.240354982141294582e-01 1.240354982141294582e-01 -1.718750000000000000e-01 3.906250000000000000e-01 -4.687500000000000000e-02 8.166057721422435856e-02 8.166057721422435856e-02 8.166057721422435856e-02 -1.718750000000000000e-01 4.218750000000000000e-01 -4.687500000000000000e-02 1.332263603561590626e-01 1.332263603561590626e-01 1.332263603561590626e-01 -1.718750000000000000e-01 4.218750000000000000e-01 -1.562500000000000000e-02 8.534236040737346041e-02 8.534236040737346041e-02 8.534236040737346041e-02 -1.406250000000000000e-01 4.531250000000000000e-01 -7.812500000000000000e-02 1.479599120724558181e-01 1.479599120724558181e-01 1.479599120724558181e-01 -1.406250000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 1.573961596673444652e-01 1.573961596673444652e-01 1.573961596673444652e-01 -1.406250000000000000e-01 4.531250000000000000e-01 -1.562500000000000000e-02 8.510286075219936075e-02 8.510286075219936075e-02 8.510286075219936075e-02 -1.406250000000000000e-01 4.843750000000000000e-01 -4.687500000000000000e-02 1.240949425767051972e-01 1.240949425767051972e-01 1.240949425767051972e-01 -1.406250000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 1.429309703058337377e-01 1.429309703058337377e-01 1.429309703058337377e-01 -1.718750000000000000e-01 4.531250000000000000e-01 -4.687500000000000000e-02 1.527106963778503967e-01 1.527106963778503967e-01 1.527106963778503967e-01 -1.718750000000000000e-01 4.531250000000000000e-01 -1.562500000000000000e-02 1.135798368918193996e-01 1.135798368918193996e-01 1.135798368918193996e-01 -1.718750000000000000e-01 4.843750000000000000e-01 -4.687500000000000000e-02 1.024623275760373348e-01 1.024623275760373348e-01 1.024623275760373348e-01 -1.718750000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 1.218858320230347542e-01 1.218858320230347542e-01 1.218858320230347542e-01 -2.031250000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 1.338207341021276087e-01 1.338207341021276087e-01 1.338207341021276087e-01 -2.343750000000000000e-01 3.906250000000000000e-01 -1.093750000000000000e-01 9.286935873860749369e-02 9.286935873860749369e-02 9.286935873860749369e-02 -2.031250000000000000e-01 3.906250000000000000e-01 -4.687500000000000000e-02 7.448756818659950374e-02 7.448756818659950374e-02 7.448756818659950374e-02 -2.031250000000000000e-01 3.906250000000000000e-01 -1.562500000000000000e-02 9.722241657623011124e-02 9.722241657623011124e-02 9.722241657623011124e-02 -2.031250000000000000e-01 4.218750000000000000e-01 -4.687500000000000000e-02 7.751067364652503011e-02 7.751067364652503011e-02 7.751067364652503011e-02 -2.031250000000000000e-01 4.218750000000000000e-01 -1.562500000000000000e-02 8.773892507739526614e-02 8.773892507739526614e-02 8.773892507739526614e-02 -2.031250000000000000e-01 4.843750000000000000e-01 -1.562500000000000000e-02 1.010730330940395744e-01 1.010730330940395744e-01 1.010730330940395744e-01 -2.656250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 6.712517091111501466e-02 6.712517091111501466e-02 6.712517091111501466e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 3.718376863096858193e-02 3.718376863096858193e-02 3.718376863096858193e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 4.029825930371747078e-02 4.029825930371747078e-02 4.029825930371747078e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 4.952755707116007072e-02 4.952755707116007072e-02 4.952755707116007072e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 6.150615811904969199e-02 6.150615811904969199e-02 6.150615811904969199e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 6.440940794292535077e-02 6.440940794292535077e-02 6.440940794292535077e-02 -2.656250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 8.439882408051428697e-02 8.439882408051428697e-02 8.439882408051428697e-02 -2.656250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 8.815361513931647963e-02 8.815361513931647963e-02 8.815361513931647963e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 8.217415629821345213e-02 8.217415629821345213e-02 8.217415629821345213e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 8.997790456212213794e-02 8.997790456212213794e-02 8.997790456212213794e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 6.954567023051085040e-02 6.954567023051085040e-02 6.954567023051085040e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 1.008938453037235422e-01 1.008938453037235422e-01 1.008938453037235422e-01 -2.968750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 4.518904494005854255e-02 4.518904494005854255e-02 4.518904494005854255e-02 -2.968750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 7.791239546985861963e-02 7.791239546985861963e-02 7.791239546985861963e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 7.680335543702263013e-02 7.680335543702263013e-02 7.680335543702263013e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 1.155401258360821276e-01 1.155401258360821276e-01 1.155401258360821276e-01 -2.656250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.121762728018462080e-01 1.121762728018462080e-01 1.121762728018462080e-01 -2.656250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 1.100198621756130618e-01 1.100198621756130618e-01 1.100198621756130618e-01 -2.968750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 1.074640711597646819e-01 1.074640711597646819e-01 1.074640711597646819e-01 -2.968750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 9.891069997000186131e-02 9.891069997000186131e-02 9.891069997000186131e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 9.359501866885985844e-02 9.359501866885985844e-02 9.359501866885985844e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 7.956756789066900259e-02 7.956756789066900259e-02 7.956756789066900259e-02 -3.281250000000000000e-01 1.562500000000000000e-02 -3.593750000000000000e-01 4.219198438776862459e-02 4.219198438776862459e-02 4.219198438776862459e-02 -3.281250000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 5.017818908641281939e-02 5.017818908641281939e-02 5.017818908641281939e-02 -3.281250000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 3.249057522124037395e-02 3.249057522124037395e-02 3.249057522124037395e-02 -3.593750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 5.713532911262840519e-02 5.713532911262840519e-02 5.713532911262840519e-02 -3.593750000000000000e-01 4.687500000000000000e-02 -3.593750000000000000e-01 3.883728628326283544e-02 3.883728628326283544e-02 3.883728628326283544e-02 -3.593750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 6.084637247031408902e-02 6.084637247031408902e-02 6.084637247031408902e-02 -3.281250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 7.811968571819170870e-02 7.811968571819170870e-02 7.811968571819170870e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 4.497081458297773338e-02 4.497081458297773338e-02 4.497081458297773338e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 7.030080031117899586e-02 7.030080031117899586e-02 7.030080031117899586e-02 -3.281250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 7.886275940068457335e-02 7.886275940068457335e-02 7.886275940068457335e-02 -3.593750000000000000e-01 7.812500000000000000e-02 -3.593750000000000000e-01 4.219254727183608528e-02 4.219254727183608528e-02 4.219254727183608528e-02 -3.593750000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 7.249364374271730083e-02 7.249364374271730083e-02 7.249364374271730083e-02 -3.593750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 7.826339807008617089e-02 7.826339807008617089e-02 7.826339807008617089e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 9.210511844674408588e-02 9.210511844674408588e-02 9.210511844674408588e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 8.895325370081853811e-02 8.895325370081853811e-02 8.895325370081853811e-02 -3.281250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 8.984610706500900656e-02 8.984610706500900656e-02 8.984610706500900656e-02 -3.281250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 1.101154717699076996e-01 1.101154717699076996e-01 1.101154717699076996e-01 -3.593750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 7.624802590783372191e-02 7.624802590783372191e-02 7.624802590783372191e-02 -3.593750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.238362789490923682e-01 1.238362789490923682e-01 1.238362789490923682e-01 -3.593750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 8.847748980576579381e-02 8.847748980576579381e-02 8.847748980576579381e-02 -3.593750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 9.084583390670213088e-02 9.084583390670213088e-02 9.084583390670213088e-02 -2.656250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 1.294792950361323414e-01 1.294792950361323414e-01 1.294792950361323414e-01 -2.968750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 1.006182328113592317e-01 1.006182328113592317e-01 1.006182328113592317e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 1.410307804924100517e-01 1.410307804924100517e-01 1.410307804924100517e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 1.738256462896591303e-01 1.738256462896591303e-01 1.738256462896591303e-01 -2.656250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 1.573801002763340617e-01 1.573801002763340617e-01 1.573801002763340617e-01 -2.656250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 1.723107380244893738e-01 1.723107380244893738e-01 1.723107380244893738e-01 -2.968750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 8.959858435277436028e-02 8.959858435277436028e-02 8.959858435277436028e-02 -2.968750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 8.189365733000572578e-02 8.189365733000572578e-02 8.189365733000572578e-02 -2.968750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 8.015365778429915655e-02 8.015365778429915655e-02 8.015365778429915655e-02 -2.656250000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 8.457965600539991968e-02 8.457965600539991968e-02 8.457965600539991968e-02 -2.656250000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 8.843409228342340167e-02 8.843409228342340167e-02 8.843409228342340167e-02 -2.968750000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 7.404788982820802168e-02 7.404788982820802168e-02 7.404788982820802168e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 7.350226734699585873e-02 7.350226734699585873e-02 7.350226734699585873e-02 -2.968750000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 7.579324602645177988e-02 7.579324602645177988e-02 7.579324602645177988e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.471065843489795910e-02 8.471065843489795910e-02 8.471065843489795910e-02 -3.593750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 7.447639540247863454e-02 7.447639540247863454e-02 7.447639540247863454e-02 -3.281250000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 7.446200742642075654e-02 7.446200742642075654e-02 7.446200742642075654e-02 -3.281250000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 7.729510300555882119e-02 7.729510300555882119e-02 7.729510300555882119e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 7.778315025215250256e-02 7.778315025215250256e-02 7.778315025215250256e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 5.422964598217797777e-02 5.422964598217797777e-02 5.422964598217797777e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 8.519689258101451057e-02 8.519689258101451057e-02 8.519689258101451057e-02 -3.593750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 8.581653547388204406e-02 8.581653547388204406e-02 8.581653547388204406e-02 -3.281250000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 7.168588370012371480e-02 7.168588370012371480e-02 7.168588370012371480e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -3.281250000000000000e-01 5.278918708284210948e-02 5.278918708284210948e-02 5.278918708284210948e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -3.281250000000000000e-01 6.768900399948463154e-02 6.768900399948463154e-02 6.768900399948463154e-02 -3.281250000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 8.086327736780724029e-02 8.086327736780724029e-02 8.086327736780724029e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 7.276243979312288501e-02 7.276243979312288501e-02 7.276243979312288501e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 6.490557229350711610e-02 6.490557229350711610e-02 6.490557229350711610e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 1.116636886272163592e-01 1.116636886272163592e-01 1.116636886272163592e-01 -3.593750000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 7.647862999446186638e-02 7.647862999446186638e-02 7.647862999446186638e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 9.570927955529613673e-02 9.570927955529613673e-02 9.570927955529613673e-02 -3.906250000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 1.152002922816269953e-01 1.152002922816269953e-01 1.152002922816269953e-01 -3.906250000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 1.097346396016390668e-01 1.097346396016390668e-01 1.097346396016390668e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -3.281250000000000000e-01 1.023377822017472599e-01 1.023377822017472599e-01 1.023377822017472599e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -3.281250000000000000e-01 1.043031660750073919e-01 1.043031660750073919e-01 1.043031660750073919e-01 -3.906250000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 1.303684858147887426e-01 1.303684858147887426e-01 1.303684858147887426e-01 -3.906250000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 1.669581548395495385e-01 1.669581548395495385e-01 1.669581548395495385e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 1.330119028049535357e-01 1.330119028049535357e-01 1.330119028049535357e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 1.567513725992384088e-01 1.567513725992384088e-01 1.567513725992384088e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -2.968750000000000000e-01 1.455362294598842310e-01 1.455362294598842310e-01 1.455362294598842310e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -2.656250000000000000e-01 1.596853930569658020e-01 1.596853930569658020e-01 1.596853930569658020e-01 -3.906250000000000000e-01 7.812500000000000000e-02 -3.281250000000000000e-01 7.427150716558303389e-02 7.427150716558303389e-02 7.427150716558303389e-02 -3.906250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 7.226785115109496394e-02 7.226785115109496394e-02 7.226785115109496394e-02 -4.218750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 6.392079722042057210e-02 6.392079722042057210e-02 6.392079722042057210e-02 -3.906250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 8.178756577482484968e-02 8.178756577482484968e-02 8.178756577482484968e-02 -3.906250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 1.150460411166122632e-01 1.150460411166122632e-01 1.150460411166122632e-01 -3.906250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 6.724398294552613731e-02 6.724398294552613731e-02 6.724398294552613731e-02 -4.218750000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 5.741318092142607549e-02 5.741318092142607549e-02 5.741318092142607549e-02 -4.218750000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 9.453121477911259618e-02 9.453121477911259618e-02 9.453121477911259618e-02 -4.218750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 7.895398538843120817e-02 7.895398538843120817e-02 7.895398538843120817e-02 -4.218750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 9.000603204878356023e-02 9.000603204878356023e-02 9.000603204878356023e-02 -4.531250000000000000e-01 1.562500000000000000e-02 -2.968750000000000000e-01 9.312651472287641896e-02 9.312651472287641896e-02 9.312651472287641896e-02 -4.531250000000000000e-01 1.562500000000000000e-02 -2.656250000000000000e-01 1.175887374221351728e-01 1.175887374221351728e-01 1.175887374221351728e-01 -4.531250000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 7.707864763838442879e-02 7.707864763838442879e-02 7.707864763838442879e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -3.281250000000000000e-01 5.861614919523321088e-02 5.861614919523321088e-02 5.861614919523321088e-02 -4.531250000000000000e-01 7.812500000000000000e-02 -2.968750000000000000e-01 7.103614904345290082e-02 7.103614904345290082e-02 7.103614904345290082e-02 -4.531250000000000000e-01 7.812500000000000000e-02 -2.656250000000000000e-01 6.932131629348299573e-02 6.932131629348299573e-02 6.932131629348299573e-02 -4.531250000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 9.744098738893790246e-02 9.744098738893790246e-02 9.744098738893790246e-02 -4.531250000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 9.401610736602870888e-02 9.401610736602870888e-02 9.401610736602870888e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -2.968750000000000000e-01 6.332526371926749942e-02 6.332526371926749942e-02 6.332526371926749942e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -2.656250000000000000e-01 6.232905365583350094e-02 6.232905365583350094e-02 6.232905365583350094e-02 -3.906250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 7.383673083015816763e-02 7.383673083015816763e-02 7.383673083015816763e-02 -3.906250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 6.772461522384233545e-02 6.772461522384233545e-02 6.772461522384233545e-02 -4.218750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 5.798520209564020367e-02 5.798520209564020367e-02 5.798520209564020367e-02 -4.218750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 4.535195343532818363e-02 4.535195343532818363e-02 4.535195343532818363e-02 -3.906250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 7.889844605491330709e-02 7.889844605491330709e-02 7.889844605491330709e-02 -4.218750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 5.578480772445850583e-02 5.578480772445850583e-02 5.578480772445850583e-02 -4.218750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 7.065641798377095273e-02 7.065641798377095273e-02 7.065641798377095273e-02 -3.906250000000000000e-01 2.031250000000000000e-01 -2.968750000000000000e-01 8.459572993461904333e-02 8.459572993461904333e-02 8.459572993461904333e-02 -3.906250000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 9.923372778576580733e-02 9.923372778576580733e-02 9.923372778576580733e-02 -3.906250000000000000e-01 2.343750000000000000e-01 -2.968750000000000000e-01 5.567836014089734553e-02 5.567836014089734553e-02 5.567836014089734553e-02 -3.906250000000000000e-01 2.343750000000000000e-01 -2.656250000000000000e-01 8.336927991042175634e-02 8.336927991042175634e-02 8.336927991042175634e-02 -4.218750000000000000e-01 2.031250000000000000e-01 -2.656250000000000000e-01 8.398170355701005396e-02 8.398170355701005396e-02 8.398170355701005396e-02 -4.531250000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 8.925864120495992371e-02 8.925864120495992371e-02 8.925864120495992371e-02 -4.531250000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 5.460036942623033851e-02 5.460036942623033851e-02 5.460036942623033851e-02 -4.843750000000000000e-01 1.406250000000000000e-01 -3.281250000000000000e-01 6.201922273687099363e-02 6.201922273687099363e-02 6.201922273687099363e-02 -4.843750000000000000e-01 1.718750000000000000e-01 -3.281250000000000000e-01 3.800361591261865180e-02 3.800361591261865180e-02 3.800361591261865180e-02 -4.531250000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 1.148805421419216294e-01 1.148805421419216294e-01 1.148805421419216294e-01 -4.531250000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 6.456054063560301426e-02 6.456054063560301426e-02 6.456054063560301426e-02 -4.843750000000000000e-01 1.406250000000000000e-01 -2.968750000000000000e-01 7.481519532423511198e-02 7.481519532423511198e-02 7.481519532423511198e-02 -4.843750000000000000e-01 1.406250000000000000e-01 -2.656250000000000000e-01 7.092948048691062601e-02 7.092948048691062601e-02 7.092948048691062601e-02 -4.843750000000000000e-01 1.718750000000000000e-01 -2.968750000000000000e-01 4.647147806634986666e-02 4.647147806634986666e-02 4.647147806634986666e-02 -4.843750000000000000e-01 1.718750000000000000e-01 -2.656250000000000000e-01 4.579026088338739725e-02 4.579026088338739725e-02 4.579026088338739725e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 7.646520690958921729e-02 7.646520690958921729e-02 7.646520690958921729e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 7.633169933877811952e-02 7.633169933877811952e-02 7.633169933877811952e-02 -2.656250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 8.432890229392099590e-02 8.432890229392099590e-02 8.432890229392099590e-02 -2.656250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 5.438079779866683561e-02 5.438079779866683561e-02 5.438079779866683561e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.281185811780597150e-01 1.281185811780597150e-01 1.281185811780597150e-01 -2.968750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 6.969655212149837575e-02 6.969655212149837575e-02 6.969655212149837575e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 9.668402270332056292e-02 9.668402270332056292e-02 9.668402270332056292e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 5.659168225980912292e-02 5.659168225980912292e-02 5.659168225980912292e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 7.113172459302816164e-02 7.113172459302816164e-02 7.113172459302816164e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 8.588725965108112703e-02 8.588725965108112703e-02 8.588725965108112703e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 5.495075015250961564e-02 5.495075015250961564e-02 5.495075015250961564e-02 -2.968750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 8.646269496388797604e-02 8.646269496388797604e-02 8.646269496388797604e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 3.488935808535047201e-02 3.488935808535047201e-02 3.488935808535047201e-02 -2.968750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 5.186448506708361134e-02 5.186448506708361134e-02 5.186448506708361134e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 8.222800555843351455e-02 8.222800555843351455e-02 8.222800555843351455e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 5.715510679045560094e-02 5.715510679045560094e-02 5.715510679045560094e-02 -2.656250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 1.051468361653922629e-01 1.051468361653922629e-01 1.051468361653922629e-01 -2.656250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 6.165649234000202678e-02 6.165649234000202678e-02 6.165649234000202678e-02 -2.968750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 6.991174120157914174e-02 6.991174120157914174e-02 6.991174120157914174e-02 -2.968750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 7.737089841608378593e-02 7.737089841608378593e-02 7.737089841608378593e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 9.762902209827095668e-02 9.762902209827095668e-02 9.762902209827095668e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 5.989676042786824806e-02 5.989676042786824806e-02 5.989676042786824806e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 4.647236255139031158e-02 4.647236255139031158e-02 4.647236255139031158e-02 -2.656250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 5.421573678478770753e-02 5.421573678478770753e-02 5.421573678478770753e-02 -2.656250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 4.648860491126789035e-02 4.648860491126789035e-02 4.648860491126789035e-02 -2.968750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 6.711777529829558719e-02 6.711777529829558719e-02 6.711777529829558719e-02 -3.593750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 1.572411864103916146e-01 1.572411864103916146e-01 1.572411864103916146e-01 -3.593750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 1.560495685971743651e-01 1.560495685971743651e-01 1.560495685971743651e-01 -3.281250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 9.110942540960915992e-02 9.110942540960915992e-02 9.110942540960915992e-02 -3.281250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 8.666602517275340256e-02 8.666602517275340256e-02 8.666602517275340256e-02 -3.281250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 8.943865855908179896e-02 8.943865855908179896e-02 8.943865855908179896e-02 -3.281250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 8.864063213402799402e-02 8.864063213402799402e-02 8.864063213402799402e-02 -3.593750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.236507153995831942e-01 1.236507153995831942e-01 1.236507153995831942e-01 -3.593750000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.617754359678445220e-01 1.617754359678445220e-01 1.617754359678445220e-01 -3.593750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 1.275474600632910682e-01 1.275474600632910682e-01 1.275474600632910682e-01 -3.281250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 8.579805073550726691e-02 8.579805073550726691e-02 8.579805073550726691e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 7.096492951046744213e-02 7.096492951046744213e-02 7.096492951046744213e-02 -3.281250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 6.604122405916676430e-02 6.604122405916676430e-02 6.604122405916676430e-02 -3.593750000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 1.009669668268792647e-01 1.009669668268792647e-01 1.009669668268792647e-01 -3.593750000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.207009204603690100e-01 1.207009204603690100e-01 1.207009204603690100e-01 -3.281250000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 8.029849173807721008e-02 8.029849173807721008e-02 8.029849173807721008e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 9.303329577355069768e-02 9.303329577355069768e-02 9.303329577355069768e-02 -3.593750000000000000e-01 7.812500000000000000e-02 -1.718750000000000000e-01 8.063260547488788899e-02 8.063260547488788899e-02 8.063260547488788899e-02 -3.593750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 1.032995888939836765e-01 1.032995888939836765e-01 1.032995888939836765e-01 -3.593750000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.058008752715631079e-01 1.058008752715631079e-01 1.058008752715631079e-01 -3.593750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 9.996736574364289973e-02 9.996736574364289973e-02 9.996736574364289973e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.044638658219326360e-01 1.044638658219326360e-01 1.044638658219326360e-01 -2.656250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.227429741196430918e-01 1.227429741196430918e-01 1.227429741196430918e-01 -2.656250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 8.659449800371134265e-02 8.659449800371134265e-02 8.659449800371134265e-02 -2.656250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.195320583971403589e-01 1.195320583971403589e-01 1.195320583971403589e-01 -2.656250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.286607810165301957e-01 1.286607810165301957e-01 1.286607810165301957e-01 -2.656250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 9.188010414883188148e-02 9.188010414883188148e-02 9.188010414883188148e-02 -2.656250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 1.004462758509357817e-01 1.004462758509357817e-01 1.004462758509357817e-01 -2.968750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.034450239928825926e-01 1.034450239928825926e-01 1.034450239928825926e-01 -2.968750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.125514694928173992e-01 1.125514694928173992e-01 1.125514694928173992e-01 -2.656250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 3.647376368049080192e-02 3.647376368049080192e-02 3.647376368049080192e-02 -2.656250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 5.317165571638892557e-02 5.317165571638892557e-02 5.317165571638892557e-02 -2.656250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.200727094210177759e-01 1.200727094210177759e-01 1.200727094210177759e-01 -2.968750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 6.693545715006095354e-02 6.693545715006095354e-02 6.693545715006095354e-02 -2.968750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.064123247130618760e-01 1.064123247130618760e-01 1.064123247130618760e-01 -2.656250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 8.221112743596749317e-02 8.221112743596749317e-02 8.221112743596749317e-02 -2.656250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 5.376043034279257005e-02 5.376043034279257005e-02 5.376043034279257005e-02 -2.656250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.149424034489984620e-01 1.149424034489984620e-01 1.149424034489984620e-01 -2.656250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.181310082281395585e-01 1.181310082281395585e-01 1.181310082281395585e-01 -2.968750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.112571540286551308e-01 1.112571540286551308e-01 1.112571540286551308e-01 -2.968750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.238427053846937742e-01 1.238427053846937742e-01 1.238427053846937742e-01 -3.281250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.266453856836191050e-01 1.266453856836191050e-01 1.266453856836191050e-01 -3.281250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.259585813999575532e-01 1.259585813999575532e-01 1.259585813999575532e-01 -3.281250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.231928294853972261e-01 1.231928294853972261e-01 1.231928294853972261e-01 -3.281250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.108883787720408992e-01 1.108883787720408992e-01 1.108883787720408992e-01 -3.593750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 9.637143117466380471e-02 9.637143117466380471e-02 9.637143117466380471e-02 -3.593750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.103717691974249321e-01 1.103717691974249321e-01 1.103717691974249321e-01 -3.593750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.187640545599182723e-01 1.187640545599182723e-01 1.187640545599182723e-01 -3.281250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.103709657584938525e-01 1.103709657584938525e-01 1.103709657584938525e-01 -3.281250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.098848837314253812e-01 1.098848837314253812e-01 1.098848837314253812e-01 -3.281250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 9.699982730742025272e-02 9.699982730742025272e-02 9.699982730742025272e-02 -3.593750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.006744803354589768e-01 1.006744803354589768e-01 1.006744803354589768e-01 -3.593750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.152701872434180180e-01 1.152701872434180180e-01 1.152701872434180180e-01 -3.593750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 1.083527018265506708e-01 1.083527018265506708e-01 1.083527018265506708e-01 -3.281250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 8.812950531052193837e-02 8.812950531052193837e-02 8.812950531052193837e-02 -3.281250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 9.465014706732746697e-02 9.465014706732746697e-02 9.465014706732746697e-02 -3.281250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.735168834530498083e-02 7.735168834530498083e-02 7.735168834530498083e-02 -3.281250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 1.035599255701905447e-01 1.035599255701905447e-01 1.035599255701905447e-01 -3.593750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.169789796613756871e-01 1.169789796613756871e-01 1.169789796613756871e-01 -3.281250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 1.060587934081745620e-01 1.060587934081745620e-01 1.060587934081745620e-01 -3.281250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.239471348913154941e-01 1.239471348913154941e-01 1.239471348913154941e-01 -3.593750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.193055140945168818e-01 1.193055140945168818e-01 1.193055140945168818e-01 -3.593750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 1.090380495156841045e-01 1.090380495156841045e-01 1.090380495156841045e-01 -3.593750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 1.087343439915843674e-01 1.087343439915843674e-01 1.087343439915843674e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 1.575607682402802856e-01 1.575607682402802856e-01 1.575607682402802856e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 8.260253822200910867e-02 8.260253822200910867e-02 8.260253822200910867e-02 -2.656250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 1.053244075050462497e-01 1.053244075050462497e-01 1.053244075050462497e-01 -2.656250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 7.510022020319771785e-02 7.510022020319771785e-02 7.510022020319771785e-02 -2.968750000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 9.666232615828278252e-02 9.666232615828278252e-02 9.666232615828278252e-02 -2.968750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 8.233490025180899285e-02 8.233490025180899285e-02 8.233490025180899285e-02 -2.968750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 5.986444190682280869e-02 5.986444190682280869e-02 5.986444190682280869e-02 -2.656250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 6.574740474242793398e-02 6.574740474242793398e-02 6.574740474242793398e-02 -2.656250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 6.883185116170184581e-02 6.883185116170184581e-02 6.883185116170184581e-02 -2.656250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 8.822433726210962557e-02 8.822433726210962557e-02 8.822433726210962557e-02 -2.656250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 9.815776691698580025e-02 9.815776691698580025e-02 9.815776691698580025e-02 -2.968750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 6.741166999729493459e-02 6.741166999729493459e-02 6.741166999729493459e-02 -2.968750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 8.926024850453699588e-02 8.926024850453699588e-02 8.926024850453699588e-02 -2.656250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 7.228939351185013906e-02 7.228939351185013906e-02 7.228939351185013906e-02 -2.656250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 4.696421513445183521e-02 4.696421513445183521e-02 4.696421513445183521e-02 -2.656250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 1.187945820490205751e-01 1.187945820490205751e-01 1.187945820490205751e-01 -2.968750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 4.383221181461046528e-02 4.383221181461046528e-02 4.383221181461046528e-02 -2.968750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 6.444043840192226202e-02 6.444043840192226202e-02 6.444043840192226202e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 4.428966510342809831e-02 4.428966510342809831e-02 4.428966510342809831e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 9.502140753867922840e-02 9.502140753867922840e-02 9.502140753867922840e-02 -2.656250000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 7.722758635493216783e-02 7.722758635493216783e-02 7.722758635493216783e-02 -2.656250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 1.219324247990739712e-01 1.219324247990739712e-01 1.219324247990739712e-01 -2.656250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 1.373844748606933841e-01 1.373844748606933841e-01 1.373844748606933841e-01 -2.656250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 1.538581983933904607e-01 1.538581983933904607e-01 1.538581983933904607e-01 -2.968750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 9.241531569708698324e-02 9.241531569708698324e-02 9.241531569708698324e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 7.524851955051237162e-02 7.524851955051237162e-02 7.524851955051237162e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 8.360878472622747248e-02 8.360878472622747248e-02 8.360878472622747248e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 4.288272057450803754e-02 4.288272057450803754e-02 4.288272057450803754e-02 -3.593750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 9.342545752143660565e-02 9.342545752143660565e-02 9.342545752143660565e-02 -3.281250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 8.337812070488680172e-02 8.337812070488680172e-02 8.337812070488680172e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 8.757899558704973497e-02 8.757899558704973497e-02 8.757899558704973497e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.346665043087174884e-01 1.346665043087174884e-01 1.346665043087174884e-01 -3.593750000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 7.803585339437948964e-02 7.803585339437948964e-02 7.803585339437948964e-02 -3.593750000000000000e-01 1.718750000000000000e-01 -1.406250000000000000e-01 1.121955549014275050e-01 1.121955549014275050e-01 1.121955549014275050e-01 -3.281250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 3.557106966683272475e-02 3.557106966683272475e-02 3.557106966683272475e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 5.181632405011301484e-02 5.181632405011301484e-02 5.181632405011301484e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 5.545187716257106436e-02 5.545187716257106436e-02 5.545187716257106436e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 6.055140867004495803e-02 6.055140867004495803e-02 6.055140867004495803e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 4.614445915881478649e-02 4.614445915881478649e-02 4.614445915881478649e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 7.513735534996938970e-02 7.513735534996938970e-02 7.513735534996938970e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -2.031250000000000000e-01 3.263871186598483326e-02 3.263871186598483326e-02 3.263871186598483326e-02 -3.281250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 8.103366872466119530e-02 8.103366872466119530e-02 8.103366872466119530e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 5.730786104895514016e-02 5.730786104895514016e-02 5.730786104895514016e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -1.406250000000000000e-01 7.014863340825237825e-02 7.014863340825237825e-02 7.014863340825237825e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -1.718750000000000000e-01 6.061982364618175023e-02 6.061982364618175023e-02 6.061982364618175023e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 8.150786918602952180e-02 8.150786918602952180e-02 8.150786918602952180e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -1.718750000000000000e-01 4.484336585083619625e-02 4.484336585083619625e-02 4.484336585083619625e-02 -2.656250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.212166603836470208e-01 1.212166603836470208e-01 1.212166603836470208e-01 -2.656250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 9.778571735365690354e-02 9.778571735365690354e-02 9.778571735365690354e-02 -2.656250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.317106874285799423e-01 1.317106874285799423e-01 1.317106874285799423e-01 -2.968750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 5.798319219000284269e-02 5.798319219000284269e-02 5.798319219000284269e-02 -2.968750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.811228174661831669e-01 1.811228174661831669e-01 1.811228174661831669e-01 -2.968750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.229124734902845850e-01 1.229124734902845850e-01 1.229124734902845850e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.513182541779153623e-01 1.513182541779153623e-01 1.513182541779153623e-01 -2.656250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 1.528231185721226348e-01 1.528231185721226348e-01 1.528231185721226348e-01 -2.968750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 7.627840877754536730e-02 7.627840877754536730e-02 7.627840877754536730e-02 -2.968750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 9.603955246411208235e-02 9.603955246411208235e-02 9.603955246411208235e-02 -2.968750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.188508168670224102e-01 1.188508168670224102e-01 1.188508168670224102e-01 -2.968750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 1.215259420851850514e-01 1.215259420851850514e-01 1.215259420851850514e-01 -2.656250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 1.140233162760689450e-01 1.140233162760689450e-01 1.140233162760689450e-01 -2.656250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 9.488801111630182361e-02 9.488801111630182361e-02 9.488801111630182361e-02 -2.968750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 1.007773328492635456e-01 1.007773328492635456e-01 1.007773328492635456e-01 -2.968750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.417463686530898714e-01 1.417463686530898714e-01 1.417463686530898714e-01 -2.968750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 9.072046691324649192e-02 9.072046691324649192e-02 9.072046691324649192e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 1.322592888229808250e-01 1.322592888229808250e-01 1.322592888229808250e-01 -2.656250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 1.438489242019690140e-01 1.438489242019690140e-01 1.438489242019690140e-01 -2.968750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 1.469906084036948779e-01 1.469906084036948779e-01 1.469906084036948779e-01 -2.968750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 8.230114404818604512e-02 8.230114404818604512e-02 8.230114404818604512e-02 -2.968750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 1.402806509411138047e-01 1.402806509411138047e-01 1.402806509411138047e-01 -2.968750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 1.290174260291602204e-01 1.290174260291602204e-01 1.290174260291602204e-01 -3.281250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 8.527485050961981783e-02 8.527485050961981783e-02 8.527485050961981783e-02 -3.281250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 7.174512560684696838e-02 7.174512560684696838e-02 7.174512560684696838e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 7.333636136864070398e-02 7.333636136864070398e-02 7.333636136864070398e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 8.944106950305867609e-02 8.944106950305867609e-02 8.944106950305867609e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 7.794679652516493806e-02 7.794679652516493806e-02 7.794679652516493806e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 8.528047633659775750e-02 8.528047633659775750e-02 8.528047633659775750e-02 -3.593750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 6.550945452307034567e-02 6.550945452307034567e-02 6.550945452307034567e-02 -3.281250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 9.493783390234758479e-02 9.493783390234758479e-02 9.493783390234758479e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 8.021691215689313870e-02 8.021691215689313870e-02 8.021691215689313870e-02 -3.281250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 9.591660431339972537e-02 9.591660431339972537e-02 9.591660431339972537e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 9.535007609340036272e-02 9.535007609340036272e-02 9.535007609340036272e-02 -3.593750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 1.066437261805334019e-01 1.066437261805334019e-01 1.066437261805334019e-01 -3.593750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.707048740711620063e-02 1.707048740711620063e-02 1.707048740711620063e-02 -3.281250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 7.651568412729152502e-02 7.651568412729152502e-02 7.651568412729152502e-02 -3.281250000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 7.784029788334605182e-02 7.784029788334605182e-02 7.784029788334605182e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 5.926710969032298465e-02 5.926710969032298465e-02 5.926710969032298465e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 7.385634364205538593e-02 7.385634364205538593e-02 7.385634364205538593e-02 -3.593750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 8.384025179019501117e-02 8.384025179019501117e-02 8.384025179019501117e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 6.584338851685005156e-02 6.584338851685005156e-02 6.584338851685005156e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 9.136015798897477447e-02 9.136015798897477447e-02 9.136015798897477447e-02 -3.281250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 6.064538880447980368e-02 6.064538880447980368e-02 6.064538880447980368e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 9.329607650033677757e-02 9.329607650033677757e-02 9.329607650033677757e-02 -3.281250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 1.075042445482016218e-01 1.075042445482016218e-01 1.075042445482016218e-01 -3.593750000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 8.647716116173571888e-02 8.647716116173571888e-02 8.647716116173571888e-02 -3.593750000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 8.436587244151746989e-02 8.436587244151746989e-02 8.436587244151746989e-02 -3.906250000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 1.965025086775173124e-01 1.965025086775173124e-01 1.965025086775173124e-01 -3.906250000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 1.775754634530833931e-01 1.775754634530833931e-01 1.775754634530833931e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.543223338181058391e-01 1.543223338181058391e-01 1.543223338181058391e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 1.864519833726392406e-01 1.864519833726392406e-01 1.864519833726392406e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -2.343750000000000000e-01 1.515840567126754412e-01 1.515840567126754412e-01 1.515840567126754412e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -2.031250000000000000e-01 1.667734935978504862e-01 1.667734935978504862e-01 1.667734935978504862e-01 -3.906250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 1.392751129909533536e-01 1.392751129909533536e-01 1.392751129909533536e-01 -3.906250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 9.263631041790097720e-02 9.263631041790097720e-02 9.263631041790097720e-02 -3.906250000000000000e-01 4.687500000000000000e-02 -1.718750000000000000e-01 1.572612606833054261e-01 1.572612606833054261e-01 1.572612606833054261e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 1.096366192160029562e-01 1.096366192160029562e-01 1.096366192160029562e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.070671570037068782e-01 1.070671570037068782e-01 1.070671570037068782e-01 -3.906250000000000000e-01 7.812500000000000000e-02 -2.343750000000000000e-01 1.201634870227409335e-01 1.201634870227409335e-01 1.201634870227409335e-01 -3.906250000000000000e-01 7.812500000000000000e-02 -2.031250000000000000e-01 1.166977986364267916e-01 1.166977986364267916e-01 1.166977986364267916e-01 -3.906250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 1.226064103859046822e-01 1.226064103859046822e-01 1.226064103859046822e-01 -3.906250000000000000e-01 1.093750000000000000e-01 -2.031250000000000000e-01 1.468813903568534085e-01 1.468813903568534085e-01 1.468813903568534085e-01 -4.218750000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 9.621473316474016269e-02 9.621473316474016269e-02 9.621473316474016269e-02 -3.906250000000000000e-01 1.093750000000000000e-01 -1.718750000000000000e-01 1.491195276310627316e-01 1.491195276310627316e-01 1.491195276310627316e-01 -4.218750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 7.618709937791709463e-02 7.618709937791709463e-02 7.618709937791709463e-02 -4.218750000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 7.639744842904687416e-02 7.639744842904687416e-02 7.639744842904687416e-02 -4.531250000000000000e-01 1.562500000000000000e-02 -2.343750000000000000e-01 1.265489924536345179e-01 1.265489924536345179e-01 1.265489924536345179e-01 -4.531250000000000000e-01 1.562500000000000000e-02 -2.031250000000000000e-01 4.678104723600685910e-02 4.678104723600685910e-02 4.678104723600685910e-02 -4.531250000000000000e-01 1.562500000000000000e-02 -1.718750000000000000e-01 9.177161488748282470e-02 9.177161488748282470e-02 9.177161488748282470e-02 -4.531250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.091625845181917742e-01 1.091625845181917742e-01 1.091625845181917742e-01 -4.531250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 9.413745121893687950e-02 9.413745121893687950e-02 9.413745121893687950e-02 -4.843750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 9.841249532338744443e-02 9.841249532338744443e-02 9.841249532338744443e-02 -4.843750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 9.266443697519388678e-02 9.266443697519388678e-02 9.266443697519388678e-02 -4.531250000000000000e-01 1.093750000000000000e-01 -2.343750000000000000e-01 6.575142416575809057e-02 6.575142416575809057e-02 6.575142416575809057e-02 -4.531250000000000000e-01 1.093750000000000000e-01 -1.406250000000000000e-01 5.487485321780408154e-02 5.487485321780408154e-02 5.487485321780408154e-02 -4.843750000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 9.279221178305373241e-02 9.279221178305373241e-02 9.279221178305373241e-02 -3.906250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 8.777830465186338416e-02 8.777830465186338416e-02 8.777830465186338416e-02 -3.906250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 9.247639066245288975e-02 9.247639066245288975e-02 9.247639066245288975e-02 -3.906250000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 1.098656010780655751e-01 1.098656010780655751e-01 1.098656010780655751e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.050873778011871817e-01 1.050873778011871817e-01 1.050873778011871817e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.107598292656684497e-01 1.107598292656684497e-01 1.107598292656684497e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 1.068156698954994543e-01 1.068156698954994543e-01 1.068156698954994543e-01 -3.906250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 2.388338472035981541e-01 2.388338472035981541e-01 2.388338472035981541e-01 -3.906250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.003627078496235892e-01 1.003627078496235892e-01 1.003627078496235892e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 1.328167218401216099e-01 1.328167218401216099e-01 1.328167218401216099e-01 -4.218750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.458679040566709939e-01 1.458679040566709939e-01 1.458679040566709939e-01 -4.218750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 6.600159267903711602e-02 6.600159267903711602e-02 6.600159267903711602e-02 -3.906250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 9.983719169824975537e-02 9.983719169824975537e-02 9.983719169824975537e-02 -3.906250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 9.283239249831040651e-02 9.283239249831040651e-02 9.283239249831040651e-02 -3.906250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 8.537129320335772042e-02 8.537129320335772042e-02 8.537129320335772042e-02 -3.906250000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 8.326319030106572872e-02 8.326319030106572872e-02 8.326319030106572872e-02 -4.218750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.082241482686305684e-01 1.082241482686305684e-01 1.082241482686305684e-01 -4.218750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 9.591660431339972537e-02 9.591660431339972537e-02 9.591660431339972537e-02 -3.906250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.052464690015071092e-01 1.052464690015071092e-01 1.052464690015071092e-01 -3.906250000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 9.645178901009938965e-02 9.645178901009938965e-02 9.645178901009938965e-02 -4.218750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 8.590011858572188519e-02 8.590011858572188519e-02 8.590011858572188519e-02 -4.218750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 7.594620603662222136e-02 7.594620603662222136e-02 7.594620603662222136e-02 -4.531250000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 1.061624425198838956e-01 1.061624425198838956e-01 1.061624425198838956e-01 -4.531250000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 1.352359685085264551e-01 1.352359685085264551e-01 1.352359685085264551e-01 -4.531250000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 9.778491378902803843e-02 9.778491378902803843e-02 9.778491378902803843e-02 -4.531250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 4.926994007368563216e-02 4.926994007368563216e-02 4.926994007368563216e-02 -4.843750000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 4.664604306147147189e-02 4.664604306147147189e-02 4.664604306147147189e-02 -4.531250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.054834982366616158e-01 1.054834982366616158e-01 1.054834982366616158e-01 -4.531250000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 9.670812996870659095e-02 9.670812996870659095e-02 9.670812996870659095e-02 -4.843750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.194501169145076452e-01 1.194501169145076452e-01 1.194501169145076452e-01 -4.843750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.065288290073095612e-01 1.065288290073095612e-01 1.065288290073095612e-01 -4.843750000000000000e-01 1.093750000000000000e-01 -1.093750000000000000e-01 7.964673689285671487e-02 7.964673689285671487e-02 7.964673689285671487e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -7.812500000000000000e-02 7.467236098787964627e-02 7.467236098787964627e-02 7.467236098787964627e-02 -4.531250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 6.517069580069420609e-02 6.517069580069420609e-02 6.517069580069420609e-02 -4.531250000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 7.529642540591741096e-02 7.529642540591741096e-02 7.529642540591741096e-02 -4.843750000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.275659352120269985e-01 1.275659352120269985e-01 1.275659352120269985e-01 -4.843750000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 9.178366925709516289e-02 9.178366925709516289e-02 9.178366925709516289e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -4.687500000000000000e-02 6.580496286545536866e-02 6.580496286545536866e-02 6.580496286545536866e-02 -4.843750000000000000e-01 1.093750000000000000e-01 -1.562500000000000000e-02 5.232060625756659172e-02 5.232060625756659172e-02 5.232060625756659172e-02 -3.906250000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.166728939839943718e-01 1.166728939839943718e-01 1.166728939839943718e-01 -3.906250000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 1.277763909547900700e-01 1.277763909547900700e-01 1.277763909547900700e-01 -4.218750000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 1.164447348737640137e-01 1.164447348737640137e-01 1.164447348737640137e-01 -4.218750000000000000e-01 1.406250000000000000e-01 -2.031250000000000000e-01 1.275305914455133194e-01 1.275305914455133194e-01 1.275305914455133194e-01 -4.218750000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 1.119031092280891732e-01 1.119031092280891732e-01 1.119031092280891732e-01 -4.218750000000000000e-01 1.718750000000000000e-01 -2.031250000000000000e-01 1.062532358181063341e-01 1.062532358181063341e-01 1.062532358181063341e-01 -3.906250000000000000e-01 1.406250000000000000e-01 -1.718750000000000000e-01 1.452607698570952399e-01 1.452607698570952399e-01 1.452607698570952399e-01 -3.906250000000000000e-01 1.406250000000000000e-01 -1.406250000000000000e-01 1.311452144334214476e-01 1.311452144334214476e-01 1.311452144334214476e-01 -3.906250000000000000e-01 1.718750000000000000e-01 -1.718750000000000000e-01 1.095217263168734995e-01 1.095217263168734995e-01 1.095217263168734995e-01 -3.906250000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 8.117753661761516193e-02 8.117753661761516193e-02 8.117753661761516193e-02 -3.906250000000000000e-01 2.031250000000000000e-01 -2.031250000000000000e-01 9.210913655348085260e-02 9.210913655348085260e-02 9.210913655348085260e-02 -3.906250000000000000e-01 2.343750000000000000e-01 -2.343750000000000000e-01 6.671969739674793454e-02 6.671969739674793454e-02 6.671969739674793454e-02 -4.218750000000000000e-01 2.031250000000000000e-01 -2.343750000000000000e-01 7.770148774388713209e-02 7.770148774388713209e-02 7.770148774388713209e-02 -3.906250000000000000e-01 2.031250000000000000e-01 -1.406250000000000000e-01 7.432512057574970632e-02 7.432512057574970632e-02 7.432512057574970632e-02 -4.531250000000000000e-01 1.406250000000000000e-01 -2.343750000000000000e-01 6.699896307750498325e-02 6.699896307750498325e-02 6.699896307750498325e-02 -4.531250000000000000e-01 1.718750000000000000e-01 -2.343750000000000000e-01 5.178713797737186098e-02 5.178713797737186098e-02 5.178713797737186098e-02 -3.906250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 9.171455751356094588e-02 9.171455751356094588e-02 9.171455751356094588e-02 -3.906250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 8.859241276110335628e-02 8.859241276110335628e-02 8.859241276110335628e-02 -3.906250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 8.885199337774173090e-02 8.885199337774173090e-02 8.885199337774173090e-02 -4.218750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 9.751973702154116685e-02 9.751973702154116685e-02 9.751973702154116685e-02 -4.218750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.131829529063366757e-01 1.131829529063366757e-01 1.131829529063366757e-01 -4.218750000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 8.451616395361914724e-02 8.451616395361914724e-02 8.451616395361914724e-02 -4.218750000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.188106491438814527e-01 1.188106491438814527e-01 1.188106491438814527e-01 -3.906250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 9.390842458831404060e-02 9.390842458831404060e-02 9.390842458831404060e-02 -3.906250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 1.163804645850650965e-01 1.163804645850650965e-01 1.163804645850650965e-01 -4.218750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.087656787415606369e-01 1.087656787415606369e-01 1.087656787415606369e-01 -4.218750000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 1.579373592697798090e-01 1.579373592697798090e-01 1.579373592697798090e-01 -4.218750000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.303957959451326198e-01 1.303957959451326198e-01 1.303957959451326198e-01 -4.218750000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 1.688288296105107944e-01 1.688288296105107944e-01 1.688288296105107944e-01 -3.906250000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 1.111117330508825801e-01 1.111117330508825801e-01 1.111117330508825801e-01 -3.906250000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 8.388847401137849991e-02 8.388847401137849991e-02 8.388847401137849991e-02 -3.906250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 1.046213512624864367e-01 1.046213512624864367e-01 1.046213512624864367e-01 -4.218750000000000000e-01 2.031250000000000000e-01 -1.093750000000000000e-01 8.131095577445290878e-02 8.131095577445290878e-02 8.131095577445290878e-02 -4.218750000000000000e-01 2.031250000000000000e-01 -7.812500000000000000e-02 1.115712945806575929e-01 1.115712945806575929e-01 1.115712945806575929e-01 -4.218750000000000000e-01 2.343750000000000000e-01 -1.093750000000000000e-01 5.279200113240328091e-02 5.279200113240328091e-02 5.279200113240328091e-02 -4.218750000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 1.072881114820064125e-01 1.072881114820064125e-01 1.072881114820064125e-01 -4.218750000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 1.104400614776505918e-01 1.104400614776505918e-01 1.104400614776505918e-01 -4.218750000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 1.339701300558272246e-01 1.339701300558272246e-01 1.339701300558272246e-01 -4.531250000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 7.342984428515351991e-02 7.342984428515351991e-02 7.342984428515351991e-02 -4.531250000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 1.075821808645943400e-01 1.075821808645943400e-01 1.075821808645943400e-01 -4.531250000000000000e-01 1.718750000000000000e-01 -1.093750000000000000e-01 5.841114016808642700e-02 5.841114016808642700e-02 5.841114016808642700e-02 -4.531250000000000000e-01 1.718750000000000000e-01 -7.812500000000000000e-02 1.140072482251257430e-01 1.140072482251257430e-01 1.140072482251257430e-01 -4.843750000000000000e-01 1.406250000000000000e-01 -1.093750000000000000e-01 4.126217496213647334e-02 4.126217496213647334e-02 4.126217496213647334e-02 -4.843750000000000000e-01 1.406250000000000000e-01 -7.812500000000000000e-02 7.517834867390177367e-02 7.517834867390177367e-02 7.517834867390177367e-02 -4.531250000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 1.010537483285881138e-01 1.010537483285881138e-01 1.010537483285881138e-01 -4.531250000000000000e-01 1.406250000000000000e-01 -1.562500000000000000e-02 9.430138566998143290e-02 9.430138566998143290e-02 9.430138566998143290e-02 -4.531250000000000000e-01 1.718750000000000000e-01 -4.687500000000000000e-02 1.036981286485851583e-01 1.036981286485851583e-01 1.036981286485851583e-01 -4.531250000000000000e-01 1.718750000000000000e-01 -1.562500000000000000e-02 1.197658321683228583e-01 1.197658321683228583e-01 1.197658321683228583e-01 -4.843750000000000000e-01 1.406250000000000000e-01 -4.687500000000000000e-02 7.130093081745082773e-02 7.130093081745082773e-02 7.130093081745082773e-02 -4.531250000000000000e-01 2.343750000000000000e-01 -7.812500000000000000e-02 7.427657110241160654e-02 7.427657110241160654e-02 7.427657110241160654e-02 -4.531250000000000000e-01 2.031250000000000000e-01 -4.687500000000000000e-02 1.015495260387405674e-01 1.015495260387405674e-01 1.015495260387405674e-01 -4.531250000000000000e-01 2.031250000000000000e-01 -1.562500000000000000e-02 9.974880179427753069e-02 9.974880179427753069e-02 9.974880179427753069e-02 -4.531250000000000000e-01 2.343750000000000000e-01 -4.687500000000000000e-02 9.500855006182276630e-02 9.500855006182276630e-02 9.500855006182276630e-02 -4.531250000000000000e-01 2.343750000000000000e-01 -1.562500000000000000e-02 8.273997359045862088e-02 8.273997359045862088e-02 8.273997359045862088e-02 -2.656250000000000000e-01 2.656250000000000000e-01 -3.593750000000000000e-01 9.120827200055652006e-02 9.120827200055652006e-02 9.120827200055652006e-02 -2.656250000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 9.957523588207810306e-02 9.957523588207810306e-02 9.957523588207810306e-02 -2.656250000000000000e-01 2.968750000000000000e-01 -3.593750000000000000e-01 8.640000807650227710e-02 8.640000807650227710e-02 8.640000807650227710e-02 -2.656250000000000000e-01 2.968750000000000000e-01 -3.281250000000000000e-01 1.187913686296633575e-01 1.187913686296633575e-01 1.187913686296633575e-01 -2.968750000000000000e-01 2.656250000000000000e-01 -3.281250000000000000e-01 6.230019296415285901e-02 6.230019296415285901e-02 6.230019296415285901e-02 -2.656250000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 9.437933477708314312e-02 9.437933477708314312e-02 9.437933477708314312e-02 -2.656250000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 9.078797224168666524e-02 9.078797224168666524e-02 9.078797224168666524e-02 -2.656250000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 5.651546528232443550e-02 5.651546528232443550e-02 5.651546528232443550e-02 -2.968750000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 7.846610599578840439e-02 7.846610599578840439e-02 7.846610599578840439e-02 -2.968750000000000000e-01 2.656250000000000000e-01 -2.656250000000000000e-01 6.890652915145371871e-02 6.890652915145371871e-02 6.890652915145371871e-02 -2.968750000000000000e-01 2.968750000000000000e-01 -2.968750000000000000e-01 3.071637241866453927e-02 3.071637241866453927e-02 3.071637241866453927e-02 -2.968750000000000000e-01 2.968750000000000000e-01 -2.656250000000000000e-01 5.794178812245213278e-02 5.794178812245213278e-02 5.794178812245213278e-02 -2.656250000000000000e-01 3.281250000000000000e-01 -3.281250000000000000e-01 9.238799267124420123e-02 9.238799267124420123e-02 9.238799267124420123e-02 -3.281250000000000000e-01 2.656250000000000000e-01 -2.968750000000000000e-01 4.960458471482809273e-02 4.960458471482809273e-02 4.960458471482809273e-02 -3.281250000000000000e-01 2.656250000000000000e-01 -2.656250000000000000e-01 1.120758451251896992e-01 1.120758451251896992e-01 1.120758451251896992e-01 -2.656250000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 1.408364221150819606e-01 1.408364221150819606e-01 1.408364221150819606e-01 -2.656250000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 6.337205120302487338e-02 6.337205120302487338e-02 6.337205120302487338e-02 -2.656250000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 7.443194538991065867e-02 7.443194538991065867e-02 7.443194538991065867e-02 -2.968750000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 8.703330412899144830e-02 8.703330412899144830e-02 8.703330412899144830e-02 -2.968750000000000000e-01 2.656250000000000000e-01 -2.031250000000000000e-01 9.027846633938313436e-02 9.027846633938313436e-02 9.027846633938313436e-02 -2.968750000000000000e-01 2.968750000000000000e-01 -2.343750000000000000e-01 7.085166942353565700e-02 7.085166942353565700e-02 7.085166942353565700e-02 -2.968750000000000000e-01 2.968750000000000000e-01 -2.031250000000000000e-01 7.316080932134229331e-02 7.316080932134229331e-02 7.316080932134229331e-02 -2.656250000000000000e-01 2.656250000000000000e-01 -1.718750000000000000e-01 1.727996543022476961e-01 1.727996543022476961e-01 1.727996543022476961e-01 -2.656250000000000000e-01 2.656250000000000000e-01 -1.406250000000000000e-01 1.489010971691436536e-01 1.489010971691436536e-01 1.489010971691436536e-01 -2.656250000000000000e-01 2.968750000000000000e-01 -1.718750000000000000e-01 1.255545288891825317e-01 1.255545288891825317e-01 1.255545288891825317e-01 -2.656250000000000000e-01 2.968750000000000000e-01 -1.406250000000000000e-01 1.411689192189375386e-01 1.411689192189375386e-01 1.411689192189375386e-01 -2.656250000000000000e-01 3.281250000000000000e-01 -1.718750000000000000e-01 1.315797615062837544e-01 1.315797615062837544e-01 1.315797615062837544e-01 -2.656250000000000000e-01 3.281250000000000000e-01 -1.406250000000000000e-01 1.398349068350207280e-01 1.398349068350207280e-01 1.398349068350207280e-01 -2.656250000000000000e-01 3.593750000000000000e-01 -1.718750000000000000e-01 8.316915621218366750e-02 8.316915621218366750e-02 8.316915621218366750e-02 -2.656250000000000000e-01 3.593750000000000000e-01 -1.406250000000000000e-01 1.092035605091300904e-01 1.092035605091300904e-01 1.092035605091300904e-01 -3.281250000000000000e-01 2.656250000000000000e-01 -2.343750000000000000e-01 6.334745160155316746e-02 6.334745160155316746e-02 6.334745160155316746e-02 -2.656250000000000000e-01 2.656250000000000000e-01 -1.093750000000000000e-01 1.018653115450473823e-01 1.018653115450473823e-01 1.018653115450473823e-01 -2.656250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 1.159908248607110226e-01 1.159908248607110226e-01 1.159908248607110226e-01 -2.656250000000000000e-01 2.968750000000000000e-01 -1.093750000000000000e-01 7.138436824508419265e-02 7.138436824508419265e-02 7.138436824508419265e-02 -2.656250000000000000e-01 2.968750000000000000e-01 -7.812500000000000000e-02 8.990879126738215987e-02 8.990879126738215987e-02 8.990879126738215987e-02 -2.968750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 7.031092868435924459e-02 7.031092868435924459e-02 7.031092868435924459e-02 -2.656250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 1.418861123995395490e-01 1.418861123995395490e-01 1.418861123995395490e-01 -2.656250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 1.214881856814335054e-01 1.214881856814335054e-01 1.214881856814335054e-01 -2.656250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 1.152999126685312625e-01 1.152999126685312625e-01 1.152999126685312625e-01 -2.968750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 1.219814275171782203e-01 1.219814275171782203e-01 1.219814275171782203e-01 -3.281250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 6.810395819082218360e-02 6.810395819082218360e-02 6.810395819082218360e-02 -3.593750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 6.491811302487522639e-02 6.491811302487522639e-02 6.491811302487522639e-02 -3.593750000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 1.007829575923218091e-01 1.007829575923218091e-01 1.007829575923218091e-01 -3.906250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 8.115101350583704687e-02 8.115101350583704687e-02 8.115101350583704687e-02 -4.218750000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 7.633997826141931953e-02 7.633997826141931953e-02 7.633997826141931953e-02 -3.906250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 1.049772993622863360e-01 1.049772993622863360e-01 1.049772993622863360e-01 -3.906250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 1.073692618834786311e-01 1.073692618834786311e-01 1.073692618834786311e-01 -3.906250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 5.841765222757341197e-02 5.841765222757341197e-02 5.841765222757341197e-02 -3.906250000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 7.524538477037975848e-02 7.524538477037975848e-02 7.524538477037975848e-02 -4.218750000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 1.090484943942586632e-01 1.090484943942586632e-01 1.090484943942586632e-01 -4.218750000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 7.129538439578859965e-02 7.129538439578859965e-02 7.129538439578859965e-02 -4.218750000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 6.820862084336933029e-02 6.820862084336933029e-02 6.820862084336933029e-02 -4.531250000000000000e-01 2.656250000000000000e-01 -7.812500000000000000e-02 5.386881007210931466e-02 5.386881007210931466e-02 5.386881007210931466e-02 -4.531250000000000000e-01 2.656250000000000000e-01 -4.687500000000000000e-02 1.041617500322029044e-01 1.041617500322029044e-01 1.041617500322029044e-01 -4.531250000000000000e-01 2.656250000000000000e-01 -1.562500000000000000e-02 9.679571963882409313e-02 9.679571963882409313e-02 9.679571963882409313e-02 -4.531250000000000000e-01 2.968750000000000000e-01 -4.687500000000000000e-02 5.387202608558376571e-02 5.387202608558376571e-02 5.387202608558376571e-02 -4.531250000000000000e-01 2.968750000000000000e-01 -1.562500000000000000e-02 6.218603636640014642e-02 6.218603636640014642e-02 6.218603636640014642e-02 -1.093750000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 1.092091846631216834e-01 1.092091846631216834e-01 1.092091846631216834e-01 -1.093750000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 7.929027483216109784e-02 7.929027483216109784e-02 7.929027483216109784e-02 -1.406250000000000000e-01 5.156250000000000000e-01 -4.687500000000000000e-02 7.075151168365031995e-02 7.075151168365031995e-02 7.075151168365031995e-02 -1.406250000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 1.291499626241626453e-01 1.291499626241626453e-01 1.291499626241626453e-01 -1.406250000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 1.013309663874588512e-01 1.013309663874588512e-01 1.013309663874588512e-01 -1.718750000000000000e-01 5.156250000000000000e-01 -4.687500000000000000e-02 6.540856663314670305e-02 6.540856663314670305e-02 6.540856663314670305e-02 -1.718750000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 1.129290746742780960e-01 1.129290746742780960e-01 1.129290746742780960e-01 -1.718750000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 1.928907347801659886e-02 1.928907347801659886e-02 1.928907347801659886e-02 -1.406250000000000000e-01 5.781250000000000000e-01 -1.562500000000000000e-02 3.535490410951176721e-02 3.535490410951176721e-02 3.535490410951176721e-02 -1.406250000000000000e-01 6.093750000000000000e-01 -1.562500000000000000e-02 2.536457487381348769e-02 2.536457487381348769e-02 2.536457487381348769e-02 -1.718750000000000000e-01 5.781250000000000000e-01 -1.562500000000000000e-02 4.393425250818062955e-02 4.393425250818062955e-02 4.393425250818062955e-02 -1.718750000000000000e-01 6.093750000000000000e-01 -1.562500000000000000e-02 3.405419924231621598e-02 3.405419924231621598e-02 3.405419924231621598e-02 -2.031250000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 6.948731093625107325e-02 6.948731093625107325e-02 6.948731093625107325e-02 -2.031250000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 5.252522879644858783e-02 5.252522879644858783e-02 5.252522879644858783e-02 -2.343750000000000000e-01 5.156250000000000000e-01 -1.562500000000000000e-02 6.844310649159135451e-02 6.844310649159135451e-02 6.844310649159135451e-02 -2.343750000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 6.478330006025226351e-02 6.478330006025226351e-02 6.478330006025226351e-02 -2.031250000000000000e-01 5.781250000000000000e-01 -1.562500000000000000e-02 5.431551311277061506e-02 5.431551311277061506e-02 5.431551311277061506e-02 -2.031250000000000000e-01 6.093750000000000000e-01 -1.562500000000000000e-02 3.765388512194933757e-02 3.765388512194933757e-02 3.765388512194933757e-02 -2.343750000000000000e-01 5.781250000000000000e-01 -1.562500000000000000e-02 4.928063392924675323e-02 4.928063392924675323e-02 4.928063392924675323e-02 -2.343750000000000000e-01 6.093750000000000000e-01 -1.562500000000000000e-02 2.802857486159909470e-02 2.802857486159909470e-02 2.802857486159909470e-02 -2.656250000000000000e-01 5.468750000000000000e-01 -1.562500000000000000e-02 6.959020332738881376e-02 6.959020332738881376e-02 6.959020332738881376e-02 -5.156250000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 1.053485121815697784e-01 1.053485121815697784e-01 1.053485121815697784e-01 -5.156250000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 9.502622909197956658e-02 9.502622909197956658e-02 9.502622909197956658e-02 -5.468750000000000000e-01 1.562500000000000000e-02 -1.406250000000000000e-01 6.006631185918163973e-02 6.006631185918163973e-02 6.006631185918163973e-02 -5.468750000000000000e-01 4.687500000000000000e-02 -1.406250000000000000e-01 5.436552183011542083e-02 5.436552183011542083e-02 5.436552183011542083e-02 -5.156250000000000000e-01 7.812500000000000000e-02 -1.406250000000000000e-01 8.784018680139805968e-02 8.784018680139805968e-02 8.784018680139805968e-02 -5.468750000000000000e-01 1.562500000000000000e-02 -1.093750000000000000e-01 5.957775515423153340e-02 5.957775515423153340e-02 5.957775515423153340e-02 -5.468750000000000000e-01 1.562500000000000000e-02 -7.812500000000000000e-02 5.875016853962568286e-02 5.875016853962568286e-02 5.875016853962568286e-02 -5.468750000000000000e-01 4.687500000000000000e-02 -1.093750000000000000e-01 7.345106481169923207e-02 7.345106481169923207e-02 7.345106481169923207e-02 -5.468750000000000000e-01 4.687500000000000000e-02 -7.812500000000000000e-02 6.787630439346205302e-02 6.787630439346205302e-02 6.787630439346205302e-02 -5.156250000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 8.175782796531680385e-02 8.175782796531680385e-02 8.175782796531680385e-02 -5.156250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 8.486496777147523041e-02 8.486496777147523041e-02 8.486496777147523041e-02 -5.156250000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 1.340400087131231321e-01 1.340400087131231321e-01 1.340400087131231321e-01 -5.156250000000000000e-01 4.687500000000000000e-02 -1.562500000000000000e-02 1.081036291215148049e-01 1.081036291215148049e-01 1.081036291215148049e-01 -5.468750000000000000e-01 1.562500000000000000e-02 -4.687500000000000000e-02 7.109362299982607825e-02 7.109362299982607825e-02 7.109362299982607825e-02 -5.468750000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 1.004727926024436419e-01 1.004727926024436419e-01 1.004727926024436419e-01 -5.468750000000000000e-01 4.687500000000000000e-02 -4.687500000000000000e-02 7.113558298122352186e-02 7.113558298122352186e-02 7.113558298122352186e-02 -5.156250000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 1.026929368890827921e-01 1.026929368890827921e-01 1.026929368890827921e-01 -5.156250000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 1.045305561226474445e-01 1.045305561226474445e-01 1.045305561226474445e-01 -5.468750000000000000e-01 7.812500000000000000e-02 -1.093750000000000000e-01 3.630866592414706828e-02 3.630866592414706828e-02 3.630866592414706828e-02 -5.468750000000000000e-01 7.812500000000000000e-02 -7.812500000000000000e-02 5.849547531739980599e-02 5.849547531739980599e-02 5.849547531739980599e-02 -5.156250000000000000e-01 7.812500000000000000e-02 -4.687500000000000000e-02 1.480578857785376512e-01 1.480578857785376512e-01 1.480578857785376512e-01 -5.156250000000000000e-01 7.812500000000000000e-02 -1.562500000000000000e-02 1.210238607992700083e-01 1.210238607992700083e-01 1.210238607992700083e-01 -5.781250000000000000e-01 1.562500000000000000e-02 -1.562500000000000000e-02 9.408923514036145186e-02 9.408923514036145186e-02 9.408923514036145186e-02 -1.562500000000000000e-02 1.562500000000000000e-02 1.562500000000000000e-02 4.093712585464929221e-01 4.093712585464929221e-01 4.093712585464929221e-01 -1.562500000000000000e-02 1.562500000000000000e-02 4.687500000000000000e-02 3.777717541866543738e-01 3.777717541866543738e-01 3.777717541866543738e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.562500000000000000e-02 3.456102857440805920e-01 3.456102857440805920e-01 3.456102857440805920e-01 -1.562500000000000000e-02 4.687500000000000000e-02 4.687500000000000000e-02 4.755003742912752851e-01 4.755003742912752851e-01 4.755003742912752851e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.562500000000000000e-02 1.947183551875846519e-01 1.947183551875846519e-01 1.947183551875846519e-01 -4.687500000000000000e-02 1.562500000000000000e-02 4.687500000000000000e-02 1.086025772171361342e-01 1.086025772171361342e-01 1.086025772171361342e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.562500000000000000e-02 2.861007033859099824e-01 2.861007033859099824e-01 2.861007033859099824e-01 -4.687500000000000000e-02 4.687500000000000000e-02 4.687500000000000000e-02 1.067843343860376548e-01 1.067843343860376548e-01 1.067843343860376548e-01 -1.562500000000000000e-02 1.562500000000000000e-02 7.812500000000000000e-02 8.702767842458014602e-02 8.702767842458014602e-02 8.702767842458014602e-02 -1.562500000000000000e-02 1.562500000000000000e-02 1.093750000000000000e-01 1.198148362060462713e-01 1.198148362060462713e-01 1.198148362060462713e-01 -1.562500000000000000e-02 4.687500000000000000e-02 7.812500000000000000e-02 1.856974610745987797e-01 1.856974610745987797e-01 1.856974610745987797e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.093750000000000000e-01 1.309219157640264530e-01 1.309219157640264530e-01 1.309219157640264530e-01 -1.562500000000000000e-02 7.812500000000000000e-02 4.687500000000000000e-02 8.910416962877190095e-01 8.910416962877190095e-01 8.910416962877190095e-01 -4.687500000000000000e-02 7.812500000000000000e-02 4.687500000000000000e-02 5.169937413567602391e-01 5.169937413567602391e-01 5.169937413567602391e-01 -4.687500000000000000e-02 1.093750000000000000e-01 4.687500000000000000e-02 9.759357989437822400e-01 9.759357989437822400e-01 9.759357989437822400e-01 -1.562500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 5.092984593516746150e-01 5.092984593516746150e-01 5.092984593516746150e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 2.789421309234931812e-01 2.789421309234931812e-01 2.789421309234931812e-01 -1.562500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 8.964441864162341345e-01 8.964441864162341345e-01 8.964441864162341345e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 2.362412336969660909e-01 2.362412336969660909e-01 2.362412336969660909e-01 -4.687500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 1.918120987287507129e-01 1.918120987287507129e-01 1.918120987287507129e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 1.976036398945525130e-01 1.976036398945525130e-01 1.976036398945525130e-01 -4.687500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 -7.812500000000000000e-02 1.562500000000000000e-02 1.562500000000000000e-02 2.316173183267284663e-01 2.316173183267284663e-01 2.316173183267284663e-01 -7.812500000000000000e-02 1.562500000000000000e-02 4.687500000000000000e-02 1.923691192837844732e-01 1.923691192837844732e-01 1.923691192837844732e-01 -7.812500000000000000e-02 4.687500000000000000e-02 1.562500000000000000e-02 3.178692537093874559e-01 3.178692537093874559e-01 3.178692537093874559e-01 -7.812500000000000000e-02 4.687500000000000000e-02 4.687500000000000000e-02 1.408259813625260259e-01 1.408259813625260259e-01 1.408259813625260259e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 2.198782464772820189e-01 2.198782464772820189e-01 2.198782464772820189e-01 -1.093750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.582850419601971870e-01 1.582850419601971870e-01 1.582850419601971870e-01 -1.093750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 6.582431369661486675e-01 6.582431369661486675e-01 6.582431369661486675e-01 -1.093750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 1.611716335276463519e-01 1.611716335276463519e-01 1.611716335276463519e-01 -7.812500000000000000e-02 1.562500000000000000e-02 7.812500000000000000e-02 1.824007577782187084e-01 1.824007577782187084e-01 1.824007577782187084e-01 -7.812500000000000000e-02 4.687500000000000000e-02 7.812500000000000000e-02 2.186362051082494373e-01 2.186362051082494373e-01 2.186362051082494373e-01 -7.812500000000000000e-02 4.687500000000000000e-02 1.093750000000000000e-01 1.850826004373893330e-01 1.850826004373893330e-01 1.850826004373893330e-01 -1.093750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 1.959711994493687215e-01 1.959711994493687215e-01 1.959711994493687215e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.685141096880509448e-01 1.685141096880509448e-01 1.685141096880509448e-01 -1.093750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 2.580736909251399869e-01 2.580736909251399869e-01 2.580736909251399869e-01 -1.093750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.725877106648759929e-01 1.725877106648759929e-01 1.725877106648759929e-01 -7.812500000000000000e-02 7.812500000000000000e-02 1.562500000000000000e-02 7.096114674908650111e-01 7.096114674908650111e-01 7.096114674908650111e-01 -7.812500000000000000e-02 7.812500000000000000e-02 4.687500000000000000e-02 5.367537978197731707e-01 5.367537978197731707e-01 5.367537978197731707e-01 -7.812500000000000000e-02 1.093750000000000000e-01 4.687500000000000000e-02 5.942047914677330844e-01 5.942047914677330844e-01 5.942047914677330844e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 7.998655230714289965e-01 7.998655230714289965e-01 7.998655230714289965e-01 -1.093750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 5.923208207393334535e-01 5.923208207393334535e-01 5.923208207393334535e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 6.928315995787062143e-01 6.928315995787062143e-01 6.928315995787062143e-01 -1.093750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 2.968457845220473512e-01 2.968457845220473512e-01 2.968457845220473512e-01 -7.812500000000000000e-02 7.812500000000000000e-02 7.812500000000000000e-02 2.140971350395405592e-01 2.140971350395405592e-01 2.140971350395405592e-01 -7.812500000000000000e-02 7.812500000000000000e-02 1.093750000000000000e-01 2.190068938807893106e-01 2.190068938807893106e-01 2.190068938807893106e-01 -7.812500000000000000e-02 1.093750000000000000e-01 7.812500000000000000e-02 1.031011217878906733e-01 1.031011217878906733e-01 1.031011217878906733e-01 -7.812500000000000000e-02 1.093750000000000000e-01 1.093750000000000000e-01 1.515141932916450884e-01 1.515141932916450884e-01 1.515141932916450884e-01 -1.093750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 1.631066758706596898e-01 1.631066758706596898e-01 1.631066758706596898e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.828727557251152436e-01 1.828727557251152436e-01 1.828727557251152436e-01 -1.093750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.408372252498515387e-01 1.408372252498515387e-01 1.408372252498515387e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.373539544245331034e-01 1.373539544245331034e-01 1.373539544245331034e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.406250000000000000e-01 1.773009162956261098e-01 1.773009162956261098e-01 1.773009162956261098e-01 -1.562500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 1.692752159605236950e-01 1.692752159605236950e-01 1.692752159605236950e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 1.352006281113215247e-01 1.352006281113215247e-01 1.352006281113215247e-01 -1.562500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 1.762548990965896734e-01 1.762548990965896734e-01 1.762548990965896734e-01 -4.687500000000000000e-02 1.562500000000000000e-02 1.406250000000000000e-01 9.239281438236550403e-02 9.239281438236550403e-02 9.239281438236550403e-02 -4.687500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 1.140514353575200202e-01 1.140514353575200202e-01 1.140514353575200202e-01 -4.687500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 8.762400090290529964e-02 8.762400090290529964e-02 8.762400090290529964e-02 -1.562500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 1.505987359618384258e-01 1.505987359618384258e-01 1.505987359618384258e-01 -1.562500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 2.124144767428147729e-01 2.124144767428147729e-01 2.124144767428147729e-01 -1.562500000000000000e-02 4.687500000000000000e-02 2.343750000000000000e-01 1.599760592092990263e-01 1.599760592092990263e-01 1.599760592092990263e-01 -4.687500000000000000e-02 1.562500000000000000e-02 2.031250000000000000e-01 1.024189375965554871e-01 1.024189375965554871e-01 1.024189375965554871e-01 -4.687500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 2.078622161784802191e-01 2.078622161784802191e-01 2.078622161784802191e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 1.825203629620777424e-01 1.825203629620777424e-01 1.825203629620777424e-01 -1.562500000000000000e-02 7.812500000000000000e-02 1.718750000000000000e-01 2.088877611308834481e-01 2.088877611308834481e-01 2.088877611308834481e-01 -1.562500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 1.809959855993045763e-01 1.809959855993045763e-01 1.809959855993045763e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 1.017150524383373111e-01 1.017150524383373111e-01 1.017150524383373111e-01 -4.687500000000000000e-02 7.812500000000000000e-02 1.718750000000000000e-01 2.279221664647249901e-01 2.279221664647249901e-01 2.279221664647249901e-01 -4.687500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 2.057741726717310093e-01 2.057741726717310093e-01 2.057741726717310093e-01 -4.687500000000000000e-02 1.093750000000000000e-01 1.718750000000000000e-01 2.376113505016098637e-01 2.376113505016098637e-01 2.376113505016098637e-01 -1.562500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 2.442201517954718792e-01 2.442201517954718792e-01 2.442201517954718792e-01 -1.562500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 2.082963490880815061e-01 2.082963490880815061e-01 2.082963490880815061e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 2.770483578889592624e-01 2.770483578889592624e-01 2.770483578889592624e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 1.321074800266977822e-01 1.321074800266977822e-01 1.321074800266977822e-01 -4.687500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 1.830734342853608809e-01 1.830734342853608809e-01 1.830734342853608809e-01 -4.687500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 1.853828071319008342e-01 1.853828071319008342e-01 1.853828071319008342e-01 -4.687500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 2.885385934746442782e-01 2.885385934746442782e-01 2.885385934746442782e-01 -4.687500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 1.305194946546605339e-01 1.305194946546605339e-01 1.305194946546605339e-01 -7.812500000000000000e-02 1.562500000000000000e-02 1.406250000000000000e-01 8.219344558959142122e-02 8.219344558959142122e-02 8.219344558959142122e-02 -7.812500000000000000e-02 1.562500000000000000e-02 1.718750000000000000e-01 1.124679140642480119e-01 1.124679140642480119e-01 1.124679140642480119e-01 -7.812500000000000000e-02 4.687500000000000000e-02 1.406250000000000000e-01 9.675795162762225454e-02 9.675795162762225454e-02 9.675795162762225454e-02 -7.812500000000000000e-02 4.687500000000000000e-02 1.718750000000000000e-01 7.935244735692911222e-01 7.935244735692911222e-01 7.935244735692911222e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 2.867035689742162274e-01 2.867035689742162274e-01 2.867035689742162274e-01 -1.093750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.256179885629782611e-01 1.256179885629782611e-01 1.256179885629782611e-01 -1.093750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 3.516086480325836261e-01 3.516086480325836261e-01 3.516086480325836261e-01 -1.093750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 2.331038350243737900e-01 2.331038350243737900e-01 2.331038350243737900e-01 -7.812500000000000000e-02 4.687500000000000000e-02 2.031250000000000000e-01 2.362067398229243942e-01 2.362067398229243942e-01 2.362067398229243942e-01 -7.812500000000000000e-02 7.812500000000000000e-02 1.406250000000000000e-01 1.269201057554511236e-01 1.269201057554511236e-01 1.269201057554511236e-01 -7.812500000000000000e-02 1.093750000000000000e-01 1.406250000000000000e-01 1.513712541491999963e-01 1.513712541491999963e-01 1.513712541491999963e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 2.639599008294399862e-01 2.639599008294399862e-01 2.639599008294399862e-01 -1.093750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.497523301804771223e-01 1.497523301804771223e-01 1.497523301804771223e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.904789258030617216e-01 1.904789258030617216e-01 1.904789258030617216e-01 -1.093750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.689251721978006215e-01 1.689251721978006215e-01 1.689251721978006215e-01 -7.812500000000000000e-02 7.812500000000000000e-02 2.031250000000000000e-01 2.455291738857796890e-01 2.455291738857796890e-01 2.455291738857796890e-01 -7.812500000000000000e-02 7.812500000000000000e-02 2.343750000000000000e-01 1.944045391236200737e-01 1.944045391236200737e-01 1.944045391236200737e-01 -7.812500000000000000e-02 1.093750000000000000e-01 2.031250000000000000e-01 9.407396670945644690e-02 9.407396670945644690e-02 9.407396670945644690e-02 -7.812500000000000000e-02 1.093750000000000000e-01 2.343750000000000000e-01 9.608857095547744531e-02 9.608857095547744531e-02 9.608857095547744531e-02 -1.093750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 2.155711372581297913e-01 2.155711372581297913e-01 2.155711372581297913e-01 -1.093750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.751430393504734839e-01 1.751430393504734839e-01 1.751430393504734839e-01 -1.093750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.382406486941222534e-01 1.382406486941222534e-01 1.382406486941222534e-01 -1.093750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 1.225991805347251967e-01 1.225991805347251967e-01 1.225991805347251967e-01 -4.687500000000000000e-02 1.406250000000000000e-01 4.687500000000000000e-02 7.216684159580342151e-01 7.216684159580342151e-01 7.216684159580342151e-01 -1.562500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 4.948220438442799129e-01 4.948220438442799129e-01 4.948220438442799129e-01 -1.562500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 2.521533653271095798e-01 2.521533653271095798e-01 2.521533653271095798e-01 -1.562500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 2.094478732769915752e-01 2.094478732769915752e-01 2.094478732769915752e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 2.698761503334214384e-01 2.698761503334214384e-01 2.698761503334214384e-01 -4.687500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 4.856668011409584484e-01 4.856668011409584484e-01 4.856668011409584484e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 1.297491859589177676e-01 1.297491859589177676e-01 1.297491859589177676e-01 -4.687500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 4.323563448008141963e-01 4.323563448008141963e-01 4.323563448008141963e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 3.020382451033044036e-01 3.020382451033044036e-01 3.020382451033044036e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.562500000000000000e-02 3.942363651935701374e-01 3.942363651935701374e-01 3.942363651935701374e-01 -1.562500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 1.759594750456723866e-01 1.759594750456723866e-01 1.759594750456723866e-01 -1.562500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 1.194830541871609308e-01 1.194830541871609308e-01 1.194830541871609308e-01 -1.562500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 1.023884038932727641e-01 1.023884038932727641e-01 1.023884038932727641e-01 -4.687500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 7.672225457676085103e-02 7.672225457676085103e-02 7.672225457676085103e-02 -4.687500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 6.588623550815618513e-02 6.588623550815618513e-02 6.588623550815618513e-02 -1.562500000000000000e-02 2.031250000000000000e-01 7.812500000000000000e-02 1.657466087872102589e-01 1.657466087872102589e-01 1.657466087872102589e-01 -1.562500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 2.499958910152048353e-01 2.499958910152048353e-01 2.499958910152048353e-01 -1.562500000000000000e-02 2.343750000000000000e-01 7.812500000000000000e-02 1.113945404567930481e-01 1.113945404567930481e-01 1.113945404567930481e-01 -4.687500000000000000e-02 2.031250000000000000e-01 7.812500000000000000e-02 2.026933669362531165e-01 2.026933669362531165e-01 2.026933669362531165e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 2.140682484987148082e-01 2.140682484987148082e-01 2.140682484987148082e-01 -4.687500000000000000e-02 2.343750000000000000e-01 7.812500000000000000e-02 5.031833318296246443e-02 5.031833318296246443e-02 5.031833318296246443e-02 -4.687500000000000000e-02 2.343750000000000000e-01 1.093750000000000000e-01 5.094475742545474806e-02 5.094475742545474806e-02 5.094475742545474806e-02 -7.812500000000000000e-02 1.406250000000000000e-01 4.687500000000000000e-02 2.030922171502655138e-01 2.030922171502655138e-01 2.030922171502655138e-01 -7.812500000000000000e-02 1.718750000000000000e-01 4.687500000000000000e-02 2.237173810247583827e-01 2.237173810247583827e-01 2.237173810247583827e-01 -1.093750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 4.677395317275488407e-01 4.677395317275488407e-01 4.677395317275488407e-01 -1.093750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 1.292736632491787718e-01 1.292736632491787718e-01 1.292736632491787718e-01 -1.093750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 2.736271062124557285e-01 2.736271062124557285e-01 2.736271062124557285e-01 -1.093750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 2.140297330948195687e-01 2.140297330948195687e-01 2.140297330948195687e-01 -7.812500000000000000e-02 1.406250000000000000e-01 7.812500000000000000e-02 1.628360939104425698e-01 1.628360939104425698e-01 1.628360939104425698e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.093750000000000000e-01 1.554778427341232117e-01 1.554778427341232117e-01 1.554778427341232117e-01 -7.812500000000000000e-02 1.718750000000000000e-01 7.812500000000000000e-02 1.714934624726945356e-01 1.714934624726945356e-01 1.714934624726945356e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.093750000000000000e-01 1.071812499373588634e-01 1.071812499373588634e-01 1.071812499373588634e-01 -1.093750000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 1.801193953314260132e-01 1.801193953314260132e-01 1.801193953314260132e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.562500000000000000e-02 2.153135699553338223e-01 2.153135699553338223e-01 2.153135699553338223e-01 -7.812500000000000000e-02 2.031250000000000000e-01 4.687500000000000000e-02 1.353058460664026408e-01 1.353058460664026408e-01 1.353058460664026408e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.562500000000000000e-02 8.210664374193525628e-02 8.210664374193525628e-02 8.210664374193525628e-02 -7.812500000000000000e-02 2.343750000000000000e-01 4.687500000000000000e-02 1.007668868968212283e-01 1.007668868968212283e-01 1.007668868968212283e-01 -1.093750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 1.466557261286446368e-01 1.466557261286446368e-01 1.466557261286446368e-01 -1.093750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 1.736016632397873738e-01 1.736016632397873738e-01 1.736016632397873738e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 8.501686573562214355e-02 8.501686573562214355e-02 8.501686573562214355e-02 -1.093750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 6.240775727213680041e-02 6.240775727213680041e-02 6.240775727213680041e-02 -7.812500000000000000e-02 2.031250000000000000e-01 7.812500000000000000e-02 9.879498819811173560e-02 9.879498819811173560e-02 9.879498819811173560e-02 -7.812500000000000000e-02 2.031250000000000000e-01 1.093750000000000000e-01 7.131644471950294994e-02 7.131644471950294994e-02 7.131644471950294994e-02 -7.812500000000000000e-02 2.343750000000000000e-01 1.093750000000000000e-01 1.482899705570236148e-01 1.482899705570236148e-01 1.482899705570236148e-01 -1.093750000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 1.569930679836549769e-01 1.569930679836549769e-01 1.569930679836549769e-01 -1.093750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 6.055197142567849550e-02 6.055197142567849550e-02 6.055197142567849550e-02 -1.093750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 8.821871164097988549e-02 8.821871164097988549e-02 8.821871164097988549e-02 -1.093750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 4.391905496626865441e-02 4.391905496626865441e-02 4.391905496626865441e-02 -1.562500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 2.039894222762379250e-01 2.039894222762379250e-01 2.039894222762379250e-01 -1.562500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 2.001958936808296008e-01 2.001958936808296008e-01 2.001958936808296008e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 2.367113115298126180e-01 2.367113115298126180e-01 2.367113115298126180e-01 -4.687500000000000000e-02 1.406250000000000000e-01 1.718750000000000000e-01 2.495772220109341022e-01 2.495772220109341022e-01 2.495772220109341022e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 2.467178629940639245e-01 2.467178629940639245e-01 2.467178629940639245e-01 -4.687500000000000000e-02 1.718750000000000000e-01 1.718750000000000000e-01 1.531362938563690101e-01 1.531362938563690101e-01 1.531362938563690101e-01 -1.562500000000000000e-02 1.406250000000000000e-01 2.031250000000000000e-01 3.227262074680907200e-01 3.227262074680907200e-01 3.227262074680907200e-01 -1.562500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 3.437565347170195573e-01 3.437565347170195573e-01 3.437565347170195573e-01 -1.562500000000000000e-02 1.718750000000000000e-01 2.031250000000000000e-01 2.009623180439075729e-01 2.009623180439075729e-01 2.009623180439075729e-01 -1.562500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 2.532705774290804346e-01 2.532705774290804346e-01 2.532705774290804346e-01 -4.687500000000000000e-02 1.406250000000000000e-01 2.031250000000000000e-01 2.724901312163032219e-01 2.724901312163032219e-01 2.724901312163032219e-01 -4.687500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 4.769181694806335498e-02 4.769181694806335498e-02 4.769181694806335498e-02 -4.687500000000000000e-02 1.718750000000000000e-01 2.031250000000000000e-01 1.602699360747305846e-01 1.602699360747305846e-01 1.602699360747305846e-01 -4.687500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 5.048444744137121909e-02 5.048444744137121909e-02 5.048444744137121909e-02 -4.687500000000000000e-02 2.031250000000000000e-01 1.406250000000000000e-01 2.709017069447886006e-01 2.709017069447886006e-01 2.709017069447886006e-01 -4.687500000000000000e-02 2.031250000000000000e-01 1.718750000000000000e-01 1.726166121028498979e-01 1.726166121028498979e-01 1.726166121028498979e-01 -4.687500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 1.410323867580251800e-01 1.410323867580251800e-01 1.410323867580251800e-01 -1.562500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 1.280551234766210411e-01 1.280551234766210411e-01 1.280551234766210411e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 1.109630980782376486e-01 1.109630980782376486e-01 1.109630980782376486e-01 -1.562500000000000000e-02 2.343750000000000000e-01 2.343750000000000000e-01 1.210648307496080128e-01 1.210648307496080128e-01 1.210648307496080128e-01 -4.687500000000000000e-02 2.031250000000000000e-01 2.031250000000000000e-01 1.641360030833336203e-01 1.641360030833336203e-01 1.641360030833336203e-01 -4.687500000000000000e-02 2.031250000000000000e-01 2.343750000000000000e-01 5.982729970987941265e-02 5.982729970987941265e-02 5.982729970987941265e-02 -4.687500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 1.772182308570381948e-01 1.772182308570381948e-01 1.772182308570381948e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.343750000000000000e-01 1.127049220250067735e-01 1.127049220250067735e-01 1.127049220250067735e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.406250000000000000e-01 1.190388015447508829e-01 1.190388015447508829e-01 1.190388015447508829e-01 -7.812500000000000000e-02 1.406250000000000000e-01 1.718750000000000000e-01 1.539690129768598315e-01 1.539690129768598315e-01 1.539690129768598315e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.406250000000000000e-01 1.342753467333136219e-01 1.342753467333136219e-01 1.342753467333136219e-01 -7.812500000000000000e-02 1.718750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -7.812500000000000000e-02 1.406250000000000000e-01 2.031250000000000000e-01 7.658689874681824661e-02 7.658689874681824661e-02 7.658689874681824661e-02 -7.812500000000000000e-02 1.406250000000000000e-01 2.343750000000000000e-01 1.078441106117759146e-01 1.078441106117759146e-01 1.078441106117759146e-01 -7.812500000000000000e-02 1.718750000000000000e-01 2.031250000000000000e-01 2.147671393957344688e-01 2.147671393957344688e-01 2.147671393957344688e-01 -7.812500000000000000e-02 1.718750000000000000e-01 2.343750000000000000e-01 4.831022105216396106e-02 4.831022105216396106e-02 4.831022105216396106e-02 -7.812500000000000000e-02 2.031250000000000000e-01 1.406250000000000000e-01 1.122927687497272259e-01 1.122927687497272259e-01 1.122927687497272259e-01 -7.812500000000000000e-02 2.031250000000000000e-01 1.718750000000000000e-01 1.500221531041970868e-01 1.500221531041970868e-01 1.500221531041970868e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.406250000000000000e-01 1.104826436936380968e-01 1.104826436936380968e-01 1.104826436936380968e-01 -7.812500000000000000e-02 2.343750000000000000e-01 1.718750000000000000e-01 1.316954261357106970e-01 1.316954261357106970e-01 1.316954261357106970e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 1.034345783868002855e-01 1.034345783868002855e-01 1.034345783868002855e-01 -1.093750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 8.675844782507551034e-02 8.675844782507551034e-02 8.675844782507551034e-02 -7.812500000000000000e-02 2.031250000000000000e-01 2.031250000000000000e-01 1.856420756484134515e-01 1.856420756484134515e-01 1.856420756484134515e-01 -7.812500000000000000e-02 2.343750000000000000e-01 2.031250000000000000e-01 2.129657377719029743e-01 2.129657377719029743e-01 2.129657377719029743e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.329685292981274969e-01 1.329685292981274969e-01 1.329685292981274969e-01 -1.406250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 8.032445251356194749e-02 8.032445251356194749e-02 8.032445251356194749e-02 -1.406250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 8.011949879495157412e-02 8.011949879495157412e-02 8.011949879495157412e-02 -1.406250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 1.616557999400834722e-01 1.616557999400834722e-01 1.616557999400834722e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.815578974142475210e-01 1.815578974142475210e-01 1.815578974142475210e-01 -1.406250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 1.539617859434673774e-01 1.539617859434673774e-01 1.539617859434673774e-01 -1.406250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.334657167981802561e-01 1.334657167981802561e-01 1.334657167981802561e-01 -1.718750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 8.952947073220043905e-02 8.952947073220043905e-02 8.952947073220043905e-02 -1.718750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 1.014153369114400433e-01 1.014153369114400433e-01 1.014153369114400433e-01 -1.718750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 4.872487317678307617e-02 4.872487317678307617e-02 4.872487317678307617e-02 -1.406250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 2.757703165165907300e-01 2.757703165165907300e-01 2.757703165165907300e-01 -1.406250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 1.783300619250181573e-01 1.783300619250181573e-01 1.783300619250181573e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 6.504751631771032994e-01 6.504751631771032994e-01 6.504751631771032994e-01 -1.406250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 1.429727322153163116e-01 1.429727322153163116e-01 1.429727322153163116e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 1.188090424345486784e-01 1.188090424345486784e-01 1.188090424345486784e-01 -1.718750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 1.932736675019986750e-01 1.932736675019986750e-01 1.932736675019986750e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 3.635199351102516019e-01 3.635199351102516019e-01 3.635199351102516019e-01 -1.406250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 1.742655825079000298e-01 1.742655825079000298e-01 1.742655825079000298e-01 -1.406250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.228409785386209568e-01 1.228409785386209568e-01 1.228409785386209568e-01 -1.406250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.689051008349602701e-01 1.689051008349602701e-01 1.689051008349602701e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.360214851482696441e-01 1.360214851482696441e-01 1.360214851482696441e-01 -1.718750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 1.067843343860376548e-01 1.067843343860376548e-01 1.067843343860376548e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 6.214061485817306413e-02 6.214061485817306413e-02 6.214061485817306413e-02 -1.718750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.596661223357067616e-01 1.596661223357067616e-01 1.596661223357067616e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.724969921949131846e-01 1.724969921949131846e-01 1.724969921949131846e-01 -2.031250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 8.724868794484257062e-02 8.724868794484257062e-02 8.724868794484257062e-02 -2.343750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.217251670711309991e-01 1.217251670711309991e-01 1.217251670711309991e-01 -2.343750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.447186818787180584e-01 1.447186818787180584e-01 1.447186818787180584e-01 -2.343750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.105035330743667360e-01 1.105035330743667360e-01 1.105035330743667360e-01 -2.343750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 4.507775878919619006e-02 4.507775878919619006e-02 4.507775878919619006e-02 -2.031250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 5.071030117574120560e-02 5.071030117574120560e-02 5.071030117574120560e-02 -2.031250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 5.204699817532835310e-02 5.204699817532835310e-02 5.204699817532835310e-02 -2.031250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 6.450944447035640399e-03 6.450944447035640399e-03 6.450944447035640399e-03 -2.031250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 6.066331656785211440e-02 6.066331656785211440e-02 6.066331656785211440e-02 -2.343750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 1.179775660449196573e-01 1.179775660449196573e-01 1.179775660449196573e-01 -2.343750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 5.971177289680656974e-02 5.971177289680656974e-02 5.971177289680656974e-02 -2.343750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 9.489845783205130836e-02 9.489845783205130836e-02 9.489845783205130836e-02 -2.343750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 4.993898675124178177e-02 4.993898675124178177e-02 4.993898675124178177e-02 -2.031250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 1.972601399369172115e-01 1.972601399369172115e-01 1.972601399369172115e-01 -2.031250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 1.807021844307778180e-01 1.807021844307778180e-01 1.807021844307778180e-01 -2.343750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -2.343750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 7.905574042102300747e-02 7.905574042102300747e-02 7.905574042102300747e-02 -2.343750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 1.141076734909211299e-01 1.141076734909211299e-01 1.141076734909211299e-01 -2.031250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 7.921263260451763544e-02 7.921263260451763544e-02 7.921263260451763544e-02 -2.031250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.728309641104218974e-01 1.728309641104218974e-01 1.728309641104218974e-01 -2.031250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 2.934077391424313452e-01 2.934077391424313452e-01 2.934077391424313452e-01 -2.031250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.796345372713657185e-01 1.796345372713657185e-01 1.796345372713657185e-01 -2.343750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 2.110302893873340080e-01 2.110302893873340080e-01 2.110302893873340080e-01 -2.343750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 2.388362536748530607e-01 2.388362536748530607e-01 2.388362536748530607e-01 -2.343750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.258734333258867688e-01 1.258734333258867688e-01 1.258734333258867688e-01 -2.343750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.953395629166920500e-01 1.953395629166920500e-01 1.953395629166920500e-01 -1.406250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 2.997025610180031885e-01 2.997025610180031885e-01 2.997025610180031885e-01 -1.406250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.264381400963766056e-01 1.264381400963766056e-01 1.264381400963766056e-01 -1.718750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.316576745041209140e-01 1.316576745041209140e-01 1.316576745041209140e-01 -1.718750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 1.128350752522271627e-01 1.128350752522271627e-01 1.128350752522271627e-01 -1.406250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.361869406405436522e-01 1.361869406405436522e-01 1.361869406405436522e-01 -1.406250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 9.063688880909229195e-02 9.063688880909229195e-02 9.063688880909229195e-02 -1.718750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.177590510171247773e-01 1.177590510171247773e-01 1.177590510171247773e-01 -1.718750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.011863309976578917e-01 1.011863309976578917e-01 1.011863309976578917e-01 -1.406250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 2.020874639343930579e-01 2.020874639343930579e-01 2.020874639343930579e-01 -1.406250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.292045837028220345e-01 1.292045837028220345e-01 1.292045837028220345e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.021127965207897365e-01 1.021127965207897365e-01 1.021127965207897365e-01 -1.406250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.536124785551200023e-01 1.536124785551200023e-01 1.536124785551200023e-01 -1.718750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 1.099322869013117654e-01 1.099322869013117654e-01 1.099322869013117654e-01 -1.718750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 8.839230205460679723e-02 8.839230205460679723e-02 8.839230205460679723e-02 -1.406250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.330625052000214970e-01 1.330625052000214970e-01 1.330625052000214970e-01 -1.406250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.063713473004988114e-01 1.063713473004988114e-01 1.063713473004988114e-01 -1.406250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.358054286776294306e-01 1.358054286776294306e-01 1.358054286776294306e-01 -1.406250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 1.415134618695851609e-01 1.415134618695851609e-01 1.415134618695851609e-01 -1.718750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 6.827550197553719502e-02 6.827550197553719502e-02 6.827550197553719502e-02 -1.718750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.077918854234942297e-01 1.077918854234942297e-01 1.077918854234942297e-01 -1.718750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 8.497668111691694670e-02 8.497668111691694670e-02 8.497668111691694670e-02 -2.031250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 6.308384951757672887e-02 6.308384951757672887e-02 6.308384951757672887e-02 -2.031250000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 8.585993440817447919e-02 8.585993440817447919e-02 8.585993440817447919e-02 -2.031250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 1.133878224145775798e-01 1.133878224145775798e-01 1.133878224145775798e-01 -2.343750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 7.541643105604169117e-02 7.541643105604169117e-02 7.541643105604169117e-02 -2.343750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 5.297893420418371691e-02 5.297893420418371691e-02 5.297893420418371691e-02 -2.343750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 6.242407680703880579e-02 6.242407680703880579e-02 6.242407680703880579e-02 -2.031250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 6.667218837184167579e-02 6.667218837184167579e-02 6.667218837184167579e-02 -2.031250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 8.283481189493650809e-02 8.283481189493650809e-02 8.283481189493650809e-02 -2.031250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.152316245133914174e-01 1.152316245133914174e-01 1.152316245133914174e-01 -2.031250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 8.569357169959727905e-02 8.569357169959727905e-02 8.569357169959727905e-02 -2.343750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 4.507856288042885740e-02 4.507856288042885740e-02 4.507856288042885740e-02 -2.343750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 8.963635572498242221e-02 8.963635572498242221e-02 8.963635572498242221e-02 -2.343750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.242074047641009843e-01 1.242074047641009843e-01 1.242074047641009843e-01 -2.343750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.082345932528694932e-01 1.082345932528694932e-01 1.082345932528694932e-01 -2.031250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 9.726661292816599080e-02 9.726661292816599080e-02 9.726661292816599080e-02 -2.031250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 8.253582974216067125e-02 8.253582974216067125e-02 8.253582974216067125e-02 -2.343750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 1.509440412658985819e-01 1.509440412658985819e-01 1.509440412658985819e-01 -2.343750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 9.933497504315511040e-02 9.933497504315511040e-02 9.933497504315511040e-02 -2.031250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 9.467505853784917436e-02 9.467505853784917436e-02 9.467505853784917436e-02 -2.031250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 9.703920234927322641e-02 9.703920234927322641e-02 9.703920234927322641e-02 -2.031250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 1.046366176918796798e-01 1.046366176918796798e-01 1.046366176918796798e-01 -2.343750000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 1.077637641542361496e-01 1.077637641542361496e-01 1.077637641542361496e-01 -2.343750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.129885272435066229e-01 1.129885272435066229e-01 1.129885272435066229e-01 -2.343750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 8.467288475011813809e-02 8.467288475011813809e-02 8.467288475011813809e-02 -2.343750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 9.195162661890349254e-02 9.195162661890349254e-02 9.195162661890349254e-02 -1.406250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 3.708976248321643188e-01 3.708976248321643188e-01 3.708976248321643188e-01 -1.406250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 9.067787423640621958e-02 9.067787423640621958e-02 9.067787423640621958e-02 -1.406250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.319902095435194211e-01 1.319902095435194211e-01 1.319902095435194211e-01 -1.406250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.425310186133948720e-01 1.425310186133948720e-01 1.425310186133948720e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 2.194024538258175505e-01 2.194024538258175505e-01 2.194024538258175505e-01 -1.718750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.735510863357773714e-01 1.735510863357773714e-01 1.735510863357773714e-01 -1.406250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 1.420483433409686636e-01 1.420483433409686636e-01 1.420483433409686636e-01 -1.406250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 7.021229756747951467e-02 7.021229756747951467e-02 7.021229756747951467e-02 -1.718750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 8.956724213685574032e-02 8.956724213685574032e-02 8.956724213685574032e-02 -1.718750000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 2.333290517617789359e-03 2.333290517617789359e-03 2.333290517617789359e-03 -1.718750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 3.876089165368518108e-02 3.876089165368518108e-02 3.876089165368518108e-02 -1.406250000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 1.379731957453376734e-01 1.379731957453376734e-01 1.379731957453376734e-01 -1.406250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 1.446150824271159874e-01 1.446150824271159874e-01 1.446150824271159874e-01 -1.718750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 1.341412121781863920e-01 1.341412121781863920e-01 1.341412121781863920e-01 -1.718750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 9.460112769956251222e-02 9.460112769956251222e-02 9.460112769956251222e-02 -1.406250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 1.415777120841016645e-01 1.415777120841016645e-01 1.415777120841016645e-01 -1.406250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 8.447035320161103145e-02 8.447035320161103145e-02 8.447035320161103145e-02 -1.406250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 9.924417393727119618e-02 9.924417393727119618e-02 9.924417393727119618e-02 -1.406250000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 5.862418875428511422e-02 5.862418875428511422e-02 5.862418875428511422e-02 -1.718750000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 3.928479652472268574e-02 3.928479652472268574e-02 3.928479652472268574e-02 -1.718750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 3.633729468746591668e-02 3.633729468746591668e-02 3.633729468746591668e-02 -1.718750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 5.032428307034986226e-02 5.032428307034986226e-02 5.032428307034986226e-02 -2.031250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 2.057236159886833005e-01 2.057236159886833005e-01 2.057236159886833005e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 2.022527836166975734e-01 2.022527836166975734e-01 2.022527836166975734e-01 -2.031250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.925473008374109507e-01 1.925473008374109507e-01 1.925473008374109507e-01 -2.343750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 1.901305795681232647e-01 1.901305795681232647e-01 1.901305795681232647e-01 -2.343750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.465256276026640214e-01 1.465256276026640214e-01 1.465256276026640214e-01 -2.343750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.566036248970058831e-01 1.566036248970058831e-01 1.566036248970058831e-01 -2.031250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 1.461256937795336330e-01 1.461256937795336330e-01 1.461256937795336330e-01 -2.031250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 6.254860359249014845e-02 6.254860359249014845e-02 6.254860359249014845e-02 -2.343750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 8.461662603778857816e-02 8.461662603778857816e-02 8.461662603778857816e-02 -2.343750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 9.489685064510947066e-02 9.489685064510947066e-02 9.489685064510947066e-02 -2.343750000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 8.024423931644746044e-02 8.024423931644746044e-02 8.024423931644746044e-02 -2.343750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.258782530305873060e-01 1.258782530305873060e-01 1.258782530305873060e-01 -2.031250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 9.510739186239680620e-02 9.510739186239680620e-02 9.510739186239680620e-02 -2.031250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 4.413415218367007509e-02 4.413415218367007509e-02 4.413415218367007509e-02 -2.343750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 1.654920934804846588e-01 1.654920934804846588e-01 1.654920934804846588e-01 -2.343750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 1.911218373590103381e-01 1.911218373590103381e-01 1.911218373590103381e-01 -2.343750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 3.308874964135839758e-02 3.308874964135839758e-02 3.308874964135839758e-02 -2.031250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 2.906461805601251447e-02 2.906461805601251447e-02 2.906461805601251447e-02 -2.343750000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 4.567214083935759034e-02 4.567214083935759034e-02 4.567214083935759034e-02 -2.343750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 9.382243898322406572e-02 9.382243898322406572e-02 9.382243898322406572e-02 -2.343750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 1.162270190631877059e-01 1.162270190631877059e-01 1.162270190631877059e-01 -2.343750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 1.062781436961776904e-01 1.062781436961776904e-01 1.062781436961776904e-01 -1.718750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 2.133974359115104469e-01 2.133974359115104469e-01 2.133974359115104469e-01 -1.718750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.902317125013754662e-01 1.902317125013754662e-01 1.902317125013754662e-01 -1.406250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 1.202518545012536688e-01 1.202518545012536688e-01 1.202518545012536688e-01 -1.406250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 1.328560793567350462e-01 1.328560793567350462e-01 1.328560793567350462e-01 -1.406250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 1.114106090295462204e-01 1.114106090295462204e-01 1.114106090295462204e-01 -1.718750000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 1.519349789558773478e-01 1.519349789558773478e-01 1.519349789558773478e-01 -1.718750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 8.469779931014520535e-02 8.469779931014520535e-02 8.469779931014520535e-02 -1.718750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 1.962023434722432458e-01 1.962023434722432458e-01 1.962023434722432458e-01 -1.718750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 9.324866352746949416e-02 9.324866352746949416e-02 9.324866352746949416e-02 -1.406250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 3.567464879055142618e-02 3.567464879055142618e-02 3.567464879055142618e-02 -1.406250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 6.538565581979909058e-02 6.538565581979909058e-02 6.538565581979909058e-02 -1.406250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.718750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 6.684453908311310810e-02 6.684453908311310810e-02 6.684453908311310810e-02 -1.718750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 9.530186074154400888e-02 9.530186074154400888e-02 9.530186074154400888e-02 -1.718750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 8.008453604964595185e-02 8.008453604964595185e-02 8.008453604964595185e-02 -1.718750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.110008594216369965e-01 1.110008594216369965e-01 1.110008594216369965e-01 -1.718750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.176522033793992728e-01 1.176522033793992728e-01 1.176522033793992728e-01 -1.718750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.466565292053072234e-01 1.466565292053072234e-01 1.466565292053072234e-01 -2.031250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.545126446282591715e-01 1.545126446282591715e-01 1.545126446282591715e-01 -2.343750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 1.698091100510369655e-01 1.698091100510369655e-01 1.698091100510369655e-01 -2.343750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 1.067754961632154387e-01 1.067754961632154387e-01 1.067754961632154387e-01 -2.343750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.087664821965227263e-01 1.087664821965227263e-01 1.087664821965227263e-01 -2.031250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 9.367698648875415202e-02 9.367698648875415202e-02 9.367698648875415202e-02 -2.031250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 8.686614017299483514e-02 8.686614017299483514e-02 8.686614017299483514e-02 -2.031250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 1.176578269428012608e-01 1.176578269428012608e-01 1.176578269428012608e-01 -2.343750000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 1.102560739080466340e-01 1.102560739080466340e-01 1.102560739080466340e-01 -2.343750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 1.106818960274358471e-01 1.106818960274358471e-01 1.106818960274358471e-01 -2.343750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 8.198769290968967172e-02 8.198769290968967172e-02 8.198769290968967172e-02 -2.031250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 6.387063366140997844e-02 6.387063366140997844e-02 6.387063366140997844e-02 -2.031250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 5.693980319047151767e-02 5.693980319047151767e-02 5.693980319047151767e-02 -2.031250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 7.372749381083264220e-02 7.372749381083264220e-02 7.372749381083264220e-02 -2.031250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 8.841882277925917910e-02 8.841882277925917910e-02 8.841882277925917910e-02 -2.343750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 9.119782480561948457e-02 9.119782480561948457e-02 9.119782480561948457e-02 -2.343750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 1.047499105772703304e-01 1.047499105772703304e-01 1.047499105772703304e-01 -2.343750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.033783327923212952e-01 1.033783327923212952e-01 1.033783327923212952e-01 -2.031250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.013333769750892344e-01 1.013333769750892344e-01 1.013333769750892344e-01 -2.031250000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 9.481006250203659336e-02 9.481006250203659336e-02 9.481006250203659336e-02 -2.031250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.316070712254460706e-01 1.316070712254460706e-01 1.316070712254460706e-01 -2.031250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 8.222157579791669613e-02 8.222157579791669613e-02 8.222157579791669613e-02 -2.343750000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 8.182775198643520154e-02 8.182775198643520154e-02 8.182775198643520154e-02 -2.343750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.117785784675516120e-01 1.117785784675516120e-01 1.117785784675516120e-01 -2.343750000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 9.301641991772593987e-02 9.301641991772593987e-02 9.301641991772593987e-02 -1.562500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 9.969657135082593546e-02 9.969657135082593546e-02 9.969657135082593546e-02 -1.562500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 1.439332501501138228e-01 1.439332501501138228e-01 1.439332501501138228e-01 -4.687500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 1.511889662227078601e-01 1.511889662227078601e-01 1.511889662227078601e-01 -1.562500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 1.415712870649625255e-01 1.415712870649625255e-01 1.415712870649625255e-01 -1.562500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 1.256220049963373553e-01 1.256220049963373553e-01 1.256220049963373553e-01 -4.687500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 1.298375429095371958e-01 1.298375429095371958e-01 1.298375429095371958e-01 -4.687500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 1.358728961880105446e-01 1.358728961880105446e-01 1.358728961880105446e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 1.523750348917045638e-01 1.523750348917045638e-01 1.523750348917045638e-01 -1.562500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 1.090950946052711146e-01 1.090950946052711146e-01 1.090950946052711146e-01 -4.687500000000000000e-02 7.812500000000000000e-02 2.656250000000000000e-01 9.976326560337460403e-02 9.976326560337460403e-02 9.976326560337460403e-02 -4.687500000000000000e-02 7.812500000000000000e-02 2.968750000000000000e-01 7.950029427124175041e-02 7.950029427124175041e-02 7.950029427124175041e-02 -4.687500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 1.309572580407529219e-01 1.309572580407529219e-01 1.309572580407529219e-01 -4.687500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 1.097756153012260510e-01 1.097756153012260510e-01 1.097756153012260510e-01 -1.562500000000000000e-02 7.812500000000000000e-02 3.281250000000000000e-01 9.779294943499129700e-02 9.779294943499129700e-02 9.779294943499129700e-02 -1.562500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 7.543893711919452683e-02 7.543893711919452683e-02 7.543893711919452683e-02 -4.687500000000000000e-02 7.812500000000000000e-02 3.281250000000000000e-01 1.060170123331363040e-01 1.060170123331363040e-01 1.060170123331363040e-01 -4.687500000000000000e-02 1.093750000000000000e-01 3.281250000000000000e-01 8.811343208731760301e-02 8.811343208731760301e-02 8.811343208731760301e-02 -7.812500000000000000e-02 1.562500000000000000e-02 2.656250000000000000e-01 6.953433599071540128e-02 6.953433599071540128e-02 6.953433599071540128e-02 -7.812500000000000000e-02 1.562500000000000000e-02 2.968750000000000000e-01 9.977371168612517160e-02 9.977371168612517160e-02 9.977371168612517160e-02 -7.812500000000000000e-02 4.687500000000000000e-02 2.968750000000000000e-01 7.063391058272766587e-02 7.063391058272766587e-02 7.063391058272766587e-02 -7.812500000000000000e-02 1.562500000000000000e-02 3.281250000000000000e-01 5.836209871554920436e-02 5.836209871554920436e-02 5.836209871554920436e-02 -7.812500000000000000e-02 4.687500000000000000e-02 3.281250000000000000e-01 8.144598216575331395e-02 8.144598216575331395e-02 8.144598216575331395e-02 -1.093750000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 7.256180741943789314e-02 7.256180741943789314e-02 7.256180741943789314e-02 -1.093750000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 5.390740222533600690e-02 5.390740222533600690e-02 5.390740222533600690e-02 -7.812500000000000000e-02 7.812500000000000000e-02 2.656250000000000000e-01 8.602951150104141964e-02 8.602951150104141964e-02 8.602951150104141964e-02 -7.812500000000000000e-02 7.812500000000000000e-02 2.968750000000000000e-01 7.839376777798715001e-02 7.839376777798715001e-02 7.839376777798715001e-02 -7.812500000000000000e-02 1.093750000000000000e-01 2.656250000000000000e-01 9.482292001063147291e-02 9.482292001063147291e-02 9.482292001063147291e-02 -7.812500000000000000e-02 1.093750000000000000e-01 2.968750000000000000e-01 7.770687297090221601e-02 7.770687297090221601e-02 7.770687297090221601e-02 -1.093750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 7.483529017394592586e-02 7.483529017394592586e-02 7.483529017394592586e-02 -1.093750000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 7.985370117520346200e-02 7.985370117520346200e-02 7.985370117520346200e-02 -1.093750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.053420842685387077e-01 1.053420842685387077e-01 1.053420842685387077e-01 -1.093750000000000000e-01 7.812500000000000000e-02 3.281250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -4.687500000000000000e-02 1.718750000000000000e-01 2.656250000000000000e-01 6.601308819293207064e-02 6.601308819293207064e-02 6.601308819293207064e-02 -4.687500000000000000e-02 1.718750000000000000e-01 2.968750000000000000e-01 4.323291110224541933e-02 4.323291110224541933e-02 4.323291110224541933e-02 -4.687500000000000000e-02 2.031250000000000000e-01 2.656250000000000000e-01 8.237428247145063553e-02 8.237428247145063553e-02 8.237428247145063553e-02 -4.687500000000000000e-02 2.031250000000000000e-01 2.968750000000000000e-01 1.000686120777753568e-01 1.000686120777753568e-01 1.000686120777753568e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.656250000000000000e-01 1.171798226489778744e-01 1.171798226489778744e-01 1.171798226489778744e-01 -4.687500000000000000e-02 2.343750000000000000e-01 2.968750000000000000e-01 1.179486449723908398e-01 1.179486449723908398e-01 1.179486449723908398e-01 -7.812500000000000000e-02 1.406250000000000000e-01 2.656250000000000000e-01 7.418445563042071200e-02 7.418445563042071200e-02 7.418445563042071200e-02 -7.812500000000000000e-02 1.406250000000000000e-01 2.968750000000000000e-01 5.135626026114208098e-02 5.135626026114208098e-02 5.135626026114208098e-02 -7.812500000000000000e-02 1.718750000000000000e-01 2.656250000000000000e-01 6.075609066972178368e-02 6.075609066972178368e-02 6.075609066972178368e-02 -7.812500000000000000e-02 1.718750000000000000e-01 2.968750000000000000e-01 7.528444894473146354e-02 7.528444894473146354e-02 7.528444894473146354e-02 -1.093750000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 8.881341798305204815e-02 8.881341798305204815e-02 8.881341798305204815e-02 -1.093750000000000000e-01 1.406250000000000000e-01 2.968750000000000000e-01 6.454888413483432508e-02 6.454888413483432508e-02 6.454888413483432508e-02 -1.093750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.093750000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 9.042553225443242249e-02 9.042553225443242249e-02 9.042553225443242249e-02 -7.812500000000000000e-02 1.718750000000000000e-01 3.281250000000000000e-01 4.200221182421789295e-02 4.200221182421789295e-02 4.200221182421789295e-02 -1.093750000000000000e-01 1.718750000000000000e-01 3.281250000000000000e-01 6.626767722990137277e-02 6.626767722990137277e-02 6.626767722990137277e-02 -7.812500000000000000e-02 2.031250000000000000e-01 2.968750000000000000e-01 9.155704680647230864e-02 9.155704680647230864e-02 9.155704680647230864e-02 -7.812500000000000000e-02 2.343750000000000000e-01 2.968750000000000000e-01 1.421551585842145971e-01 1.421551585842145971e-01 1.421551585842145971e-01 -1.093750000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 7.796809623660468092e-02 7.796809623660468092e-02 7.796809623660468092e-02 -1.093750000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 1.390678999347033096e-01 1.390678999347033096e-01 1.390678999347033096e-01 -7.812500000000000000e-02 2.031250000000000000e-01 3.281250000000000000e-01 9.861177755224335983e-02 9.861177755224335983e-02 9.861177755224335983e-02 -7.812500000000000000e-02 2.343750000000000000e-01 3.281250000000000000e-01 5.590580726131238326e-02 5.590580726131238326e-02 5.590580726131238326e-02 -1.093750000000000000e-01 2.031250000000000000e-01 3.281250000000000000e-01 7.957359599002135353e-02 7.957359599002135353e-02 7.957359599002135353e-02 -1.093750000000000000e-01 2.343750000000000000e-01 3.281250000000000000e-01 9.116326868964649832e-02 9.116326868964649832e-02 9.116326868964649832e-02 -1.406250000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 8.612434592793827282e-02 8.612434592793827282e-02 8.612434592793827282e-02 -1.406250000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 7.131314902034825709e-02 7.131314902034825709e-02 7.131314902034825709e-02 -1.718750000000000000e-01 1.562500000000000000e-02 2.656250000000000000e-01 7.817128716267496280e-02 7.817128716267496280e-02 7.817128716267496280e-02 -1.718750000000000000e-01 1.562500000000000000e-02 2.968750000000000000e-01 7.641810552821330649e-02 7.641810552821330649e-02 7.641810552821330649e-02 -1.718750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 8.189365733000572578e-02 8.189365733000572578e-02 8.189365733000572578e-02 -1.718750000000000000e-01 4.687500000000000000e-02 2.968750000000000000e-01 5.772391394018783900e-02 5.772391394018783900e-02 5.772391394018783900e-02 -1.406250000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 9.570847596990998685e-02 9.570847596990998685e-02 9.570847596990998685e-02 -1.406250000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 7.761130523194172126e-02 7.761130523194172126e-02 7.761130523194172126e-02 -1.718750000000000000e-01 1.562500000000000000e-02 3.281250000000000000e-01 7.609378042137396325e-02 7.609378042137396325e-02 7.609378042137396325e-02 -1.718750000000000000e-01 4.687500000000000000e-02 3.281250000000000000e-01 5.928423381158031552e-02 5.928423381158031552e-02 5.928423381158031552e-02 -1.406250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 7.269218636663954403e-02 7.269218636663954403e-02 7.269218636663954403e-02 -1.406250000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 8.614202691042061044e-02 8.614202691042061044e-02 8.614202691042061044e-02 -1.406250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 9.890105732870513311e-02 9.890105732870513311e-02 9.890105732870513311e-02 -1.718750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 7.377507905014719924e-02 7.377507905014719924e-02 7.377507905014719924e-02 -1.718750000000000000e-01 7.812500000000000000e-02 2.968750000000000000e-01 6.001156342752578254e-02 6.001156342752578254e-02 6.001156342752578254e-02 -1.406250000000000000e-01 7.812500000000000000e-02 3.281250000000000000e-01 8.056589536165176257e-02 8.056589536165176257e-02 8.056589536165176257e-02 -1.406250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 8.092194990405844612e-02 8.092194990405844612e-02 8.092194990405844612e-02 -1.406250000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 8.731860719393175208e-02 8.731860719393175208e-02 8.731860719393175208e-02 -1.406250000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 6.704172906623423467e-02 6.704172906623423467e-02 6.704172906623423467e-02 -1.718750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 1.246178904140490401e-01 1.246178904140490401e-01 1.246178904140490401e-01 -1.718750000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 8.334838348328053870e-02 8.334838348328053870e-02 8.334838348328053870e-02 -1.406250000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 6.241780624721815496e-02 6.241780624721815496e-02 6.241780624721815496e-02 -1.406250000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 0.000000000000000000e+00 0.000000000000000000e+00 0.000000000000000000e+00 -1.406250000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 9.843901274521374423e-02 9.843901274521374423e-02 9.843901274521374423e-02 -1.718750000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 1.126294009200796559e-01 1.126294009200796559e-01 1.126294009200796559e-01 -1.718750000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 9.765312908049940399e-02 9.765312908049940399e-02 9.765312908049940399e-02 -1.718750000000000000e-01 2.031250000000000000e-01 3.281250000000000000e-01 4.850978823250837180e-02 4.850978823250837180e-02 4.850978823250837180e-02 -2.031250000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 1.244403616521981698e-01 1.244403616521981698e-01 1.244403616521981698e-01 -2.031250000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 7.716473151734408453e-02 7.716473151734408453e-02 7.716473151734408453e-02 -2.343750000000000000e-01 1.718750000000000000e-01 2.656250000000000000e-01 9.676277307683624207e-02 9.676277307683624207e-02 9.676277307683624207e-02 -2.343750000000000000e-01 1.718750000000000000e-01 2.968750000000000000e-01 4.922772747202263516e-02 4.922772747202263516e-02 4.922772747202263516e-02 -2.031250000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 9.458184138275890773e-02 9.458184138275890773e-02 9.458184138275890773e-02 -2.031250000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 8.605844404991468133e-02 8.605844404991468133e-02 8.605844404991468133e-02 -2.343750000000000000e-01 2.031250000000000000e-01 2.656250000000000000e-01 8.010913053413462603e-02 8.010913053413462603e-02 8.010913053413462603e-02 -2.343750000000000000e-01 2.031250000000000000e-01 2.968750000000000000e-01 5.556564132261710559e-02 5.556564132261710559e-02 5.556564132261710559e-02 -2.343750000000000000e-01 2.343750000000000000e-01 2.656250000000000000e-01 6.783426232581710180e-02 6.783426232581710180e-02 6.783426232581710180e-02 -2.343750000000000000e-01 2.343750000000000000e-01 2.968750000000000000e-01 4.448682996559892577e-02 4.448682996559892577e-02 4.448682996559892577e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.562500000000000000e-02 9.912926619620310298e-02 9.912926619620310298e-02 9.912926619620310298e-02 -1.562500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 5.160808159141978824e-02 5.160808159141978824e-02 5.160808159141978824e-02 -1.562500000000000000e-02 2.968750000000000000e-01 1.562500000000000000e-02 1.102544670278478856e-01 1.102544670278478856e-01 1.102544670278478856e-01 -1.562500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 9.533962943629187281e-02 9.533962943629187281e-02 9.533962943629187281e-02 -4.687500000000000000e-02 2.656250000000000000e-01 1.562500000000000000e-02 6.628251067549084316e-03 6.628251067549084316e-03 6.628251067549084316e-03 -4.687500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 3.663644857124032095e-02 3.663644857124032095e-02 3.663644857124032095e-02 -4.687500000000000000e-02 2.968750000000000000e-01 1.562500000000000000e-02 8.778955595531906519e-02 8.778955595531906519e-02 8.778955595531906519e-02 -4.687500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 9.562731380588665453e-02 9.562731380588665453e-02 9.562731380588665453e-02 -1.562500000000000000e-02 2.656250000000000000e-01 7.812500000000000000e-02 1.559419688153279027e-01 1.559419688153279027e-01 1.559419688153279027e-01 -1.562500000000000000e-02 2.656250000000000000e-01 1.093750000000000000e-01 1.260726475466455443e-01 1.260726475466455443e-01 1.260726475466455443e-01 -1.562500000000000000e-02 2.968750000000000000e-01 7.812500000000000000e-02 1.773779822589792443e-01 1.773779822589792443e-01 1.773779822589792443e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.093750000000000000e-01 1.286872884705019537e-01 1.286872884705019537e-01 1.286872884705019537e-01 -1.562500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 9.279542624101058679e-02 9.279542624101058679e-02 9.279542624101058679e-02 -4.687500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 8.301162877426951359e-02 8.301162877426951359e-02 8.301162877426951359e-02 -1.562500000000000000e-02 3.281250000000000000e-01 7.812500000000000000e-02 8.499757712114351660e-02 8.499757712114351660e-02 8.499757712114351660e-02 -1.562500000000000000e-02 3.281250000000000000e-01 1.093750000000000000e-01 9.366493240283013666e-02 9.366493240283013666e-02 9.366493240283013666e-02 -1.562500000000000000e-02 3.593750000000000000e-01 1.093750000000000000e-01 7.337108590404682607e-02 7.337108590404682607e-02 7.337108590404682607e-02 -7.812500000000000000e-02 2.656250000000000000e-01 1.562500000000000000e-02 6.495469014685202602e-02 6.495469014685202602e-02 6.495469014685202602e-02 -7.812500000000000000e-02 2.656250000000000000e-01 4.687500000000000000e-02 4.718268130561217855e-02 4.718268130561217855e-02 4.718268130561217855e-02 -7.812500000000000000e-02 2.968750000000000000e-01 1.562500000000000000e-02 7.341449155223302159e-02 7.341449155223302159e-02 7.341449155223302159e-02 -7.812500000000000000e-02 2.968750000000000000e-01 4.687500000000000000e-02 7.031052676481530650e-02 7.031052676481530650e-02 7.031052676481530650e-02 -1.093750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 7.638249815162510836e-02 7.638249815162510836e-02 7.638249815162510836e-02 -1.093750000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 3.634983987268143590e-02 3.634983987268143590e-02 3.634983987268143590e-02 -1.093750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 7.219550736006476177e-02 7.219550736006476177e-02 7.219550736006476177e-02 -1.093750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 6.158598803713505321e-02 6.158598803713505321e-02 6.158598803713505321e-02 -7.812500000000000000e-02 2.968750000000000000e-01 7.812500000000000000e-02 1.441452692863853802e-01 1.441452692863853802e-01 1.441452692863853802e-01 -1.093750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 7.058142008371239007e-02 7.058142008371239007e-02 7.058142008371239007e-02 -7.812500000000000000e-02 3.281250000000000000e-01 1.562500000000000000e-02 7.755439856811073562e-02 7.755439856811073562e-02 7.755439856811073562e-02 -7.812500000000000000e-02 3.281250000000000000e-01 4.687500000000000000e-02 7.436659659266713074e-02 7.436659659266713074e-02 7.436659659266713074e-02 -7.812500000000000000e-02 3.593750000000000000e-01 1.562500000000000000e-02 7.885464148839937959e-02 7.885464148839937959e-02 7.885464148839937959e-02 -7.812500000000000000e-02 3.593750000000000000e-01 4.687500000000000000e-02 1.134553087265922217e-01 1.134553087265922217e-01 1.134553087265922217e-01 -1.093750000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 6.394636132982149668e-02 6.394636132982149668e-02 6.394636132982149668e-02 -1.093750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 3.805194603108542906e-02 3.805194603108542906e-02 3.805194603108542906e-02 -1.093750000000000000e-01 3.593750000000000000e-01 1.562500000000000000e-02 6.435699377256387521e-02 6.435699377256387521e-02 6.435699377256387521e-02 -1.093750000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 5.069397926461356035e-02 5.069397926461356035e-02 5.069397926461356035e-02 -7.812500000000000000e-02 3.593750000000000000e-01 7.812500000000000000e-02 8.988227103387491645e-02 8.988227103387491645e-02 8.988227103387491645e-02 -7.812500000000000000e-02 3.593750000000000000e-01 1.093750000000000000e-01 6.646454707587416688e-02 6.646454707587416688e-02 6.646454707587416688e-02 -1.093750000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 4.932533905443260008e-02 4.932533905443260008e-02 4.932533905443260008e-02 -1.093750000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 5.375729472531391717e-02 5.375729472531391717e-02 5.375729472531391717e-02 -1.562500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 6.098665877154300918e-02 6.098665877154300918e-02 6.098665877154300918e-02 -1.562500000000000000e-02 2.968750000000000000e-01 1.406250000000000000e-01 1.305194946546605339e-01 1.305194946546605339e-01 1.305194946546605339e-01 -1.562500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 5.481117692076862419e-02 5.481117692076862419e-02 5.481117692076862419e-02 -4.687500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 9.766759326637283745e-02 9.766759326637283745e-02 9.766759326637283745e-02 -4.687500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 4.301821353123772701e-02 4.301821353123772701e-02 4.301821353123772701e-02 -1.562500000000000000e-02 2.656250000000000000e-01 2.031250000000000000e-01 7.318026153593383543e-02 7.318026153593383543e-02 7.318026153593383543e-02 -1.562500000000000000e-02 2.656250000000000000e-01 2.343750000000000000e-01 1.802333847160206559e-01 1.802333847160206559e-01 1.802333847160206559e-01 -1.562500000000000000e-02 2.968750000000000000e-01 2.031250000000000000e-01 1.554457231830781438e-01 1.554457231830781438e-01 1.554457231830781438e-01 -1.562500000000000000e-02 2.968750000000000000e-01 2.343750000000000000e-01 2.083324598530290339e-01 2.083324598530290339e-01 2.083324598530290339e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.031250000000000000e-01 1.112161790836160707e-01 1.112161790836160707e-01 1.112161790836160707e-01 -4.687500000000000000e-02 2.656250000000000000e-01 2.343750000000000000e-01 2.141597225090711154e-01 2.141597225090711154e-01 2.141597225090711154e-01 -4.687500000000000000e-02 2.968750000000000000e-01 2.343750000000000000e-01 2.558826919176084846e-01 2.558826919176084846e-01 2.558826919176084846e-01 -1.562500000000000000e-02 3.281250000000000000e-01 1.406250000000000000e-01 6.252882724047682805e-02 6.252882724047682805e-02 6.252882724047682805e-02 -1.562500000000000000e-02 3.281250000000000000e-01 1.718750000000000000e-01 1.135589483098168873e-01 1.135589483098168873e-01 1.135589483098168873e-01 -1.562500000000000000e-02 3.593750000000000000e-01 1.406250000000000000e-01 7.137343617857214162e-02 7.137343617857214162e-02 7.137343617857214162e-02 -1.562500000000000000e-02 3.593750000000000000e-01 1.718750000000000000e-01 1.108988234104190673e-01 1.108988234104190673e-01 1.108988234104190673e-01 -4.687500000000000000e-02 3.281250000000000000e-01 1.406250000000000000e-01 9.147266594369993231e-02 9.147266594369993231e-02 9.147266594369993231e-02 -4.687500000000000000e-02 3.281250000000000000e-01 1.718750000000000000e-01 1.001361095630853154e-01 1.001361095630853154e-01 1.001361095630853154e-01 -4.687500000000000000e-02 3.593750000000000000e-01 1.406250000000000000e-01 8.446151252716632696e-02 8.446151252716632696e-02 8.446151252716632696e-02 -4.687500000000000000e-02 3.593750000000000000e-01 1.718750000000000000e-01 1.054489482560269226e-01 1.054489482560269226e-01 1.054489482560269226e-01 -1.562500000000000000e-02 3.281250000000000000e-01 2.343750000000000000e-01 1.884498279220538641e-01 1.884498279220538641e-01 1.884498279220538641e-01 -1.562500000000000000e-02 3.593750000000000000e-01 2.031250000000000000e-01 1.353419896069993078e-01 1.353419896069993078e-01 1.353419896069993078e-01 -1.562500000000000000e-02 3.593750000000000000e-01 2.343750000000000000e-01 1.055116203029733274e-01 1.055116203029733274e-01 1.055116203029733274e-01 -4.687500000000000000e-02 3.281250000000000000e-01 2.343750000000000000e-01 2.300120419819841888e-01 2.300120419819841888e-01 2.300120419819841888e-01 -4.687500000000000000e-02 3.593750000000000000e-01 2.031250000000000000e-01 1.357122591655151311e-01 1.357122591655151311e-01 1.357122591655151311e-01 -4.687500000000000000e-02 3.593750000000000000e-01 2.343750000000000000e-01 1.261055821082022743e-01 1.261055821082022743e-01 1.261055821082022743e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.406250000000000000e-01 1.590165357400328550e-01 1.590165357400328550e-01 1.590165357400328550e-01 -7.812500000000000000e-02 2.656250000000000000e-01 1.718750000000000000e-01 1.459024366842861797e-01 1.459024366842861797e-01 1.459024366842861797e-01 -7.812500000000000000e-02 2.968750000000000000e-01 1.718750000000000000e-01 1.102705358283196657e-01 1.102705358283196657e-01 1.102705358283196657e-01 -1.093750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 9.178447288166582951e-02 9.178447288166582951e-02 9.178447288166582951e-02 -1.093750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 9.808705352549899892e-02 9.808705352549899892e-02 9.808705352549899892e-02 -1.093750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 7.477524674810516470e-02 7.477524674810516470e-02 7.477524674810516470e-02 -1.093750000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 8.445990513170024971e-02 8.445990513170024971e-02 8.445990513170024971e-02 -7.812500000000000000e-02 2.656250000000000000e-01 2.031250000000000000e-01 2.149003372016773383e-01 2.149003372016773383e-01 2.149003372016773383e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.343750000000000000e-01 1.656871951914388186e-01 1.656871951914388186e-01 1.656871951914388186e-01 -7.812500000000000000e-02 2.968750000000000000e-01 2.031250000000000000e-01 1.779896907245337723e-01 1.779896907245337723e-01 1.779896907245337723e-01 -7.812500000000000000e-02 2.968750000000000000e-01 2.343750000000000000e-01 2.196808690915505735e-01 2.196808690915505735e-01 2.196808690915505735e-01 -1.093750000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 1.806604421012130701e-01 1.806604421012130701e-01 1.806604421012130701e-01 -1.093750000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 1.177389668855205879e-01 1.177389668855205879e-01 1.177389668855205879e-01 -1.093750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 1.262445497438798858e-01 1.262445497438798858e-01 1.262445497438798858e-01 -1.093750000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 1.331307782223126457e-01 1.331307782223126457e-01 1.331307782223126457e-01 -7.812500000000000000e-02 3.281250000000000000e-01 1.718750000000000000e-01 1.102046537260184533e-01 1.102046537260184533e-01 1.102046537260184533e-01 -7.812500000000000000e-02 3.593750000000000000e-01 1.406250000000000000e-01 8.417619933032620405e-02 8.417619933032620405e-02 8.417619933032620405e-02 -7.812500000000000000e-02 3.593750000000000000e-01 1.718750000000000000e-01 7.215684359618454446e-02 7.215684359618454446e-02 7.215684359618454446e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 8.245706544173628250e-02 8.245706544173628250e-02 8.245706544173628250e-02 -1.093750000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 9.317633859977392241e-02 9.317633859977392241e-02 9.317633859977392241e-02 -1.093750000000000000e-01 3.593750000000000000e-01 1.406250000000000000e-01 6.945202203118067130e-02 6.945202203118067130e-02 6.945202203118067130e-02 -7.812500000000000000e-02 3.281250000000000000e-01 2.031250000000000000e-01 1.962175925337505400e-01 1.962175925337505400e-01 1.962175925337505400e-01 -7.812500000000000000e-02 3.281250000000000000e-01 2.343750000000000000e-01 2.178001432083193079e-01 2.178001432083193079e-01 2.178001432083193079e-01 -7.812500000000000000e-02 3.593750000000000000e-01 2.031250000000000000e-01 1.357387642963199803e-01 1.357387642963199803e-01 1.357387642963199803e-01 -7.812500000000000000e-02 3.593750000000000000e-01 2.343750000000000000e-01 1.238539516457699413e-01 1.238539516457699413e-01 1.238539516457699413e-01 -1.093750000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 1.233542948157406866e-01 1.233542948157406866e-01 1.233542948157406866e-01 -1.562500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 6.692452447899897849e-02 6.692452447899897849e-02 6.692452447899897849e-02 -1.562500000000000000e-02 4.218750000000000000e-01 4.687500000000000000e-02 7.187357670117580644e-02 7.187357670117580644e-02 7.187357670117580644e-02 -4.687500000000000000e-02 3.906250000000000000e-01 1.562500000000000000e-02 9.233656106804716268e-02 9.233656106804716268e-02 9.233656106804716268e-02 -4.687500000000000000e-02 3.906250000000000000e-01 4.687500000000000000e-02 1.251344085203709711e-01 1.251344085203709711e-01 1.251344085203709711e-01 -4.687500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 7.431033067305790885e-02 7.431033067305790885e-02 7.431033067305790885e-02 -4.687500000000000000e-02 4.218750000000000000e-01 4.687500000000000000e-02 9.491613688641767355e-02 9.491613688641767355e-02 9.491613688641767355e-02 -1.562500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 6.514320274260472499e-02 6.514320274260472499e-02 6.514320274260472499e-02 -1.562500000000000000e-02 4.218750000000000000e-01 7.812500000000000000e-02 7.020441993433773620e-02 7.020441993433773620e-02 7.020441993433773620e-02 -1.562500000000000000e-02 4.218750000000000000e-01 1.093750000000000000e-01 5.699752840935020520e-02 5.699752840935020520e-02 5.699752840935020520e-02 -4.687500000000000000e-02 3.906250000000000000e-01 7.812500000000000000e-02 6.862341158351953352e-02 6.862341158351953352e-02 6.862341158351953352e-02 -4.687500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 8.067761467665533759e-02 8.067761467665533759e-02 8.067761467665533759e-02 -4.687500000000000000e-02 4.218750000000000000e-01 7.812500000000000000e-02 4.748742333594383608e-02 4.748742333594383608e-02 4.748742333594383608e-02 -1.562500000000000000e-02 4.531250000000000000e-01 4.687500000000000000e-02 7.048576349664144314e-02 7.048576349664144314e-02 7.048576349664144314e-02 -4.687500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 8.468011801026992247e-02 8.468011801026992247e-02 8.468011801026992247e-02 -4.687500000000000000e-02 4.843750000000000000e-01 1.562500000000000000e-02 5.108666905535493019e-02 5.108666905535493019e-02 5.108666905535493019e-02 -1.562500000000000000e-02 4.531250000000000000e-01 7.812500000000000000e-02 6.577272710608583761e-02 6.577272710608583761e-02 6.577272710608583761e-02 -7.812500000000000000e-02 3.906250000000000000e-01 1.562500000000000000e-02 7.001214113951030604e-02 7.001214113951030604e-02 7.001214113951030604e-02 -7.812500000000000000e-02 3.906250000000000000e-01 4.687500000000000000e-02 8.897575597751410104e-02 8.897575597751410104e-02 8.897575597751410104e-02 -7.812500000000000000e-02 4.218750000000000000e-01 1.562500000000000000e-02 7.732162738851679207e-02 7.732162738851679207e-02 7.732162738851679207e-02 -7.812500000000000000e-02 4.218750000000000000e-01 4.687500000000000000e-02 9.198778964135592706e-02 9.198778964135592706e-02 9.198778964135592706e-02 -1.093750000000000000e-01 3.906250000000000000e-01 1.562500000000000000e-02 6.266155380251361984e-02 6.266155380251361984e-02 6.266155380251361984e-02 -1.093750000000000000e-01 3.906250000000000000e-01 4.687500000000000000e-02 6.486971865330287690e-02 6.486971865330287690e-02 6.486971865330287690e-02 -1.093750000000000000e-01 4.218750000000000000e-01 4.687500000000000000e-02 9.109335278170761774e-02 9.109335278170761774e-02 9.109335278170761774e-02 -7.812500000000000000e-02 3.906250000000000000e-01 7.812500000000000000e-02 8.089623044139360175e-02 8.089623044139360175e-02 8.089623044139360175e-02 -7.812500000000000000e-02 3.906250000000000000e-01 1.093750000000000000e-01 8.187276051959636869e-02 8.187276051959636869e-02 8.187276051959636869e-02 -1.093750000000000000e-01 3.906250000000000000e-01 7.812500000000000000e-02 4.118216404934938596e-02 4.118216404934938596e-02 4.118216404934938596e-02 -1.093750000000000000e-01 3.906250000000000000e-01 1.093750000000000000e-01 3.825636361539811597e-02 3.825636361539811597e-02 3.825636361539811597e-02 -1.093750000000000000e-01 4.218750000000000000e-01 7.812500000000000000e-02 9.111103267222983582e-02 9.111103267222983582e-02 9.111103267222983582e-02 -7.812500000000000000e-02 4.531250000000000000e-01 1.562500000000000000e-02 8.414565870281669191e-02 8.414565870281669191e-02 8.414565870281669191e-02 -7.812500000000000000e-02 4.531250000000000000e-01 4.687500000000000000e-02 8.246510261878606252e-02 8.246510261878606252e-02 8.246510261878606252e-02 -7.812500000000000000e-02 4.843750000000000000e-01 1.562500000000000000e-02 9.090530279681702241e-02 9.090530279681702241e-02 9.090530279681702241e-02 -7.812500000000000000e-02 4.843750000000000000e-01 4.687500000000000000e-02 8.272711415072421526e-02 8.272711415072421526e-02 8.272711415072421526e-02 -1.093750000000000000e-01 4.531250000000000000e-01 4.687500000000000000e-02 8.602790413690211691e-02 8.602790413690211691e-02 8.602790413690211691e-02 -1.093750000000000000e-01 4.843750000000000000e-01 1.562500000000000000e-02 7.282819180032169826e-02 7.282819180032169826e-02 7.282819180032169826e-02 -1.093750000000000000e-01 4.843750000000000000e-01 4.687500000000000000e-02 9.377824073923973769e-02 9.377824073923973769e-02 9.377824073923973769e-02 -1.093750000000000000e-01 4.531250000000000000e-01 7.812500000000000000e-02 9.972389189469955950e-02 9.972389189469955950e-02 9.972389189469955950e-02 -1.093750000000000000e-01 4.843750000000000000e-01 7.812500000000000000e-02 9.848079775582375961e-02 9.848079775582375961e-02 9.848079775582375961e-02 -1.562500000000000000e-02 3.906250000000000000e-01 1.406250000000000000e-01 6.839929623212957777e-02 6.839929623212957777e-02 6.839929623212957777e-02 -4.687500000000000000e-02 3.906250000000000000e-01 1.406250000000000000e-01 7.407586212440170348e-02 7.407586212440170348e-02 7.407586212440170348e-02 -7.812500000000000000e-02 3.906250000000000000e-01 1.406250000000000000e-01 6.966367484491781115e-02 6.966367484491781115e-02 6.966367484491781115e-02 -1.406250000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 9.344554772344505766e-02 9.344554772344505766e-02 9.344554772344505766e-02 -1.406250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 9.024551710844294639e-02 9.024551710844294639e-02 9.024551710844294639e-02 -1.718750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 1.029894336060268728e-01 1.029894336060268728e-01 1.029894336060268728e-01 -1.406250000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 6.433504733831536815e-02 6.433504733831536815e-02 6.433504733831536815e-02 -1.406250000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 5.465335275008210980e-02 5.465335275008210980e-02 5.465335275008210980e-02 -1.718750000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 6.505035331035455282e-02 6.505035331035455282e-02 6.505035331035455282e-02 -1.718750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 9.777286031856044501e-02 9.777286031856044501e-02 9.777286031856044501e-02 -1.718750000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 9.010648727804748681e-02 9.010648727804748681e-02 9.010648727804748681e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 1.471600566976282165e-01 1.471600566976282165e-01 1.471600566976282165e-01 -1.406250000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 4.560355233393934005e-02 4.560355233393934005e-02 4.560355233393934005e-02 -1.406250000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 5.219292796178013477e-02 5.219292796178013477e-02 5.219292796178013477e-02 -1.718750000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 7.630469236194604987e-02 7.630469236194604987e-02 7.630469236194604987e-02 -1.718750000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 1.169380076303329768e-01 1.169380076303329768e-01 1.169380076303329768e-01 -1.718750000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 4.346891694714700993e-02 4.346891694714700993e-02 4.346891694714700993e-02 -1.718750000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 7.167647894292929200e-02 7.167647894292929200e-02 7.167647894292929200e-02 -2.031250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 2.143490894280841164e-01 2.143490894280841164e-01 2.143490894280841164e-01 -2.031250000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 1.452985151062445024e-01 1.452985151062445024e-01 1.452985151062445024e-01 -2.031250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 1.491147093184575778e-01 1.491147093184575778e-01 1.491147093184575778e-01 -2.343750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 1.774510343018927128e-01 1.774510343018927128e-01 1.774510343018927128e-01 -2.343750000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 1.132938235285077394e-01 1.132938235285077394e-01 1.132938235285077394e-01 -2.343750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 1.664338763815614575e-01 1.664338763815614575e-01 1.664338763815614575e-01 -2.343750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 8.266040577418555524e-02 8.266040577418555524e-02 8.266040577418555524e-02 -2.031250000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 9.008077075131330769e-02 9.008077075131330769e-02 9.008077075131330769e-02 -2.031250000000000000e-01 3.281250000000000000e-01 1.562500000000000000e-02 5.957799633813404272e-02 5.957799633813404272e-02 5.957799633813404272e-02 -2.031250000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 1.285788488308528821e-01 1.285788488308528821e-01 1.285788488308528821e-01 -2.031250000000000000e-01 3.593750000000000000e-01 1.562500000000000000e-02 8.090346404109464984e-02 8.090346404109464984e-02 8.090346404109464984e-02 -2.031250000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 9.519417968471524660e-02 9.519417968471524660e-02 9.519417968471524660e-02 -2.343750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 1.059197909014577416e-01 1.059197909014577416e-01 1.059197909014577416e-01 -2.343750000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 7.370747906495050961e-02 7.370747906495050961e-02 7.370747906495050961e-02 -2.031250000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 8.141785168624614266e-02 8.141785168624614266e-02 8.141785168624614266e-02 -2.031250000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 6.792863588484129855e-02 6.792863588484129855e-02 6.792863588484129855e-02 -2.343750000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 1.027371302359699756e-01 1.027371302359699756e-01 1.027371302359699756e-01 -2.343750000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 8.291116468595777222e-02 8.291116468595777222e-02 8.291116468595777222e-02 -2.343750000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 7.653473364230711784e-02 7.653473364230711784e-02 7.653473364230711784e-02 -2.343750000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 7.030112184686389265e-02 7.030112184686389265e-02 7.030112184686389265e-02 -1.406250000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 1.027258810227164448e-01 1.027258810227164448e-01 1.027258810227164448e-01 -1.406250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 4.013670761417303251e-02 4.013670761417303251e-02 4.013670761417303251e-02 -1.406250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 8.777026800558983266e-02 8.777026800558983266e-02 8.777026800558983266e-02 -1.718750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 7.425543117357444323e-02 7.425543117357444323e-02 7.425543117357444323e-02 -1.718750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 1.009573244320282892e-01 1.009573244320282892e-01 1.009573244320282892e-01 -1.718750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.072736490256222391e-01 1.072736490256222391e-01 1.072736490256222391e-01 -1.718750000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 7.943695896043043159e-02 7.943695896043043159e-02 7.943695896043043159e-02 -1.406250000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 1.576322323451414542e-01 1.576322323451414542e-01 1.576322323451414542e-01 -1.406250000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 1.156999997540835989e-01 1.156999997540835989e-01 1.156999997540835989e-01 -1.718750000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 1.490737536495650439e-01 1.490737536495650439e-01 1.490737536495650439e-01 -1.718750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 9.830562198925356376e-02 9.830562198925356376e-02 9.830562198925356376e-02 -1.406250000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 9.645018185416939782e-02 9.645018185416939782e-02 9.645018185416939782e-02 -1.718750000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 1.330689308987023090e-01 1.330689308987023090e-01 1.330689308987023090e-01 -1.406250000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 1.079590059066538876e-01 1.079590059066538876e-01 1.079590059066538876e-01 -1.406250000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 1.334102954034805943e-01 1.334102954034805943e-01 1.334102954034805943e-01 -1.718750000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 8.172246406942991481e-02 8.172246406942991481e-02 8.172246406942991481e-02 -1.718750000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 1.126711785613645628e-01 1.126711785613645628e-01 1.126711785613645628e-01 -2.031250000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 6.975491126398050690e-02 6.975491126398050690e-02 6.975491126398050690e-02 -2.031250000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 1.035904588288645983e-01 1.035904588288645983e-01 1.035904588288645983e-01 -2.031250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.022293070412524929e-01 1.022293070412524929e-01 1.022293070412524929e-01 -2.031250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 7.087932129765749101e-02 7.087932129765749101e-02 7.087932129765749101e-02 -2.343750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 1.310271393149509134e-01 1.310271393149509134e-01 1.310271393149509134e-01 -2.343750000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 9.597205154188405418e-02 9.597205154188405418e-02 9.597205154188405418e-02 -2.343750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.081044325830884667e-01 1.081044325830884667e-01 1.081044325830884667e-01 -2.343750000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 9.936068861202883296e-02 9.936068861202883296e-02 9.936068861202883296e-02 -2.031250000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 1.395313175435863307e-01 1.395313175435863307e-01 1.395313175435863307e-01 -2.031250000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 1.079501678128732128e-01 1.079501678128732128e-01 1.079501678128732128e-01 -2.031250000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 1.140972292691106033e-01 1.140972292691106033e-01 1.140972292691106033e-01 -2.031250000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 1.033751187571649438e-01 1.033751187571649438e-01 1.033751187571649438e-01 -2.343750000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 9.555338384264012996e-02 9.555338384264012996e-02 9.555338384264012996e-02 -2.343750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 1.006576060823527186e-01 1.006576060823527186e-01 1.006576060823527186e-01 -2.343750000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 9.295534536232757938e-02 9.295534536232757938e-02 9.295534536232757938e-02 -2.343750000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 5.976089392110423004e-02 5.976089392110423004e-02 5.976089392110423004e-02 -2.343750000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 8.777348266419915390e-02 8.777348266419915390e-02 8.777348266419915390e-02 -2.031250000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 8.200698224579107409e-02 8.200698224579107409e-02 8.200698224579107409e-02 -2.343750000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 9.815535623420516831e-02 9.815535623420516831e-02 9.815535623420516831e-02 -1.406250000000000000e-01 3.906250000000000000e-01 4.687500000000000000e-02 6.558284937861247332e-02 6.558284937861247332e-02 6.558284937861247332e-02 -1.406250000000000000e-01 4.218750000000000000e-01 4.687500000000000000e-02 8.862455901293679605e-02 8.862455901293679605e-02 8.862455901293679605e-02 -1.718750000000000000e-01 3.906250000000000000e-01 4.687500000000000000e-02 7.035972170237601853e-02 7.035972170237601853e-02 7.035972170237601853e-02 -1.718750000000000000e-01 4.218750000000000000e-01 1.562500000000000000e-02 7.983674218025449409e-02 7.983674218025449409e-02 7.983674218025449409e-02 -1.718750000000000000e-01 4.218750000000000000e-01 4.687500000000000000e-02 8.826934221698654048e-02 8.826934221698654048e-02 8.826934221698654048e-02 -1.406250000000000000e-01 3.906250000000000000e-01 7.812500000000000000e-02 3.430342087728652234e-02 3.430342087728652234e-02 3.430342087728652234e-02 -1.406250000000000000e-01 4.218750000000000000e-01 7.812500000000000000e-02 9.062403063152167648e-02 9.062403063152167648e-02 9.062403063152167648e-02 -1.718750000000000000e-01 4.531250000000000000e-01 1.562500000000000000e-02 9.466702258046952312e-02 9.466702258046952312e-02 9.466702258046952312e-02 -1.718750000000000000e-01 4.531250000000000000e-01 4.687500000000000000e-02 1.270060559946432077e-01 1.270060559946432077e-01 1.270060559946432077e-01 -1.718750000000000000e-01 4.843750000000000000e-01 4.687500000000000000e-02 9.708741665997053238e-02 9.708741665997053238e-02 9.708741665997053238e-02 -1.406250000000000000e-01 4.531250000000000000e-01 7.812500000000000000e-02 1.004840421307492820e-01 1.004840421307492820e-01 1.004840421307492820e-01 -1.406250000000000000e-01 4.843750000000000000e-01 7.812500000000000000e-02 9.616410758861507202e-02 9.616410758861507202e-02 9.616410758861507202e-02 -1.718750000000000000e-01 4.531250000000000000e-01 7.812500000000000000e-02 1.038451700352842899e-01 1.038451700352842899e-01 1.038451700352842899e-01 -1.718750000000000000e-01 4.843750000000000000e-01 7.812500000000000000e-02 1.009541103001544982e-01 1.009541103001544982e-01 1.009541103001544982e-01 -2.031250000000000000e-01 3.906250000000000000e-01 1.562500000000000000e-02 8.504579864866046446e-02 8.504579864866046446e-02 8.504579864866046446e-02 -2.031250000000000000e-01 3.906250000000000000e-01 4.687500000000000000e-02 6.749286063024727278e-02 6.749286063024727278e-02 6.749286063024727278e-02 -2.031250000000000000e-01 4.218750000000000000e-01 1.562500000000000000e-02 7.616555806078391389e-02 7.616555806078391389e-02 7.616555806078391389e-02 -2.031250000000000000e-01 4.531250000000000000e-01 1.562500000000000000e-02 1.012618628447768815e-01 1.012618628447768815e-01 1.012618628447768815e-01 -2.031250000000000000e-01 4.531250000000000000e-01 4.687500000000000000e-02 1.196308700740270486e-01 1.196308700740270486e-01 1.196308700740270486e-01 -2.031250000000000000e-01 4.843750000000000000e-01 1.562500000000000000e-02 1.187423639685316057e-01 1.187423639685316057e-01 1.187423639685316057e-01 -2.031250000000000000e-01 4.843750000000000000e-01 4.687500000000000000e-02 1.307074520700297615e-01 1.307074520700297615e-01 1.307074520700297615e-01 -2.031250000000000000e-01 4.843750000000000000e-01 7.812500000000000000e-02 1.121770762227491530e-01 1.121770762227491530e-01 1.121770762227491530e-01 -1.562500000000000000e-02 2.968750000000000000e-01 2.656250000000000000e-01 1.436248576817639733e-01 1.436248576817639733e-01 1.436248576817639733e-01 -4.687500000000000000e-02 2.968750000000000000e-01 2.656250000000000000e-01 1.952231871568590182e-01 1.952231871568590182e-01 1.952231871568590182e-01 -1.562500000000000000e-02 3.281250000000000000e-01 2.656250000000000000e-01 1.444159141144159553e-01 1.444159141144159553e-01 1.444159141144159553e-01 -4.687500000000000000e-02 3.281250000000000000e-01 2.656250000000000000e-01 1.718097763920702070e-01 1.718097763920702070e-01 1.718097763920702070e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.656250000000000000e-01 1.424394631270313460e-01 1.424394631270313460e-01 1.424394631270313460e-01 -7.812500000000000000e-02 2.656250000000000000e-01 2.968750000000000000e-01 1.037350898967469570e-01 1.037350898967469570e-01 1.037350898967469570e-01 -1.093750000000000000e-01 2.656250000000000000e-01 2.656250000000000000e-01 8.945312422184145684e-02 8.945312422184145684e-02 8.945312422184145684e-02 -1.093750000000000000e-01 2.656250000000000000e-01 2.968750000000000000e-01 9.081449217666584528e-02 9.081449217666584528e-02 9.081449217666584528e-02 -1.093750000000000000e-01 2.968750000000000000e-01 2.656250000000000000e-01 1.212158570530088991e-01 1.212158570530088991e-01 1.212158570530088991e-01 -1.093750000000000000e-01 2.968750000000000000e-01 2.968750000000000000e-01 8.771963711551002130e-02 8.771963711551002130e-02 8.771963711551002130e-02 -1.093750000000000000e-01 3.281250000000000000e-01 2.656250000000000000e-01 1.349331650564233043e-01 1.349331650564233043e-01 1.349331650564233043e-01 -1.406250000000000000e-01 2.656250000000000000e-01 2.968750000000000000e-01 8.038674226575960591e-02 8.038674226575960591e-02 8.038674226575960591e-02 -1.406250000000000000e-01 2.968750000000000000e-01 2.968750000000000000e-01 8.677853969197057982e-02 8.677853969197057982e-02 8.677853969197057982e-02 -1.718750000000000000e-01 2.656250000000000000e-01 2.968750000000000000e-01 8.166379211696409013e-02 8.166379211696409013e-02 8.166379211696409013e-02 -1.718750000000000000e-01 2.968750000000000000e-01 2.968750000000000000e-01 8.706866569055918270e-02 8.706866569055918270e-02 8.706866569055918270e-02 -1.406250000000000000e-01 3.281250000000000000e-01 2.656250000000000000e-01 1.294070026709486232e-01 1.294070026709486232e-01 1.294070026709486232e-01 -1.406250000000000000e-01 3.281250000000000000e-01 2.968750000000000000e-01 8.789081761559659756e-02 8.789081761559659756e-02 8.789081761559659756e-02 -1.718750000000000000e-01 3.281250000000000000e-01 2.656250000000000000e-01 1.203546819904335458e-01 1.203546819904335458e-01 1.203546819904335458e-01 -1.718750000000000000e-01 3.281250000000000000e-01 2.968750000000000000e-01 9.518132223546967030e-02 9.518132223546967030e-02 9.518132223546967030e-02 -2.031250000000000000e-01 2.656250000000000000e-01 2.656250000000000000e-01 9.471684550336678665e-02 9.471684550336678665e-02 9.471684550336678665e-02 -2.031250000000000000e-01 2.656250000000000000e-01 2.968750000000000000e-01 7.684965281910269286e-02 7.684965281910269286e-02 7.684965281910269286e-02 -2.031250000000000000e-01 2.968750000000000000e-01 2.656250000000000000e-01 1.301981989106673343e-01 1.301981989106673343e-01 1.301981989106673343e-01 -2.031250000000000000e-01 2.968750000000000000e-01 2.968750000000000000e-01 7.928754208422605920e-02 7.928754208422605920e-02 7.928754208422605920e-02 -2.031250000000000000e-01 3.281250000000000000e-01 2.656250000000000000e-01 1.153601668749446585e-01 1.153601668749446585e-01 1.153601668749446585e-01 -2.656250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.158285413673123820e-01 1.158285413673123820e-01 1.158285413673123820e-01 -2.656250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 2.294777449997069396e-01 2.294777449997069396e-01 2.294777449997069396e-01 -2.656250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.120573664190164520e-01 1.120573664190164520e-01 1.120573664190164520e-01 -2.656250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 1.834322463034864237e-01 1.834322463034864237e-01 1.834322463034864237e-01 -2.968750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.226843320741449889e-01 1.226843320741449889e-01 1.226843320741449889e-01 -2.968750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.171123394610764368e-01 1.171123394610764368e-01 1.171123394610764368e-01 -2.968750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.170295921414983426e-01 1.170295921414983426e-01 1.170295921414983426e-01 -2.656250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 8.308717768604684251e-02 8.308717768604684251e-02 8.308717768604684251e-02 -2.656250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 7.150011944650491724e-02 7.150011944650491724e-02 7.150011944650491724e-02 -2.656250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 1.354721062187172476e-01 1.354721062187172476e-01 1.354721062187172476e-01 -2.968750000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 1.020870838314709983e-01 1.020870838314709983e-01 1.020870838314709983e-01 -2.968750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 8.183177060648508250e-02 8.183177060648508250e-02 8.183177060648508250e-02 -2.968750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.160599157535873588e-01 1.160599157535873588e-01 1.160599157535873588e-01 -2.656250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 1.026013360564142635e-01 1.026013360564142635e-01 1.026013360564142635e-01 -2.656250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 7.418485753061239418e-02 7.418485753061239418e-02 7.418485753061239418e-02 -2.656250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 1.462855069312904988e-01 1.462855069312904988e-01 1.462855069312904988e-01 -2.656250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 1.000000000000000000e+00 1.000000000000000000e+00 1.000000000000000000e+00 -2.968750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 7.493238841700079755e-02 7.493238841700079755e-02 7.493238841700079755e-02 -2.656250000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 8.068404456056406382e-02 8.068404456056406382e-02 8.068404456056406382e-02 -2.656250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 9.613196434914084154e-02 9.613196434914084154e-02 9.613196434914084154e-02 -3.281250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 9.318276748486457872e-02 9.318276748486457872e-02 9.318276748486457872e-02 -3.281250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 8.080621225726512813e-02 8.080621225726512813e-02 8.080621225726512813e-02 -3.281250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.153842685448676214e-01 1.153842685448676214e-01 1.153842685448676214e-01 -3.593750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 5.092714910943269002e-02 5.092714910943269002e-02 5.092714910943269002e-02 -3.593750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.376254252660282229e-01 1.376254252660282229e-01 1.376254252660282229e-01 -3.281250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 6.703216299177654214e-02 6.703216299177654214e-02 6.703216299177654214e-02 -3.281250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 5.132739563302721880e-02 5.132739563302721880e-02 5.132739563302721880e-02 -3.281250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.406308193536460471e-01 1.406308193536460471e-01 1.406308193536460471e-01 -3.593750000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 6.726207001252330897e-02 6.726207001252330897e-02 6.726207001252330897e-02 -3.593750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.210206474689511508e-01 1.210206474689511508e-01 1.210206474689511508e-01 -3.281250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 1.066967555897558873e-01 1.066967555897558873e-01 1.066967555897558873e-01 -3.281250000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 2.322943967963036482e-01 2.322943967963036482e-01 2.322943967963036482e-01 -3.593750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 1.165057916004743899e-01 1.165057916004743899e-01 1.165057916004743899e-01 -3.593750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 7.108767464821064141e-02 7.108767464821064141e-02 7.108767464821064141e-02 -3.281250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.652640727742790971e-01 1.652640727742790971e-01 1.652640727742790971e-01 -3.281250000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 6.361089204065771552e-02 6.361089204065771552e-02 6.361089204065771552e-02 -3.281250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.084764344320786333e-01 1.084764344320786333e-01 1.084764344320786333e-01 -3.593750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.657835415408561441e-01 1.657835415408561441e-01 1.657835415408561441e-01 -3.593750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 6.402578687573451388e-02 6.402578687573451388e-02 6.402578687573451388e-02 -2.656250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 9.471523831277911532e-02 9.471523831277911532e-02 9.471523831277911532e-02 -2.656250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 9.296498871625943905e-02 9.296498871625943905e-02 9.296498871625943905e-02 -2.656250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 5.543459142806055756e-02 5.543459142806055756e-02 5.543459142806055756e-02 -2.968750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.129612112036346983e-01 1.129612112036346983e-01 1.129612112036346983e-01 -2.968750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 9.528016382376737481e-02 9.528016382376737481e-02 9.528016382376737481e-02 -2.968750000000000000e-01 4.687500000000000000e-02 1.406250000000000000e-01 3.401137975295342453e-01 3.401137975295342453e-01 3.401137975295342453e-01 -2.968750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 9.171295026301487519e-02 9.171295026301487519e-02 9.171295026301487519e-02 -2.656250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.381980811671622011e-01 1.381980811671622011e-01 1.381980811671622011e-01 -2.656250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.432586400902252088e-01 1.432586400902252088e-01 1.432586400902252088e-01 -2.968750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 1.110538859590404770e-01 1.110538859590404770e-01 1.110538859590404770e-01 -2.968750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.203852088759952421e-01 1.203852088759952421e-01 1.203852088759952421e-01 -2.968750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 9.374047131150083090e-02 9.374047131150083090e-02 9.374047131150083090e-02 -2.968750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 1.161233829168671489e-01 1.161233829168671489e-01 1.161233829168671489e-01 -2.968750000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 2.525648027443163079e-01 2.525648027443163079e-01 2.525648027443163079e-01 -2.968750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 1.188733107832245367e-01 1.188733107832245367e-01 1.188733107832245367e-01 -2.968750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.323926232966515237e-01 1.323926232966515237e-01 1.323926232966515237e-01 -2.968750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 1.286230279609624216e-01 1.286230279609624216e-01 1.286230279609624216e-01 -2.656250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.324247520524524102e-01 1.324247520524524102e-01 1.324247520524524102e-01 -2.656250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 8.843087765120956345e-02 8.843087765120956345e-02 8.843087765120956345e-02 -2.968750000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 1.188347497801654079e-01 1.188347497801654079e-01 1.188347497801654079e-01 -3.281250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 9.734054131713082425e-02 9.734054131713082425e-02 9.734054131713082425e-02 -3.281250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.267851556619428166e-01 1.267851556619428166e-01 1.267851556619428166e-01 -3.281250000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 9.325509240678085676e-02 9.325509240678085676e-02 9.325509240678085676e-02 -3.593750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 1.011694568519055509e-01 1.011694568519055509e-01 1.011694568519055509e-01 -3.593750000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 1.191946517565064950e-01 1.191946517565064950e-01 1.191946517565064950e-01 -3.593750000000000000e-01 4.687500000000000000e-02 1.718750000000000000e-01 9.072528872430554725e-02 9.072528872430554725e-02 9.072528872430554725e-02 -3.281250000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 1.320705318107084636e-01 1.320705318107084636e-01 1.320705318107084636e-01 -3.281250000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.261112050807813856e-01 1.261112050807813856e-01 1.261112050807813856e-01 -3.593750000000000000e-01 1.562500000000000000e-02 2.031250000000000000e-01 1.058667609801153681e-01 1.058667609801153681e-01 1.058667609801153681e-01 -3.593750000000000000e-01 1.562500000000000000e-02 2.343750000000000000e-01 1.022670724840966106e-01 1.022670724840966106e-01 1.022670724840966106e-01 -3.593750000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 1.041979075667948812e-01 1.041979075667948812e-01 1.041979075667948812e-01 -3.593750000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 9.828633656044570566e-02 9.828633656044570566e-02 9.828633656044570566e-02 -3.281250000000000000e-01 7.812500000000000000e-02 1.406250000000000000e-01 1.483084409431545125e-01 1.483084409431545125e-01 1.483084409431545125e-01 -3.281250000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 6.730210270630974934e-02 6.730210270630974934e-02 6.730210270630974934e-02 -3.281250000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 1.033944029661771763e-01 1.033944029661771763e-01 1.033944029661771763e-01 -3.281250000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 7.608003575972122068e-02 7.608003575972122068e-02 7.608003575972122068e-02 -3.593750000000000000e-01 7.812500000000000000e-02 1.718750000000000000e-01 7.595890580370463774e-02 7.595890580370463774e-02 7.595890580370463774e-02 -3.593750000000000000e-01 1.093750000000000000e-01 1.406250000000000000e-01 5.606491534543629751e-02 5.606491534543629751e-02 5.606491534543629751e-02 -3.593750000000000000e-01 1.093750000000000000e-01 1.718750000000000000e-01 8.626016792091951990e-02 8.626016792091951990e-02 8.626016792091951990e-02 -3.593750000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 8.423004725056437714e-02 8.423004725056437714e-02 8.423004725056437714e-02 -3.593750000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 9.030739736030830855e-02 9.030739736030830855e-02 9.030739736030830855e-02 -2.656250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 1.372077774381548487e-01 1.372077774381548487e-01 1.372077774381548487e-01 -2.656250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 6.240952589184699251e-02 6.240952589184699251e-02 6.240952589184699251e-02 -2.656250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.508436619698360626e-01 1.508436619698360626e-01 1.508436619698360626e-01 -2.656250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 2.688378067580458539e-02 2.688378067580458539e-02 2.688378067580458539e-02 -2.968750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 9.658357568642944591e-02 9.658357568642944591e-02 9.658357568642944591e-02 -2.968750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 4.358494954991058018e-02 4.358494954991058018e-02 4.358494954991058018e-02 -2.968750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.159707402876918869e-01 1.159707402876918869e-01 1.159707402876918869e-01 -2.968750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 6.387618059494980238e-02 6.387618059494980238e-02 6.387618059494980238e-02 -2.656250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 1.121441359589531311e-01 1.121441359589531311e-01 1.121441359589531311e-01 -2.656250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 1.030440724481884313e-01 1.030440724481884313e-01 1.030440724481884313e-01 -2.656250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 8.216933397463740962e-02 8.216933397463740962e-02 8.216933397463740962e-02 -2.656250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.078417002192138124e-01 1.078417002192138124e-01 1.078417002192138124e-01 -2.968750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 7.234485702606552326e-02 7.234485702606552326e-02 7.234485702606552326e-02 -2.968750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 9.737188050500117376e-02 9.737188050500117376e-02 9.737188050500117376e-02 -2.656250000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 1.620660945693497834e-01 1.620660945693497834e-01 1.620660945693497834e-01 -2.656250000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 1.156019866360066539e-01 1.156019866360066539e-01 1.156019866360066539e-01 -2.656250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 1.336287679264059058e-01 1.336287679264059058e-01 1.336287679264059058e-01 -2.968750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 9.065697970744573952e-02 9.065697970744573952e-02 9.065697970744573952e-02 -2.968750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 1.565931861904011346e-01 1.565931861904011346e-01 1.565931861904011346e-01 -2.968750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 9.881186284186527224e-02 9.881186284186527224e-02 9.881186284186527224e-02 -2.968750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 8.837140693204049990e-02 8.837140693204049990e-02 8.837140693204049990e-02 -2.656250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 8.814156022582234074e-02 8.814156022582234074e-02 8.814156022582234074e-02 -2.656250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 1.051661199497609250e-01 1.051661199497609250e-01 1.051661199497609250e-01 -2.656250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 1.242636357988473189e-01 1.242636357988473189e-01 1.242636357988473189e-01 -3.281250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 1.016547880118950226e-01 1.016547880118950226e-01 1.016547880118950226e-01 -3.281250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 5.838010738355568774e-02 5.838010738355568774e-02 5.838010738355568774e-02 -3.281250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 1.025121456717658919e-01 1.025121456717658919e-01 1.025121456717658919e-01 -3.281250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 5.932587837291580096e-02 5.932587837291580096e-02 5.932587837291580096e-02 -3.593750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 6.340356440699333740e-02 6.340356440699333740e-02 6.340356440699333740e-02 -3.593750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 6.860604829310548713e-02 6.860604829310548713e-02 6.860604829310548713e-02 -3.593750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 6.003326985863632892e-02 6.003326985863632892e-02 6.003326985863632892e-02 -3.281250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 7.113453800109477421e-02 7.113453800109477421e-02 7.113453800109477421e-02 -3.281250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 9.269417075363005354e-02 9.269417075363005354e-02 9.269417075363005354e-02 -3.281250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 8.357181423073387072e-02 8.357181423073387072e-02 8.357181423073387072e-02 -3.593750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 6.347495141522466189e-02 6.347495141522466189e-02 6.347495141522466189e-02 -3.593750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 8.621355448172950131e-02 8.621355448172950131e-02 8.621355448172950131e-02 -3.593750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.015744353730617527e-01 1.015744353730617527e-01 1.015744353730617527e-01 -3.281250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 8.599897157704620987e-02 8.599897157704620987e-02 8.599897157704620987e-02 -3.593750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 8.576670703897687487e-02 8.576670703897687487e-02 8.576670703897687487e-02 -3.593750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 7.851859135089193920e-02 7.851859135089193920e-02 7.851859135089193920e-02 -3.593750000000000000e-01 2.343750000000000000e-01 1.093750000000000000e-01 9.358939342325327260e-02 9.358939342325327260e-02 9.358939342325327260e-02 -2.656250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 1.810072238740667860e-01 1.810072238740667860e-01 1.810072238740667860e-01 -2.656250000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 1.341388025733518397e-01 1.341388025733518397e-01 1.341388025733518397e-01 -2.656250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 2.296638668737358002e-01 2.296638668737358002e-01 2.296638668737358002e-01 -2.656250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.724415976806691619e-01 1.724415976806691619e-01 1.724415976806691619e-01 -2.968750000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 1.074166665355962974e-01 1.074166665355962974e-01 1.074166665355962974e-01 -2.968750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 7.358891771714071162e-02 7.358891771714071162e-02 7.358891771714071162e-02 -2.968750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 6.109141107648050767e-02 6.109141107648050767e-02 6.109141107648050767e-02 -2.968750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 8.218138978301768593e-02 8.218138978301768593e-02 8.218138978301768593e-02 -2.656250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 9.413021880899979932e-02 9.413021880899979932e-02 9.413021880899979932e-02 -2.656250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 1.366142318912370590e-01 1.366142318912370590e-01 1.366142318912370590e-01 -2.656250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 8.435140586404096807e-02 8.435140586404096807e-02 8.435140586404096807e-02 -2.968750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 1.174561817803086994e-01 1.174561817803086994e-01 1.174561817803086994e-01 -2.968750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 9.292962974617385852e-02 9.292962974617385852e-02 9.292962974617385852e-02 -2.968750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 7.448523717420173218e-02 7.448523717420173218e-02 7.448523717420173218e-02 -2.656250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 1.712927550261691689e-01 1.712927550261691689e-01 1.712927550261691689e-01 -2.656250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.507954798632468174e-01 1.507954798632468174e-01 1.507954798632468174e-01 -2.656250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.064533021047540662e-01 1.064533021047540662e-01 1.064533021047540662e-01 -2.968750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 1.093031883216095818e-01 1.093031883216095818e-01 1.093031883216095818e-01 -2.968750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.071916950570110244e-01 1.071916950570110244e-01 1.071916950570110244e-01 -2.968750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.220497099434421778e-01 1.220497099434421778e-01 1.220497099434421778e-01 -2.656250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.139028058157117163e-01 1.139028058157117163e-01 1.139028058157117163e-01 -2.656250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.318898065967605837e-01 1.318898065967605837e-01 1.318898065967605837e-01 -2.656250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 1.023506385073819497e-01 1.023506385073819497e-01 1.023506385073819497e-01 -2.968750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.131950040683191994e-01 1.131950040683191994e-01 1.131950040683191994e-01 -2.968750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.147246835729433673e-01 1.147246835729433673e-01 1.147246835729433673e-01 -2.968750000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 7.856271760302530049e-02 7.856271760302530049e-02 7.856271760302530049e-02 -3.281250000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 9.163098044209053161e-02 9.163098044209053161e-02 9.163098044209053161e-02 -3.281250000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 7.264918223662539254e-02 7.264918223662539254e-02 7.264918223662539254e-02 -3.281250000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 7.906361718752187573e-02 7.906361718752187573e-02 7.906361718752187573e-02 -3.593750000000000000e-01 1.406250000000000000e-01 1.406250000000000000e-01 6.992130693365856964e-02 6.992130693365856964e-02 6.992130693365856964e-02 -3.593750000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 8.958411871616842048e-02 8.958411871616842048e-02 8.958411871616842048e-02 -3.593750000000000000e-01 1.718750000000000000e-01 1.406250000000000000e-01 7.842206006646125493e-02 7.842206006646125493e-02 7.842206006646125493e-02 -3.593750000000000000e-01 1.718750000000000000e-01 1.718750000000000000e-01 1.082715524170230620e-01 1.082715524170230620e-01 1.082715524170230620e-01 -3.281250000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 9.404021543084110923e-02 9.404021543084110923e-02 9.404021543084110923e-02 -3.281250000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 1.078979426934363467e-01 1.078979426934363467e-01 1.078979426934363467e-01 -3.593750000000000000e-01 1.406250000000000000e-01 2.343750000000000000e-01 8.067198852780921303e-02 8.067198852780921303e-02 8.067198852780921303e-02 -3.593750000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 1.082892285330038645e-01 1.082892285330038645e-01 1.082892285330038645e-01 -3.593750000000000000e-01 1.718750000000000000e-01 2.343750000000000000e-01 9.535971916031853179e-02 9.535971916031853179e-02 9.535971916031853179e-02 -3.281250000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 7.449448084361598443e-02 7.449448084361598443e-02 7.449448084361598443e-02 -3.281250000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 4.263851103110641305e-02 4.263851103110641305e-02 4.263851103110641305e-02 -3.281250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 7.011969513740269611e-02 7.011969513740269611e-02 7.011969513740269611e-02 -3.593750000000000000e-01 2.031250000000000000e-01 1.406250000000000000e-01 7.709279401510270302e-02 7.709279401510270302e-02 7.709279401510270302e-02 -3.593750000000000000e-01 2.031250000000000000e-01 1.718750000000000000e-01 1.077203770337938626e-01 1.077203770337938626e-01 1.077203770337938626e-01 -3.593750000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 9.401048214986398865e-02 9.401048214986398865e-02 9.401048214986398865e-02 -3.593750000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.141968510218635685e-01 1.141968510218635685e-01 1.141968510218635685e-01 -3.281250000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 9.512024932345725103e-02 9.512024932345725103e-02 9.512024932345725103e-02 -3.281250000000000000e-01 2.031250000000000000e-01 2.343750000000000000e-01 6.456504245613488291e-02 6.456504245613488291e-02 6.456504245613488291e-02 -3.281250000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 4.365450470281512924e-02 4.365450470281512924e-02 4.365450470281512924e-02 -3.593750000000000000e-01 2.031250000000000000e-01 2.031250000000000000e-01 1.110731683276032777e-01 1.110731683276032777e-01 1.110731683276032777e-01 -3.593750000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.268574503830505740e-01 1.268574503830505740e-01 1.268574503830505740e-01 -3.593750000000000000e-01 2.343750000000000000e-01 2.343750000000000000e-01 6.021600561864433321e-02 6.021600561864433321e-02 6.021600561864433321e-02 -3.906250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.965113370489540157e-01 1.965113370489540157e-01 1.965113370489540157e-01 -3.906250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.925071698912899920e-01 1.925071698912899920e-01 1.925071698912899920e-01 -3.906250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 7.614594581179222332e-02 7.614594581179222332e-02 7.614594581179222332e-02 -4.218750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 1.240748600266952939e-01 1.240748600266952939e-01 1.240748600266952939e-01 -4.218750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 8.806039042793363525e-02 8.806039042793363525e-02 8.806039042793363525e-02 -3.906250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 8.203270135339296720e-02 8.203270135339296720e-02 8.203270135339296720e-02 -3.906250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 1.297515956952250138e-01 1.297515956952250138e-01 1.297515956952250138e-01 -4.218750000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 1.325147125004409177e-01 1.325147125004409177e-01 1.325147125004409177e-01 -4.218750000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 8.895486100649659111e-02 8.895486100649659111e-02 8.895486100649659111e-02 -3.906250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 8.341830612203597617e-02 8.341830612203597617e-02 8.341830612203597617e-02 -3.906250000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 9.201270193626925886e-02 9.201270193626925886e-02 9.201270193626925886e-02 -4.218750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 7.770341678047049117e-02 7.770341678047049117e-02 7.770341678047049117e-02 -4.218750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 7.832544829031866385e-02 7.832544829031866385e-02 7.832544829031866385e-02 -4.218750000000000000e-01 1.093750000000000000e-01 1.562500000000000000e-02 8.889780163492298770e-02 8.889780163492298770e-02 8.889780163492298770e-02 -4.218750000000000000e-01 1.093750000000000000e-01 4.687500000000000000e-02 9.868409759387547497e-02 9.868409759387547497e-02 9.868409759387547497e-02 -3.906250000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 8.341268016484269798e-02 8.341268016484269798e-02 8.341268016484269798e-02 -3.906250000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 1.011582074194556508e-01 1.011582074194556508e-01 1.011582074194556508e-01 -4.218750000000000000e-01 7.812500000000000000e-02 7.812500000000000000e-02 9.136176524658649878e-02 9.136176524658649878e-02 9.136176524658649878e-02 -4.218750000000000000e-01 7.812500000000000000e-02 1.093750000000000000e-01 1.009380396388594031e-01 1.009380396388594031e-01 1.009380396388594031e-01 -4.218750000000000000e-01 1.093750000000000000e-01 7.812500000000000000e-02 1.075620941923324803e-01 1.075620941923324803e-01 1.075620941923324803e-01 -4.218750000000000000e-01 1.093750000000000000e-01 1.093750000000000000e-01 9.322776966613297023e-02 9.322776966613297023e-02 9.322776966613297023e-02 -4.531250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 9.459389533130742322e-02 9.459389533130742322e-02 9.459389533130742322e-02 -4.531250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 5.715181051114941180e-02 5.715181051114941180e-02 5.715181051114941180e-02 -4.843750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 1.154043532642940045e-01 1.154043532642940045e-01 1.154043532642940045e-01 -4.843750000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 7.456609915053463711e-02 7.456609915053463711e-02 7.456609915053463711e-02 -4.843750000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 6.860661099238393734e-02 6.860661099238393734e-02 6.860661099238393734e-02 -4.531250000000000000e-01 1.562500000000000000e-02 7.812500000000000000e-02 1.255320368408824327e-01 1.255320368408824327e-01 1.255320368408824327e-01 -4.531250000000000000e-01 1.562500000000000000e-02 1.093750000000000000e-01 9.212681622076714094e-02 9.212681622076714094e-02 9.212681622076714094e-02 -4.531250000000000000e-01 4.687500000000000000e-02 7.812500000000000000e-02 9.845910169532733069e-02 9.845910169532733069e-02 9.845910169532733069e-02 -4.531250000000000000e-01 4.687500000000000000e-02 1.093750000000000000e-01 9.716777378026383860e-02 9.716777378026383860e-02 9.716777378026383860e-02 -4.531250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 7.596630060384522432e-02 7.596630060384522432e-02 7.596630060384522432e-02 -4.531250000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 5.307919447278582059e-02 5.307919447278582059e-02 5.307919447278582059e-02 -4.843750000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 7.336377124621576429e-02 7.336377124621576429e-02 7.336377124621576429e-02 -4.843750000000000000e-01 7.812500000000000000e-02 4.687500000000000000e-02 5.871897509486807831e-02 5.871897509486807831e-02 5.871897509486807831e-02 -3.906250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 7.505995025194564518e-02 7.505995025194564518e-02 7.505995025194564518e-02 -3.906250000000000000e-01 1.562500000000000000e-02 1.718750000000000000e-01 9.090369553010421710e-02 9.090369553010421710e-02 9.090369553010421710e-02 -4.218750000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 6.719004326829171314e-02 6.719004326829171314e-02 6.719004326829171314e-02 -3.906250000000000000e-01 4.687500000000000000e-02 2.031250000000000000e-01 9.545614976578850608e-02 9.545614976578850608e-02 9.545614976578850608e-02 -3.906250000000000000e-01 4.687500000000000000e-02 2.343750000000000000e-01 8.255994124727847328e-02 8.255994124727847328e-02 8.255994124727847328e-02 -3.906250000000000000e-01 7.812500000000000000e-02 2.031250000000000000e-01 6.264812841220114559e-02 6.264812841220114559e-02 6.264812841220114559e-02 -3.906250000000000000e-01 7.812500000000000000e-02 2.343750000000000000e-01 8.386034438586585649e-02 8.386034438586585649e-02 8.386034438586585649e-02 -3.906250000000000000e-01 1.093750000000000000e-01 2.031250000000000000e-01 6.094831119371242611e-02 6.094831119371242611e-02 6.094831119371242611e-02 -3.906250000000000000e-01 1.093750000000000000e-01 2.343750000000000000e-01 7.779158977830359645e-02 7.779158977830359645e-02 7.779158977830359645e-02 -4.531250000000000000e-01 1.562500000000000000e-02 1.406250000000000000e-01 9.002049760952983426e-02 9.002049760952983426e-02 9.002049760952983426e-02 -3.906250000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 5.468921094340018635e-02 5.468921094340018635e-02 5.468921094340018635e-02 -3.906250000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 5.950604310910328348e-02 5.950604310910328348e-02 5.950604310910328348e-02 -3.906250000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 6.111633294016078494e-02 6.111633294016078494e-02 6.111633294016078494e-02 -4.218750000000000000e-01 1.406250000000000000e-01 1.562500000000000000e-02 8.369397754249227606e-02 8.369397754249227606e-02 8.369397754249227606e-02 -4.218750000000000000e-01 1.406250000000000000e-01 4.687500000000000000e-02 7.418767083191582512e-02 7.418767083191582512e-02 7.418767083191582512e-02 -4.218750000000000000e-01 1.718750000000000000e-01 1.562500000000000000e-02 8.818736888750507152e-02 8.818736888750507152e-02 8.818736888750507152e-02 -4.218750000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 1.143454800204598276e-01 1.143454800204598276e-01 1.143454800204598276e-01 -3.906250000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 5.094435540915289579e-02 5.094435540915289579e-02 5.094435540915289579e-02 -3.906250000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 8.658646123918534165e-02 8.658646123918534165e-02 8.658646123918534165e-02 -3.906250000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.331364007039018416e-01 1.331364007039018416e-01 1.331364007039018416e-01 -4.218750000000000000e-01 1.406250000000000000e-01 7.812500000000000000e-02 1.244732968819685787e-01 1.244732968819685787e-01 1.244732968819685787e-01 -4.218750000000000000e-01 1.406250000000000000e-01 1.093750000000000000e-01 1.294029864265218988e-01 1.294029864265218988e-01 1.294029864265218988e-01 -4.218750000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 1.431397796363991504e-01 1.431397796363991504e-01 1.431397796363991504e-01 -4.218750000000000000e-01 1.718750000000000000e-01 1.093750000000000000e-01 1.348343721716291355e-01 1.348343721716291355e-01 1.348343721716291355e-01 -3.906250000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 9.342304669685563834e-02 9.342304669685563834e-02 9.342304669685563834e-02 -4.218750000000000000e-01 2.031250000000000000e-01 1.562500000000000000e-02 8.908023075121927759e-02 8.908023075121927759e-02 8.908023075121927759e-02 -4.218750000000000000e-01 2.031250000000000000e-01 4.687500000000000000e-02 9.617696488080189343e-02 9.617696488080189343e-02 9.617696488080189343e-02 -4.218750000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 7.852325314187205696e-02 7.852325314187205696e-02 7.852325314187205696e-02 -4.218750000000000000e-01 2.343750000000000000e-01 4.687500000000000000e-02 1.032505747958946812e-01 1.032505747958946812e-01 1.032505747958946812e-01 -3.906250000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 9.327920069963210881e-02 9.327920069963210881e-02 9.327920069963210881e-02 -3.906250000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 9.255835962202792200e-02 9.255835962202792200e-02 9.255835962202792200e-02 -4.218750000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 1.352199046935298188e-01 1.352199046935298188e-01 1.352199046935298188e-01 -4.218750000000000000e-01 2.031250000000000000e-01 1.093750000000000000e-01 1.142322006464134981e-01 1.142322006464134981e-01 1.142322006464134981e-01 -4.218750000000000000e-01 2.343750000000000000e-01 7.812500000000000000e-02 8.930766382790021607e-02 8.930766382790021607e-02 8.930766382790021607e-02 -4.531250000000000000e-01 1.718750000000000000e-01 4.687500000000000000e-02 9.910596320771725143e-02 9.910596320771725143e-02 9.910596320771725143e-02 -4.531250000000000000e-01 1.718750000000000000e-01 7.812500000000000000e-02 1.250998669775294225e-01 1.250998669775294225e-01 1.250998669775294225e-01 -4.531250000000000000e-01 2.343750000000000000e-01 1.562500000000000000e-02 7.641882892846571518e-02 7.641882892846571518e-02 7.641882892846571518e-02 -4.531250000000000000e-01 2.031250000000000000e-01 7.812500000000000000e-02 1.124285465726483080e-01 1.124285465726483080e-01 1.124285465726483080e-01 -3.906250000000000000e-01 1.406250000000000000e-01 1.718750000000000000e-01 6.242359445629661052e-02 6.242359445629661052e-02 6.242359445629661052e-02 -3.906250000000000000e-01 1.406250000000000000e-01 2.031250000000000000e-01 7.847607258959277132e-02 7.847607258959277132e-02 7.847607258959277132e-02 -3.906250000000000000e-01 1.718750000000000000e-01 2.031250000000000000e-01 9.895248473561743530e-02 9.895248473561743530e-02 9.895248473561743530e-02 -3.906250000000000000e-01 2.343750000000000000e-01 1.406250000000000000e-01 9.154177789500619888e-02 9.154177789500619888e-02 9.154177789500619888e-02 -3.906250000000000000e-01 2.343750000000000000e-01 1.718750000000000000e-01 1.211282939648304913e-01 1.211282939648304913e-01 1.211282939648304913e-01 -3.906250000000000000e-01 2.343750000000000000e-01 2.031250000000000000e-01 1.056192875516663160e-01 1.056192875516663160e-01 1.056192875516663160e-01 -2.968750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 1.044662763156783136e-01 1.044662763156783136e-01 1.044662763156783136e-01 -2.656250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 1.363885388630179107e-01 1.363885388630179107e-01 1.363885388630179107e-01 -2.656250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.243672614599311693e-01 1.243672614599311693e-01 1.243672614599311693e-01 -2.968750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 1.093738918556196593e-01 1.093738918556196593e-01 1.093738918556196593e-01 -2.968750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.658879166225111779e-01 1.658879166225111779e-01 1.658879166225111779e-01 -3.281250000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 1.136794592852309882e-01 1.136794592852309882e-01 1.136794592852309882e-01 -3.593750000000000000e-01 4.687500000000000000e-02 2.656250000000000000e-01 7.576045161961979246e-02 7.576045161961979246e-02 7.576045161961979246e-02 -3.281250000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 1.202237375868101810e-01 1.202237375868101810e-01 1.202237375868101810e-01 -3.281250000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 1.353010269264224574e-01 1.353010269264224574e-01 1.353010269264224574e-01 -3.593750000000000000e-01 7.812500000000000000e-02 2.656250000000000000e-01 7.385369108990076648e-02 7.385369108990076648e-02 7.385369108990076648e-02 -3.593750000000000000e-01 1.093750000000000000e-01 2.656250000000000000e-01 8.011483709644465212e-02 8.011483709644465212e-02 8.011483709644465212e-02 -2.656250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 1.382944604412380540e-01 1.382944604412380540e-01 1.382944604412380540e-01 -2.968750000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 1.258075639992091432e-01 1.258075639992091432e-01 1.258075639992091432e-01 -3.281250000000000000e-01 1.406250000000000000e-01 2.656250000000000000e-01 1.402501316036033896e-01 1.402501316036033896e-01 1.402501316036033896e-01 -2.656250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 1.567096178413367735e-01 1.567096178413367735e-01 1.567096178413367735e-01 -2.656250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 8.239035684128696857e-02 8.239035684128696857e-02 8.239035684128696857e-02 -2.968750000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 7.829659333634594875e-02 7.829659333634594875e-02 7.829659333634594875e-02 -2.968750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 7.668319110052319865e-02 7.668319110052319865e-02 7.668319110052319865e-02 -2.968750000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 6.207766784065395227e-02 6.207766784065395227e-02 6.207766784065395227e-02 -2.968750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 7.089153956458295325e-02 7.089153956458295325e-02 7.089153956458295325e-02 -2.656250000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 9.848963688989956222e-02 9.848963688989956222e-02 9.848963688989956222e-02 -2.656250000000000000e-01 3.593750000000000000e-01 4.687500000000000000e-02 6.308569851354163538e-02 6.308569851354163538e-02 6.308569851354163538e-02 -2.968750000000000000e-01 3.281250000000000000e-01 4.687500000000000000e-02 7.974913404511196902e-02 7.974913404511196902e-02 7.974913404511196902e-02 -2.656250000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 8.037340020676858598e-02 8.037340020676858598e-02 8.037340020676858598e-02 -2.656250000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 6.781352263616825804e-02 6.781352263616825804e-02 6.781352263616825804e-02 -2.968750000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 1.012763263818808740e-01 1.012763263818808740e-01 1.012763263818808740e-01 -2.968750000000000000e-01 3.281250000000000000e-01 1.093750000000000000e-01 9.021658606526583579e-02 9.021658606526583579e-02 9.021658606526583579e-02 -2.968750000000000000e-01 3.593750000000000000e-01 7.812500000000000000e-02 6.300450343297968325e-02 6.300450343297968325e-02 6.300450343297968325e-02 -2.968750000000000000e-01 3.593750000000000000e-01 1.093750000000000000e-01 6.598881095188789681e-02 6.598881095188789681e-02 6.598881095188789681e-02 -3.281250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 1.134537019102892785e-01 1.134537019102892785e-01 1.134537019102892785e-01 -3.281250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 8.466966996761775277e-02 8.466966996761775277e-02 8.466966996761775277e-02 -3.281250000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 7.522086917803091910e-02 7.522086917803091910e-02 7.522086917803091910e-02 -3.593750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 1.047916923103386910e-01 1.047916923103386910e-01 1.047916923103386910e-01 -3.593750000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 1.103500763433449966e-01 1.103500763433449966e-01 1.103500763433449966e-01 -3.593750000000000000e-01 2.968750000000000000e-01 4.687500000000000000e-02 6.531065300627075798e-02 6.531065300627075798e-02 6.531065300627075798e-02 -3.281250000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 8.454670444048423272e-02 8.454670444048423272e-02 8.454670444048423272e-02 -3.281250000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 5.856903736306251496e-02 5.856903736306251496e-02 5.856903736306251496e-02 -3.593750000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 8.627624151439299005e-02 8.627624151439299005e-02 8.627624151439299005e-02 -3.593750000000000000e-01 2.656250000000000000e-01 1.093750000000000000e-01 9.035963389951680302e-02 9.035963389951680302e-02 9.035963389951680302e-02 -3.593750000000000000e-01 2.968750000000000000e-01 7.812500000000000000e-02 7.720339287466566891e-02 7.720339287466566891e-02 7.720339287466566891e-02 -3.593750000000000000e-01 2.968750000000000000e-01 1.093750000000000000e-01 7.491864355693629574e-02 7.491864355693629574e-02 7.491864355693629574e-02 -3.281250000000000000e-01 3.281250000000000000e-01 7.812500000000000000e-02 6.049818804908951159e-02 6.049818804908951159e-02 6.049818804908951159e-02 -2.656250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 8.354046966688433162e-02 8.354046966688433162e-02 8.354046966688433162e-02 -2.656250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 9.860856332666396995e-02 9.860856332666396995e-02 9.860856332666396995e-02 -2.968750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.554633889377388944e-01 1.554633889377388944e-01 1.554633889377388944e-01 -2.656250000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 7.567934970806423911e-02 7.567934970806423911e-02 7.567934970806423911e-02 -2.656250000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 7.085392015782072950e-02 7.085392015782072950e-02 7.085392015782072950e-02 -2.968750000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 6.157457228331146559e-02 6.157457228331146559e-02 6.157457228331146559e-02 -2.968750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 8.675121475177426100e-02 8.675121475177426100e-02 8.675121475177426100e-02 -2.968750000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 5.370535601788536950e-02 5.370535601788536950e-02 5.370535601788536950e-02 -2.656250000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 7.427343628440821743e-02 7.427343628440821743e-02 7.427343628440821743e-02 -2.656250000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 1.126133325907457683e-01 1.126133325907457683e-01 1.126133325907457683e-01 -2.968750000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 1.166512028288018699e-01 1.166512028288018699e-01 1.166512028288018699e-01 -2.968750000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 1.474106146583284149e-01 1.474106146583284149e-01 1.474106146583284149e-01 -2.656250000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 9.813044584126608127e-02 9.813044584126608127e-02 9.813044584126608127e-02 -2.656250000000000000e-01 3.281250000000000000e-01 2.343750000000000000e-01 5.849426938167196638e-02 5.849426938167196638e-02 5.849426938167196638e-02 -2.968750000000000000e-01 3.281250000000000000e-01 2.031250000000000000e-01 8.734593194142330208e-02 8.734593194142330208e-02 8.734593194142330208e-02 -3.281250000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 1.369869051142546812e-01 1.369869051142546812e-01 1.369869051142546812e-01 -3.281250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 1.000774510374248527e-01 1.000774510374248527e-01 1.000774510374248527e-01 -3.593750000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 4.540775715794941048e-02 4.540775715794941048e-02 4.540775715794941048e-02 -3.593750000000000000e-01 2.968750000000000000e-01 1.406250000000000000e-01 6.050220773467464980e-02 6.050220773467464980e-02 6.050220773467464980e-02 -3.593750000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 7.903034186252906601e-02 7.903034186252906601e-02 7.903034186252906601e-02 -3.281250000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 5.065313427051048450e-02 5.065313427051048450e-02 5.065313427051048450e-02 -3.281250000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 7.384991321245489015e-02 7.384991321245489015e-02 7.384991321245489015e-02 -3.281250000000000000e-01 2.968750000000000000e-01 2.343750000000000000e-01 4.789058159922893187e-02 4.789058159922893187e-02 4.789058159922893187e-02 -3.593750000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 8.514465268969910461e-02 8.514465268969910461e-02 8.514465268969910461e-02 -3.593750000000000000e-01 2.656250000000000000e-01 2.343750000000000000e-01 6.271348672844261063e-02 6.271348672844261063e-02 6.271348672844261063e-02 -3.593750000000000000e-01 2.968750000000000000e-01 2.031250000000000000e-01 7.493021817611006385e-02 7.493021817611006385e-02 7.493021817611006385e-02 -3.281250000000000000e-01 3.281250000000000000e-01 1.406250000000000000e-01 1.155553901937273337e-01 1.155553901937273337e-01 1.155553901937273337e-01 -3.281250000000000000e-01 3.281250000000000000e-01 1.718750000000000000e-01 1.253721824593627965e-01 1.253721824593627965e-01 1.253721824593627965e-01 -3.906250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 7.529964056297502872e-02 7.529964056297502872e-02 7.529964056297502872e-02 -3.906250000000000000e-01 2.656250000000000000e-01 4.687500000000000000e-02 1.236997170711293115e-01 1.236997170711293115e-01 1.236997170711293115e-01 -4.218750000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 8.735477229892051054e-02 8.735477229892051054e-02 8.735477229892051054e-02 -4.218750000000000000e-01 2.968750000000000000e-01 1.562500000000000000e-02 4.403508691983665929e-02 4.403508691983665929e-02 4.403508691983665929e-02 -3.906250000000000000e-01 2.656250000000000000e-01 7.812500000000000000e-02 1.261433363451152645e-01 1.261433363451152645e-01 1.261433363451152645e-01 -4.531250000000000000e-01 2.656250000000000000e-01 1.562500000000000000e-02 7.393133848935462549e-02 7.393133848935462549e-02 7.393133848935462549e-02 -3.906250000000000000e-01 2.656250000000000000e-01 1.406250000000000000e-01 6.789479324992060694e-02 6.789479324992060694e-02 6.789479324992060694e-02 -3.906250000000000000e-01 2.656250000000000000e-01 1.718750000000000000e-01 1.170946652834632951e-01 1.170946652834632951e-01 1.170946652834632951e-01 -3.906250000000000000e-01 2.968750000000000000e-01 1.718750000000000000e-01 8.269094696548837109e-02 8.269094696548837109e-02 8.269094696548837109e-02 -3.906250000000000000e-01 2.656250000000000000e-01 2.031250000000000000e-01 9.701589875540718444e-02 9.701589875540718444e-02 9.701589875540718444e-02 -1.093750000000000000e-01 5.156250000000000000e-01 1.562500000000000000e-02 8.667325825371344217e-02 8.667325825371344217e-02 8.667325825371344217e-02 -1.093750000000000000e-01 5.156250000000000000e-01 4.687500000000000000e-02 7.284185663615615203e-02 7.284185663615615203e-02 7.284185663615615203e-02 -1.093750000000000000e-01 5.468750000000000000e-01 1.562500000000000000e-02 9.496113809813379325e-02 9.496113809813379325e-02 9.496113809813379325e-02 -1.093750000000000000e-01 5.468750000000000000e-01 4.687500000000000000e-02 7.537656315730190126e-02 7.537656315730190126e-02 7.537656315730190126e-02 -1.093750000000000000e-01 5.156250000000000000e-01 7.812500000000000000e-02 7.365595513797801308e-02 7.365595513797801308e-02 7.365595513797801308e-02 -1.093750000000000000e-01 5.468750000000000000e-01 7.812500000000000000e-02 7.609177096807398510e-02 7.609177096807398510e-02 7.609177096807398510e-02 -1.406250000000000000e-01 5.468750000000000000e-01 1.562500000000000000e-02 9.893239590869842837e-02 9.893239590869842837e-02 9.893239590869842837e-02 -1.406250000000000000e-01 5.468750000000000000e-01 4.687500000000000000e-02 8.149742073139282228e-02 8.149742073139282228e-02 8.149742073139282228e-02 -1.406250000000000000e-01 5.156250000000000000e-01 7.812500000000000000e-02 6.893522670281329590e-02 6.893522670281329590e-02 6.893522670281329590e-02 -1.406250000000000000e-01 5.156250000000000000e-01 1.093750000000000000e-01 4.861439597255338974e-02 4.861439597255338974e-02 4.861439597255338974e-02 -1.406250000000000000e-01 5.468750000000000000e-01 7.812500000000000000e-02 7.819724862457021197e-02 7.819724862457021197e-02 7.819724862457021197e-02 -1.406250000000000000e-01 5.468750000000000000e-01 1.093750000000000000e-01 5.285423180323038650e-02 5.285423180323038650e-02 5.285423180323038650e-02 -1.718750000000000000e-01 5.156250000000000000e-01 1.093750000000000000e-01 5.244908836832181537e-02 5.244908836832181537e-02 5.244908836832181537e-02 -1.718750000000000000e-01 5.468750000000000000e-01 1.093750000000000000e-01 5.302178804719672595e-02 5.302178804719672595e-02 5.302178804719672595e-02 -1.406250000000000000e-01 5.781250000000000000e-01 1.562500000000000000e-02 5.400524933087684498e-02 5.400524933087684498e-02 5.400524933087684498e-02 -1.406250000000000000e-01 5.781250000000000000e-01 4.687500000000000000e-02 8.077245541226142633e-02 8.077245541226142633e-02 8.077245541226142633e-02 -1.406250000000000000e-01 6.093750000000000000e-01 1.562500000000000000e-02 3.100324245604188511e-02 3.100324245604188511e-02 3.100324245604188511e-02 -1.718750000000000000e-01 5.781250000000000000e-01 1.562500000000000000e-02 5.627788974675484307e-02 5.627788974675484307e-02 5.627788974675484307e-02 -1.718750000000000000e-01 5.781250000000000000e-01 4.687500000000000000e-02 5.906965946555260694e-02 5.906965946555260694e-02 5.906965946555260694e-02 -1.718750000000000000e-01 6.093750000000000000e-01 1.562500000000000000e-02 4.581583075434949442e-02 4.581583075434949442e-02 4.581583075434949442e-02 -1.718750000000000000e-01 6.093750000000000000e-01 4.687500000000000000e-02 3.777056944300316577e-02 3.777056944300316577e-02 3.777056944300316577e-02 -1.406250000000000000e-01 5.781250000000000000e-01 7.812500000000000000e-02 6.296205686317941919e-02 6.296205686317941919e-02 6.296205686317941919e-02 -1.718750000000000000e-01 5.781250000000000000e-01 7.812500000000000000e-02 5.187590219876765663e-02 5.187590219876765663e-02 5.187590219876765663e-02 -1.718750000000000000e-01 6.093750000000000000e-01 7.812500000000000000e-02 3.273529809819492042e-02 3.273529809819492042e-02 3.273529809819492042e-02 -2.031250000000000000e-01 5.156250000000000000e-01 1.562500000000000000e-02 7.996887757242993056e-02 7.996887757242993056e-02 7.996887757242993056e-02 -2.031250000000000000e-01 5.156250000000000000e-01 4.687500000000000000e-02 1.240467444482561826e-01 1.240467444482561826e-01 1.240467444482561826e-01 -2.343750000000000000e-01 5.156250000000000000e-01 1.562500000000000000e-02 7.696981690697957124e-02 7.696981690697957124e-02 7.696981690697957124e-02 -2.343750000000000000e-01 5.156250000000000000e-01 4.687500000000000000e-02 8.357342164392536632e-02 8.357342164392536632e-02 8.357342164392536632e-02 -2.343750000000000000e-01 5.468750000000000000e-01 4.687500000000000000e-02 9.037088484196846572e-02 9.037088484196846572e-02 9.037088484196846572e-02 -2.031250000000000000e-01 5.156250000000000000e-01 7.812500000000000000e-02 1.255135612250850019e-01 1.255135612250850019e-01 1.255135612250850019e-01 -2.031250000000000000e-01 5.156250000000000000e-01 1.093750000000000000e-01 6.971496017514670906e-02 6.971496017514670906e-02 6.971496017514670906e-02 -2.031250000000000000e-01 5.468750000000000000e-01 7.812500000000000000e-02 8.343196915928076385e-02 8.343196915928076385e-02 8.343196915928076385e-02 -2.031250000000000000e-01 5.468750000000000000e-01 1.093750000000000000e-01 6.736142822795046503e-02 6.736142822795046503e-02 6.736142822795046503e-02 -2.343750000000000000e-01 5.156250000000000000e-01 7.812500000000000000e-02 1.102102778100290115e-01 1.102102778100290115e-01 1.102102778100290115e-01 -2.343750000000000000e-01 5.468750000000000000e-01 7.812500000000000000e-02 6.954406253701332641e-02 6.954406253701332641e-02 6.954406253701332641e-02 -2.031250000000000000e-01 6.093750000000000000e-01 1.562500000000000000e-02 3.731919076875372249e-02 3.731919076875372249e-02 3.731919076875372249e-02 -2.031250000000000000e-01 6.093750000000000000e-01 4.687500000000000000e-02 4.132907849848135168e-02 4.132907849848135168e-02 4.132907849848135168e-02 -2.343750000000000000e-01 5.781250000000000000e-01 1.562500000000000000e-02 5.786155260662048661e-02 5.786155260662048661e-02 5.786155260662048661e-02 -2.343750000000000000e-01 5.781250000000000000e-01 4.687500000000000000e-02 6.368412784715725417e-02 6.368412784715725417e-02 6.368412784715725417e-02 -2.343750000000000000e-01 6.093750000000000000e-01 1.562500000000000000e-02 4.345186987013278240e-02 4.345186987013278240e-02 4.345186987013278240e-02 -2.343750000000000000e-01 6.093750000000000000e-01 4.687500000000000000e-02 4.003160636571428260e-02 4.003160636571428260e-02 4.003160636571428260e-02 -2.031250000000000000e-01 5.781250000000000000e-01 7.812500000000000000e-02 4.774456360239430486e-02 4.774456360239430486e-02 4.774456360239430486e-02 -2.031250000000000000e-01 6.093750000000000000e-01 7.812500000000000000e-02 3.372278715332967941e-02 3.372278715332967941e-02 3.372278715332967941e-02 -2.343750000000000000e-01 5.781250000000000000e-01 7.812500000000000000e-02 5.364312600537493592e-02 5.364312600537493592e-02 5.364312600537493592e-02 -2.343750000000000000e-01 6.093750000000000000e-01 7.812500000000000000e-02 3.281716710348947519e-02 3.281716710348947519e-02 3.281716710348947519e-02 -2.656250000000000000e-01 5.156250000000000000e-01 1.562500000000000000e-02 6.066846175482840803e-02 6.066846175482840803e-02 6.066846175482840803e-02 -2.656250000000000000e-01 5.156250000000000000e-01 4.687500000000000000e-02 5.639703939237279001e-02 5.639703939237279001e-02 5.639703939237279001e-02 -2.656250000000000000e-01 5.468750000000000000e-01 1.562500000000000000e-02 9.508569489217566506e-02 9.508569489217566506e-02 9.508569489217566506e-02 -2.656250000000000000e-01 5.468750000000000000e-01 4.687500000000000000e-02 8.563972475888619040e-02 8.563972475888619040e-02 8.563972475888619040e-02 -2.656250000000000000e-01 5.781250000000000000e-01 1.562500000000000000e-02 6.160889993253349656e-02 6.160889993253349656e-02 6.160889993253349656e-02 -2.656250000000000000e-01 5.781250000000000000e-01 4.687500000000000000e-02 6.451069903428327534e-02 6.451069903428327534e-02 6.451069903428327534e-02 -5.156250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 9.522873406940352004e-02 9.522873406940352004e-02 9.522873406940352004e-02 -5.156250000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 7.666438275334529207e-02 7.666438275334529207e-02 7.666438275334529207e-02 -5.156250000000000000e-01 4.687500000000000000e-02 1.562500000000000000e-02 7.641915043970079480e-02 7.641915043970079480e-02 7.641915043970079480e-02 -5.156250000000000000e-01 4.687500000000000000e-02 4.687500000000000000e-02 5.538940730451159117e-02 5.538940730451159117e-02 5.538940730451159117e-02 -5.468750000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.196541671183774941e-01 1.196541671183774941e-01 1.196541671183774941e-01 -5.468750000000000000e-01 1.562500000000000000e-02 4.687500000000000000e-02 9.208342066686933669e-02 9.208342066686933669e-02 9.208342066686933669e-02 -5.156250000000000000e-01 7.812500000000000000e-02 1.562500000000000000e-02 6.659943761097349146e-02 6.659943761097349146e-02 6.659943761097349146e-02 -5.781250000000000000e-01 1.562500000000000000e-02 1.562500000000000000e-02 1.067361258861275197e-01 1.067361258861275197e-01 1.067361258861275197e-01 diff --git a/tensorflow/script/run_ae.py b/tensorflow/script/run_ae.py deleted file mode 100644 index 8449521..0000000 --- a/tensorflow/script/run_ae.py +++ /dev/null @@ -1,70 +0,0 @@ -import os -import tensorflow as tf -from tqdm import tqdm - -from config import parse_args -from tfsolver import TFSolver -from dataset import DatasetFactory -from network_ae import make_autoencoder -from ocnn import l2_regularizer - - -tf.compat.v1.logging.set_verbosity(tf.compat.v1.logging.ERROR) - -FLAGS = parse_args() - -# get the autoencoder -autoencoder = make_autoencoder(FLAGS.MODEL) - -# define the graph -def compute_graph(dataset='train', training=True, reuse=False): - flags_data = FLAGS.DATA.train if dataset=='train' else FLAGS.DATA.test - octree, label = DatasetFactory(flags_data)() - code = autoencoder.octree_encoder(octree, training, reuse) - loss, accu = autoencoder.octree_decoder(code, octree, training, reuse) - - with tf.name_scope('total_loss'): - reg = l2_regularizer('ocnn', FLAGS.LOSS.weight_decay) - total_loss = tf.add_n(loss + [reg]) - tensors = loss + [reg] + accu + [total_loss] - depth = FLAGS.MODEL.depth - names = ['loss%d' % d for d in range(2, depth + 1)] + ['normal', 'reg'] + \ - ['accu%d' % d for d in range(2, depth + 1)] + ['total_loss'] - return tensors, names - -# define the solver -class AeTFSolver(TFSolver): - def __init__(self, flags, compute_graph): - super(AeTFSolver, self).__init__(flags, compute_graph) - - def decode_shape(self): - # build graph - octree, label = DatasetFactory(FLAGS.DATA.test)() - code = autoencoder.octree_encoder(octree, training=False, reuse=False) - octree_pred = autoencoder.octree_decode_shape(code, training=False, reuse=False) - - # checkpoint - assert(self.flags.ckpt) # the self.flags.ckpt should be provided - tf_saver = tf.train.Saver(max_to_keep=20) - - # start - config = tf.ConfigProto() - config.gpu_options.allow_growth = True - with tf.Session(config=config) as sess: - # restore and initialize - self.initialize(sess) - tf_saver.restore(sess, self.flags.ckpt) - logdir = self.flags.logdir - tf.summary.FileWriter(logdir, sess.graph) - - print('Start testing ...') - for i in tqdm(range(0, self.flags.test_iter)): - origin, reconstructed = sess.run([octree, octree_pred]) - with open(logdir + ('/%04d_input.octree' % i), "wb") as f: - f.write(origin.tobytes()) - with open(logdir + ('/%04d_output.octree' % i), "wb") as f: - f.write(reconstructed.tobytes()) - -# run the experiments -solver = AeTFSolver(FLAGS.SOLVER, compute_graph) -solver.run() diff --git a/tensorflow/script/run_cls.py b/tensorflow/script/run_cls.py index c667e5e..44f8248 100644 --- a/tensorflow/script/run_cls.py +++ b/tensorflow/script/run_cls.py @@ -6,32 +6,45 @@ from network_factory import cls_network from ocnn import loss_functions, loss_functions_reg -tf.compat.v1.logging.set_verbosity(tf.compat.v1.logging.ERROR) - -# configs -FLAGS = parse_args() # define the graph -def compute_graph(dataset='train', training=True, reuse=False, task = 'class'): - flags_data = FLAGS.DATA.train if dataset=='train' else FLAGS.DATA.test - y_type = 'int' if task == 'class' else 'float' - octree, label = DatasetFactory(flags_data, y_type = y_type)() - logit = cls_network(octree, FLAGS.MODEL, training, reuse) - if task == 'class': - losses = loss_functions(logit, label, FLAGS.LOSS.num_class, - FLAGS.LOSS.weight_decay, 'ocnn', FLAGS.LOSS.label_smoothing) - names = ['loss', 'accu', 'regularizer', 'total_loss'] - else: - losses = loss_functions_reg(logit, label, FLAGS.LOSS.num_class, - FLAGS.LOSS.weight_decay, 'ocnn', FLAGS.LOSS.label_smoothing) - names = ['loss', 'rmse', 'regularizer', 'total_loss'] - losses.append(losses[0] + losses[2]) # total loss - return losses, names +class ComputeGraph: + def __init__(self, flags): + self.flags = flags + + def __call__(self, dataset='train', training=True, reuse=False, gpu_num=1): + FLAGS = self.flags + with tf.device('/cpu:0'): + flags_data = FLAGS.DATA.train if dataset == 'train' else FLAGS.DATA.test + y_type = 'int' if FLAGS.SOLVER.task == 'class' else 'float' + data_iter = DatasetFactory(flags_data, y_type = y_type)(return_iter=True) + + tower_tensors = [] + for i in range(gpu_num): + with tf.device('/gpu:%d' % i): + with tf.name_scope('device_%d' % i): + octree, label = data_iter.get_next() + logit = cls_network(octree, FLAGS.MODEL, training, reuse) + if FLAGS.SOLVER.task == 'class': + losses = loss_functions(logit, label, FLAGS.LOSS.num_class, + FLAGS.LOSS.weight_decay, 'ocnn', + FLAGS.LOSS.label_smoothing) + names = ['loss', 'accu', 'regularizer', 'total_loss'] + else: + losses = loss_functions_reg(logit, label, FLAGS.LOSS.num_class, + FLAGS.LOSS.weight_decay, 'ocnn', FLAGS.LOSS.label_smoothing) + names = ['loss', 'rmse', 'regularizer', 'total_loss'] + losses.append(losses[0] + losses[2]) # total loss + tower_tensors.append(losses) + reuse = True + + tensors = tower_tensors[0] if gpu_num == 1 else list(zip(*tower_tensors)) + return tensors, names # run the experiments if __name__ == '__main__': - solver = TFSolver(FLAGS.SOLVER, compute_graph) - # solver.timeline() + FLAGS = parse_args() + compute_graph = ComputeGraph(FLAGS) + solver = TFSolver(FLAGS, compute_graph) solver.run() - diff --git a/tensorflow/script/run_completion.py b/tensorflow/script/run_completion.py deleted file mode 100644 index 8c949d5..0000000 --- a/tensorflow/script/run_completion.py +++ /dev/null @@ -1,133 +0,0 @@ -import os -import sys -import pickle -import numpy as np -import tensorflow as tf -from tqdm import tqdm - -from config import parse_args, FLAGS -from tfsolver import TFSolver -from dataset import DatasetFactory -from network_completion import CompletionResnet -from ocnn import l2_regularizer -sys.path.append('..') -from libs import octree_scan, octree_batch - - -# flags -FLAGS.DATA.train.camera = '_' # used to generate partial scans -FLAGS.MODEL.skip_connections = True -FLAGS = parse_args() - - -# the dataset -def bounding_sphere(points): - radius = 64.0 - center = (64.0, 64.0, 64.0) - return radius, center - - -class PointDataset: - def __init__(self, parse_example, transform_points, points2octree): - self.parse_example = parse_example - self.transform_points = transform_points - self.points2octree = points2octree - with open(FLAGS.DATA.train.camera, 'rb') as fid: - self.camera_path = pickle.load(fid) - - def gen_scan_axis(self, i): - j = np.random.randint(0, 8) - key = '%d_%d' % (i, j) - axes = np.array(self.camera_path[key]) - # perturb the axes - rnd = np.random.random(axes.shape) * 0.4 - 0.2 - axes = np.reshape(axes + rnd, (-1, 3)) - axes = axes / np.sqrt(np.sum(axes ** 2, axis=1, keepdims=True) + 1.0e-6) - axes = np.reshape(axes, (-1)) - return axes.astype(np.float32) - - def __call__(self, record_names, batch_size, shuffle_size=1000, - return_iter=False, take=-1, **kwargs): - with tf.name_scope('points_dataset'): - def preprocess(record): - points, label = self.parse_example(record) - points = self.transform_points(points) - octree1 = self.points2octree(points) # the complete octree - scan_axis = tf.py_func(self.gen_scan_axis, [label], tf.float32) - octree0 = octree_scan(octree1, scan_axis) # the transformed octree - return octree0, octree1 - - def merge_octrees(octrees0, octrees1, *args): - octree0 = octree_batch(octrees0) - octree1 = octree_batch(octrees1) - return (octree0, octree1) + args - - dataset = tf.data.TFRecordDataset(record_names).take(take).repeat() - if shuffle_size > 1: - dataset = dataset.shuffle(shuffle_size) - itr = dataset.map(preprocess, num_parallel_calls=8) \ - .batch(batch_size).map(merge_octrees, num_parallel_calls=8) \ - .prefetch(8).make_one_shot_iterator() - return itr if return_iter else itr.get_next() - - -# get the network -network = CompletionResnet(FLAGS.MODEL) - - -# define the graph -def compute_graph(dataset='train', training=True, reuse=False): - flags_data = FLAGS.DATA.train if dataset == 'train' else FLAGS.DATA.test - octree0, octree1 = DatasetFactory(flags_data, bounding_sphere, PointDataset)() - convd = network.octree_encoder(octree0, training, reuse) - loss, accu = network.octree_decoder(convd, octree0, octree1, training, reuse) - - with tf.name_scope('total_loss'): - reg = l2_regularizer('ocnn', FLAGS.LOSS.weight_decay) - total_loss = tf.add_n(loss + [reg]) - tensors = loss + [reg] + accu + [total_loss] - depth = FLAGS.MODEL.depth - names = ['loss%d' % d for d in range(2, depth + 1)] + ['normal', 'reg'] + \ - ['accu%d' % d for d in range(2, depth + 1)] + ['total_loss'] - return tensors, names - - -# define the solver -class CompletionSolver(TFSolver): - def __init__(self, flags, compute_graph): - super(CompletionSolver, self).__init__(flags, compute_graph) - - def decode_shape(self): - # build graph - octree_in, _ = DatasetFactory(FLAGS.DATA.test, bounding_sphere)() - convd = network.octree_encoder(octree_in, training=False, reuse=False) - octree_out = network.decode_shape(convd, octree_in, training=False, reuse=False) - - # checkpoint - assert(self.flags.ckpt) - tf_saver = tf.train.Saver(max_to_keep=20) - - # start - config = tf.ConfigProto() - config.gpu_options.allow_growth = True - with tf.Session(config=config) as sess: - # restore and initialize - self.initialize(sess) - print('Load check point: ' + self.flags.ckpt) - tf_saver.restore(sess, self.flags.ckpt) - logdir = self.flags.logdir - tf.summary.FileWriter(logdir, sess.graph) - - print('Start testing ...') - for i in tqdm(range(0, self.flags.test_iter), ncols=80): - o0, o1 = sess.run([octree_in, octree_out]) - with open(logdir + ('/%04d_input.octree' % i), "wb") as f: - f.write(o0.tobytes()) - with open(logdir + ('/%04d_output.octree' % i), "wb") as f: - f.write(o1.tobytes()) - - -# run the experiments -if __name__ == '__main__': - solver = CompletionSolver(FLAGS.SOLVER, compute_graph) - solver.run() diff --git a/tensorflow/script/tensorflow_lrp.py b/tensorflow/script/tensorflow_lrp.py deleted file mode 100644 index 83f4387..0000000 --- a/tensorflow/script/tensorflow_lrp.py +++ /dev/null @@ -1,211 +0,0 @@ -import numpy as np -import os -import sys - -# sys.path.append("../..") - -import tensorflow as tf -from dataset import * -from ocnn import * -from learning_rate import LRFactory -from tensorflow.python.client import timeline - - -# np.set_printoptions(threshold=sys.maxsize) -# tf.enable_eager_execution() # for save input.octree - -depth=6 -channel=24 -nout=2 - -def network_ocnn_original(octree, training=False, reuse=False): - channels = [512, 256, 128, 64, 32, 16, 12, 8, 6]# [512, 256, 128, 64, 32, 16, 8, 4] - - with tf.variable_scope("ocnn", reuse=reuse): - data = octree_property(octree, property_name="feature", dtype=tf.float32, - depth=depth, channel=channel) - data = tf.reshape(data, [1, channel, -1, 1]) - for d in range(depth, 2, -1): - with tf.variable_scope('depth_%d' % d): - data = octree_conv_bn_relu(data, octree, d, channels[d], training) - data, _ = octree_max_pool(data, octree, d) - - with tf.variable_scope("full_voxel"): - data = octree_full_voxel(data, depth=2) - data = tf.layers.dropout(data, rate=0.5, training=training) - - with tf.variable_scope("fc1"): - data = fc_bn_relu(data, channels[2], training=training) - data = tf.layers.dropout(data, rate=0.5, training=training) - - with tf.variable_scope("fc2"): - logit = dense(data, nout, use_bias=True) - return logit - -#Function to call octree_max_pool and only return the first value instead of a tuple -octree_max_pool_first = lambda x, *args, **kwargs: octree_max_pool(x, *args, **kwargs)[0] - -class network_ocnn_class(): - def __init__(self, training=False): - self.channels = [2048, 1024, 512, 256, 128, 64, 32, 32, 32] # [512, 256, 128, 64, 32, 16, 8, 4] - - self.layer_list = [ - ('ocnn', octree_property, [], {'property_name': 'feature', 'dtype': tf.float32, 'depth': depth, 'channel': channel}, 'octree_property'), - ('ocnn', tf.reshape, [[1, channel, -1, 1]], {}, 'reshape'), - ] - - for d in range(depth, 2, -1): - self.layer_list.append(('depth_%d'%d, octree_conv_memory, [], {'depth':d, 'channel':self.channels[d]}, 'conv_depth_%d'%d)) - self.layer_list.append(('depth_%d'%d, tf.layers.batch_normalization, [], {'axis':1, 'training':training}, 'batch_norm_depth_%d'%d)) - self.layer_list.append(('depth_%d'%d, tf.nn.relu, [], {}, 'relu_depth_%d'%d)) - self.layer_list.append(['depth_%d'%d, octree_max_pool_first, [], {'depth': d}, 'conv_pooling_depth_%d'%d]) - - self.layer_list.extend([ - ('full_voxel', octree_full_voxel, [], {'depth': 2}, 'full voxel'), - ('full_voxel', tf.layers.dropout, [], {'rate': 0.5, 'training': training}, 'dropout 1'), - - ('fc1', dense, [self.channels[2]], {}, 'dense'), - ('fc1', batch_norm, [], {'training': training}, 'batch_norm'), - ('fc1', tf.nn.relu, [], {}, 'relu'), - - - ('fc1', tf.layers.dropout, [], {'rate': 0.5, 'training': training} , 'dropout 2'), - ('fc2', dense, [nout], {'use_bias': False}, 'fully connected'), - ]) - - def call(self, octree, reuse=tf.AUTO_REUSE): - print('Test call') - data = octree - with tf.variable_scope("ocnn", reuse=reuse): - for layer in self.layer_list: - with tf.variable_scope(layer[0], reuse=reuse): - args = layer[2] - kwargs = layer[3] - if layer[4][:4]=='conv': - kwargs['octree']=octree - if 'depth' in layer[4]: - with tf.variable_scope('conv_bn_relu'): - data = layer[1](data, *args, **kwargs) - else: - data = layer[1](data, *args, **kwargs) - return data - - def LRP(self, octree, analyze_index=0): - layer_list = self.layer_list - L=len(layer_list) - A=[0]*(L+1) - - A[0] = octree - with tf.variable_scope("ocnn"): - #Forward Pass - for i in range(0,L): - with tf.variable_scope(layer_list[i][0], reuse=tf.AUTO_REUSE): - args = layer_list[i][2] - kwargs = layer_list[i][3] - if layer_list[i][4][:4]=='conv': - kwargs['octree']=octree - if 'depth' in layer_list[i][4]: - with tf.variable_scope('conv_bn_relu'): - A[i+1] = layer_list[i][1](A[i], *args, **kwargs) - else: - A[i+1] = layer_list[i][1](A[i], *args, **kwargs) - - #Create a mask for the outputs - T = A[-1]/tf.reduce_max(A[-1]) - T = tf.floor(tf.nn.relu(T)) - #Create a list to store relevance values, append output layer with mask - R = [None]*L + [(A[-1]*T)] - - Cs = [0]*L - result_table=[] - - #Backward Pass - for i in range(1,L)[::-1]: - if layer_list[i][4][:10] == 'batch_norm': - R[i]=R[i+1] - else: - with tf.variable_scope(layer_list[i][0], reuse=tf.AUTO_REUSE): - print("Layer",i,":",layer_list[i][4]) - args = layer_list[i][2] - kwargs = layer_list[i][3] - - # octree_avg_pool - if layer_list[i][4][:9]=='conv_pool': - layer_list[i][1]=octree_avg_pool - if layer_list[i][4][:4]=='conv': - kwargs['octree']=octree - if layer_list[i][0][:5] == 'depth': - with tf.variable_scope('conv_bn_relu'): - z = layer_list[i][1](A[i], *args, **kwargs) - else: - z = layer_list[i][1](A[i], *args, **kwargs) - - # Define LRP rule layer by layer - if i<=13: - rho = lambda x: x + 0.25*tf.nn.relu(x) - else: - rho = lambda x: x - incr = lambda z: z+1e-9 - - z = incr(rho(z)) #LRP Step 1 - s = R[i+1]/z #LRP Step 2 - print('Differentiating with respect to layer',i) - c = tf.gradients(tf.math.reduce_sum(z*s), A[i], stop_gradients=[s, R[i+1]]) #LRP Step 3 - Cs[i]=c - R[i] = A[i]*c #LRP Step 4 - for i in range(1, L): - layer_label = [ord(c) for c in "layer %d: %s"%(i, layer_list[i][4])] - result_table.append([tf.constant(layer_label), R[i]]) - result_table.append([tf.constant([ord(c) for c in 'output']), R[-1]]) - return [octree, R[1], A[-1], result_table] - -network_ocnn=network_ocnn_class() - -def run_lrp(octree, label): - # logit = network_ocnn.call(octree) - outputs = network_ocnn.LRP(octree) - tf_saver = tf.train.Saver(max_to_keep=10) - - config = tf.ConfigProto() - config.gpu_options.allow_growth = True - with tf.Session(config=config) as sess: - #Load Data - sess.run(tf.global_variables_initializer()) - path=tf.train.latest_checkpoint('logs/pdbbind/ocnn_points_20200704_class_6/model/') - tf_saver.restore(sess, path) - print('Test Restored') - for i in range(1): - # tmp = sess.run((logit)) - results, label = sess.run((outputs, label)) - print(results) - - octree, heatmap, output, result_table = results - - print("== Summed Relevance By Layer ==") - for result in result_table: - result[0] = "Relevance in " + ''.join(chr(c) for c in result[0]) - result[1] = round(tf.math.reduce_sum(result[1]).eval(), 3) - for r in result: - print(str(r).ljust(45), end='') - print('') - print("===============================") - - heatmap = tf.math.reduce_sum(heatmap, 1) - heatmap=tf.keras.backend.repeat_elements(heatmap, channel, axis=0) - - print("Actual Label:", label[0], "| Predicted Label:", np.argmax(output)) - - heatmap_octree = octree_set_property(in_octree=octree, property_name='feature', in_property=heatmap, depth=depth) - - with open('./output.octree', "wb") as f: - f.write(heatmap_octree.eval().tobytes()) - -octree, label = PointDataset(ParseExample(), - TransformPoints(distort=False, depth=depth), - Points2Octree(depth=depth))(record_names='/media/data/data_share/pdbbind/tfrecords/test_class_points_den3.tfrecords', batch_size=1, shuffle_size=1) - -# if use this, also enable_eager_execution at the top of file. -# with open('./input.octree', "wb") as f: -# f.write(octree.numpy().tobytes()) - -run_lrp(octree, label) diff --git a/tensorflow/script/tensorflow_lrp_bbgv2.py b/tensorflow/script/tensorflow_lrp_bbgv2.py deleted file mode 100644 index e798ca5..0000000 --- a/tensorflow/script/tensorflow_lrp_bbgv2.py +++ /dev/null @@ -1,488 +0,0 @@ -#Blake Gaines - -import os -import sys -import numpy as np -os.environ['TF_CPP_MIN_LOG_LEVEL'] = '3' -import tensorflow as tf -tf.autograph.set_verbosity(0) -from dataset import * -from ocnn import * -from tqdm import tqdm -import subprocess - -depth=7 -# channel=3 -# nout=40 -resblock_num=3 - - - -channel=24 -nout=2 - -model_path = 'logs/pdbbind/ocnn_points_20200704_class_7/model/' -record_name = '/media/data/data_share/pdbbind/tfrecords/test_class_points_den4.tfrecords' - -# flags = parse_args() -# depth, channel, nout = FLAGS.MODEL.depth, FLAGS.MODEL.channel, FLAGS.MODEL.nout - -#Original network for comparison, first defined in network_cls.py -def network_ocnn_original(octree, training=False, reuse=False): - channels = [2048, 1024, 512, 256, 128, 64, 32, 32, 32] - with tf.variable_scope("ocnn", reuse=reuse): - data = octree_property(octree, property_name="feature", dtype=tf.float32, - depth=depth, channel=channel) - data = tf.reshape(data, [1, channel, -1, 1]) - for d in range(depth, 2, -1): - with tf.variable_scope('depth_%d' % d): - data = octree_conv_bn_relu(data, octree, d, channels[d], training) - data, _ = octree_max_pool(data, octree, d) - - with tf.variable_scope("full_voxel"): - data = octree_full_voxel(data, depth=2) - data = tf.layers.dropout(data, rate=0.5, training=training) - - with tf.variable_scope("fc1"): - data = fc_bn_relu(data, channels[2], training=training) - data = tf.layers.dropout(data, rate=0.5, training=training) - - with tf.variable_scope("fc2"): - logit = dense(data, nout, use_bias=True) - return logit - -def network_resnet_original(octree, training=False, reuse=None): - channels = [2048, 1024, 512, 256, 128, 64, 32, 32, 32] - with tf.variable_scope("ocnn_resnet", reuse=reuse): - data = octree_property(octree, property_name="feature", dtype=tf.float32, - depth=depth, channel=channel) - data = tf.reshape(data, [1, channel, -1, 1]) - - with tf.variable_scope("conv1"): - data = octree_conv_bn_relu(data, octree, depth, channels[depth], training) - - for d in range(depth, 2, -1): - for i in range(0, resblock_num): - with tf.variable_scope('resblock_%d_%d' % (d, i)): - data = octree_resblock(data, octree, d, channels[d], 1, training) - with tf.variable_scope('max_pool_%d' % d): - data, _ = octree_max_pool(data, octree, d) - - with tf.variable_scope("global_average"): - data = octree_full_voxel(data, depth=2) - data = tf.reduce_mean(data, 2) - - data = tf.layers.dropout(data, rate=0.5, training=training) - - with tf.variable_scope("fc2"): - logit = dense(data, nout, use_bias=True) - - return logit - -def octree_conv1x1_bn_LRP(inputs, nout, training): - conv = octree_conv1x1(inputs, nout, use_bias=False) - return conv - -def octree_conv1x1_bn_relu_LRP(inputs, nout, training): - conv = octree_conv1x1_bn_LRP(inputs, nout, training) - return conv - -def octree_conv_bn_relu_LRP(data, octree, depth, channel, training, kernel_size=[3], - stride=1, fast_mode=False): - with tf.variable_scope('conv_bn_relu'): - data = octree_conv_memory(data, octree, depth, channel, kernel_size, stride) - return data - -def fc_bn_relu_LRP(inputs, nout, training): - fc = dense(inputs, nout, use_bias=False) - return fc - -def octree_resblock_1(data, octree, depth, num_out, stride, training, bottleneck=4): - if stride == 2: - data, mask = octree_max_pool(data, octree, depth=depth) - return data - -def octree_resblock_2(data, octree, depth, num_out, stride, training, bottleneck=4): - channelb = int(num_out / bottleneck) - with tf.variable_scope("1x1x1_a"): - block1 = octree_conv1x1_bn_relu(data, channelb, training=training) - return block1, data - -def octree_resblock_3(block1_data, octree, depth, num_out, stride, training, bottleneck=4): - channelb = int(num_out / bottleneck) - block1, data = block1_data - if stride == 2: - depth -= 1 - with tf.variable_scope("3x3x3"): - block2 = octree_conv_bn_relu(block1, octree, depth, channelb, training) - return block2, data - -def octree_resblock_4(block2_data, octree, depth, num_out, stride, training, bottleneck=4): - block2, data = block2_data - with tf.variable_scope("1x1x1_b"): - block3 = octree_conv1x1_bn(block2, num_out, training=training) - return block3, data - -def octree_resblock_5(block3_data, octree, depth, num_out, stride, training, bottleneck=4): - block3, data = block3_data - num_in = int(data.shape[1]) - block4 = data - if num_in != num_out: - with tf.variable_scope("1x1x1_c"): - block4 = octree_conv1x1_bn(data, num_out, training=training) - return tf.nn.relu(block3 + block4) - -def octree_resblock_1_LRP(data, octree, depth, num_out, stride, training, bottleneck=4): - if stride == 2: - data = octree_avg_pool(data, octree, depth=depth) - return data - -def octree_resblock_2_LRP(data, octree, depth, num_out, stride, training, bottleneck=4): - channelb = int(num_out / bottleneck) - with tf.variable_scope("1x1x1_a"): - block1 = octree_conv1x1_bn_relu_LRP(data, channelb, training=training) - return block1, data - -def octree_resblock_3_LRP(block1_data, octree, depth, num_out, stride, training, bottleneck=4): - channelb = int(num_out / bottleneck) - block1, data = block1_data - if stride == 2: - depth -= 1 - with tf.variable_scope("3x3x3"): - block2 = octree_conv_bn_relu_LRP(block1, octree, depth, channelb, training) - return block2, data - -def octree_resblock_4_LRP(block2_data, octree, depth, num_out, stride, training, bottleneck=4): - block2, data = block2_data - with tf.variable_scope("1x1x1_b"): - block3 = octree_conv1x1_bn_LRP(block2, num_out, training=training) - return block3, data - -def octree_resblock_5_LRP(block3_data, octree, depth, num_out, stride, training, bottleneck=4): - block3, data = block3_data - num_in = int(data.shape[1]) - block4 = data - if num_in != num_out: - with tf.variable_scope("1x1x1_c"): - block4 = octree_conv1x1_bn_LRP(data, num_out, training=training) - return block3 + block4 - -#Function to call octree_max_pool and only return the first value instead of a tuple -octree_max_pool_first = lambda x, *args, **kwargs: octree_max_pool(x, *args, **kwargs)[0] - -replace_functions = { #Functions to replace during backpropagation - octree_max_pool_first: octree_avg_pool, - octree_conv_bn_relu: octree_conv_bn_relu_LRP, - fc_bn_relu: fc_bn_relu_LRP, - octree_resblock_1: octree_resblock_1_LRP, - octree_resblock_2: octree_resblock_2_LRP, - octree_resblock_3: octree_resblock_3_LRP, - octree_resblock_4: octree_resblock_4_LRP, - octree_resblock_5: octree_resblock_5_LRP, -} - -class network_ocnn_class(): - def __init__(self, training=False): - self.channels = [2048, 1024, 512, 256, 128, 64, 32, 32, 32] - - #Creating Layer List: ("Variable Scope", Layer Function, [Args], {Kwargs}, "Layer cName") - self.layer_list = [ - ('ocnn', octree_property, [], {'property_name': 'feature', 'dtype': tf.float32, 'depth': depth, 'channel': channel}, 'octree_property'), - ('ocnn', tf.reshape, [[1, channel, -1, 1]], {}, 'reshape'), - ] - - for d in range(depth, 2, -1): - # self.layer_list.append(('depth_%d'%d, octree_conv_memory, [], {'depth':d, 'channel':self.channels[d]}, 'conv_depth_%d'%d)) - # self.layer_list.append(('depth_%d'%d, tf.layers.batch_normalization, [], {'axis':1, 'training':training}, 'batch_norm_depth_%d'%d)) - # self.layer_list.append(('depth_%d'%d, tf.nn.relu, [], {}, 'relu_depth_%d'%d)) - self.layer_list.append(['depth_%d'%d, octree_conv_bn_relu, [], {'depth':d, 'channel':self.channels[d], 'training':training}, 'conv %d'%d]) - - self.layer_list.append(['depth_%d'%d, octree_max_pool_first, [], {'depth': d}, 'conv pooling depth %d'%d]) - - self.layer_list.extend([ - ('full_voxel', octree_full_voxel, [], {'depth': 2}, 'full voxel'), - ('full_voxel', tf.layers.dropout, [], {'rate': 0.5, 'training': training}, 'dropout 1'), - - # ('fc1', dense, [self.channels[2]], {}, 'dense'), - # ('fc1', batch_norm, [], {'training': training}, 'batch_norm'), - # ('fc1', tf.nn.relu, [], {}, 'relu'), - ['fc1', fc_bn_relu, [self.channels[2]], {'training': training}, 'dense'], - - ('fc1', tf.layers.dropout, [], {'rate': 0.5, 'training': training} , 'dropout 2'), - - ('fc2', dense, [nout], {'use_bias': True}, 'fully connected'), - ]) - - def call(self, octree, reuse=tf.AUTO_REUSE, overall_scope="ocnn"): - data = octree - with tf.variable_scope(overall_scope, reuse=reuse): - for layer in self.layer_list: - with tf.variable_scope(layer[0], reuse=reuse): - args = layer[2] - kwargs = layer[3] - if 'conv' in layer[4]: - kwargs['octree']=octree - data = layer[1](data, *args, **kwargs) - return data - - def LRP(self, octree, label=None, overall_scope="ocnn"): - layer_list = self.layer_list - L=len(layer_list) - A=[0]*(L+1) - - A[0] = octree - with tf.variable_scope(overall_scope): - #Forward Pass - for i in range(0,L): - with tf.variable_scope(layer_list[i][0], reuse=tf.AUTO_REUSE): - args = layer_list[i][2] - kwargs = layer_list[i][3] - if 'conv' in layer_list[i][4]: - kwargs['octree']=octree - - A[i+1] = layer_list[i][1](A[i], *args, **kwargs) - - #Create a mask for the outputs - if label is None: - T = A[-1]/tf.reduce_max(A[-1]) - T = tf.floor(tf.nn.relu(T)) - else: - T = tf.eye(nout)[label[0]] - - #Create a list to store relevance values, append output layer with mask - R = [[None]]*L + [(A[-1]*T)] - - result_table=[] - #Backward Pass - for i in range(1,L)[::-1]: - if layer_list[i][4][:10] == 'batch_norm': - R[i]=R[i+1] - else: - with tf.variable_scope(layer_list[i][0], reuse=tf.AUTO_REUSE): - print("Layer",i,":",layer_list[i][4]) - args = layer_list[i][2] - kwargs = layer_list[i][3] - #Replace max_pool layers with avg_pool layers - if layer_list[i][1] in replace_functions: - layer_list[i][1]=replace_functions[layer_list[i][1]] - #Add octree argument if needed - if 'conv' in layer_list[i][4]: - kwargs['octree']=octree - - - # Define LRP rule layer by layer - # if i<=7: - # rho = lambda x: x + 0.25*tf.nn.relu(x) #LRP-gamma Rule - # else: - # rho = lambda x: x #LRP-o Rule - rho = lambda x: tf.nn.relu(x) - incr = lambda z: z+1e-9 +0.5*(tf.math.reduce_mean(z**2)**.5) - - - print("name scope:",tf.get_default_graph().get_name_scope()) - weights = tf.trainable_variables(scope=tf.get_default_graph().get_name_scope()[:-2]) - print("weights:", weights) - for w in weights: - w.assign(rho(w))#rho(w)) - #return weights - - # z = layer_list[i][1](A[i], *args, **kwargs) - # for inp in z.op.inputs: - # if inp.shape.is_fully_defined(): - # inp = np.ones(inp.shape) - - # kernel = tf.get_variable("ocnn/fc2/dense_1/kernel", shape=weights[0].shape, initializer=tf.contrib.layers.xavier_initializer()) - - - z = layer_list[i][1](A[i], *args, **kwargs) - - #z = rho(z) - - z = incr(z) #LRP Step 1 - s = R[i+1]/z #LRP Step 2 - c = tf.gradients(tf.math.reduce_sum(z*s), A[i], stop_gradients=[s, R[i+1]]) #LRP Step 3 - R[i] = A[i]*c #LRP Step 4 - #Create result_table - for i in range(1, L): - layer_label = [ord(c) for c in "layer %d: %s"%(i, layer_list[i][4])] - result_table.append([tf.constant(layer_label), R[i]]) - result_table.append([tf.constant([ord(c) for c in 'output']), tf.nn.relu(R[-1])]) - return [octree, R[1], A[-1], result_table] - -network_ocnn=network_ocnn_class() - -def return_resnet_layers(d, i, training): - channels = [2048, 1024, 512, 256, 128, 64, 32, 32, 32] - layer_list=[] - resblock_functions = [ - octree_resblock_1, - octree_resblock_2, - octree_resblock_3, - octree_resblock_4, - octree_resblock_5, - ] - for layer in range(len(resblock_functions)): - layer_list.append(['resblock_%d_%d'%(d, i), resblock_functions[layer], [], {'depth':d, 'num_out':channels[d],'stride':1,'training':training}, 'resblock %i conv %d (%i)'%(layer+1, d, i)]) - return layer_list - -class network_resnet_class(network_ocnn_class): - def __init__(self, training=False): - self.channels = [2048, 1024, 512, 256, 128, 64, 32, 32, 32] - - #Creating Layer List: ("Variable Scope", Layer Function, [Args], {Kwargs}, "Layer cName") - self.layer_list = [ - ('ocnn_resnet', octree_property, [], {'property_name': 'feature', 'dtype': tf.float32, 'depth': depth, 'channel': channel}, 'octree_property'), - ('ocnn_resnet', tf.reshape, [[1, channel, -1, 1]], {}, 'reshape'), - ['conv1',octree_conv_bn_relu, [], {'depth':depth, 'channel':self.channels[depth], 'training':training}, 'conv 1'] - ] - - for d in range(depth, 2, -1): - for i in range(0, resblock_num): - self.layer_list.extend(return_resnet_layers(d,i, training)) - self.layer_list.append(['max_pool_%d'%d, octree_max_pool_first, [], {'depth': d}, 'conv pooling depth %d'%d]) - - self.layer_list.extend([ - ('global_average', octree_full_voxel, [], {'depth': 2}, 'full voxel'), - ('global_average', tf.reduce_mean, [2], {}, 'reduce mean'), - ('dropout', tf.layers.dropout, [], {'rate': 0.5, 'training': training}, 'dropout 1'), - ('fc2', dense, [nout], {'use_bias': True}, 'fully connected'), - ]) - - def call(self, octree, reuse=tf.AUTO_REUSE): - return super().call(octree, reuse=tf.AUTO_REUSE, overall_scope='ocnn_resnet') - - def LRP(self, octree, label=None): - return super().LRP(octree, label, overall_scope='ocnn_resnet') - -network_resnet = network_resnet_class() - -label_list = sorted([x[1] for x in os.walk('dataset/ModelNet40/ModelNet40.points')][0]) - -#checkpoint_dir = 'logs/m40/0608_resnet_points/model' -# checkpoint_dir = 'logs/m40/0322_ocnn_octree/model/' -#checkpoint_dir = 'QQ/ocnn_points_20200704_class_6/model/' - -octree2points_path = './../../octree/build/octree2points' -output_path = './ocnn_lrp_results/' -octree_files_path = 'octree_heatmaps/' - -print("Checkpoint Directory:", model_path) - -def run_lrp(octree, label, save=False): - with open('./output_octree.txt', 'a+') as f: - f.seek(0) - f.truncate() - outputs = network_ocnn.LRP(octree) - tf_saver = tf.train.Saver(max_to_keep=10) - - config = tf.ConfigProto() - config.gpu_options.allow_growth = True - with tf.Session(config=config) as sess: - #Load Model - sess.run(tf.global_variables_initializer()) - path=tf.train.latest_checkpoint(model_path) - #print(tf.train.list_variables(path)) - tf_saver.restore(sess, path) - - results, category = sess.run((outputs, label)) - - octree, heatmap, logit, result_table = results - print(result_table) - - # Format and print result_table - print("== Summed Relevance By Layer ==") - for result in result_table: - result[0] = "Relevance in " + ''.join(chr(c) for c in result[0]) - result[1] = round(tf.math.reduce_sum(result[1]).eval(), 3) - for r in result: - print(str(r).ljust(45), end='') - print('') - print("===============================") - - heatmap = tf.math.reduce_sum(heatmap, 1) - heatmap=tf.keras.backend.repeat_elements(heatmap, channel, axis=0) - - print("Actual Label:", category[0], "| Predicted Label:", np.argmax(logit)) - - heatmap_octree = octree_set_property(in_octree=octree, property_name='feature', in_property=heatmap, depth=depth) - - filename = octree_files_path + 'heatmap_%d.octree'%(category[0]) - - var = tf.trainable_variables() - var_vals = sess.run(var) - for v, val in zip(var, var_vals): - print("var: {}, value: {}".format(v.name, val.shape)) - conv_filter = [v for v in tf.trainable_variables() if v.name == "ocnn/depth_5/conv_bn_relu/octree_conv/weights:0"][0].eval() - # print(filter, filter.shape) - - with open('./output_octree.txt', 'a+') as f: - f.write(filename+'\n') - - with open(filename, "wb+") as f: - f.write(heatmap_octree.eval().tobytes()) - - if save: - subprocess.call([octree2points_path, '--filenames', './output_octree.txt', '--suffix', 'ply', '--output_path', output_path]) - print("Saved output to %sheatmap_%d.ply"%(output_path, category[0])) - - - -import pandas as pd -from scipy.special import softmax - -def test(octree,label,iters=925): - - columns=['label', 'accuracy','sensitivity','specificity','total'] - stats = np.zeros((nout,len(columns))) - stats = pd.DataFrame(data=stats, columns=columns) - stats['label'] = label_list - - outputs = network_ocnn.call(octree) - tf_saver = tf.train.Saver(max_to_keep=10) - - config = tf.ConfigProto() - config.gpu_options.allow_growth = True - - with tf.Session(config=config) as sess: - #Load Model - sess.run(tf.global_variables_initializer()) - path=tf.train.latest_checkpoint(checkpoint_dir) - tf_saver.restore(sess, path) - - for i in tqdm(range(iters)): - logits, labels = sess.run((outputs, label)) - softmax_array = softmax(logits) - labels = np.eye(nout)[labels] - predictions = np.eye(nout)[np.argmax(softmax_array, axis=1)] - batch_correct = np.where((predictions==labels),1,0) - stats['accuracy'] += np.sum(batch_correct, axis=0) - stats['specificity'] += np.sum(np.where(predictions-batch_correct==-1, 1, 0), axis=0) - stats['sensitivity'] += np.sum(np.where(predictions+batch_correct==2, 1, 0), axis=0) - stats['total']+=np.sum(labels, axis=0) - - total = np.sum(stats['total']) - overall_sensitivity = np.sum(stats['sensitivity']) / total - stats['sensitivity'] /= stats['total'] - stats['specificity'] /= (total-stats['total']) #Uses dataframe __sub__ method - stats['accuracy'] /= total - - print(stats.sort_values(by='sensitivity', ascending=False)[['label','sensitivity','specificity','total']]) - print("\nrecords tested:", total) - print("overall sensitivity:", overall_sensitivity, '\n') - - return stats - -# octree, label=OctreeDataset(ParseExample())( -# record_names='dataset/ModelNet40/m40_5_2_12_test_octree.tfrecords', batch_size=32, -# shuffle_size=0, return_iter=False) -# test(octree, label) - -# octree, label=OctreeDataset(ParseExample())( -# record_names='dataset/ModelNet40/m40_5_2_12_test_octree.tfrecords', batch_size=1, -# shuffle_size=0, return_iter=False) - -octree, label = PointDataset(ParseExample(), - TransformPoints(distort=False, depth=depth), - Points2Octree(depth=depth))(record_names=record_name, batch_size=1, shuffle_size=0) - -run_lrp(octree, label, save=False) diff --git a/tensorflow/script/tensorflow_lrp_bg.py b/tensorflow/script/tensorflow_lrp_bg.py deleted file mode 100644 index 00b33ae..0000000 --- a/tensorflow/script/tensorflow_lrp_bg.py +++ /dev/null @@ -1,407 +0,0 @@ -# Blake Gaines - -import os -import sys -import numpy as np -import tensorflow as tf -from dataset import * -from ocnn import * -from tqdm import tqdm -import subprocess -import seaborn as sns - -# tf.enable_eager_execution() # for save input.octree - -depth = 5 -channel = 24 -nout = 1 -y_type = 'float' - -model_path = 'logs/pdbbind/ocnn_points_20200716_reg_5/model/' -record_name = '/media/data/data_share/pdbbind/tfrecords/test_reg_points_den3.tfrecords' -# record_name = '../util/2xnb.tfrecords' -# record_name = '/media/data/data_share/pdbbind/tfrecords/pitt_example_den3.tfrecords' - -# Original network for comparison, first defined in network_cls.py -def network_ocnn_original(octree, training=False, reuse=False): - channels = [2048, 1024, 512, 256, 128, 64, 32, 32, 32] - with tf.variable_scope("ocnn", reuse=reuse): - data = octree_property(octree, property_name="feature", dtype=tf.float32, - depth=depth, channel=channel) - data = tf.reshape(data, [1, channel, -1, 1]) - for d in range(depth, 2, -1): - with tf.variable_scope('depth_%d' % d): - data = octree_conv_bn_relu(data, octree, d, channels[d], training) - data, _ = octree_max_pool(data, octree, d) - - with tf.variable_scope("full_voxel"): - data = octree_full_voxel(data, depth=2) - data = tf.layers.dropout(data, rate=0.5, training=training) - - with tf.variable_scope("fc1"): - data = fc_bn_relu(data, channels[2], training=training) - data = tf.layers.dropout(data, rate=0.5, training=training) - - with tf.variable_scope("fc2"): - logit = dense(data, nout, use_bias=True) - return logit - - -def octree_conv_bn_relu_LRP(data, octree, depth, channel, training, kernel_size=[3], - stride=1, fast_mode=False): - with tf.variable_scope('conv_bn_relu'): - data = octree_conv_memory(data, octree, depth, channel, kernel_size, stride) - return data - - -def fc_bn_relu_LRP(inputs, nout, training): - fc = dense(inputs, nout, use_bias=False) # QQ: why use false? - return fc - - -# Function to call octree_max_pool and only return the first value instead of a tuple -octree_max_pool_first = lambda x, *args, **kwargs: octree_max_pool(x, *args, **kwargs)[0] - -replace_functions = { # Functions to replace during backpropagation - octree_max_pool_first: octree_avg_pool, - octree_conv_bn_relu: octree_conv_bn_relu_LRP, - fc_bn_relu: fc_bn_relu_LRP, -} - - -class network_ocnn_class(): - def __init__(self, training=False): - self.channels = [2048, 1024, 512, 256, 128, 64, 32, 32, 32] - - # Creating Layer List: ("Variable Scope", Layer Function, [Args], {Kwargs}, "Layer cName") - self.layer_list = [ - ('ocnn', octree_property, [], - {'property_name': 'feature', 'dtype': tf.float32, 'depth': depth, 'channel': channel}, 'octree_property'), - ('ocnn', tf.reshape, [[1, channel, -1, 1]], {}, 'reshape'), - ] - - for d in range(depth, 2, -1): - # self.layer_list.append(('depth_%d'%d, octree_conv_memory, [], {'depth':d, 'channel':self.channels[d]}, 'conv_depth_%d'%d)) - # self.layer_list.append(('depth_%d'%d, tf.layers.batch_normalization, [], {'axis':1, 'training':training}, 'batch_norm_depth_%d'%d)) - # self.layer_list.append(('depth_%d'%d, tf.nn.relu, [], {}, 'relu_depth_%d'%d)) - self.layer_list.append(['depth_%d' % d, octree_conv_bn_relu, [], - {'depth': d, 'channel': self.channels[d], 'training': training}, 'conv %d' % d]) - - self.layer_list.append( - ['depth_%d' % d, octree_max_pool_first, [], {'depth': d}, 'conv pooling depth %d' % d]) - - self.layer_list.extend([ - ('full_voxel', octree_full_voxel, [], {'depth': 2}, 'full voxel'), - ('full_voxel', tf.layers.dropout, [], {'rate': 0.5, 'training': training}, 'dropout 1'), - - # ('fc1', dense, [self.channels[2]], {}, 'dense'), - # ('fc1', batch_norm, [], {'training': training}, 'batch_norm'), - # ('fc1', tf.nn.relu, [], {}, 'relu'), - ['fc1', fc_bn_relu, [self.channels[2]], {'training': training}, 'dense'], - - ('fc1', tf.layers.dropout, [], {'rate': 0.5, 'training': training}, 'dropout 2'), - - ('fc2', dense, [nout], {'use_bias': True}, 'fully connected'), # QQ: set use_bias to True when use regression - ]) - - def call(self, octree, reuse=tf.AUTO_REUSE): - data = octree - with tf.variable_scope("ocnn", reuse=reuse): - for layer in self.layer_list: - with tf.variable_scope(layer[0], reuse=reuse): - args = layer[2] - kwargs = layer[3] - if layer[4][:4] == 'conv': - kwargs['octree'] = octree - # if 'depth' in layer[4]: - # with tf.variable_scope('conv_bn_relu'): - # data = layer[1](data, *args, **kwargs) - # else: - data = layer[1](data, *args, **kwargs) - return data - - def LRP(self, octree, label=None): - layer_list = self.layer_list - L = len(layer_list) - print('Total {} layers'.format(L)) - A = [0] * (L + 1) - - A[0] = octree - with tf.variable_scope("ocnn"): - # Forward Pass - for i in range(0, L): - with tf.variable_scope(layer_list[i][0], reuse=tf.AUTO_REUSE): - args = layer_list[i][2] - kwargs = layer_list[i][3] - if layer_list[i][4][:4] == 'conv': - kwargs['octree'] = octree - # if 'depth' in layer_list[i][4]: - # with tf.variable_scope('conv_bn_relu'): - # A[i+1] = layer_list[i][1](A[i], *args, **kwargs) - # else: - A[i + 1] = layer_list[i][1](A[i], *args, **kwargs) - - # Create a mask for the outputs - if label is None: - T = A[-1] / tf.reduce_max(A[-1]) - T = tf.floor(tf.nn.relu(T)) - else: - T = tf.eye(nout)[label[0]] - - # Create a list to store relevance values, append output layer with mask - R = [None] * L + [(A[-1] * T)] - - result_table = [] - # Backward Pass - for i in range(1, L)[::-1]: - if layer_list[i][4][:10] == 'batch_norm': - R[i] = R[i + 1] - print('batch norm, relevance in layer {} equal to layer {}'.format(i, i+1)) - else: - with tf.variable_scope(layer_list[i][0], reuse=tf.AUTO_REUSE): - print("Layer", i, ":", layer_list[i][4]) - args = layer_list[i][2] - kwargs = layer_list[i][3] - - # Replace max_pool layers with avg_pool layers - if layer_list[i][1] in replace_functions: - print("Replacing Layer:", layer_list[i][4]) - layer_list[i][1] = replace_functions[layer_list[i][1]] - # Add octree argument if needed - if layer_list[i][4][:4] == 'conv': - kwargs['octree'] = octree - # Add another variable_scope if needed - # if 'depth' in layer_list[i][4]: - # with tf.variable_scope('conv_bn_relu'): - # z = layer_list[i][1](A[i], *args, **kwargs) - # else: - z = layer_list[i][1](A[i], *args, **kwargs) - - # Define LRP rule layer by layer - # if i <= 13: - # rho = lambda x: x + 0.25 * tf.nn.relu(x) # LRP-gamma Rule - # else: - # rho = lambda x: x # LRP-o Rule - rho = lambda x: x # LRP-o Rule - incr = lambda z: z+1e-9+0.25*(tf.math.reduce_mean(z**2)**.5) - - z = incr(rho(z)) # LRP Step 1 - s = R[i + 1] / z # LRP Step 2 - c = tf.gradients(tf.math.reduce_sum(z * s), A[i], stop_gradients=[s, R[i + 1]]) # LRP Step 3 - R[i] = A[i] * c # LRP Step 4 - pass - # Create result_table - for i in range(1, L): - layer_label = [ord(c) for c in "layer %d: %s" % (i, layer_list[i][4])] - result_table.append([tf.constant(layer_label), R[i]]) - result_table.append([tf.constant([ord(c) for c in 'output']), R[-1]]) - return [octree, R[1], A[-1], result_table] - - -network_ocnn = network_ocnn_class() - - -def run_lrp(octree, label, index): - with open('./output_octree.txt', 'a') as f: - f.seek(0) - f.truncate() - outputs = network_ocnn.LRP(octree, label) - tf_saver = tf.train.Saver(max_to_keep=10) - - config = tf.ConfigProto() - config.gpu_options.allow_growth = True - with tf.Session(config=config) as sess: - # Load Model - sess.run(tf.global_variables_initializer()) - path = tf.train.latest_checkpoint(model_path) - tf_saver.restore(sess, path) - - num=0 - while num <= index: - results, category = sess.run((outputs, label)) - num += 1 - octree, heatmap, logit, result_table = results - - # Format and print result_table - print("== Summed Relevance By Layer ==") - for result in result_table: - result[0] = "Relevance in " + ''.join(chr(c) for c in result[0]) - result[1] = round(tf.math.reduce_sum(result[1]).eval(), 8) - for r in result: - print(str(r).ljust(45), end='') - print('') - print("===============================") - - heatmap = tf.math.reduce_sum(heatmap, 1) - heatmap = tf.keras.backend.repeat_elements(heatmap, channel, axis=0) - - print("Actual Label:", category[0], "| Predicted Label:", np.argmax(logit)) - - heatmap_octree = octree_set_property(in_octree=octree, property_name='feature', in_property=heatmap, - depth=depth) - - filename = 'octree_heatmaps/heatmap_%d.octree' % (category[0]) - print(filename) - - with open('./output_octree.txt', 'a+') as f: - f.write(filename + '\n') - - with open(filename, "wb") as f: - f.write(heatmap_octree.eval().tobytes()) - - subprocess.call(['./../../octree/build/octree2points', '--filenames', './output_octree.txt', '--suffix', 'ply', - '--output_path', './ocnn_lrp_results']) - - -import pandas as pd -from scipy.special import softmax -from scipy.stats import pearsonr - -from sklearn import metrics -from sklearn.metrics import roc_curve, auc, mean_squared_error, mean_absolute_error -import matplotlib.pyplot as plt - -def report_auc(all_labels, all_probs): - fpr, tpr, thresholds = metrics.roc_curve(all_labels, all_probs, pos_label=1) - roc_auc = auc(fpr, tpr) - print('AUC: {}'.format(metrics.auc(fpr, tpr))) - - plt.figure() - lw = 2 - plt.plot(fpr, tpr, color='darkorange', - lw=lw, label='ROC curve (area = %0.2f)' % roc_auc) - plt.plot([0, 1], [0, 1], color='navy', lw=lw, linestyle='--') - plt.xlim([0.0, 1.0]) - plt.ylim([0.0, 1.05]) - plt.xlabel('False Positive Rate') - plt.ylabel('True Positive Rate') - plt.title('Receiver operating characteristic example') - plt.legend(loc="lower right") - plt.show() - pass - -def report_reg_metrics(all_labels, all_preds): - rmse = np.sqrt(mean_squared_error(all_labels, all_preds)) - mae = mean_absolute_error(all_labels, all_preds) - r = pearsonr(all_labels, all_preds) - print('rmse: {}, mae: {}, r: {}'.format(rmse, mae, r)) - pass - -def report_scatter(all_labels, all_probs): - plt.figure() - sns.scatterplot(all_labels, all_probs) - plt.show() - - -def test_reg(octree, label, iters=925, test_size = 285): - columns = ['label', 'accuracy', 'sensitivity', 'specificity', 'total'] - stats = np.zeros((nout, len(columns))) - stats = pd.DataFrame(data=stats, columns=columns) - # stats['label'] = sorted([x[1] for x in os.walk('/home/bbg16101/OCNN_LRP/O-CNN/tensorflow/script/dataset/ModelNet40/ModelNet40.points')][0]) - # stats['label'] = pd.Series(['0', '1']) - - outputs = network_ocnn.call(octree) - tf_saver = tf.train.Saver(max_to_keep=10) - - config = tf.ConfigProto() - config.gpu_options.allow_growth = True - - all_labels = [] - all_preds = [] - - with tf.Session(config=config) as sess: - # Load Model - sess.run(tf.global_variables_initializer()) - path = tf.train.latest_checkpoint(model_path) - print('Load model') - tf_saver.restore(sess, path) - for i in tqdm(range(iters)): - logits, labels = sess.run((outputs, label)) - all_labels += labels.tolist() - all_preds += np.array(logits).flatten().tolist() - - all_labels = all_labels.reshape(285,-1) - all_preds = all_preds.reshape(285,-1) - - all_labels_mean = all_labels.mean(axis=1) - all_preds_mean = all_preds.mean(axis=1) - - if all_labels.std(axis=1).sum() !=0: - print(all_labels) - - report_reg_metrics(all_labels_mean, all_preds_mean) - report_scatter(all_labels_mean, all_preds_mean) - return stats - -def test(octree, label, iters=925): - columns = ['label', 'accuracy', 'sensitivity', 'specificity', 'total'] - stats = np.zeros((nout, len(columns))) - stats = pd.DataFrame(data=stats, columns=columns) - # stats['label'] = sorted([x[1] for x in os.walk('/home/bbg16101/OCNN_LRP/O-CNN/tensorflow/script/dataset/ModelNet40/ModelNet40.points')][0]) - stats['label'] = pd.Series(['0', '1']) - - outputs = network_ocnn.call(octree) - tf_saver = tf.train.Saver(max_to_keep=10) - - config = tf.ConfigProto() - config.gpu_options.allow_growth = True - - all_labels = [] - all_probs = [] - - with tf.Session(config=config) as sess: - # Load Model - sess.run(tf.global_variables_initializer()) - path = tf.train.latest_checkpoint('logs/pdbbind/ocnn_points_20200704_class_6/model/') - print('Load model') - tf_saver.restore(sess, path) - for i in tqdm(range(iters)): - logits, labels = sess.run((outputs, label)) - softmax_array = softmax(logits, axis=1) - labels = np.eye(nout)[labels] - predictions = np.eye(nout)[np.argmax(softmax_array, axis=1)] - batch_correct = np.where((predictions == labels), 1, 0) - stats['accuracy'] += np.sum(batch_correct, axis=0) - stats['specificity'] += np.sum(np.where(predictions - batch_correct == -1, 1, 0), axis=0) - stats['sensitivity'] += np.sum(np.where(predictions + batch_correct == 2, 1, 0), axis=0) - stats['total'] += np.sum(labels, axis=0) - - all_labels += labels[:,1].tolist() - all_probs += softmax_array[:,1].tolist() - - total = np.sum(stats['total']) - overall_sensitivity = np.sum(stats['sensitivity']) / total - stats['sensitivity'] /= stats['total'] - stats['specificity'] /= (-stats['total'] + total) - stats['accuracy'] /= total - print(stats.sort_values(by='sensitivity', ascending=False)[ - ['label', 'sensitivity', 'specificity', 'total']]) # accuracy, sensitivity, specificity, total - print("\nrecords tested:", total) - print("overall accuracy:", stats['accuracy'][0], '\n') - # print("overall sensitivity:", overall_sensitivity, '\n') - - report_auc(all_labels, all_probs) - report_scatter(all_labels, all_probs) - return stats - - -octree, label = PointDataset(ParseExample(y_type = y_type), - TransformPoints(distort=False, depth=depth), - Points2Octree(depth=depth))(record_names=record_name, batch_size=5, - shuffle_size=1) - -# grids, label = Point2GridDataset(ParseExample(y_type = y_type, **flags), -# TransformPoints(**flags, bounding_sphere=bounding_sphere), -# MakeGrids(out_size, feature_num)) - -# octree, label=OctreeDataset(ParseExample())( -# record_names='dataset/ModelNet40/m40_5_2_12_test_octree.tfrecords', batch_size=1, -# shuffle_size=0, return_iter=False) - -# if use this, also enable_eager_execution at the top of file. -# with open('./input.octree', "wb") as f: -# f.write(octree.numpy().tobytes()) - -# run_lrp(octree, label, 0) -# test(octree=octree, label=label, iters=17) -test_reg(octree=octree, label=label, iters=57) \ No newline at end of file diff --git a/tensorflow/script/tfsolver.py b/tensorflow/script/tfsolver.py index 7305020..6c293be 100644 --- a/tensorflow/script/tfsolver.py +++ b/tensorflow/script/tfsolver.py @@ -10,17 +10,33 @@ class TFSolver: def __init__(self, flags, compute_graph=None, build_solver=build_solver): - self.flags = flags + self.flags = flags.SOLVER self.graph = compute_graph self.build_solver = build_solver def build_train_graph(self): - self.train_tensors, train_names = self.graph('train', training=True, reuse=False, task = self.flags['task']) - self.test_tensors, self.test_names = self.graph('test', training=False, reuse=True, task = self.flags['task']) - total_loss = self.train_tensors[train_names.index('total_loss')] # TODO: use dict - self.train_op, lr = self.build_solver(total_loss, LRFactory(self.flags)) - self.summaries(train_names + ['lr'], self.train_tensors + [lr,], self.test_names) + gpu_num = len(self.flags.gpu) + train_params = {'dataset': 'train', 'training': True, 'reuse': False} + test_params = {'dataset': 'test', 'training': False, 'reuse': True} + if gpu_num > 1: + train_params['gpu_num'] = gpu_num + test_params['gpu_num'] = gpu_num + + self.train_tensors, train_names = self.graph(**train_params) + self.test_tensors, self.test_names = self.graph(**test_params) + self.total_loss = self.train_tensors[train_names.index('total_loss')] + solver_param = [self.total_loss, LRFactory(self.flags)] + if gpu_num > 1: + solver_param.append(gpu_num) + self.train_op, lr = self.build_solver(*solver_param) # qq: self.train_op is the optimizer. + + if gpu_num > 1: # average the tensors from different gpus for summaries + with tf.device('/cpu:0'): + self.train_tensors = average_tensors(self.train_tensors) + self.test_tensors = average_tensors(self.test_tensors) + self.summaries(train_names + ['lr'], self.train_tensors + [lr,], self.test_names) + def summaries(self, train_names, train_tensors, test_names): self.summ_train = summary_train(train_names, train_tensors) self.summ_test, self.summ_holder = summary_test(test_names) @@ -35,7 +51,13 @@ def summ2txt(self, values, step, flag='a'): fid.write(msg + '\n') def build_test_graph(self): - self.test_tensors, self.test_names = self.graph('test', training=False, reuse=False, task = self.flags['task']) + gpu_num = len(self.flags.gpu) + test_params = {'dataset': 'test', 'training': False, 'reuse': False} + if gpu_num > 1: test_params['gpu_num'] = gpu_num + self.test_tensors, self.test_names = self.graph(**test_params) + if gpu_num > 1: # average the tensors from different gpus + with tf.device('/cpu:0'): + self.test_tensors = average_tensors(self.test_tensors) def restore(self, sess, ckpt): print('Load checkpoint: ' + ckpt) @@ -54,12 +76,28 @@ def run_k_iterations(self, sess, k, tensors): for j in range(num): avg_results[j] /= k + avg_results = self.result_callback(avg_results) return avg_results + def result_callback(self, avg_results): + return avg_results # calc some metrics, such as IoU, based on the graph output + + def qq_set_update_after_k_round(self): + self.opt = tf.train.AdamOptimizer(learning_rate=0.1) + tvs = tf.trainable_variables() + accum_vars = [tf.Variable(tf.zeros_like(tv.initialized_value()), trainable=False) for tv in tvs] + self.zero_ops = [tv.assign(tf.zeros_like(tv)) for tv in accum_vars] + gvs = self.opt.compute_gradients(self.total_loss, tvs) + self.accum_ops = [accum_vars[i].assign_add(gv[0]) for i, gv in enumerate(gvs)] + self.train_step = self.opt.apply_gradients([(accum_vars[i], gv[1]) for i, gv in enumerate(gvs)]) + def train(self): # build the computation graph self.build_train_graph() + # qq: add + self.qq_set_update_after_k_round() + # checkpoint start_iter = 1 self.tf_saver = tf.train.Saver(max_to_keep=self.flags.ckpt_num) @@ -70,15 +108,10 @@ def train(self): ckpt = tf.train.latest_checkpoint(ckpt_path) if ckpt: start_iter = int(ckpt[ckpt.find("iter")+5:-5]) + 1 - # timeline_skip, timeline_iter = 50, 2 - # session config = tf.ConfigProto(allow_soft_placement=True) config.gpu_options.allow_growth = True - # options = tf.RunOptions(trace_level=tf.RunOptions.FULL_TRACE) - # run_metadata = tf.RunMetadata() - with tf.Session(config=config) as sess: summary_writer = tf.summary.FileWriter(self.flags.logdir, sess.graph) @@ -89,34 +122,19 @@ def train(self): print('Start training ...') for i in tqdm(range(start_iter, self.flags.max_iter + 1), ncols=80): # training - # https://stackoverflow.com/questions/34293714/can-i-measure-the-execution-time-of-individual-operations-with-tensorflow# - # run_options = tf.RunOptions(trace_level=tf.RunOptions.FULL_TRACE) - # run_metadata = tf.RunMetadata() - # summary, _ = sess.run([self.summ_train, self.train_op], options=run_options, run_metadata=run_metadata) + # qq: revise the training, to update gradients after multiple iterations + # first 2 lines are original code. # summary, _ = sess.run([self.summ_train, self.train_op]) - # if i < timeline_skip: - summary, _ = sess.run([self.summ_train, self.train_op]) - # iter_test_result = sess.run(self.test_tensors) # qq add for for test - # else: # add for time - # summary, _ = sess.run([self.summ_train, self.train_op], - # options=options, run_metadata=run_metadata) - - # if (i == timeline_skip + timeline_iter - 1): - # # summary_writer.add_run_metadata(run_metadata, 'step_%d'%i, i) - # # write timeline to a json file - # fetched_timeline = timeline.Timeline(run_metadata.step_stats) - # chrome_trace = fetched_timeline.generate_chrome_trace_format() - # with open(os.path.join(self.flags.logdir, 'timeline.json'), 'w') as f: - # f.write(chrome_trace) - - summary_writer.add_summary(summary, i) - # summary_writer.add_run_metadata(run_metadata, 'step%d' % i, i) - - # Create the Timeline object, and write it to a json - # tl = timeline.Timeline(run_metadata.step_stats) - # ctf = tl.generate_chrome_trace_format() - # with open(os.path.join(self.flags.logdir, 'timeline.json'), 'w') as f: - # f.write(ctf) + # summary_writer.add_summary(summary, i) + if i == 0: + sess.run(self.zero_ops) + if i % 10 !=0 or i ==0: + sess.run(self.accum_ops) + else: + sess.run(self.accum_ops) + sess.run(self.train_step) + sess.run(self.zero_ops) + # qq: end revise # testing if i % self.flags.test_every_iter == 0: @@ -137,7 +155,6 @@ def train(self): def timeline(self): # build the computation graph - self.build_train_graph() # session @@ -145,18 +162,17 @@ def timeline(self): config.gpu_options.allow_growth = True options = tf.RunOptions(trace_level=tf.RunOptions.FULL_TRACE) run_metadata = tf.RunMetadata() - timeline_skip, timeline_iter = 50, 1 + timeline_skip, timeline_iter = 100, 2 with tf.Session(config=config) as sess: summary_writer = tf.summary.FileWriter(self.flags.logdir, sess.graph) print('Initialize ...') self.initialize(sess) print('Start profiling ...') - for i in tqdm(range(0, timeline_skip + timeline_iter)): - if i < timeline_skip or i > (timeline_skip + timeline_iter): + for i in tqdm(range(0, timeline_skip + timeline_iter), ncols=80): + if i < timeline_skip: summary, _ = sess.run([self.summ_train, self.train_op]) else: - print('i: ', i) summary, _ = sess.run([self.summ_train, self.train_op], options=options, run_metadata=run_metadata) if (i == timeline_skip + timeline_iter - 1): @@ -166,10 +182,8 @@ def timeline(self): chrome_trace = fetched_timeline.generate_chrome_trace_format() with open(os.path.join(self.flags.logdir, 'timeline.json'), 'w') as f: f.write(chrome_trace) - print('Profiling done!') - - summary_writer.add_summary(summary, i) - + summary_writer.add_summary(summary, i) + print('Profiling done!') def param_stats(self): # build the computation graph @@ -191,15 +205,16 @@ def param_stats(self): def test(self): # build graph self.build_test_graph() + self.qq_set_update_after_k_round() # checkpoint assert(self.flags.ckpt) # the self.flags.ckpt should be provided tf_saver = tf.train.Saver(max_to_keep=10) # start - num_tensors = 4 # len(self.test_tensors) # qq: original has 4, revise for test, since we add logit and input in loss. + num_tensors = len(self.test_tensors) avg_test = [0] * num_tensors - config = tf.ConfigProto() + config = tf.ConfigProto(allow_soft_placement=True) config.gpu_options.allow_growth = True with tf.Session(config=config) as sess: summary_writer = tf.summary.FileWriter(self.flags.logdir, sess.graph) @@ -207,12 +222,13 @@ def test(self): # restore and initialize self.initialize(sess) + print('Restore from checkpoint: %s' % self.flags.ckpt) tf_saver.restore(sess, self.flags.ckpt) print('Start testing ...') - test_logits = [] # qq add to record all logits for i in range(0, self.flags.test_iter): iter_test_result = sess.run(self.test_tensors) + iter_test_result = self.result_callback(iter_test_result) # run testing average for j in range(num_tensors): avg_test[j] += iter_test_result[j] @@ -223,11 +239,14 @@ def test(self): print(reports) self.summ2txt(iter_test_result, i) - # summary - print('Testing done!\n') - reports = 'batch: %04d; ' % self.flags.test_iter + # Final testing results for j in range(num_tensors): avg_test[j] /= self.flags.test_iter + avg_test = self.result_callback(avg_test) + # print the results + print('Testing done!\n') + reports = 'ALL: %04d; ' % self.flags.test_iter + for j in range(num_tensors): reports += '%s: %0.4f; ' % (self.test_names[j], avg_test[j]) print(reports) self.summ2txt(avg_test, 'ALL') @@ -262,7 +281,6 @@ def test_ave(self, test_size = 285): all_labels = np.array(test_labels).reshape(test_size, -1) all_labels = all_labels.reshape(-1, test_size) - print(all_labels) all_preds = all_preds.reshape(-1, test_size) all_labels_mean = all_labels.mean(axis=0) @@ -271,7 +289,6 @@ def test_ave(self, test_size = 285): # if abs(all_labels.std(axis=0).sum()) < 1e-4: # print(all_labels.std(axis=0)) # print(all_labels) - np.savetxt('pred.csv', np.array([all_labels_mean, all_preds_mean]).swapaxes(0,1)) def report_reg_metrics(all_labels, all_preds): from scipy.stats import pearsonr, spearmanr, kendalltau diff --git a/tensorflow/test/test_all.py b/tensorflow/test/test_all.py index cb5f0ed..e23c68d 100644 --- a/tensorflow/test/test_all.py +++ b/tensorflow/test/test_all.py @@ -11,6 +11,8 @@ from test_octree_nearest import OctreeNearestTest from test_octree_gather import OctreeGatherTest from test_octree_align import OctreeAlignTest +from test_octree2points import Octree2PointsTest +from test_points_property import PointsPropertyTest if __name__ == "__main__": diff --git a/tensorflow/test/test_octree2col.py b/tensorflow/test/test_octree2col.py index 66a9016..76376f2 100644 --- a/tensorflow/test/test_octree2col.py +++ b/tensorflow/test/test_octree2col.py @@ -23,7 +23,7 @@ def initialize(self): [9, 10, 11, 12, 13, 14, 15, 16, 17]] def forward(self, kernel_size, stride, idx_map): - kernel = kernel_size[0] * kernel_size[1] * kernel_size[2]; + kernel = kernel_size[0] * kernel_size[1] * kernel_size[2] # kernel = 27 btm_h = 8 top_h = 8 if stride == 1 else 1 diff --git a/tensorflow/test/test_octree2points.py b/tensorflow/test/test_octree2points.py new file mode 100644 index 0000000..ea71f77 --- /dev/null +++ b/tensorflow/test/test_octree2points.py @@ -0,0 +1,49 @@ +import os +import sys +import numpy as np +import tensorflow as tf +sys.path.append("..") +sys.path.append("../script") +from libs import * +from ocnn import octree2points + +class Octree2PointsTest(tf.test.TestCase): + + def test_forward1(self): + octree = octree_batch(octree_samples(['octree_3'])) + pts = octree2points(octree, depth=5, pts_channel=3) + + gt = np.array([[18.5, 16.605, 16.605], [18.5, 16.48, 17.5], + [18.5, 17.5, 16.48], [18.5, 16.48, 18.5], + [18.5, 16.48, 19.5], [18.5, 18.5, 16.48], + [18.5, 19.5, 16.48], [16.48, 18.5, 20.5], + [18.5, 16.48, 20.5], [18.5, 16.48, 21.5], + [16.48, 20.5, 18.5], [18.5, 20.5, 16.48], + [18.5, 21.5, 16.48]]) + + with self.cached_session() as sess: + pt = sess.run(pts) + self.assertAllClose(pt, gt) + + def test_forward2(self): + octree = octree_batch(octree_samples(['octree_3', 'octree_3'])) + pts = octree2points(octree, depth=5, pts_channel=4) + + gt = np.array([[18.5, 16.605, 16.605], [18.5, 16.48, 17.5], + [18.5, 17.5, 16.48], [18.5, 16.48, 18.5], + [18.5, 16.48, 19.5], [18.5, 18.5, 16.48], + [18.5, 19.5, 16.48], [16.48, 18.5, 20.5], + [18.5, 16.48, 20.5], [18.5, 16.48, 21.5], + [16.48, 20.5, 18.5], [18.5, 20.5, 16.48], + [18.5, 21.5, 16.48]]) + idx = np.concatenate([np.zeros([13, 1]), np.ones([13, 1])], axis=0) + gt = np.concatenate([np.concatenate([gt, gt], axis=0), idx], axis=1) + + with self.cached_session() as sess: + pt = sess.run(pts) + self.assertAllClose(pt, gt) + + +if __name__ == "__main__": + os.environ['CUDA_VISIBLE_DEVICES'] = '0' + tf.test.main() diff --git a/tensorflow/test/test_octree_grow.py b/tensorflow/test/test_octree_grow.py index 0e9a718..04a2d7a 100644 --- a/tensorflow/test/test_octree_grow.py +++ b/tensorflow/test/test_octree_grow.py @@ -1,101 +1,40 @@ import os import sys import numpy as np -# from tqdm import tqdm import tensorflow as tf sys.path.append("..") -from config import * -from ocnn import * +from libs import * -# # ===================== -# tf.enable_eager_execution() +tf.compat.v1.enable_eager_execution() -# octree = octree_new(batch_size=1, channel=4, has_displace=True) -# octree = octree_grow(octree, target_depth=1, full_octree=True) -# print('octree_1.octree') -# with open('octree_1.octree', 'wb') as f: -# f.write(octree.numpy().tobytes()) - -# octree = octree_grow(octree, target_depth=2, full_octree=True) -# print('octree_2.octree') -# with open('octree_2.octree', 'wb') as f: -# f.write(octree.numpy().tobytes()) - -# # load test octree -# depth = 6 -# with open('octree_test.octree', 'rb') as f: -# bytes_in = f.read() -# octree_gt = tf.decode_raw(bytes=bytes_in, out_type=tf.int8) -# label_gt = [None]*10 -# for d in range(2, depth + 1): -# label = octree_property(octree_gt, property_name="split", dtype=tf.float32, -# depth=d, channel=1) -# label_gt[d] = tf.reshape(tf.cast(label, dtype=tf.int32), [-1]) - -# for d in range(2, depth + 1): -# octree = octree_update(octree, label_gt[d], depth=d, mask=1) -# if d < depth: -# octree = octree_grow(octree, target_depth=d+1, full_octree=False) - -# print('octree_6.octree') -# with open('octree_6.octree', 'wb') as f: -# f.write(octree.numpy().tobytes()) - - -# ==================== -# tf.enable_eager_execution() - - -depth = 6 -octree = octree_new(batch_size=1, channel=4, has_displace=True) +depth, channel = 5, 3 +octree = octree_new(batch_size=1, channel=channel, has_displace=False) octree = octree_grow(octree, target_depth=1, full_octree=True) octree = octree_grow(octree, target_depth=2, full_octree=True) -# load test octree -test_set = '/home/penwan/workspace/ps/Dataset/completion_test_octree_6_lmdb_new.tfrecord' -octree_gt, _ = dataset(test_set, 1) -label_gt = [None]*10 -for d in range(2, depth + 1): - label = octree_property(octree_gt, property_name="split", dtype=tf.float32, - depth=d, channel=1) - label_gt[d] = tf.reshape(tf.cast(label, dtype=tf.int32), [-1]) - +octree_gt = tf.decode_raw(octree_samples('octree_2'), out_type=tf.int8) for d in range(2, depth + 1): - octree = octree_update(octree, label_gt[d], depth=d, mask=1) + child = octree_child(octree_gt, depth=d) + label = tf.cast(child > -1, tf.int32) + octree = octree_update(octree, label, depth=d, mask=1) if d < depth: - octree = octree_grow(octree, target_depth=d+1, full_octree=False) - -# d = 2 -# octree = octree_update(octree, label_gt[d], depth=d, mask=1) -# octree = octree_grow(octree, target_depth=d+1, full_octree=False) - -# d = 3 -# octree = octree_update(octree, label_gt[d], depth=d, mask=1) -# octree = octree_grow(octree, target_depth=d+1, full_octree=False) - -# d = 4 -# octree = octree_update(octree, label_gt[d], depth=d, mask=1) -# octree = octree_grow(octree, target_depth=d+1, full_octree=False) - -# d = 5 -# octree = octree_update(octree, label_gt[d], depth=d, mask=1) -# octree = octree_grow(octree, target_depth=d+1, full_octree=False) + octree = octree_grow(octree, target_depth=d + 1, full_octree=False) -# d = 6 -# octree = octree_update(octree, label_gt[d], depth=d, mask=1) +signal = octree_signal(octree_gt, depth, channel) +octree = octree_set_property(octree, signal, property_name="feature", depth=depth) -config = tf.ConfigProto() -config.gpu_options.allow_growth = True -with tf.Session(config=config) as sess: - tf.summary.FileWriter('./logs', sess.graph) - o1, o2 = sess.run([octree_gt, octree]) +# config = tf.ConfigProto() +# config.gpu_options.allow_growth = True +# with tf.Session(config=config) as sess: +# tf.summary.FileWriter('./logs', sess.graph) +# o1, o2 = sess.run([octree_gt, octree]) -# o1 = octree_gt.numpy() -# o2 = octree.numpy() +o1 = octree_gt.numpy() +o2 = octree.numpy() -print('output') +print('Please check the output files: `octree_1.octree` and `octree_2.octree`') with open('octree_1.octree', 'wb') as f: f.write(o1.tobytes()) with open('octree_2.octree', 'wb') as f: diff --git a/tensorflow/test/test_octree_key.py b/tensorflow/test/test_octree_key.py new file mode 100644 index 0000000..57eedd2 --- /dev/null +++ b/tensorflow/test/test_octree_key.py @@ -0,0 +1,58 @@ +import tensorflow as tf +import numpy as np +import os +import sys +sys.path.append("..") +from libs import * + +tf.enable_eager_execution() + + +class OctreeKeyTest(tf.test.TestCase): + + def test_decode_encode_key(self): + octree = octree_batch(octree_samples(['octree_1', 'octree_1'])) + xyz = octree_property(octree, property_name='xyz', depth=5, channel=1, dtype=tf.uint64) + xyz = tf.reshape(xyz, [-1]) + pts = octree_decode_key(xyz) + xyz_encode = octree_encode_key(pts) + + gt = tf.constant([ + [16, 16, 16, 0], [16, 16, 17, 0], [16, 17, 16, 0], [16, 17, 17, 0], + [17, 16, 16, 0], [17, 16, 17, 0], [17, 17, 16, 0], [17, 17, 17, 0], + [16, 16, 16, 1], [16, 16, 17, 1], [16, 17, 16, 1], [16, 17, 17, 1], + [17, 16, 16, 1], [17, 16, 17, 1], [17, 17, 16, 1], [17, 17, 17, 1]], + dtype=tf.uint16) + + # test + with self.cached_session() as sess: + self.assertAllEqual(gt, pts) + self.assertAllEqual(xyz_encode, xyz) + + def test_xyz_key(self): + octree = octree_batch(octree_samples(['octree_1', 'octree_1'])) + xyz = octree_property(octree, property_name='xyz', depth=5, channel=1, dtype=tf.uint64) + xyz = tf.reshape(xyz, [-1]) + + key = octree_xyz2key(xyz) + xyz_out = octree_key2xyz(key) + + # test + with self.cached_session() as sess: + self.assertAllEqual(xyz_out, xyz) + + def test_search_key(self): + octree = octree_batch(octree_samples(['octree_1', 'octree_1'])) + key = tf.constant([28673, 281474976739335, 10], dtype=tf.uint64) + idx_gt = tf.constant([1, 15, -1], dtype=tf.int32) + idx = octree_search_key(key, octree, depth=5, is_xyz=False) + + # test + with self.cached_session() as sess: + self.assertAllEqual(idx_gt, idx) + + + +if __name__ == "__main__": + os.environ['CUDA_VISIBLE_DEVICES'] = '0' + tf.test.main() diff --git a/tensorflow/test/test_octree_linear.py b/tensorflow/test/test_octree_linear.py index 4d48afc..81631e5 100644 --- a/tensorflow/test/test_octree_linear.py +++ b/tensorflow/test/test_octree_linear.py @@ -42,5 +42,5 @@ def test_forward_backward(self): if __name__ == "__main__": - os.environ['CUDA_VISIBLE_DEVICES'] = '1' + os.environ['CUDA_VISIBLE_DEVICES'] = '0' tf.test.main() \ No newline at end of file diff --git a/tensorflow/test/test_octree_nearest.py b/tensorflow/test/test_octree_nearest.py index eb6d1b8..efdcbf9 100644 --- a/tensorflow/test/test_octree_nearest.py +++ b/tensorflow/test/test_octree_nearest.py @@ -16,9 +16,7 @@ def test_forward_backward(self): data = tf.constant(data_np) nearest1 = octree_tile(data, octree, depth) - xyz = octree_property( - octree, property_name='xyz', depth=depth+1, channel=1, dtype=tf.uint32) - xyz = tf.reshape(xyz, [-1]) + xyz = octree_xyz(octree, depth=depth+1, decode=False) xyz = tf.cast(octree_decode_key(xyz), dtype=tf.float32) xyz += tf.constant([0.5, 0.5, 0.5, 0.0], dtype=tf.float32) xyz *= tf.constant([0.5, 0.5, 0.5, 1.0], dtype=tf.float32) diff --git a/tensorflow/test/test_octree_search.py b/tensorflow/test/test_octree_search.py index 56eaabe..855da9c 100644 --- a/tensorflow/test/test_octree_search.py +++ b/tensorflow/test/test_octree_search.py @@ -27,7 +27,7 @@ def test_forward1(self): def test_forward2(self): octree, data, idx_gt = self.init_data() - data = tf.cast(data.T, tf.uint8) + data = tf.cast(data.T, tf_uints) data = octree_encode_key(data) idx = octree_search_key(data, octree, depth=5, is_xyz=True) with self.cached_session() as sess: @@ -36,7 +36,7 @@ def test_forward2(self): def test_forward3(self): octree, data, idx_gt = self.init_data() - data = tf.cast(data.T, tf.uint8) + data = tf.cast(data.T, tf_uints) data = octree_encode_key(data) key = octree_xyz2key(data) idx = octree_search_key(key, octree, depth=5, is_xyz=False) diff --git a/tensorflow/test/test_points_property.py b/tensorflow/test/test_points_property.py index 2d310b5..7614edc 100644 --- a/tensorflow/test/test_points_property.py +++ b/tensorflow/test/test_points_property.py @@ -1,44 +1,55 @@ +from libs import * import os import sys import numpy as np import tensorflow as tf sys.path.append('..') -from libs import * -import pyoctree - -tf.enable_eager_execution() - -filename1 = '/home/ps/workspace/ocnn-tf/script/logs/seg/0430_run_dataset/00.points' -filename2 = '/home/ps/workspace/ocnn-tf/script/logs/seg/0430_run_dataset/01.points' - -with open(filename1, 'rb') as fid: - points_raw1 = fid.read() -with open(filename2, 'rb') as fid: - points_raw2 = fid.read() -points_raw = [points_raw1, points_raw2] - -tf_xyz = points_property(points_raw, property_name='xyz', channel=4) -tf_label = points_property(points_raw, property_name='label', channel=1) - -points1 = pyoctree.Points() -succ = points1.read_points(filename1) -points2 = pyoctree.Points() -succ = points2.read_points(filename2) - -np_xyz1 = np.array(points1.points()).reshape((-1, 3)) -np_xyz2 = np.array(points2.points()).reshape((-1, 3)) -np_label1 = np.array(points1.labels()).reshape((-1, 1)) -np_label2 = np.array(points2.labels()).reshape((-1, 1)) -np_id1 = np.zeros(np_label1.shape) -np_id2 = np.ones(np_label2.shape) - -np_xyz = np.concatenate( - (np.concatenate((np_xyz1, np_id1), axis=1), - np.concatenate((np_xyz2, np_id2), axis=1)), axis=0).astype(np.float32) -np_label = np.concatenate((np_label1, np_label2), axis=0).astype(np.float32) -eq1 = np.array_equal(np_xyz, tf_xyz.numpy()) -eq2 = np.array_equal(np_label, tf_label.numpy()) -print('Pass xyz test: ', eq1) -print('Pass label test: ', eq2) +class PointsPropertyTest(tf.test.TestCase): + + def test_points_property(self): + points = np.arange(15, dtype=np.float32).reshape([-1, 3]) + index = np.array([[0.0], [0.0], [0.0], [1.0], [1.0]], dtype=np.float32) + points4 = np.concatenate([points, index], axis=1) + normals = np.arange(0, 1.5, 0.1, dtype=np.float32).reshape([-1, 3]) + labels = np.arange(5, dtype=np.float32) + feats = np.arange(10, dtype=np.float32).reshape([-1, 2]) + + # creat points + pts1 = points_new(points[:3, :], normals[:3, :], feats[:3, :], labels[:3]) + pts2 = points_new(points[3:, :], normals[3:, :], feats[3:, :], labels[3:]) + + # # save points + # with open('points1.points', 'wb') as fid: + # fid.write(pts1.numpy()[0]) + # with open('points2.points', 'wb') as fid: + # fid.write(pts2.numpy()[0]) + + # get property + tf_labels = points_property([pts1, pts2], property_name='label', channel=1) + tf_labels = tf.reshape(tf_labels, [-1]) + tf_normals = points_property([pts1, pts2], property_name='normal', channel=3) + tf_pts3 = points_property([pts1, pts2], property_name='xyz', channel=3) + tf_pts4 = points_property([pts1, pts2], property_name='xyz', channel=4) + tf_feats = points_property([pts1, pts2], property_name='feature', channel=2) + + # set property + points_set = -np.arange(9, dtype=np.float32).reshape([-1, 3]) + pts3 = points_set_property(pts1, points_set, property_name='xyz') + tf_points_set = points_property(pts3, property_name='xyz', channel=3) + feats_set = -np.arange(6, dtype=np.float32).reshape([-1, 2]) + tf_feats_set = points_property(pts3, property_name='feature', channel=2) + + with self.cached_session() as sess: + self.assertAllEqual(tf_labels, labels) + self.assertAllEqual(tf_normals, normals) + self.assertAllEqual(tf_pts3, points) + self.assertAllEqual(tf_pts4, points4) + self.assertAllEqual(tf_feats, feats) + self.assertAllEqual(tf_points_set, points_set) + + +if __name__ == "__main__": + os.environ['CUDA_VISIBLE_DEVICES'] = '0' + tf.test.main() diff --git a/tensorflow/util/.DS_Store b/tensorflow/util/.DS_Store deleted file mode 100644 index 8f70269..0000000 Binary files a/tensorflow/util/.DS_Store and /dev/null differ diff --git a/tensorflow/util/convert_grids_tfrecords.py b/tensorflow/util/convert_grids_tfrecords.py deleted file mode 100644 index 9969b10..0000000 --- a/tensorflow/util/convert_grids_tfrecords.py +++ /dev/null @@ -1,103 +0,0 @@ -import os -import argparse -import tensorflow as tf -from random import shuffle - -from make_voxel import read_points_file, make_grid - -parser = argparse.ArgumentParser() -parser.add_argument('--file_dir', type=str, required=True, - help='Base folder containing the data') -parser.add_argument('--list_file', type=str, required=True, - help='File containing the list of data') -parser.add_argument('--records_name', type=str, required=True, - help='Name of tfrecords') -parser.add_argument('--file_type', type=str, required=False, default='data', - help='File type') -parser.add_argument('--shuffle', type=str, required=False, default='', - help='Whether to shuffle the data order') -parser.add_argument('--label_type', type=str, required=False, default='int', - help='If label is int for classification or float for regression') -parser.add_argument('--resolution', type=float, required=False, default=1.0, - help='If label is int for classification or float for regression') -shuffle_data = False - - -def _int64_feature(value): - return tf.train.Feature(int64_list=tf.train.Int64List(value=[value])) - - -def _bytes_feature(value): - return tf.train.Feature(bytes_list=tf.train.BytesList(value=[value])) - - -# QQ add -def _float_feature(value): - return tf.train.Feature(float_list=tf.train.FloatList(value=[value])) - - -def load_octree(file): - with open(file, 'rb') as f: - octree_bytes = f.read() - return octree_bytes - - -def write_data_to_tfrecords(file_dir, list_file, records_name, file_type, label_type='int', resolution = 1.0): - [data, label, index] = get_data_label_pair(list_file, label_type) - - writer = tf.python_io.TFRecordWriter(records_name) - for i in range(len(data)): - if not i % 1000: - print('data loaded: {}/{}'.format(i, len(data))) - - # octree_file = load_octree(os.path.join(file_dir, data[i])) - coords, features = read_points_file(os.path.join(file_dir, data[i])) - grid_string = make_grid(coords, features, grid_resolution=resolution, radius=32.0) - - if label_type == 'int': - feature = {file_type: _bytes_feature(grid_string), - 'label': _int64_feature(label[i]), - 'index': _int64_feature(index[i]), - 'filename': _bytes_feature(('%06d_%s' % (i, data[i])).encode('utf8'))} - else: - feature = {file_type: _bytes_feature(grid_string), - 'label': _float_feature(label[i]), # QQ: add float option - 'index': _int64_feature(index[i]), - 'filename': _bytes_feature(('%06d_%s' % (i, data[i])).encode('utf8'))} - example = tf.train.Example(features=tf.train.Features(feature=feature)) - writer.write(example.SerializeToString()) - writer.close() - - -def get_data_label_pair(list_file, label_tye='int'): - file_list = [] - label_list = [] - with open(list_file) as f: - for line in f: - file, label = line.split() - file_list.append(file) - if label_tye == 'int': # QQ: add float option - label_list.append(int(label)) - else: - label_list.append(float(label)) - index_list = list(range(len(label_list))) - - if shuffle_data: - c = list(zip(file_list, label_list, index_list)) - shuffle(c) - file_list, label_list, index_list = zip(*c) - with open(list_file + '.shuffle.txt', 'w') as f: - for item in c: - f.write('{} {}\n'.format(item[0], item[1])) - return file_list, label_list, index_list - - -if __name__ == '__main__': - args = parser.parse_args() - shuffle_data = args.shuffle - write_data_to_tfrecords(args.file_dir, - args.list_file, - args.records_name, - args.file_type, - args.label_type, # QQ: add float option - args.resolution) diff --git a/tensorflow/util/convert_tfrecords.py b/tensorflow/util/convert_tfrecords.py index ed20cf3..d7b99c6 100644 --- a/tensorflow/util/convert_tfrecords.py +++ b/tensorflow/util/convert_tfrecords.py @@ -22,6 +22,7 @@ def _int64_feature(value): return tf.train.Feature(int64_list=tf.train.Int64List(value=[value])) + def _bytes_feature(value): return tf.train.Feature(bytes_list=tf.train.BytesList(value=[value])) @@ -70,7 +71,7 @@ def get_data_label_pair(list_file, label_tye = 'int'): if label_tye == 'int': # QQ: add float option label_list.append(int(label)) else: - label_list.append(float(label)) + label_list.append(float(label)) index_list = list(range(len(label_list))) if shuffle_data: diff --git a/tensorflow/util/parse_ckpt.py b/tensorflow/util/parse_ckpt.py index b42cc9d..bf4c30f 100644 --- a/tensorflow/util/parse_ckpt.py +++ b/tensorflow/util/parse_ckpt.py @@ -4,30 +4,44 @@ parser = argparse.ArgumentParser() +parser.add_argument('--run', type=str, required=False, default='list_var', + help='The command to run') parser.add_argument('--ckpt', type=str, required=True, help='The path of the ckpt file') parser.add_argument('--skips', type=str, required=False, nargs='*', help="Skip specific variables") +parser.add_argument('--vars', type=str, required=False, nargs='*', + help="The variable names") args = parser.parse_args() -ckpt, skips = args.ckpt, args.skips +ckpt, skips, varis = args.ckpt, args.skips, args.vars if not skips: skips = [] +if not varis: varis = [] -reader = tf.contrib.framework.load_checkpoint(ckpt) -all_vars = tf.contrib.framework.list_variables(ckpt) +def print_var(): + for v in varis: + t = tf.train.load_variable(ckpt, v) + print(v, '\n', t) -total_num = 0 -for idx, var in enumerate(all_vars): - name, shape = var[0], var[1] +def list_var(): + all_vars = tf.train.list_variables(ckpt) + total_num = 0 + for idx, var in enumerate(all_vars): + name, shape = var[0], var[1] - exclude = False - for s in skips: - exclude = s in name - if exclude: break - if exclude: continue + exclude = False + for s in skips: + exclude = s in name + if exclude: + break + if exclude: + continue - shape_str = '; '.join([str(s) for s in shape]) - shape_num = prod(shape) - print("{:3}, {}, [{}], {}".format(idx, name, shape_str, shape_num)) - total_num += shape_num + shape_str = '; '.join([str(s) for s in shape]) + shape_num = prod(shape) + print("{:3}, {}, [{}], {}".format(idx, name, shape_str, shape_num)) + total_num += shape_num -print('Total parameters: {}'.format(total_num)) + print('Total parameters: {}'.format(total_num)) + +if __name__ == '__main__': + eval(args.run + '()') \ No newline at end of file diff --git a/tensorflow/util/prepare_full_voxel_model.py b/tensorflow/util/prepare_full_voxel_model.py deleted file mode 100644 index 9832e61..0000000 --- a/tensorflow/util/prepare_full_voxel_model.py +++ /dev/null @@ -1,23 +0,0 @@ -from tensorflow.python.data.ops import dataset_ops -from tensorflow.python.keras.preprocessing import dataset_utils - -def path_to_tensor(): - pass - -# refer to https://github.com/tensorflow/tensorflow/blob/master/tensorflow/python/keras/preprocessing/image_dataset.py -def paths_and_labels_to_dataset(image_paths, - image_size, - num_channels, - labels, - label_mode, - num_classes, - interpolation): - """Constructs a dataset of images and labels.""" - # TODO(fchollet): consider making num_parallel_calls settable - path_ds = dataset_ops.Dataset.from_tensor_slices(image_paths) - img_ds = path_ds.map( - lambda x: path_to_image(x, image_size, num_channels, interpolation)) - if label_mode: - label_ds = dataset_utils.labels_to_dataset(labels, label_mode, num_classes) - img_ds = dataset_ops.Dataset.zip((img_ds, label_ds)) - return img_ds \ No newline at end of file diff --git a/tensorflow/util/revert_tfrecords.py b/tensorflow/util/revert_tfrecords.py index 6129dbe..f164c7b 100644 --- a/tensorflow/util/revert_tfrecords.py +++ b/tensorflow/util/revert_tfrecords.py @@ -13,10 +13,9 @@ help='Specify the count of the data to extract') parser.add_argument('--file_type', type=str, required=False, default='data', help='File type') -parser.add_argument('--label_type', type=str, required=False, default='float', - help='If label is int for classification or float for regression') -def read_data_from_tfrecords(records_name, output_path, list_file, file_type, count, label_type = 'int'): + +def read_data_from_tfrecords(records_name, output_path, list_file, file_type, count): records_iterator = tf.python_io.tf_record_iterator(records_name) count = count if count != 0 else float('Inf') @@ -27,10 +26,8 @@ def read_data_from_tfrecords(records_name, output_path, list_file, file_type, co example = tf.train.Example() example.ParseFromString(string_record) - if label_type == 'int': - label = int(example.features.feature['label'].int64_list.value[0]) - else: - label = float(example.features.feature['label'].float_list.value[0]) + label = int(example.features.feature['label'].int64_list.value[0]) + # index = int(example.features.feature['index'].int64_list.value[0]) octree = example.features.feature[file_type].bytes_list.value[0] if 'filename' in example.features.feature: filename = example.features.feature['filename'].bytes_list.value[0] \ @@ -55,5 +52,4 @@ def read_data_from_tfrecords(records_name, output_path, list_file, file_type, co args.output_path, args.list_file, args.file_type, - args.count, - args.label_type) + args.count) diff --git a/visualize/.DS_Store b/visualize/.DS_Store deleted file mode 100644 index 4f11359..0000000 Binary files a/visualize/.DS_Store and /dev/null differ diff --git a/visualize/adaptive_octree_opt.py b/visualize/adaptive_octree_opt.py deleted file mode 100644 index a8fc6f2..0000000 --- a/visualize/adaptive_octree_opt.py +++ /dev/null @@ -1,205 +0,0 @@ -# An optimized version of adaptive_octree.py -# reduce the number of points (and lines for output) -# accelerate for loop by multiprocessing. (Can not make it.) - -import numpy as np -import os -import vtk -import operator -from utils import * -import time -import math - - -by_folder = False # if True, all complexes in complex_path will be treated. o.w only single complex with complex_id wull be treated. -in_folder = False # for shell script. assume working directory is already the folder for complex - -complex_path = '/media/data/data_share/pdbbind/refined_set_v2018/' #'../test_set/' #'/media/data/data_share/pdbbind/refined_set_v2018/' #'../test_set/' ## -complex_id = '1a1e' #'1a1e' # when by_folder is False, will handle this single complex -plot_octree = True # if True, we will create non-adaptive version - -plot_adaptive = False # if True, we will create the adaptive version. -light = False # light will associate with plot_adaptive, if true, no vtk files will generated. -protein_flag = False # if True, protein points will be included instead of pocket. - -adaptive_line = True # Now need always be True. -center_by_ligand = True # if True, the ligand will be in center of Cubic. -shift_to_ori = False # if True, the visualization will have same coordinate system with original pdb - -total_depth = 10 # depth of octree -# area1, area2, area3, area4 = 12, 20, 36, 68 #16, 32, 64, 64 # Use for adaptive resolution -target_range = 32 # The area that around the center of ligand -line_depth = 5 # Only plot first line_depth octree division segment lines. -save_folder ='./results' # '/media/data/data_share/OctSurf/vtk_result/' # # The folder to save generated vtk file -differ = False # if True, octree segment line will have different color. ow the same color 0 will be used. -# max_amount = 300 - -# sometimes we want to skip some cases. -skip_list = [ '1a4r', "2y80", '2pjt', '4g17'] # '1a1e', '2pjt', '4g17' finished - -def vtk_from_cubic_dic(cubic_dic, total_depth, complex_id, differ=False, - shift = [0,0,0], save_folder = './results'): - - vtk_line_dic = {} - for i in range(total_depth + 1): - current_depth = total_depth - i - base = target_range*2 / 2 ** current_depth - vtk_dic = {} - color = get_color_for_dep(current_depth + 1, differ) - for key, value in cubic_dic.items(): - [depth, x, y, z] = [int(item) for item in key.split('_')] - coord_x = x * base - target_range - coord_y = y * base - target_range - coord_z = z * base - target_range - min_coord = [coord_x, coord_y, coord_z] - max_coord = [coord_x + base, coord_y + base, coord_z + base] - cubic = Cubic([min_coord, max_coord], key) - cubic.set_color_new(value) - vtk_dic = cubic.load_to_vtk_opt(vtk_dic) - if current_depth < line_depth: # current_depth < depth for all. - vtk_line_dic = cubic.write_oct_line_opt(vtk_line_dic, color) - - if not os.path.isdir('{}/{}/'.format(save_folder, complex_id)): - os.makedirs('{}/{}/'.format(save_folder, complex_id)) - file_name = '{}/{}/{}_Octree_{}_{}'.format(save_folder, complex_id, complex_id, target_range, current_depth) - vtk_writer(vtk_dic=vtk_dic, file_name = file_name, shift = shift) - - if current_depth > 0: - upper_layer_dic = get_upper_layer_dic(cubic_dic) - cubic_dic = upper_layer_dic - - # dept = 0 - color = get_color_for_dep(0, differ) - vtk_line_dic = cubic.write_edge_line_opt(vtk_line_dic, color) - - pts, lines, colors = fill_vtk_lines(vtk_line_dic, shift) - - linesPolyData = vtk.vtkPolyData() - linesPolyData.SetPoints(pts) - linesPolyData.SetLines(lines) - linesPolyData.GetCellData().SetScalars(colors) - - # add for clean data - # cleanFilter = vtk.vtkCleanPolyData() - # cleanFilter.SetInputConnection(linesPolyData) - # cleanFilter.Update() - # mapper = vtk.vtkPolyDataMapper() - # mapper.SetInputConnection(cleanFilter.GetOutputPort()) - - ShellVolmapper = vtk.vtkDataSetMapper() - ShellVolmapper.SetScalarModeToUseCellData() - ShellVolmapper.UseLookupTableScalarRangeOn() - ShellVolmapper.SetInputData(linesPolyData) - ShellVolactor = vtk.vtkActor() - ShellVolactor.SetMapper(ShellVolmapper) - - # modelwriter = vtk.vtkUnstructuredGridWriter() - modelwriter = vtk.vtkDataSetWriter() - modelwriter.SetFileName('{}/{}/{}_segline_{}_{}.vtk'.format(save_folder, complex_id, complex_id, target_range, line_depth)) - # modelwriter.SetInputData(grid) - modelwriter.SetInputData(ShellVolmapper.GetInput()) - modelwriter.Write() - print('Save {}/{}/{}_segline_{}_{}.vtk'.format(save_folder, complex_id, complex_id, target_range, line_depth)) - - -def points_to_vtk_by_id(complex_id, path = '../test_set/', protein_flag = False, - total_depth = 10, line_depth = 10, save_folder = './results'): - # path = path + complex_id +'/' - path = path #+ '/' - #file_names = [path + complex_id + '_protein_pc.ply', path + complex_id + '_ligand_pc.ply'] - file_names = [path + complex_id + '_cdk_pocket.xyz', - path + complex_id + '_cdk_protein.xyz', - path + complex_id + '_cdk_ligand.xyz'] - print(file_names) - - if protein_flag: - x_protein, y_protein, z_protein = read_xyz_file(file_names[1]) - else: - x_protein, y_protein, z_protein = read_xyz_file(file_names[0]) - x_ligand, y_ligand, z_ligand = read_xyz_file(file_names[2]) - - protein_xyz, ligand_xyz, _, center, ligand_center = centerize([x_protein, y_protein, z_protein], - [x_ligand, y_ligand, z_ligand], - by_ligand = center_by_ligand) - if not shift_to_ori: - center = [0,0,0] - [x_protein, y_protein, z_protein], [x_ligand, y_ligand, z_ligand] = protein_xyz, ligand_xyz - del protein_xyz, ligand_xyz - - x_protein, y_protein, z_protein = filter_by_center_range(x_protein, y_protein, z_protein, target_range) - x_ligand, y_ligand, z_ligand = filter_by_center_range(x_ligand, y_ligand, z_ligand, target_range) - - ligand_area = max(max(x_ligand), max(y_ligand), max(z_ligand)) + 7.5 + 2 - ligand_area = math.ceil(ligand_area) - # area1, area2, area3, area4 = ligand_area, ligand_area * 2, min(ligand_area * 4, target_range), min(ligand_area * 8, target_range) - area1, area2, area3, area4 = ligand_area, ligand_area * 2, min(ligand_area * 3, target_range), min(ligand_area * 5, target_range) - - - print('Area: {}, {}, {}, {}'.format(area1, area2, area3, area4)) - - x_protein, y_protein, z_protein = get_vol_index(x_protein, y_protein, z_protein, total_depth, target_range) - x_ligand, y_ligand, z_ligand = get_vol_index(x_ligand, y_ligand, z_ligand, total_depth, target_range) - - time1 = time.time() - cubic_dic = create_cubic_dic([x_protein, y_protein, z_protein], - [x_ligand, y_ligand, z_ligand], total_depth) - del x_protein, y_protein, z_protein, x_ligand, y_ligand, z_ligand - time2 = time.time() - print('Finished create_cubic_dic, time {}s'.format(time2-time1)) - - if not os.path.isdir('{}/{}/'.format(save_folder, complex_id)): - os.makedirs('{}/{}/'.format(save_folder, complex_id)) - time3 = None - if plot_adaptive: - adap_cubics = Adaptive_Cubics(cubic_dic, complex_id, ligand_center, center, adaptive_line, differ) - adap_cubics.get_adaptive_cubic(area1, area2, area3, area4, target_range, line_depth, - total_depth, save_folder, light = light) - del adap_cubics - time3 = time.time() - print('Finished get_adaptive_cubic, time {}s'.format(time3 - time2)) - if plot_octree: - vtk_from_cubic_dic(cubic_dic, total_depth, complex_id, differ, center, save_folder) - time4 = time.time() - if time3 is not None: - diff = time4 - time3 - else: - diff = time4 - time2 - print('Finished vtk_from_cubic_dic, time {}s'.format(diff)) - - -def points_to_vtk_by_folder(path = '../test_set', protein_flag=False, - skip_list = [], save_folder = './results'): - i = 0 - for dir in os.listdir(path): - if dir in skip_list: - continue - if not os.path.isdir(os.path.join(path, dir)): - continue - try: - path = path + dir + '/' - points_to_vtk_by_id(dir, path, protein_flag, save_folder= save_folder) - i += 1 - except FileNotFoundError: - print('not find {}'.format(dir)) - else: - pass - # if i > max_amount: - # break - -if __name__ == "__main__": - if by_folder: - # points_to_vtk_by_folder(skip_list = ["1a1e", "4g17", "3v2w", "2y80", "4prg", "1a4r"]) - points_to_vtk_by_folder(complex_path, protein_flag=protein_flag, skip_list = skip_list) - if in_folder: - path = os.getcwd() - complex_id = path.split('/')[-1] - save_folder = '~/2019_Spring/OctSurf/python/results' - for depth in range(12,13): - print('{}, {}'.format(complex_id, depth)) - points_to_vtk_by_id(complex_id, path= path, protein_flag=protein_flag, total_depth = depth, - line_depth = depth, save_folder = save_folder) - if not by_folder and not in_folder: - path = complex_path + complex_id + '/' - points_to_vtk_by_id(complex_id, path=path, protein_flag=protein_flag, total_depth = total_depth, - line_depth=line_depth, save_folder=save_folder) - diff --git a/visualize/octree_parse.py b/visualize/octree_parse.py deleted file mode 100644 index 8f053a6..0000000 --- a/visualize/octree_parse.py +++ /dev/null @@ -1,80 +0,0 @@ -import sys -import numpy as np -sys.path.insert(0, '/home/qil15006/2020Summer/OCNN_Jun26_2020/octree/build/python') -import pyoctree - -from adaptive_octree_opt import vtk_from_cubic_dic - -pro_lig_flag_pos = 18 -kLeaf_flag = -1 - -def convert_key_to_xyz(key, depth): - xyz = [0,0,0] - for i in range(depth): - for j in range(3): - mask = 1 << (3 * i + 2 - j) - xyz[j] |= (key & mask) >> (2 * i + 2 - j) - return xyz - -def octree_info_to_cubic_dic(depth, node_number, keys, children, features): - cubic_dic = {} - for node_idx_d in range(node_number): - child = children[node_idx_d] - if child == kLeaf_flag: - continue - key = keys[node_idx_d] - xyz = convert_key_to_xyz(key, depth) - [x,y,z] = xyz - key_for_cubic_dic = '{}_{}_{}_{}'.format(depth, x,y,z) - if features[node_idx_d][pro_lig_flag_pos] == 1: - cubic_dic[key_for_cubic_dic] = 'Protein' - elif features[node_idx_d][pro_lig_flag_pos] == 0: - cubic_dic[key_for_cubic_dic] = 'Ligand' - else: - cubic_dic[key_for_cubic_dic] = 'Mixture' - return cubic_dic - - -oct = pyoctree.Octree() -# oct.read_octree("/home/qil15006/2020Summer/OCNN_Jun26_2020/tensorflow/script/input.octree") -# oct.read_octree("/home/qil15006/2020Summer/OCNN_Jun26_2020/octree/build/test_folder_qq/1a1e_points_6_2_001.octree") -# oct.read_octree("/home/qil15006/2020Summer/OCNN_Jun26_2020/octree/build/test_folder_qq/2xnb_points_6_2_000.octree") -# oct.read_octree("/media/data/data_share/pdbbind/CASF-2016/coreset/1z95/octree_folder/1z95_points_5_2_000.octree") -# oct.read_octree("/media/data/data_share/pdbbind/refined_set_v2018/1a1e/octree_folder/1a1e_points_8_2_000.octree") -# oct.read_octree("/home/qil15006/2020Summer/OCNN_Jun26_2020/tensorflow/script/octree_heatmaps/heatmap_1.octree") -oct.read_octree("/media/data/data_share/pdbbind/v2018-other-PL/4ii9/4ii9_points_7_2_000.octree") - - -num_channel = oct.num_channel() - -depth = oct.depth() -features = oct.features(depth) -node_number = oct.num_nodes(depth) -children = oct.children(depth) -keys = oct.keys(depth) - -# non_empty_idx = [] -# coords = [] -# for i in range(len(children)): -# if children[i] >= 0: -# non_empty_idx.append(i) -# x,y,z = convert_key_to_xyz(keys[i], 6) -# coords.append((x,y,z)) -# # coords = np.array(coords) -# -# -# grids_in_oc_count = 0 -# for i in range(len(grids_idx[0])): -# grid_coord = (grids_idx[0][i], grids_idx[1][i], grids_idx[2][i]) -# if grid_coord in coords: -# grids_in_oc_count += 1 -# else: -# print(grid_coord) - - - -features = np.array(features).reshape((num_channel, node_number)) -features = np.swapaxes(features, 0, 1) -cubic_dic = octree_info_to_cubic_dic(depth, node_number, keys, children, features) -vtk_from_cubic_dic(cubic_dic, depth, 'input', differ = False, save_folder = './') - diff --git a/visualize/points_filter.py b/visualize/points_filter.py deleted file mode 100644 index 47cac5e..0000000 --- a/visualize/points_filter.py +++ /dev/null @@ -1,132 +0,0 @@ -import numpy as np -import seaborn as sns -import matplotlib.pyplot as plt - - -def ply_filter(filename, center = None, threshold = None, normalize = False, cut_negative = False, log_norm = False): - points = [] - rewrite_lines = [] - prefix = filename.split('.ply')[0] - with open(filename, 'r') as f: - lines = f.readlines() - check_line = False - for line in lines: - if not check_line: - if 'end_header' not in line: - rewrite_lines.append(line) - continue - else: - check_line = True - rewrite_lines.append(line) - elif len(line) <3: - break - else: - line = line.replace('\n', '') - contents = line.split(' ') - if len(contents) == 7: - contents = contents[:-1] - contents = [float(item) for item in contents] - point = contents[:6] - points.append(point) - - points = np.array(points) - if center is not None: - points[:, :3] *= 32 - points[:, :3] += center - - - plt.figure() - sns.distplot(points[:,3]) - plt.show() - print(points.shape) - - if threshold is not None: - min_thres = np.percentile(points[:, 3], threshold[0]) - max_thres = np.percentile(points[:, 3], threshold[1]) - print(min_thres, max_thres) - flag = np.logical_or(points[:, 3]max_thres) - points = points[flag,:] - - print(points[:, 3].argmax(), points[:, 3].max()) - print(points[:, 3].argmin(), points[:, 3].min()) - print(points.shape) - - if normalize: - # tmp = points[:,3] - # tmp = (tmp - tmp.mean())/tmp.std() - # points[:,3] = tmp - tmp = points[:, 3] - tmp_min = tmp.min() - tmp_max = tmp.max() - print("max {}, min {}".format(tmp_max, tmp_min)) - scale = tmp_max - tmp_min - tmp = (tmp - tmp_min)/scale - points[:, 3:] = tmp.reshape(-1,1) - # points[:, 4] = tmp - # points[:, 5] = tmp - - plt.figure() - sns.distplot(points[:, 3]) - plt.show() - - if cut_negative: - points[points[:,3]<0, 3:] = 0 - if log_norm: - tmp = points[:,3] - top_n_value = np.sort(tmp)[-2] - tmp += 1 - tmp = np.log10(tmp)/np.log10(top_n_value) - tmp[tmp > 1] = 1 - tmp = tmp.reshape((-1,1)) - points[:,3:] = tmp - plt.figure() - sns.distplot(points[:, 3]) - plt.show() - return points, prefix, rewrite_lines - -def write_ply(points, prefix, rewrite_lines): - write_filename = prefix + '_filt.ply' - print(write_filename) - with open(write_filename, 'w') as f: - for line in rewrite_lines: - if 'element vertex'not in line: - f.write(line) - else: - f.write('element vertex {}\n'.format(points.shape[0])) - for i in range(points.shape[0]): - string_list = [str(item) for item in points[i,:]] - f.write(' '.join(string_list) + '\n') - return points - -def ply_to_xyz(points, prefix, threshold=None): - sorted_points = points[points[:, 3].argsort()] - size = sorted_points.shape[0] - write_filename = prefix + '_filt.xyz' - with open(write_filename, 'w') as f: - f.write(str(size) + '\n') - for i in range(size): - string_list = [str(item) for item in points[i, :3]] - if i < size/4: - string_list = ['H'] + string_list - elif i < size/2: - string_list = ['C'] + string_list - elif i< size/4 * 3: - string_list = ['N'] + string_list - else: - string_list = ['O'] + string_list - f.write(' '.join(string_list) + '\n') - pass - -points, prefix, rewrite_lines = ply_filter('../tensorflow/script/ocnn_lrp_results/molecule_heatmap-1.ply', - center = np.array([24.589, 26.7851, 27.4071]), - threshold = None, normalize=False, - cut_negative = False, log_norm=False) -write_ply(points, prefix, rewrite_lines) -# ply_to_xyz(points, prefix, threshold = None) - - -# center -# 2xnb: [24.589, 26.7851, 27.4071] -# 1w40: [37.2144, -0.397999, 12.6513] -# 4djv: [24.5628, 10.4633, 21.5968] -# 3udh: [23.6291, 36.6386, 41.1921] \ No newline at end of file diff --git a/visualize/utils.py b/visualize/utils.py deleted file mode 100644 index 8925f5c..0000000 --- a/visualize/utils.py +++ /dev/null @@ -1,1036 +0,0 @@ -# utils for adaptive_octree_opt.py. - - -import numpy as np -import vtk -import time - -def read_xyz_file(file_name): - with open('{}'.format(file_name), 'r') as data_fid: - points, x, y, z = [], [], [], [] - for row in data_fid.readlines(): - row = row.replace('\n', '') - numbers = row.split(' ') - try: - point_coord = [float(item) for item in numbers[0:3]] - point_x = point_coord[0] - point_y = point_coord[1] - point_z = point_coord[2] - points.append(point_coord) - x.append(point_x) - y.append(point_y) - z.append(point_z) - except ValueError: - print('ValueError: {}, row {}'.format(file_name, row)) - except IndexError: - print('IndexError: {}, row {}'.format(file_name, row)) - else: - pass - return np.array(x), np.array(y), np.array(z) - -def read_feature_file(file_name): - with open('{}'.format(file_name), 'r') as data_fid: - features = [] - for row in data_fid.readlines(): - row = row.replace('\n', '') - row_features = row.split(' ') - try: - row_features = [float(item) for item in row_features] - features.append(row_features) - except ValueError: - print('ValueError: {}, row {}'.format(file_name, row)) - except IndexError: - print('IndexError: {}, row {}'.format(file_name, row)) - else: - pass - return features - -class Point(object): - def __init__(self, coord): - self.coord = coord - self.string = '{}_{}_{}'.format(coord[0], coord[1], coord[2]) - self.order = None - - def get_coord(self): - return self.coord - -class Cubic(object): - """ - A class that describe a cubic in 3D space. - Can detect if this cubic contain points, then spilt into 8 child cubics and plot. - """ - def __init__(self, coord, id): - self.id = id - min_coord = coord[0] - max_coord = coord[1] - self.min_coord = min_coord - self.max_coord = max_coord - self.min_x = min_coord[0] - self.min_y = min_coord[1] - self.min_z = min_coord[2] - self.max_x = max_coord[0] - self.max_y = max_coord[1] - self.max_z = max_coord[2] - - self.dot1 = [self.min_x, self.min_y, self.min_z] - self.dot2 = [self.min_x, self.min_y, self.max_z] - self.dot3 = [self.min_x, self.max_y, self.min_z] - self.dot4 = [self.min_x, self.max_y, self.max_z] - self.dot5 = [self.max_x, self.min_y, self.min_z] - self.dot6 = [self.max_x, self.min_y, self.max_z] - self.dot7 = [self.max_x, self.max_y, self.min_z] - self.dot8 = [self.max_x, self.max_y, self.max_z] - - self.resolution = self.max_z - self.min_z - self.mid_point = [(self.min_x + self.max_x)/2, (self.min_y + self.max_y)/2, (self.min_z + self.max_z)/2] - - def set_color_new(self, value): - if value == 'Protein': - self.color = [.4, .4, 1, 1] - self.color_scale = 11 - elif value == 'Ligand': - self.color = [.4, 1, .4, 1] - self.color_scale = 12 - elif value == 'Mixture': - self.color = [.4, 1, 1, 1] - self.color_scale = 13 - elif value == 'Empty': - self.color = [1, 1, 1, 1] - self.color_scale = 14 - else: - print('error in assign color') - - def member_test(self, points): - if points[0] >= self.min_x and points[0] <= self.max_x and \ - points[1] >= self.min_y and points[1] <= self.max_y and \ - points[2] >= self.min_z and points[2] <= self.max_z: - return True - else: - return False - - def load_to_vtk(self, vtk_dic): - if 'points' not in vtk_dic: - vtk_dic['points'] = [] - vtk_dic['num_points'] = 0 - vtk_dic['cells'] = [] - vtk_dic['num_cells'] = 0 - vtk_dic['cell_color_scale'] = [] - - vtk_dic['Ligand'] = 0 - vtk_dic['Protein'] = 0 - vtk_dic['Mixture'] = 0 - vtk_dic['Empty'] = 0 - - vtk_dic['points'] += [self.dot1, self.dot2, self.dot3, self.dot4, self.dot5, self.dot6, self.dot7, self.dot8] - index_start = vtk_dic['num_points'] - - # use all 6 surfaces as cells. - new_cells = [[4, 0 + index_start, 1 + index_start, 3 + index_start, 2 + index_start], - [4, 4 + index_start, 5 + index_start, 7 + index_start, 6 + index_start], - [4, 0 + index_start, 4 + index_start, 6 + index_start, 2 + index_start], - [4, 2 + index_start, 6 + index_start, 7 + index_start, 3 + index_start], - [4, 3 + index_start, 7 + index_start, 5 + index_start, 1 + index_start], - [4, 0 + index_start, 4 + index_start, 5 + index_start, 1 + index_start]] - vtk_dic['cells'] += new_cells - vtk_dic['num_cells'] += 6 - for i in range(6): - vtk_dic['cell_color_scale'].append(self.color_scale) - - if self.color_scale == 11: - vtk_dic['Protein'] += 1 - elif self.color_scale == 12: - vtk_dic['Ligand'] += 1 - elif self.color_scale == 13: - vtk_dic['Mixture'] += 1 - elif self.color_scale == 14: - vtk_dic['Empty'] += 1 - - vtk_dic['num_points'] += 8 - if len(vtk_dic['points']) != vtk_dic['num_points']: - print('points error') - print(len(vtk_dic['points']), vtk_dic['num_points']) - if len(vtk_dic['cells']) != vtk_dic['num_cells']: - print('cell error') - return vtk_dic - - # print('number of ligand cells: {}'.format(vtk_dic['ligand'])) - # print('number of pocket cells: {}'.format(vtk_dic['pocket'])) - # print('number of mix cells: {}'.format(vtk_dic['mix'])) - # print('number of empty cells: {}'.format(vtk_dic['empty'])) - # print('number of total cells: {}'.format(vtk_dic['ligand'] + vtk_dic['pocket'] + vtk_dic['mix'] + vtk_dic['empty'])) - - def load_to_vtk_opt(self, vtk_dic_opt): - if 'points' not in vtk_dic_opt: - vtk_dic_opt['points'] = {} - vtk_dic_opt['num_points'] = 0 - vtk_dic_opt['cells'] = [] - vtk_dic_opt['num_cells'] = 0 - vtk_dic_opt['cell_color_scale'] = [] - - vtk_dic_opt['Ligand'] = 0 - vtk_dic_opt['Protein'] = 0 - vtk_dic_opt['Mixture'] = 0 - vtk_dic_opt['Empty'] = 0 - - # current_cubic_points = [self.dot1, self.dot2, self.dot3, self.dot4, self.dot5, self.dot6, self.dot7, self.dot8] - current_cubic_cells = [[self.dot1, self.dot2, self.dot4, self.dot3], - [self.dot5, self.dot6, self.dot8, self.dot7], - [self.dot1, self.dot5, self.dot7, self.dot3], - [self.dot3, self.dot7, self.dot8, self.dot4], - [self.dot4, self.dot8, self.dot6, self.dot2], - [self.dot1, self.dot5, self.dot6, self.dot2]] - - for cell in current_cubic_cells: - cell_order = [] - for point in cell: - point = Point(point) - if point.string in vtk_dic_opt['points']: - point_order = vtk_dic_opt['points'][point.string] - cell_order.append(point_order) - else: - point_order = len(vtk_dic_opt['points']) - vtk_dic_opt['points'][point.string] = point_order - cell_order.append(point_order) - vtk_dic_opt['cells'].append(cell_order) - vtk_dic_opt['cell_color_scale'].append(self.color_scale) - - vtk_dic_opt['num_cells'] += 6 - if self.color_scale == 11: - vtk_dic_opt['Protein'] += 1 - elif self.color_scale == 12: - vtk_dic_opt['Ligand'] += 1 - elif self.color_scale == 13: - vtk_dic_opt['Mixture'] += 1 - elif self.color_scale == 14: - vtk_dic_opt['Empty'] += 1 - else: - print('Cubic {} have no color scale settled.'.format(self.id)) - - if len(vtk_dic_opt['cells']) != vtk_dic_opt['num_cells']: - print('cell error') - return vtk_dic_opt - - def write_oct_line_opt(self, vtk_line_dic, color): - """ - :param pts_dic: {key, value}, where key is Point.string, value is order of the point. - :param lines_list: - :param colors_list: - :param color: - :return: - """ - if len(vtk_line_dic) == 0: - vtk_line_dic['pts_dic'] = {} - vtk_line_dic['lines_dic'] = {} - vtk_line_dic['colors_list'] = [] - pts_dic = vtk_line_dic['pts_dic'] - lines_dic = vtk_line_dic['lines_dic'] - colors_list = vtk_line_dic['colors_list'] - - pts_len = len(pts_dic) - pts_inc = 0 - - p0 = [self.min_x, (self.min_y + self.max_y) / 2, (self.min_z + self.max_z) / 2] - p1 = [self.max_x, (self.min_y + self.max_y) / 2, (self.min_z + self.max_z) / 2] - p2 = [(self.min_x + self.max_x) / 2, self.min_y, (self.min_z + self.max_z) / 2] - p3 = [(self.min_x + self.max_x) / 2, self.max_y, (self.min_z + self.max_z) / 2] - p4 = [(self.min_x + self.max_x) / 2, (self.min_y + self.max_y) / 2, self.min_z] - p5 = [(self.min_x + self.max_x) / 2, (self.min_y + self.max_y) / 2, self.max_z] - - p6 = [self.min_x, (self.min_y + self.max_y) / 2, self.min_z] - p7 = [self.min_x, (self.min_y + self.max_y) / 2, self.max_z] - p8 = [self.min_x, self.min_y, (self.min_z + self.max_z) / 2] - p9 = [self.min_x, self.max_y, (self.min_z + self.max_z) / 2] - - p10 = [(self.min_x + self.max_x) / 2, self.min_y, self.min_z] - p11 = [(self.min_x + self.max_x) / 2, self.min_y, self.max_z] - p12 = [(self.min_x + self.max_x) / 2, self.max_y, self.min_z] - p13 = [(self.min_x + self.max_x) / 2, self.max_y, self.max_z] - - p14 = [self.max_x, (self.min_y + self.max_y) / 2, self.min_z] - p15 = [self.max_x, (self.min_y + self.max_y) / 2, self.max_z] - p16 = [self.max_x, self.min_y, (self.min_z + self.max_z) / 2] - p17 = [self.max_x, self.max_y, (self.min_z + self.max_z) / 2] - - line_list = [[p0, p1], [p2,p3], [p4, p5], [p6, p7], [p8, p9], [p14, p15], [p16, p17], - [p8, p16], [p10, p11], [p9, p17], [p12, p13], [p11, p13], [p7, p15], - [p6, p14], [p10, p12]] - - for line in line_list: - start_point = Point(line[0]) - end_point = Point(line[1]) - if start_point.string in pts_dic and end_point.string in pts_dic: - start_point_order = pts_dic[start_point.string] - end_point_order = pts_dic[end_point.string] - elif start_point.string not in pts_dic and end_point.string in pts_dic: - start_point_order = pts_len + pts_inc - pts_dic[start_point.string] = start_point_order - pts_inc += 1 - end_point_order = pts_dic[end_point.string] - elif start_point.string in pts_dic and end_point.string not in pts_dic: - end_point_order = pts_len + pts_inc - pts_dic[end_point.string] = end_point_order - pts_inc += 1 - start_point_order = pts_dic[start_point.string] - else: - start_point_order = pts_len + pts_inc - pts_dic[start_point.string] = start_point_order - pts_inc += 1 - end_point_order = pts_len + pts_inc - pts_dic[end_point.string] = end_point_order - pts_inc += 1 - line_string = '{}_{}'.format(start_point_order, end_point_order) - if line_string not in lines_dic: - lines_dic[line_string] = len(lines_dic) - colors_list.append(color) - - vtk_line_dic['pts_dic'] = pts_dic - vtk_line_dic['lines_dic'], vtk_line_dic['colors_list'] = lines_dic, colors_list - - return vtk_line_dic - - def write_edge_line_opt(self, vtk_line_dic, color): - if 'pts_dic' not in vtk_line_dic: - vtk_line_dic['pts_dic'] = {} - vtk_line_dic['lines_dic'] = {} - vtk_line_dic['colors_list'] = [] - pts_dic = vtk_line_dic['pts_dic'] - lines_dic, colors_list = vtk_line_dic['lines_dic'], vtk_line_dic['colors_list'] - pts_len = len(pts_dic) - pts_inc = 0 - - p0 = self.dot1 #= [self.min_x, self.min_y, self.min_z] - p1 = self.dot2 #= [self.min_x, self.min_y, self.max_z] - p2 = self.dot3 #= [self.min_x, self.max_y, self.min_z] - p3 = self.dot4 #= [self.min_x, self.max_y, self.max_z] - p4 = self.dot5 #= [self.max_x, self.min_y, self.min_z] - p5 = self.dot6 #= [self.max_x, self.min_y, self.max_z] - p6 = self.dot7 #= [self.max_x, self.max_y, self.min_z] - p7 = self.dot8 #= [self.max_x, self.max_y, self.max_z] - - line_list = [[p0,p1], [p1,p3], [p2,p3], [p0,p2], [p4,p5], [p5,p7], [p6,p7], [p4,p6], - [p0,p4], [p2,p6], [p3,p7], [p1,p5]] - - for line in line_list: - start_point = Point(line[0]) - end_point = Point(line[1]) - if start_point.string in pts_dic and end_point.string in pts_dic: - start_point_order = pts_dic[start_point.string] - end_point_order = pts_dic[end_point.string] - elif start_point.string not in pts_dic and end_point.string in pts_dic: - start_point_order = pts_len + pts_inc - pts_dic[start_point.string] = start_point_order - pts_inc += 1 - end_point_order = pts_dic[end_point.string] - elif start_point.string in pts_dic and end_point.string not in pts_dic: - end_point_order = pts_len + pts_inc - pts_dic[end_point.string] = end_point_order - pts_inc += 1 - start_point_order = pts_dic[start_point.string] - else: - start_point_order = pts_len + pts_inc - pts_dic[start_point.string] = start_point_order - pts_inc += 1 - end_point_order = pts_len + pts_inc - pts_dic[end_point.string] = end_point_order - pts_inc += 1 - line_string = '{}_{}'.format(start_point_order, end_point_order) - if line_string not in lines_dic: - lines_dic[line_string] = len(lines_dic) - colors_list.append(color) - vtk_line_dic['pts_dic'] = pts_dic - vtk_line_dic['lines_dic'], vtk_line_dic['colors_list'] = lines_dic, colors_list - return vtk_line_dic - -class Adaptive_Cubics(object): - def __init__(self, cubic_dic, complex_id, focus_center = [0,0,0], center = [0,0,0], - adaptive_line = True, differ = False, - count = False): - self.cubic_dic = cubic_dic - self.complex_id = complex_id - self.differ = differ - self.adaptive_line = adaptive_line - self.focus_center = focus_center - self.center = center - self.count = count - - def get_adaptive_cubic(self, core_area, side_area1, side_area2, side_area3, - target_range, line_depth, total_depth, save_folder, light = False): - """ - :param core_area: the range core area that need the finest resolution - :param side_area1: the range side area that need less resolution - :param side_area2: more range side area that need much less resolution - :return: - """ - self.vtk_dic = {} - self.fine_cubic_id_set = set() - self.parent_cubic_id_set = set() - - self.fine_cubic_count = {} - # self.non_fine_cubic_id_set = set() - - for value in ['Protein', 'Ligand', 'Mixture', 'Empty']: - self.fine_cubic_count[value] = 0 - - side1_layer_dic = self.construct_adaptive_dic_V1(self.cubic_dic, core_area, - target_range, self.focus_center, light) - side2_layer_dic = self.construct_adaptive_dic_V1(side1_layer_dic, side_area1, - target_range, self.focus_center, light) - side3_layer_dic = self.construct_adaptive_dic_V1(side2_layer_dic, side_area2, - target_range, self.focus_center, light) - side4_layer_dic = self.construct_adaptive_dic_V1(side3_layer_dic, side_area3, - target_range, self.focus_center, light) - side5_layer_dic = self.construct_adaptive_dic_V1(side4_layer_dic, target_range, - target_range, self.focus_center, light) - - print('Fine Cubic Dic Length: {}'.format(len(self.fine_cubic_id_set))) - # add for adaptive count: - # count_cubic_id_set = set() - # parent_cubic_id_set = set() - - if self.adaptive_line: - segline_cubic_id_set = set() - vtk_line_dic = {} - for cubic_id in self.fine_cubic_id_set: - # if not light: - # segline_cubic_id_set.add(cubic.id) # why need this? - # pass - # self.get_complement_adaptive_id(cubic_id, count_cubic_id_set, target_range) - parent_cubic_id = get_parent_cubic_id(cubic_id, target_range) - if parent_cubic_id in self.fine_cubic_id_set: - print('Parent and Fine conflict: {}'.format(parent_cubic_id)) - - while int(parent_cubic_id.split('_')[0]) >= 0: - # self.get_complement_adaptive_id(parent_cubic_id, parent_cubic_id_set, target_range) - # parent_cubic_set.add(parent_cubic) - # self.get_complement_adaptive(parent_cubic, count_cubic_set, target_range) - if int(parent_cubic_id.split('_')[0]) < line_depth: - segline_cubic_id_set.add(parent_cubic_id) - parent_cubic_id = get_parent_cubic_id(parent_cubic_id, target_range) - - if not light: - # for parent_cubic_id in parent_cubic_id_set: - # if int(parent_cubic_id.split('_')[0]) < line_depth: - # segline_cubic_id_set.add(parent_cubic_id) - print('parent_cubic_id_set length: {}'.format(len(self.parent_cubic_id_set))) - print('segline_cubic_id_set: {}'.format(len(segline_cubic_id_set))) - for cubic_id in segline_cubic_id_set: - depth = int(cubic_id.split('_')[0]) - color = get_color_for_dep(depth + 1, self.differ) - cubic = cubic_id_to_cubic(cubic_id, target_range) - vtk_line_dic = cubic.write_oct_line_opt(vtk_line_dic, color) - - max_cubic = Cubic( - [[-target_range, -target_range, -target_range], [target_range, target_range, target_range]], - '0_0_0_0') - color = get_color_for_dep(0, self.differ) - vtk_line_dic = max_cubic.write_edge_line_opt(vtk_line_dic, color) - - pts, lines, colors = fill_vtk_lines(vtk_line_dic, self.center) - write_seg_vtk(pts, lines, colors, self.complex_id, target_range, line_depth, save_folder) - - # - # for cubic_id in self.parent_cubic_id_set: - # if cubic_id not in segline_cubic_id_set: - # print('parent cubic {} not in segline_cubic_id_set'.format(cubic_id)) - - print('Final Node: {}'.format(len(self.fine_cubic_id_set))) - print('Mid Node: {}'.format(len(segline_cubic_id_set))) - - if not light: - file_name = '{}/{}/{}_Octree_Adaptive_{}_{}'.format(save_folder, self.complex_id, self.complex_id, target_range, total_depth) - vtk_writer(vtk_dic=self.vtk_dic, file_name=file_name, shift=self.center) - - def get_adaptive_count(self,core_area, side_area1, side_area2, side_area3, - target_range, line_depth, total_depth, save_folder, light = False): - depth_cubic_dic = {} - for depth in range(0, total_depth + 1): - depth_cubic_dic[depth] = set() - for cubic_id, value in self.cubic_dic: - [depth, x, y, z] = [int(item) for item in cubic_id.split('_')] - while depth >= 0: - depth_cubic_dic[depth].add(cubic_id) - depth = depth - 1 - x >> 1 - y >> 1 - z >> 1 - cubic_id = '{}_{}_{}_{}'.format(depth, x, y, z) - - - - - - - - def get_complement_adaptive_id(self, cubic_id, count_cubic_id_set, target_range): - [depth, x, y, z] = [int(item) for item in cubic_id.split('_')] - if depth <= 0: - count_cubic_id_set.add(cubic_id) - return - x = x >> 1 << 1 - y = y >> 1 << 1 - z = z >> 1 << 1 - - for i in range(0, 2): - for j in range(0, 2): - for k in range(0, 2): - string = '{}_{}_{}_{}'.format(depth, x + i, y + j, z + k) - - # base = target_range * 2 / 2 ** depth - # coord_x = x * base - target_range + i - # coord_y = y * base - target_range + j - # coord_z = z * base - target_range + k - # min_coord = [coord_x, coord_y, coord_z] - # max_coord = [coord_x + base, coord_y + base, coord_z + base] - # comp_cubic = Cubic([min_coord, max_coord], string) - # count_cubic_set.add(comp_cubic) - count_cubic_id_set.add(string) - - def construct_adaptive_dic_V1(self, cubic_dic, area, target_range, - focus_center=[0, 0, 0], light=False): - ''' - :param cubic_dic: dictionary, key is cubic.id, value is Protein, Mixture, Ligand. - :param area: within this area, use current depth in cubic_dic, otherwise need to compute upper layer - :param vtk_dic: dictionary that used to plot cubic. - :param seg_dic: dictionary that used to plot segment line of adaptive cibics. - :return: - ''' - - side_dic = {} - for key, value in cubic_dic.items(): - [depth, x, y, z] = [int(item) for item in key.split('_')] - - # if cubic's parent in the core range, the all child of its parent should be in fine_cubic_set. - p_x = x >> 1 - p_y = y >> 1 - p_z = z >> 1 - p_depth = depth - 1 - - p_base = target_range * 2 / 2 ** p_depth - p_coord_x = p_x * p_base - target_range - p_coord_y = p_y * p_base - target_range - p_coord_z = p_z * p_base - target_range - [focus_x, focus_y, focus_z] = focus_center - - # test if this cubic is in core area, if so, dump into adaptive cubic_dic - core_flag_z = min(abs(p_coord_z - focus_z), abs(p_coord_z + p_base - focus_z)) <= area - core_flag_y = min(abs(p_coord_y - focus_y), abs(p_coord_y + p_base - focus_y)) <= area - core_flag_x = min(abs(p_coord_x - focus_x), abs(p_coord_x + p_base - focus_x)) <= area - core_flag = core_flag_x and core_flag_y and core_flag_z - - p_id = '{}_{}_{}_{}'.format(p_depth, p_x, p_y, p_z) - - if not core_flag: - if p_id not in side_dic: - side_dic[p_id] = value - elif value != side_dic[p_id]: - side_dic[p_id] = 'Mixture' - else: - pass - - else: - self.parent_cubic_id_set.add(p_id) - # self.non_fine_cubic_id_set.add(p_id) - b_x = p_x << 1 - b_y = p_y << 1 - b_z = p_z << 1 - for i in range(0, 2): - for j in range(0, 2): - for k in range(0, 2): - n_x = b_x + i - n_y = b_y + j - n_z = b_z + k - n_id = '{}_{}_{}_{}'.format(depth, n_x, n_y, n_z) - - if n_id in self.parent_cubic_id_set: - continue - if n_id in self.fine_cubic_id_set: - continue - self.fine_cubic_id_set.add(n_id) - - if n_id in cubic_dic: - base = target_range * 2 / 2 ** depth - n_coord_x = n_x * base - target_range - n_coord_y = n_y * base - target_range - n_coord_z = n_z * base - target_range - min_coord = [n_coord_x, n_coord_y, n_coord_z] - max_coord = [n_coord_x + base, n_coord_y + base, n_coord_z + base] - n_cubic = Cubic([min_coord, max_coord], n_id) - n_value = cubic_dic[n_cubic.id] - n_cubic.set_color_new(value) - if not light: - self.vtk_dic = n_cubic.load_to_vtk_opt(self.vtk_dic) - self.fine_cubic_count[n_value] += 1 - else: - self.fine_cubic_count['Empty'] += 1 - #cubic.set_color_new('Empty') - pass - return side_dic - -def cubic_id_to_cubic(id, target_range): - ''' - based on id, target range, the cubic is identicle. - :param id: - :param target_range: - :return: - ''' - [depth, x, y, z] = [int(item) for item in id.split('_')] - # (depth, x, y, z) = id - base = target_range * 2 / 2 ** depth - coord_x = x * base - target_range - coord_y = y * base - target_range - coord_z = z * base - target_range - min_coord = [coord_x, coord_y, coord_z] - max_coord = [coord_x + base, coord_y + base, coord_z + base] - return Cubic([min_coord, max_coord], id) - -def point_string_to_coord(string): - coord = string.split('_') - return [float(item) for item in coord] - -def write_seg_vtk(pts, lines, colors, complex_id, target_range, line_depth, save_folder): - linesPolyData = vtk.vtkPolyData() - linesPolyData.SetPoints(pts) - linesPolyData.SetLines(lines) - linesPolyData.GetCellData().SetScalars(colors) - - # clean = vtk.vtkCleanPolyData() - # clean.SetInputConnection(linesPolyData) - # clean.Update() - # pd = clean.GetOutput() - - # print('clean segline_Adaptive data.') - # then = time.time() - # # pd = linesPolyData.getPolyData() - # # clean = vtk.vtkCleanPolyData() - # # clean.SetInput(linesPolyData) - # # clean.Update() - # # pd = clean.GetOutput() - # - # # clean = vtk.vtkCleanPolyData() - # # clean.SetInputConnection(linesPolyData) - # # clean.Update() - # # pd = clean.GetOutput() - # - # now = time.time() - # diff = int(now - then) - # print('clean segline_Adaptive data done. spend {} seconds'.format(diff)) - - ShellVolmapper = vtk.vtkDataSetMapper() - ShellVolmapper.SetScalarModeToUseCellData() - ShellVolmapper.UseLookupTableScalarRangeOn() - # ShellVolmapper.SetLookupTable(lut) - ShellVolmapper.SetInputData(linesPolyData) - ShellVolactor = vtk.vtkActor() - ShellVolactor.SetMapper(ShellVolmapper) - - # modelwriter = vtk.vtkUnstructuredGridWriter() - modelwriter = vtk.vtkDataSetWriter() - modelwriter.SetFileName('{}/{}/{}_segline_Adaptive_{}_{}.vtk'.format(save_folder, complex_id, complex_id, - target_range, line_depth)) - # modelwriter.SetInputData(grid) - modelwriter.SetInputData(ShellVolmapper.GetInput()) - modelwriter.Write() - print('Save {}/{}/{}_segline_Adaptive_{}_{}.vtk'.format(save_folder, complex_id, complex_id, target_range, line_depth)) - -def get_parent_cubic(cubic, target_range): - id = cubic.id - [depth, x, y, z] = [int(item) for item in id.split('_')] - x = x >> 1 - y = y >> 1 - z = z >> 1 - depth -= 1 - base = target_range * 2 / 2 ** depth - coord_x = x * base - target_range - coord_y = y * base - target_range - coord_z = z * base - target_range - min_coord = [coord_x, coord_y, coord_z] - max_coord = [coord_x + base, coord_y + base, coord_z + base] - string = '{}_{}_{}_{}'.format(depth, x, y, z) - parent_cubic = Cubic([min_coord, max_coord], string) - return parent_cubic - -def get_parent_cubic_id(id, target_range): - [depth, x, y, z] = [int(item) for item in id.split('_')] - x = x >> 1 - y = y >> 1 - z = z >> 1 - depth -= 1 - # base = target_range * 2 / 2 ** depth - # coord_x = x * base - target_range - # coord_y = y * base - target_range - # coord_z = z * base - target_range - # min_coord = [coord_x, coord_y, coord_z] - # max_coord = [coord_x + base, coord_y + base, coord_z + base] - parent_id = '{}_{}_{}_{}'.format(depth, x, y, z) - # parent_cubic = Cubic([min_coord, max_coord], string) - return parent_id - -def get_color_for_dep(depth, differ = True): - # need to be different with the volume scaler (0,1,2,3). - if differ == False: - color = 0 - return color - if depth == 0: - color = 0 #[0, 0, 0] # white - elif depth == 1: - color = 1 # [255, 0, 0] # red - elif depth == 2: - color = 2 # [255, 128, 0] - elif depth == 3: - color = 3 #[255,255,0] - elif depth == 4: - color = 4 # [0, 255, 0] - elif depth == 5: - color = 5 #[0, 255, 255] - elif depth == 6: - color = 6 #[0, 0, 255] - elif depth == 7: - color = 7 # [255, 0 , 255] - elif depth == 8 : - color = 8 - else: - color = 9 - return color - -# A better way is use class in vtk package, this solve the color issue to distinguish ligand, pocket. -def vtk_writer(vtk_dic, file_name, shift = [0,0,0]): - points = vtk.vtkPoints() - grid = vtk.vtkUnstructuredGrid() - Color = vtk.vtkFloatArray() - Scale = vtk.vtkFloatArray() - - sorted_dic = sorted(vtk_dic['points'].items(), key=lambda x: x[1]) - pts = vtk.vtkPoints() - for item in sorted_dic: - # pts.InsertNextPoint(point_string_to_coord(item[0])) - coord = point_string_to_coord(item[0]) - coord = [coord[0] + shift[0], coord[1] + shift[1], coord[2] + shift[2]] - pts.InsertNextPoint(coord) - grid.SetPoints(pts) - - # for vtk_point in vtk_dic['points']: - # Coord = vtk_point - # test = points.InsertNextPoint(*Coord) - # #Color.InsertTuple1(test, 0) - # grid.SetPoints(points) - - for i in range(len(vtk_dic['cells'])): - vtk_node = vtk_dic['cells'][i] - elem = vtk.vtkQuad() - elem.GetPointIds().SetId(0, vtk_node[0]) - elem.GetPointIds().SetId(1, vtk_node[1]) - elem.GetPointIds().SetId(2, vtk_node[2]) - elem.GetPointIds().SetId(3, vtk_node[3]) - Quad4cell = grid.InsertNextCell(elem.GetCellType(), elem.GetPointIds()) - color = vtk_dic['cell_color_scale'][i] - Color.InsertTuple1(Quad4cell, color) - - lut = vtk.vtkLookupTable() - lut.SetNumberOfTableValues(5) - lut.SetTableRange(0, 5) - lut.Build() - lut.SetTableValue(0, 0, 0, 0, 1) # Black - lut.SetTableValue(1, 1, 0, 0, 1) # Red - lut.SetTableValue(2, 0, 1, 0, 1) # Green - lut.SetTableValue(3, 0, 0, 1, 1) # Blue - lut.SetTableValue(4, 1, 1, 1, 1) # White - - grid.GetCellData().SetScalars(Color) - ShellVolmapper = vtk.vtkDataSetMapper() - # ShellVolmapper = vtk.vtkUnstructuredGridVolumeRayCastMapper() - ShellVolmapper.SetScalarModeToUseCellData() - ShellVolmapper.UseLookupTableScalarRangeOn() - ShellVolmapper.SetLookupTable(lut) - ShellVolmapper.SetInputData(grid) - ShellVolactor = vtk.vtkActor() - ShellVolactor.SetMapper(ShellVolmapper) - - modelwriter = vtk.vtkUnstructuredGridWriter() - modelwriter.SetFileName('{}.vtk'.format(file_name)) - #modelwriter.SetInputData(grid) - modelwriter.SetInputData(ShellVolmapper.GetInput()) - modelwriter.Write() - print('Save {}.vtk'.format(file_name)) - - -def construct_adaptive_dic(cubic_dic, area, vtk_dic, fine_cubic_set, target_range, - focus_center = [0,0,0], light =False): - ''' - :param cubic_dic: dictionary, key is cubic.id, value is Protein, Mixture, Ligand. - :param area: within this area, use current depth in cubic_dic, otherwise need to compute upper layer - :param vtk_dic: dictionary that used to plot cubic. - :param seg_dic: dictionary that used to plot segment line of adaptive cibics. - :return: - ''' - side_dic = {} - for key, value in cubic_dic.items(): - [depth, x, y, z] = [int(item) for item in key.split('_')] - base = target_range * 2 / 2 ** depth - coord_x = x * base - target_range - coord_y = y * base - target_range - coord_z = z * base - target_range - min_coord = [coord_x, coord_y, coord_z] - max_coord = [coord_x + base, coord_y + base, coord_z + base] - [focus_x, focus_y, focus_z] = focus_center - - # test if this cubic is in core area, if so, dump into adaptive cubic_dic - core_flag_z = min(abs(coord_z - focus_z), abs(coord_z + base - focus_z)) <= area - core_flag_y = min(abs(coord_y - focus_y), abs(coord_y + base - focus_y)) <= area - core_flag_x = min(abs(coord_x - focus_x), abs(coord_x + base - focus_x)) <= area - core_flag = core_flag_x and core_flag_y and core_flag_z - - # find parent cubic or upper layer cubic. - # parent cubic for adaptive segment line, upper layer cubic for cubic plot. - x = x >> 1 - y = y >> 1 - z = z >> 1 - depth -= 1 - string = '{}_{}_{}_{}'.format(depth, x, y, z) - - if core_flag: - cubic = Cubic([min_coord, max_coord], key) - cubic.set_color_new(value) - if not light: - vtk_dic = cubic.load_to_vtk_opt(vtk_dic) - fine_cubic_set.add(cubic) - else: - if string not in side_dic: - side_dic[string] = value - elif value != side_dic[string]: - side_dic[string] = 'Mixture' - else: - pass - return side_dic - - - - -def centerize(pocket_xyz, ligand_xyz, by_ligand = True, protein_xyz = None): - if by_ligand: - [x, y, z] = ligand_xyz - center_x, center_y, center_z = x.mean(), y.mean(), z.mean() - x, y, z = x - center_x, y - center_y, z - center_z - ligand_xyz = [x, y, z] - [x, y, z] = pocket_xyz - x, y, z = x - center_x, y - center_y, z - center_z - pocket_xyz = [x, y, z] - ligand_center = [0, 0, 0] - center = [center_x, center_y, center_z] - - if protein_xyz is not None: - [x, y, z] = protein_xyz - x, y, z = x - center_x, y - center_y, z - center_z - protein_xyz = [x, y, z] - - else: - [x_ligand, y_ligand, z_ligand] = ligand_xyz - x_ligand_max, y_ligand_max, z_ligand_max = x_ligand.max(), y_ligand.max(), z_ligand.max() - x_ligand_min, y_ligand_min, z_ligand_min = x_ligand.min(), y_ligand.min(), z_ligand.min() - if protein_xyz is None: - [x_pocket, y_pocket, z_pocket] = pocket_xyz - x_protein_max, y_protein_max, z_protein_max = x_pocket.max(), y_pocket.max(), z_pocket.max() - x_protein_min, y_protein_min, z_protein_min = x_pocket.min(), y_pocket.min(), z_pocket.min() - else: - [x_protein, y_protein, z_protein] = protein_xyz - x_protein_max, y_protein_max, z_protein_max = x_protein.max(), y_protein.max(), z_protein.max() - x_protein_min, y_protein_min, z_protein_min = x_protein.min(), y_protein.min(), z_protein.min() - x_max, y_max, z_max = max(x_ligand_max, x_protein_max), max(y_ligand_max, y_protein_max), max(z_ligand_max, z_protein_max) - x_min, y_min, z_min = min(x_ligand_min, x_protein_min), min(y_ligand_min, y_protein_min), min(z_ligand_min, z_protein_min) - center = [(x_max+x_min)/2, (y_max+y_min)/2, (z_max+z_min)/2] - ligand_center = [x_ligand.mean() - center[0], y_ligand.mean() - center[1], z_ligand.mean()- center[2]] - ligand_xyz = [ligand_xyz[0] - center[0], ligand_xyz[1] - center[1], ligand_xyz[2] - center[2]] - pocket_xyz = [pocket_xyz[0] - center[0], pocket_xyz[1] - center[1], pocket_xyz[2] - center[2]] - if protein_xyz is not None: - [x, y, z] = protein_xyz - x, y, z = x - center[0], y - center[1], z - center[2] - protein_xyz = [x, y, z] - - return pocket_xyz, ligand_xyz, protein_xyz, center, ligand_center - -def filter_by_center_range(x, y, z, target_range, feature=None): # Here x, y, z is list - x = np.array(x) - y = np.array(y) - z = np.array(z) - - min_x, min_y, min_z = -target_range, -target_range, -target_range - max_x, max_y, max_z = target_range, target_range, target_range - - flags_x = np.logical_and(x > min_x, x < max_x) - flags_y = np.logical_and(y > min_y, y < max_y) - flags_z = np.logical_and(z > min_z, z < max_z) - flag1 = np.logical_and(flags_x, flags_y) - flag2 = np.logical_and(flag1, flags_z) - x = x[(flag2)] - y = y[(flag2)] - z = z[(flag2)] - - if feature is not None: - feature = np.array(feature) - feature = feature[(flag2)] - return x,y,z,feature - return x, y, z - -def get_vol_index(x, y, z, depth, target_range): - min_x, min_y, min_z = -target_range, -target_range, -target_range - x = x - min_x - y = y - min_y - z = z - min_z - resolution = target_range*2 / 2 ** depth - x = (x // resolution).astype(int) - y = (y // resolution).astype(int) - z = (z // resolution).astype(int) - # vol_set = set() - # for i in range(len(x)): - # vol_set.add((x[i], y[i], z[i])) - # print(vol_set) - # print(min(x), max(x)) - return x, y, z - -def get_comp_dic(cubic_dic, comp_layer_dic = {}): - for key, value in cubic_dic.items(): - [depth, x, y, z] = [int(item) for item in key.split('_')] - x = x >> 1 << 1 - y = y >> 1 << 1 - z = z >> 1 << 1 - - for i in range(0,2): - for j in range(0,2): - for k in range(0,2): - string = '{}_{}_{}_{}'.format(depth, x+i, y+j, z+k) - if string not in cubic_dic: - comp_layer_dic[string] = 'Empty' - else: - comp_layer_dic[string] = cubic_dic[string] - pass - - # for key, value in comp_layer_dic.items(): - # if value == 'Ligand': - # print(key) - return comp_layer_dic - - - -def get_upper_layer_dic(cubic_dic): - upper_layer_dic = {} - for key, value in cubic_dic.items(): - [depth, x, y, z] = [int(item) for item in key.split('_')] - x = x >> 1 - y = y >> 1 - z = z >> 1 - depth -= 1 - string = '{}_{}_{}_{}'.format(depth, x,y,z) - if string not in upper_layer_dic: - upper_layer_dic[string] = value - elif value != upper_layer_dic[string]: - upper_layer_dic[string] = 'Mixture' - else: - pass - return upper_layer_dic - - -def create_cubic_dic(protein_xyz, ligand_xyz, depth): - cubic_dic = {} - [x, y, z] = protein_xyz - print('Protein points number: {}'.format(len(x))) - for i in range(len(x)): - string = '{}_{}_{}_{}'.format(depth, x[i], y[i], z[i]) - if string not in cubic_dic: - cubic_dic[string] = 'Protein' - else: - pass - - [x, y, z] = ligand_xyz - print('Ligand points number: {}'.format(len(x))) - for i in range(len(x)): - string = '{}_{}_{}_{}'.format(depth, x[i], y[i], z[i]) - if string not in cubic_dic: - cubic_dic[string] = 'Ligand' - elif cubic_dic[string] == 'Protein': - cubic_dic[string] = 'Mixture' - else: - pass - return cubic_dic - -def create_cubic_dic_with_feature(protein_xyz, ligand_xyz, depth, pocket_feature, ligand_feature): - cubic_dic = {} - [x, y, z] = protein_xyz - for i in range(len(x)): - string = '{}_{}_{}_{}'.format(depth, x[i], y[i], z[i]) - feature = pocket_feature[i] - atom_type = feature[0] - atom_index = 'P' + str(feature[1]) - atom_detail_type = 'P' + str(feature[0]) - if string not in cubic_dic: - cubic_dic[string] = {} - cubic_dic[string]['PLM'] = 'Protein' - cubic_dic[string]['Atoms'] = [atom_type] - cubic_dic[string]['Atom_index'] = [atom_index] - cubic_dic[string]['Atom_Detail_Type'] = [atom_detail_type] - else: - cubic_dic[string]['Atom_Detail_Type'].append(atom_detail_type) - if atom_type not in cubic_dic[string]['Atoms']: - cubic_dic[string]['Atoms'].append(atom_type) - if atom_index not in cubic_dic[string]['Atom_index']: - cubic_dic[string]['Atom_index'].append(atom_index) - - [x, y, z] = ligand_xyz - for i in range(len(x)): - string = '{}_{}_{}_{}'.format(depth, x[i], y[i], z[i]) - feature = ligand_feature[i] - atom_type = feature[0] - atom_index = 'L' + str(feature[1]) - atom_detail_type = 'L' + str(feature[0]) - if string not in cubic_dic: - cubic_dic[string] = {} - cubic_dic[string]['PLM'] = 'Ligand' - cubic_dic[string]['Atoms'] = [atom_type] - cubic_dic[string]['Atom_index'] = [atom_index] - cubic_dic[string]['Atom_Detail_Type'] = [atom_detail_type] - elif cubic_dic[string]['PLM'] == 'Protein': - cubic_dic[string]['PLM'] = 'Mixture' - cubic_dic[string]['Atom_Detail_Type'].append(atom_detail_type) - else: - cubic_dic[string]['Atom_Detail_Type'].append(atom_detail_type) - if atom_type not in cubic_dic[string]['Atoms']: - cubic_dic[string]['Atoms'].append(atom_type) - if atom_index not in cubic_dic[string]['Atom_index']: - cubic_dic[string]['Atom_index'].append(atom_index) - return cubic_dic - -def line_string_to_idx(string): - contents = string.split('_') - contents = [int(item) for item in contents] - return contents - -def fill_vtk_lines(vtk_line_dic, shift = [0,0,0]): - pts_dic = vtk_line_dic['pts_dic'] - lines_dic, colors_list = vtk_line_dic['lines_dic'], vtk_line_dic['colors_list'] - - pts = vtk.vtkPoints() - sorted_dic = sorted(pts_dic.items(), key=lambda x: x[1]) - for item in sorted_dic: - coord = point_string_to_coord(item[0]) - coord = [coord[0] + shift[0], coord[1] + shift[1], coord[2] + shift[2]] - pts.InsertNextPoint(coord) - - - lines = vtk.vtkCellArray() - colors = vtk.vtkFloatArray() - sorted_line_dic = sorted(lines_dic.items(), key=lambda x: x[1]) - for item in sorted_line_dic: - line_idx = line_string_to_idx(item[0]) - line0 = vtk.vtkLine() - line0.GetPointIds().SetId(0, line_idx[0]) - line0.GetPointIds().SetId(1, line_idx[1]) - lines.InsertNextCell(line0) - - # for line in lines_list: - # points = line.split('_') - # points = [int(item) for item in points] - # line0 = vtk.vtkLine() - # line0.GetPointIds().SetId(0, points[0]) - # line0.GetPointIds().SetId(1, points[1]) - # lines.InsertNextCell(line0) - for color in colors_list: - colors.InsertNextTuple1(color) - return pts, lines, colors